cummeRbund/DESCRIPTION0000644000175200017520000000275714516027267015430 0ustar00biocbuildbiocbuildPackage: cummeRbund Title: Analysis, exploration, manipulation, and visualization of Cufflinks high-throughput sequencing data. Version: 2.44.0 Date: 2013-04-22 Author: L. Goff, C. Trapnell, D. Kelley Description: Allows for persistent storage, access, exploration, and manipulation of Cufflinks high-throughput sequencing data. In addition, provides numerous plotting functions for commonly used visualizations. Imports: methods, plyr, BiocGenerics, S4Vectors (>= 0.9.25), Biobase Depends: R (>= 2.7.0), BiocGenerics (>= 0.3.2), RSQLite, ggplot2, reshape2, fastcluster, rtracklayer, Gviz Suggests: cluster, plyr, NMFN, stringr, GenomicFeatures, GenomicRanges, rjson Maintainer: Loyal A. Goff License: Artistic-2.0 Collate: AllGenerics.R AllClasses.R database-setup.R methods-CuffSet.R methods-CuffData.R methods-CuffDist.R methods-CuffGeneSet.R methods-CuffFeatureSet.R methods-CuffGene.R methods-CuffFeature.R tools.R LazyLoad: yes biocViews: HighThroughputSequencing, HighThroughputSequencingData, RNAseq, RNAseqData, GeneExpression, DifferentialExpression, Infrastructure, DataImport, DataRepresentation, Visualization, Bioinformatics, Clustering, MultipleComparisons, QualityControl git_url: https://git.bioconductor.org/packages/cummeRbund git_branch: RELEASE_3_18 git_last_commit: c4179c6 git_last_commit_date: 2023-10-24 Date/Publication: 2023-10-24 NeedsCompilation: no Packaged: 2023-10-24 20:53:11 UTC; biocbuild cummeRbund/NAMESPACE0000644000175200017520000000262414516004263015121 0ustar00biocbuildbiocbuildimport(methods) #importFrom(graphics, plot) importFrom(plyr, defaults) importFrom(BiocGenerics, annotation) #import(S4Vectors) importFrom(Biobase, featureNames) exportClasses(CuffSet, CuffData, CuffDist, CuffFeature, CuffFeatureSet, CuffGene, CuffGeneSet ) exportMethods( runInfo, varModel, annotation, genes, isoforms, TSS, CDS, promoters, splicing, relCDS, fpkm, repFpkm, count, distValues, csDensity, csScatter, csVolcano, csBoxplot, csHeatmap, csFoldChangeHeatmap, csDistHeat, csCluster, csDendro, MAplot, dispersionPlot, csSpecificity, fpkmMatrix, repFpkmMatrix, countMatrix, repCountMatrix, diffData, diffTable, features, featureNames, samples, replicates, expressionPlot, expressionBarplot, getGene, getGenes, getFeatures, getGeneId, findGene, getSig, getSigTable, addFeatures, getLevels, getRepLevels, findSimilar, makeRnk, genePlot, makeGeneRegionTrack, DB, sigMatrix, csScatterMatrix, csVolcanoMatrix, MDSplot, PCAplot, fpkmSCVPlot, csNMF, conditions, csPie ) export("readCufflinks", "JSdist", "JSdistVec", "JSdistFromP", "shannon.entropy", "makeprobs", "makeprobsvec", "csClusterPlot" ) #importClassesFrom("Biobase","Versioned") #importClassesFrom("Biobase","VersionedBiobase") cummeRbund/R/0000755000175200017520000000000014516004263014077 5ustar00biocbuildbiocbuildcummeRbund/R/AllClasses.R0000644000175200017520000000551714516004263016260 0ustar00biocbuildbiocbuild# AllClasses.R # # Author: lgoff ############################################################################### #TODO: I get the distinct feeling that these two should be nested environments, but I don't really know what that means. #CuffRun class describes information about a Cuffdiff run? #setClass("CuffRun", # representation(DB = "SQLiteConnection", # sampleInfo = "data.frame", # runParams = "data.frame" # ) # ) #CuffData Class is a 'pointer' container to a group of features in a cufflinks dataset setClass("CuffData", representation(DB = "SQLiteConnection", tables = "list", filters = "list", type = "character", idField = "character" ) ) #CuffDist Class is a 'pointer' container to one of the distribution test data sets (promoters.diff, splicing.diff, cds.diff) setClass("CuffDist", representation(DB = "SQLiteConnection", table = "character", type = "character", idField = "character" ) ) #CuffSet Class is a 'pointer' container to a group of CuffData elements in a cufflinks dataset setClass("CuffSet", representation(DB = "SQLiteConnection", #runInfo = "data.frame", #varModel = "data.frame", phenoData = "data.frame", conditions = "data.frame", genes = "CuffData", isoforms = "CuffData", TSS = "CuffData", CDS = "CuffData", promoters = "CuffDist", splicing = "CuffDist", relCDS = "CuffDist" ) ) #CuffFeature is a 'data' container for all information linked to a single 'idField' (cufflinks class agnostic) setClass("CuffFeature", representation(annotation="data.frame", fpkm="data.frame", diff="data.frame", repFpkm="data.frame", count="data.frame", genome="character" ) ) #CuffGene is a 'data' container for all information linked to a single 'gene_id' setClass("CuffGene", representation(id = "character", features = "data.frame", isoforms = "CuffFeature", TSS = "CuffFeature", CDS = "CuffFeature", promoters = "CuffFeature", splicing = "CuffFeature", relCDS = "CuffFeature"), contains="CuffFeature" ) #CuffFeatureSet is a 'data' container for all information from a set of features #This allows for plotting of gene set information setClass("CuffFeatureSet", representation(annotation="data.frame", fpkm="data.frame", diff="data.frame", repFpkm="data.frame", count="data.frame", genome="character" ) ) #CuffGene is a 'data' container for all information from a set of genes #This allows for plotting of gene set information setClass("CuffGeneSet", representation(ids = "character", isoforms = "CuffFeatureSet", TSS = "CuffFeatureSet", CDS= "CuffFeatureSet", promoters= "CuffFeatureSet", splicing= "CuffFeatureSet", relCDS= "CuffFeatureSet"), contains = "CuffFeatureSet" ) cummeRbund/R/AllGenerics.R0000644000175200017520000001657514516004263016430 0ustar00biocbuildbiocbuild#New for cummeRbund 0.1.2 #setGeneric("loadGenes",function(fpkmFile,..) standardGeneric("loadGenes")) #setGeneric("loadIsoforms",function(fpkmFile,..) standardGeneric("loadIsoforms")) #setGeneric("loadTSS",function(fpkmFile,..) standardGeneric("loadTSS")) #setGeneric("loadCDS",function(fpkmFile,..) standardGeneric("loadCDS")) ################## #CuffSet #################3 #CuffSet generics setGeneric("samples",function(object) standardGeneric("samples")) setGeneric("replicates",function(object) standardGeneric("replicates")) setGeneric("conditions",function(object) standardGeneric("conditions")) setGeneric("runInfo",function(object) standardGeneric("runInfo")) setGeneric("varModel",function(object) standardGeneric("varModel")) setGeneric("genes",function(object) standardGeneric("genes")) setGeneric("isoforms",function(object) standardGeneric("isoforms")) setGeneric("TSS",function(object) standardGeneric("TSS")) setGeneric("CDS",function(object) standardGeneric("CDS")) setGeneric("promoters",function(object) standardGeneric("promoters")) setGeneric("splicing",function(object) standardGeneric("splicing")) setGeneric("relCDS",function(object) standardGeneric("relCDS")) setGeneric("getGene",function(object,geneId,sampleIdList=NULL) standardGeneric("getGene")) setGeneric("getGenes",function(object,geneIdList,sampleIdList=NULL) standardGeneric("getGenes")) setGeneric("getGeneId",function(object,idList) standardGeneric("getGeneId")) setGeneric("findGene",function(object,query) standardGeneric("findGene")) setGeneric("getFeatures",function(object,featureIdList,sampleIdList=NULL,...) standardGeneric("getFeatures")) setGeneric("getSig", function(object,x,y,alpha=0.05,level="genes",method="BH",useCuffMTC=FALSE) standardGeneric("getSig")) setGeneric("getSigTable", function(object,alpha=0.05,level='genes') standardGeneric("getSigTable")) setGeneric("addFeatures",function(object, features, ...) standardGeneric("addFeatures")) setGeneric("findSimilar",function(object,x,n,...) standardGeneric("findSimilar")) setGeneric("makeGRanges",function(object,id,idField='transcript_id') standardGeneric("makeGRanges")) setGeneric("sigMatrix",function(object,alpha=0.05,level='genes',orderByDist=F) standardGeneric("sigMatrix")) ############### #CuffData ############### #CuffData generics setGeneric("features",function(object) standardGeneric("features")) #setGeneric("featureNames",function(object) standardGeneric("featureNames")) setGeneric("fpkm",function(object, features=FALSE,...) standardGeneric("fpkm")) setGeneric("repFpkm",function(object,features=FALSE,...) standardGeneric("repFpkm")) setGeneric("count",function(object,...) standardGeneric("count")) setGeneric("filters",function(object) standardGeneric("filters")) setGeneric("idField",function(object) standardGeneric("idField")) setGeneric("tables",function(object) standardGeneric("tables")) setGeneric("fpkmMatrix",function(object,...) standardGeneric("fpkmMatrix")) setGeneric("repFpkmMatrix",function(object,...) standardGeneric("repFpkmMatrix")) setGeneric("countMatrix",function(object,...) standardGeneric("countMatrix")) setGeneric("repCountMatrix",function(object,...) standardGeneric("repCountMatrix")) setGeneric("diffData",function(object, x, y, features=FALSE, lnFcCutoff=20, ...) standardGeneric("diffData")) setGeneric("diffTable",function(object,...) standardGeneric("diffTable")) setGeneric("getLevels",function(object) standardGeneric("getLevels")) setGeneric("getRepLevels",function(object) standardGeneric("getRepLevels")) setGeneric("MAplot",function(object,x,y,logMode=T,pseudocount=1,...) standardGeneric("MAplot")) setGeneric("dispersionPlot",function(object) standardGeneric("dispersionPlot")) setGeneric("makeRnk",function(object,x,y,filename,...) standardGeneric("makeRnk")) setGeneric("csScatterMatrix",function(object,replicates=FALSE,logMode=TRUE,...) standardGeneric("csScatterMatrix")) setGeneric("csVolcanoMatrix",function(object,replicates=FALSE,logMode=TRUE,...) standardGeneric("csVolcanoMatrix")) setGeneric("MDSplot",function(object,replicates=FALSE,logMode=TRUE,...) standardGeneric("MDSplot")) setGeneric("PCAplot",function(object,x="PC1", y="PC2",replicates=TRUE,pseudocount=1.0,scale=TRUE,...) standardGeneric("PCAplot")) setGeneric("fpkmSCVPlot",function(object,FPKMLowerBound=1,...) standardGeneric("fpkmSCVPlot")) setGeneric("csNMF",function(object,k,...) standardGeneric("csNMF")) #CuffDist generics setGeneric("distValues",function(object, x, y,...) standardGeneric("distValues")) setGeneric("DB",function(object,...) standardGeneric("DB")) #setGeneric("table",function(object,...) standardGeneric("table")) setGeneric("type",function(object,...) standardGeneric("type")) #setGeneric("testId",function(object,...) standardGeneric("testId")) #CuffData plotting setGeneric("csDensity",function(object, logMode=TRUE, pseudocount=1.0, labels, features=FALSE, ...) standardGeneric("csDensity")) setGeneric("csScatter",function(object, x, y, logMode=TRUE, pseudocount=1.0, labels, smooth=FALSE, ...) standardGeneric("csScatter")) setGeneric("csVolcano",function(object, x, y, features=F, ...) standardGeneric("csVolcano")) setGeneric("csBoxplot",function(object, logMode=T, ...) standardGeneric("csBoxplot")) ################### #CuffGeneSet ################### ################# #CuffFeatureSet ################# setGeneric("csHeatmap",function(object,rescaling='none', clustering='none', labCol=T, labRow=T, logMode=T, pseudocount=1.0, border=FALSE, heatscale= c(low='darkred',mid='orange',high='white'), heatMidpoint=NULL, ...) standardGeneric("csHeatmap")) setGeneric("csFoldChangeHeatmap",function(object, control_condition, replicate_num=NULL, clustering='none', labCol=T, labRow=T, logMode=F, pseudocount=1.0, border=FALSE, heatscale=c(low='steelblue',mid='white',high='tomato'), heatMidpoint=0,fullnames=T,replicates=FALSE,method='none',heatRange=3, ...) standardGeneric("csFoldChangeHeatmap")) setGeneric("csDistHeat",function(object, replicates=F, samples.not.genes=T, logMode=T, pseudocount=1.0, heatscale=c(low='lightyellow',mid='orange',high='darkred'), heatMidpoint=NULL, ...) standardGeneric("csDistHeat")) setGeneric("csCluster",function(object, k, logMode=T, pseudocount=1,...) standardGeneric("csCluster")) #setGeneric("csClusterPlot",function(clustering, pseudocount=1.0) standardGeneric("csClusterPlot")) #setGeneric("diff",function(object) standardGeneric("diff")) #setGeneric("annotation",function(object) standardGeneric("annotation")) setGeneric("csSpecificity",function(object,logMode=T,pseudocount=1,relative=FALSE,...) standardGeneric("csSpecificity")) setGeneric("csDendro",function(object,logMode=T,pseudocount=1,replicates=FALSE,...) standardGeneric("csDendro")) ################## #CuffGene ################## setGeneric("genePlot",function(object) standardGeneric("genePlot")) setGeneric("makeGeneRegionTrack",function(object) standardGeneric("makeGeneRegionTrack")) setGeneric("as.GRangesList",function(object,f="transcript") standardGeneric("as.GRangesList")) setGeneric("csPie",function(object,...) standardGeneric("csPie")) ############## #CuffFeature ############## setGeneric("getGenome",function(object) standardGeneric ("getGenome")) #CuffFeature plotting setGeneric("expressionBarplot",function(object, logMode=FALSE, pseudocount=1.0, showErrorbars=TRUE, ...) standardGeneric("expressionBarplot")) setGeneric("expressionPlot",function(object, logMode=FALSE, pseudocount=1.0, drawSummary=FALSE, sumFun=mean_cl_boot, showErrorbars=TRUE, ...) standardGeneric("expressionPlot")) cummeRbund/R/database-setup.R0000644000175200017520000021420114516004263017124 0ustar00biocbuildbiocbuild# TODO: Add comment # # Author: lgoff ############################################################################### ##################### #File Archetype parsing ##################### #RunInfo loadRunInfo<-function(runInfoFile, dbConn, path, fileArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors=FALSE, row.names=NULL, ...) { #Setup and reporting write(paste("Reading Run Info File ",runInfoFile,sep=""),stderr()) fileArgs$file = runInfoFile #Read Run Info file runInfo = as.data.frame(do.call(read.table,fileArgs)) #Parsing #not needed... #Load into database (runInfo table) write("Writing runInfo Table",stderr()) insert_SQL<-'INSERT INTO runInfo VALUES(:param, :value)' bulk_insert(dbConn,insert_SQL,runInfo) } #ReplicateTable loadRepTable<-function(repTableFile, dbConn, path, fileArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors=FALSE, row.names=NULL, ...) { #Setup and reporting write(paste("Reading Read Group Info ",repTableFile,sep=""),stderr()) fileArgs$file = repTableFile #Read Run Info file full = as.data.frame(read.delim(repTableFile)) #print(head(full)) #Fix sample_names full$condition<-make.db.names(dbConn,as.character(full$condition),unique=FALSE) #Parsing #For now, I need to concatenate condition and replicate number full$rep_name<-paste(full$condition,full$replicate_num,sep="_") #Load into database (replicates table) write("Writing replicates Table",stderr()) insert_SQL<-'INSERT INTO replicates VALUES(:file, :condition, :replicate_num, :rep_name, :total_mass, :norm_mass, :internal_scale, :external_scale)' bulk_insert(dbConn,insert_SQL,full) } #ReplicateTable loadVarModelTable<-function(VarModelFile, dbConn, path, fileArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors=FALSE, row.names=NULL, ...) { #Setup and reporting write(paste("Reading Var Model Info ",VarModelFile,sep=""),stderr()) fileArgs$file = VarModelFile #Read Run Info file full = as.data.frame(read.delim(VarModelFile)) #print(head(full)) #Fix sample_names full$condition<-make.db.names(dbConn,as.character(full$condition),unique=FALSE) #Load into database (replicates table) write("Writing varModel Table",stderr()) insert_SQL<-'INSERT INTO varModel VALUES(:condition, :locus, :compatible_count_mean, :compatible_count_var, :total_count_mean, :total_count_var, :fitted_var)' bulk_insert(dbConn,insert_SQL,full) } #Genes loadGenes<-function(fpkmFile, diffFile, promoterFile, countFile, replicateFile, dbConn, path, #Arguments to read.* methods fpkmArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), diffArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), promoterArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), countArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), replicateArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors = FALSE, row.names=NULL, ...) { #Error Trapping if (missing(fpkmFile)) stop("fpkmFile cannot be missing!") if (missing(dbConn)) stop("Must provide a dbConn connection") #TODO test dbConn connection and database structure idCols = c(1:9) #Read primary file write(paste("Reading ",fpkmFile,sep=""),stderr()) fpkmArgs$file = fpkmFile full = as.data.frame(do.call(read.table,fpkmArgs)) ######## #Handle Sample Names ######## #Check that samples table is populated write("Checking samples table...",stderr()) samples<-getSamplesFromColnames(full) samples<-make.db.names(dbConn,samples,unique=FALSE) dbSamples<-dbReadTable(dbConn,"samples") if (dim(dbSamples)[1]>0) { if (all(samples %in% dbSamples$sample_name)){ write ("OK!",stderr()) }else{ stop("Sample mismatch!") } }else{ write("Populating samples table...",stderr()) populateSampleTable(samples,dbConn) } ###### #Populate genes table ###### genesTable<-full[,c(1:3,5,7:9)] write("Writing genes table",stderr()) #dbWriteTable(dbConn,'genes',genesTable,row.names=F,append=T) insert_SQL<-'INSERT INTO genes VALUES(:tracking_id, :class_code, :nearest_ref_id, :gene_short_name, :locus, :length, :coverage)' bulk_insert(dbConn,insert_SQL,genesTable) ###### #Populate geneData table ###### write("Reshaping geneData table",stderr()) genemelt<-melt(full,id.vars=c("tracking_id"),measure.vars=-idCols,variable_name="sample_name") colnames(genemelt)[colnames(genemelt)=='variable']<-'sample_name' #Clean up and normalize data genemelt$measurement = "" genemelt$measurement[grepl("_FPKM$",genemelt$sample_name)] = "fpkm" genemelt$measurement[grepl("_conf_lo$",genemelt$sample_name)] = "conf_lo" genemelt$measurement[grepl("_conf_hi$",genemelt$sample_name)] = "conf_hi" genemelt$measurement[grepl("_status$",genemelt$sample_name)] = "status" genemelt$sample_name<-gsub("_FPKM$","",genemelt$sample_name) genemelt$sample_name<-gsub("_conf_lo$","",genemelt$sample_name) genemelt$sample_name<-gsub("_conf_hi$","",genemelt$sample_name) genemelt$sample_name<-gsub("_status$","",genemelt$sample_name) #Adjust sample names with make.db.names genemelt$sample_name <- make.db.names(dbConn,as.vector(genemelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) genemelt<-as.data.frame(dcast(genemelt,...~measurement)) #debugging #write(colnames(genemelt),stderr()) #Write geneData table write("Writing geneData table",stderr()) #dbWriteTable(dbConn,'geneData',as.data.frame(genemelt[,c(1:2,5,3,4,6)]),row.names=F,append=T) insert_SQL<-'INSERT INTO geneData VALUES(:tracking_id,:sample_name,:fpkm,:conf_hi,:conf_lo,:status)' #write(insert_SQL,stderr()) bulk_insert(dbConn,insert_SQL,genemelt[,c(1:2,5,3,4,6)]) ####### #Handle gene_exp.diff ####### if(file.exists(diffFile)){ #Read diff file write(paste("Reading ",diffFile,sep=""),stderr()) diffArgs$file = diffFile #Something like this to make sure sample names are treated as character values and not numeric, logical, etc. #diffArgs$colClasses<-c(rep('character',7),rep('numeric',6),'character') diff<-as.data.frame(do.call(read.table,diffArgs)) if(dim(diff)[1]>0){ #Adjust sample names with make.db.names diff$sample_1<-make.db.names(dbConn,as.vector(diff$sample_1),unique=FALSE) diff$sample_2<-make.db.names(dbConn,as.vector(diff$sample_2),unique=FALSE) write("Writing geneExpDiffData table",stderr()) diffCols<-c(1,5:14) colnames(diff)[colnames(diff)=="log2.fold_change."]<-"log2_fold_change" # Not sure why this is the only place this is screwy... #debugging #write(colnames(diff[,diffCols]),stderr()) #dbWriteTable(dbConn,'geneExpDiffData',diff[,diffCols],row.names=F,append=T) insert_SQL<-"INSERT INTO geneExpDiffData VALUES(:test_id,:sample_1,:sample_2,:status,:value_1,:value_2,:log2_fold_change,:test_stat,:p_value,:q_value,:significant)" bulk_insert(dbConn,insert_SQL,diff[,diffCols]) }else{ write(paste("No records found in", diffFile),stderr()) } } ######## #TODO: Handle promoters.diff ######## if(file.exists(promoterFile)){ #Read promoterFile write(paste("Reading ",promoterFile,sep=""),stderr()) promoterArgs$file = promoterFile promoter<-as.data.frame(do.call(read.table,promoterArgs)) write("Writing promoterDiffData table",stderr()) promoterCols<-c(2,5:14) if(dim(promoter)[1]>0){ #dbWriteTable(dbConn,'promoterDiffData',promoter[,promoterCols],row.names=F,append=T) insert_SQL<-"INSERT INTO promoterDiffData VALUES(?,?,?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,promoter[,promoterCols]) }else{ write(paste("No records found in", promoterFile),stderr()) } } ######### #Handle Feature Data (this will actually be done on CuffData objects instead...but I may include something here as well) ######### ########### #Handle Counts .count_tracking ########### if(file.exists(countFile)){ idCols = c(1) #Read countFile write(paste("Reading ", countFile,sep=""),stderr()) countArgs$file = countFile counts<-as.data.frame(do.call(read.table,countArgs)) if(dim(counts)[1]>0){ #Reshape geneCount table write("Reshaping geneCount table",stderr()) countmelt<-melt(counts,id.vars=c("tracking_id"),measure.vars=-idCols) colnames(countmelt)[colnames(countmelt)=='variable']<-'sample_name' countmelt$measurement = "" countmelt$measurement[grepl("_count$",countmelt$sample_name)] = "count" countmelt$measurement[grepl("_count_variance$",countmelt$sample_name)] = "variance" countmelt$measurement[grepl("_count_uncertainty_var$",countmelt$sample_name)] = "uncertainty" countmelt$measurement[grepl("_count_dispersion_var$",countmelt$sample_name)] = "dispersion" countmelt$measurement[grepl("_status$",countmelt$sample_name)] = "status" countmelt$sample_name<-gsub("_count$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_variance$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_uncertainty_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_dispersion_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_status$","",countmelt$sample_name) #Adjust sample names with make.db.names countmelt$sample_name <- make.db.names(dbConn,as.vector(countmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) countmelt<-as.data.frame(dcast(countmelt,...~measurement)) #debugging #write(colnames(countmelt),stderr()) #Write geneCount table write("Writing geneCount table",stderr()) insert_SQL<-'INSERT INTO geneCount VALUES(:tracking_id,:sample_name,:count,:variance,:uncertainty,:dispersion,:status)' bulk_insert(dbConn,insert_SQL,countmelt) }else{ write(paste("No records found in", countFile),stderr()) } } ########### #Handle Replicates .rep_tracking ########### if(file.exists(replicateFile)){ idCols = 1 #Read countFile write(paste("Reading read group info in ", replicateFile,sep=""),stderr()) replicateArgs$file = replicateFile reps<-as.data.frame(do.call(read.table,replicateArgs)) #print(head(reps)) if(dim(reps)[1]>0){ #Adjust sample names with make.db.names reps$condition <- make.db.names(dbConn,as.character(reps$condition),unique=FALSE) #Create unique rep name reps$rep_name<-paste(reps$condition,reps$replicate,sep="_") colnames(reps)[colnames(reps)=="condition"]<-"sample_name" #Write geneReplicateData table write("Writing geneReplicateData table",stderr()) insert_SQL<-'INSERT INTO geneReplicateData VALUES(:tracking_id,:sample_name,:replicate,:rep_name,:raw_frags,:internal_scaled_frags,:external_scaled_frags,:FPKM,:effective_length,:status)' bulk_insert(dbConn,insert_SQL,reps) }else{ write(paste("No records found in", replicateFile),stderr()) } } } #Isoforms loadIsoforms<-function(fpkmFile, diffFile, countFile, replicateFile, dbConn, path, #Arguments to read.* methods fpkmArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), diffArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), countArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), replicateArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors = FALSE, row.names=NULL, ...) { #Error Trapping if (missing(fpkmFile)) stop("fpkmFile cannot be missing!") if (missing(dbConn)) stop("Must provide a dbConn connection") #TODO test dbConn connection and database structure idCols = c(1:9) #Read primary file write(paste("Reading ",fpkmFile,sep=""),stderr()) fpkmArgs$file = fpkmFile full = as.data.frame(do.call(read.table,fpkmArgs)) ######## #Handle Sample Names ######## #Check that samples table is populated write("Checking samples table...",stderr()) samples<-getSamplesFromColnames(full) samples<-make.db.names(dbConn,samples,unique=FALSE) dbSamples<-dbReadTable(dbConn,"samples") if (dim(dbSamples)[1]>0) { if (all(samples %in% dbSamples$sample_name)){ write ("OK!",stderr()) }else{ write(samples,stderr()) stop("Sample mismatch!") } }else{ write("Populating samples table...",stderr()) populateSampleTable(samples,dbConn) } ###### #Populate isoforms table ###### isoformCols<-c(1,4,5,6,2,3,7:9) isoformsTable<-full[,isoformCols] #This is a temporary fix until p_id is added to the 'isoforms.fpkm_tracking' file isoformsTable<-cbind(isoformsTable[,1:2],data.frame(CDS_id=rep("NA",dim(isoformsTable)[1])),isoformsTable[,-c(1:2)]) #print (head(isoformsTable)) write("Writing isoforms table",stderr()) #dbWriteTable(dbConn,'isoforms',as.data.frame(isoformsTable),row.names=F,append=T) insert_SQL<-'INSERT INTO isoforms VALUES(?,?,?,?,?,?,?,?,?,?)' bulk_insert(dbConn,insert_SQL,isoformsTable) ###### #Populate isoformData table ###### write("Reshaping isoformData table",stderr()) isoformmelt<-melt(full,id.vars=c("tracking_id"),measure.vars=-idCols,variable_name="sample_name") colnames(isoformmelt)[colnames(isoformmelt)=='variable']<-'sample_name' #Clean up and normalize data isoformmelt$measurement = "" isoformmelt$measurement[grepl("_FPKM$",isoformmelt$sample_name)] = "fpkm" isoformmelt$measurement[grepl("_conf_lo$",isoformmelt$sample_name)] = "conf_lo" isoformmelt$measurement[grepl("_conf_hi$",isoformmelt$sample_name)] = "conf_hi" isoformmelt$measurement[grepl("_status$",isoformmelt$sample_name)] = "status" isoformmelt$sample_name<-gsub("_FPKM$","",isoformmelt$sample_name) isoformmelt$sample_name<-gsub("_conf_lo$","",isoformmelt$sample_name) isoformmelt$sample_name<-gsub("_conf_hi$","",isoformmelt$sample_name) isoformmelt$sample_name<-gsub("_status$","",isoformmelt$sample_name) #Adjust sample names with make.db.names isoformmelt$sample_name <- make.db.names(dbConn,as.vector(isoformmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) isoformmelt<-as.data.frame(dcast(isoformmelt,...~measurement)) #Write geneData table write("Writing isoformData table",stderr()) #dbWriteTable(dbConn,'isoformData',as.data.frame(isoformmelt[,c(1:2,5,3,4,6)]),row.names=F,append=T) insert_SQL<-"INSERT INTO isoformData VALUES(?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,isoformmelt[,c(1:2,5,3,4,6)]) ####### #Handle isoform_exp.diff ####### if(file.exists(diffFile)){ #Read diff file write(paste("Reading ",diffFile,sep=""),stderr()) diffArgs$file = diffFile diff<-as.data.frame(do.call(read.table,diffArgs)) if(dim(diff)[1]>0){ #Adjust sample names with make.db.names diff$sample_1<-make.db.names(dbConn,as.vector(diff$sample_1),unique=FALSE) diff$sample_2<-make.db.names(dbConn,as.vector(diff$sample_2),unique=FALSE) write("Writing isoformExpDiffData table",stderr()) diffCols<-c(1,5:14) #dbWriteTable(dbConn,'isoformExpDiffData',diff[,diffCols],row.names=F,append=T) insert_SQL<-"INSERT INTO isoformExpDiffData VALUES(?,?,?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,diff[,diffCols]) }else{ write(paste("No records found in",diffFile),stderr()) } } ########### #Handle Counts .count_tracking ########### if(file.exists(countFile)){ idCols = c(1) #Read countFile write(paste("Reading ", countFile,sep=""),stderr()) countArgs$file = countFile counts<-as.data.frame(do.call(read.table,countArgs)) if(dim(counts)[1]>0){ #Reshape isoformCount table write("Reshaping isoformCount table",stderr()) countmelt<-melt(counts,id.vars=c("tracking_id"),measure.vars=-idCols) colnames(countmelt)[colnames(countmelt)=='variable']<-'sample_name' countmelt$measurement = "" countmelt$measurement[grepl("_count$",countmelt$sample_name)] = "count" countmelt$measurement[grepl("_count_variance$",countmelt$sample_name)] = "variance" countmelt$measurement[grepl("_count_uncertainty_var$",countmelt$sample_name)] = "uncertainty" countmelt$measurement[grepl("_count_dispersion_var$",countmelt$sample_name)] = "dispersion" countmelt$measurement[grepl("_status$",countmelt$sample_name)] = "status" countmelt$sample_name<-gsub("_count$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_variance$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_uncertainty_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_dispersion_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_status$","",countmelt$sample_name) #Adjust sample names with make.db.names countmelt$sample_name <- make.db.names(dbConn,as.vector(countmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) countmelt<-as.data.frame(dcast(countmelt,...~measurement)) #debugging #write(colnames(countmelt),stderr()) #Write isoformCount table write("Writing isoformCount table",stderr()) insert_SQL<-'INSERT INTO isoformCount VALUES(:tracking_id,:sample_name,:count,:variance,:uncertainty,:dispersion,:status)' bulk_insert(dbConn,insert_SQL,countmelt) }else{ write(paste("No records found in",countFile),stderr()) } } ########### #Handle Replicates .rep_tracking ########### if(file.exists(replicateFile)){ idCols = 1 #Read countFile write(paste("Reading read group info in ", replicateFile,sep=""),stderr()) replicateArgs$file = replicateFile reps<-as.data.frame(do.call(read.table,replicateArgs)) #print(head(reps)) if(dim(reps)[1]>0){ #Adjust sample names with make.db.names reps$condition <- make.db.names(dbConn,as.character(reps$condition),unique=FALSE) #Create unique rep name reps$rep_name<-paste(reps$condition,reps$replicate,sep="_") colnames(reps)[colnames(reps)=="condition"]<-"sample_name" #Write isoformReplicateData table write("Writing isoformReplicateData table",stderr()) insert_SQL<-'INSERT INTO isoformReplicateData VALUES(:tracking_id,:sample_name,:replicate,:rep_name,:raw_frags,:internal_scaled_frags,:external_scaled_frags,:FPKM,:effective_length,:status)' bulk_insert(dbConn,insert_SQL,reps) }else{ write(paste("No records found in",replicateFile),stderr()) } } } #TSS groups loadTSS<-function(fpkmFile, diffFile, splicingFile, countFile, replicateFile, dbConn, path, #Arguments to read.* methods fpkmArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), diffArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), splicingArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), countArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), replicateArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors = FALSE, row.names=NULL, ...) { #Error Trapping if (missing(fpkmFile)) stop("fpkmFile cannot be missing!") if (missing(dbConn)) stop("Must provide a dbConn connection") #TODO test dbConn connection and database structure idCols = c(1:9) #Read primary file write(paste("Reading ",fpkmFile,sep=""),stderr()) fpkmArgs$file = fpkmFile full = as.data.frame(do.call(read.table,fpkmArgs)) ######## #Handle Sample Names ######## #Check that samples table is populated write("Checking samples table...",stderr()) samples<-getSamplesFromColnames(full) samples<-make.db.names(dbConn,samples,unique=FALSE) dbSamples<-dbReadTable(dbConn,"samples") if (dim(dbSamples)[1]>0) { if (all(samples %in% dbSamples$sample_name)){ write ("OK!",stderr()) }else{ stop("Sample mismatch!") } }else{ write("Populating samples table...",stderr()) populateSampleTable(samples,dbConn) } ###### #Populate TSS table ###### tssTable<-full[,c(1:5,7:9)] write("Writing TSS table",stderr()) #dbWriteTable(dbConn,'TSS',tssTable,row.names=F,append=T) if (nrow(tssTable)>0){ insert_SQL<-"INSERT INTO TSS VALUES(?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,tssTable) ###### #Populate geneData table ###### write("Reshaping TSSData table",stderr()) tssmelt<-melt(full,id.vars=c("tracking_id"),measure.vars=-idCols,variable_name="sample_name") colnames(tssmelt)[colnames(tssmelt)=='variable']<-'sample_name' #Clean up and normalize data tssmelt$measurement = "" tssmelt$measurement[grepl("_FPKM$",tssmelt$sample_name)] = "fpkm" tssmelt$measurement[grepl("_conf_lo$",tssmelt$sample_name)] = "conf_lo" tssmelt$measurement[grepl("_conf_hi$",tssmelt$sample_name)] = "conf_hi" tssmelt$measurement[grepl("_status$",tssmelt$sample_name)] = "status" tssmelt$sample_name<-gsub("_FPKM$","",tssmelt$sample_name) tssmelt$sample_name<-gsub("_conf_lo$","",tssmelt$sample_name) tssmelt$sample_name<-gsub("_conf_hi$","",tssmelt$sample_name) tssmelt$sample_name<-gsub("_status$","",tssmelt$sample_name) #Adjust sample names with make.db.names tssmelt$sample_name <- make.db.names(dbConn,as.vector(tssmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) tssmelt<-as.data.frame(dcast(tssmelt,...~measurement)) #Write geneData table write("Writing TSSData table",stderr()) #dbWriteTable(dbConn,'TSSData',as.data.frame(tssmelt[,c(1:2,5,3,4,6)]),row.names=F,append=T) insert_SQL<-"INSERT INTO TSSData VALUES(?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,tssmelt[,c(1:2,5,3,4,6)]) }else{ write(paste("No records found in",fpkmFile),stderr()) write("TSS FPKM tracking file was empty.",stderr()) } ####### #Handle tss_groups_exp.diff ####### if(file.exists(diffFile)){ #Read diff file write(paste("Reading ",diffFile,sep=""),stderr()) diffArgs$file = diffFile diff<-as.data.frame(do.call(read.table,diffArgs)) if(dim(diff)[1]>0){ #Adjust sample names with make.db.names diff$sample_1<-make.db.names(dbConn,as.vector(diff$sample_1),unique=FALSE) diff$sample_2<-make.db.names(dbConn,as.vector(diff$sample_2),unique=FALSE) write("Writing TSSExpDiffData table",stderr()) diffCols<-c(1,5:14) #dbWriteTable(dbConn,'TSSExpDiffData',diff[,diffCols],row.names=F,append=T) insert_SQL<-"INSERT INTO TSSExpDiffData VALUES(?,?,?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,diff[,diffCols]) }else{ write(paste("No records found in",diffFile),stderr()) } } ######### #TODO: Handle splicing.diff ######## if(file.exists(splicingFile)){ #Read promoterFile write(paste("Reading ",splicingFile,sep=""),stderr()) splicingArgs$file = splicingFile splicing<-as.data.frame(do.call(read.table,splicingArgs)) if(dim(splicing)[1]>0){ write("Writing splicingDiffData table",stderr()) splicingCols<-c(1:2,5:14) #dbWriteTable(dbConn,'splicingDiffData',splicing[,splicingCols],row.names=F,append=T) insert_SQL<-"INSERT INTO splicingDiffData VALUES(?,?,?,?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,splicing[,splicingCols]) }else{ write(paste("No records found in",splicingFile),stderr()) } } ########### #Handle Counts .count_tracking ########### if(file.exists(countFile)){ idCols = c(1) #Read countFile write(paste("Reading ", countFile,sep=""),stderr()) countArgs$file = countFile counts<-as.data.frame(do.call(read.table,countArgs)) if(dim(counts)[1]>0){ #Reshape TSSCount table write("Reshaping TSSCount table",stderr()) countmelt<-melt(counts,id.vars=c("tracking_id"),measure.vars=-idCols) colnames(countmelt)[colnames(countmelt)=='variable']<-'sample_name' countmelt$measurement = "" countmelt$measurement[grepl("_count$",countmelt$sample_name)] = "count" countmelt$measurement[grepl("_count_variance$",countmelt$sample_name)] = "variance" countmelt$measurement[grepl("_count_uncertainty_var$",countmelt$sample_name)] = "uncertainty" countmelt$measurement[grepl("_count_dispersion_var$",countmelt$sample_name)] = "dispersion" countmelt$measurement[grepl("_status$",countmelt$sample_name)] = "status" countmelt$sample_name<-gsub("_count$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_variance$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_uncertainty_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_dispersion_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_status$","",countmelt$sample_name) #Adjust sample names with make.db.names countmelt$sample_name <- make.db.names(dbConn,as.vector(countmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) countmelt<-as.data.frame(dcast(countmelt,...~measurement)) #debugging #write(colnames(countmelt),stderr()) #Write TSSCount table write("Writing TSSCount table",stderr()) insert_SQL<-'INSERT INTO TSSCount VALUES(:tracking_id,:sample_name,:count,:variance,:uncertainty,:dispersion,:status)' bulk_insert(dbConn,insert_SQL,countmelt) }else{ write(paste("No records found in",countFile),stderr()) } } ########### #Handle Replicates .rep_tracking ########### if(file.exists(replicateFile)){ idCols = 1 #Read countFile write(paste("Reading read group info in ", replicateFile,sep=""),stderr()) replicateArgs$file = replicateFile reps<-as.data.frame(do.call(read.table,replicateArgs)) #print(head(reps)) if(dim(reps)[1]>0){ #Adjust sample names with make.db.names reps$condition <- make.db.names(dbConn,as.character(reps$condition),unique=FALSE) #Create unique rep name reps$rep_name<-paste(reps$condition,reps$replicate,sep="_") colnames(reps)[colnames(reps)=="condition"]<-"sample_name" #Write TSSReplicateData table write("Writing TSSReplicateData table",stderr()) insert_SQL<-'INSERT INTO TSSReplicateData VALUES(:tracking_id,:sample_name,:replicate,:rep_name,:raw_frags,:internal_scaled_frags,:external_scaled_frags,:FPKM,:effective_length,:status)' bulk_insert(dbConn,insert_SQL,reps) }else{ write(paste("No records found in",replicateFile),stderr()) } } } #CDS loadCDS<-function(fpkmFile, diffFile, CDSDiff, countFile, replicateFile, dbConn, path, #Arguments to read.* methods fpkmArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), diffArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), CDSDiffArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), countArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), replicateArgs = list(sep=sep, header=header, row.names = row.names, quote=quote, na.string=na.string, ...), sep="\t", na.string = "-", header = TRUE, quote = "", stringsAsFactors = FALSE, row.names=NULL, ...) { #Error Trapping if (missing(fpkmFile)) stop("fpkmFile cannot be missing!") if (missing(dbConn)) stop("Must provide a dbConn connection") #TODO test dbConn connection and database structure idCols = c(1:9) #Read primary file write(paste("Reading ",fpkmFile,sep=""),stderr()) fpkmArgs$file = fpkmFile full = as.data.frame(do.call(read.table,fpkmArgs)) ######## #Handle Sample Names ######## #Check that samples table is populated write("Checking samples table...",stderr()) samples<-getSamplesFromColnames(full) samples<-make.db.names(dbConn,samples,unique=FALSE) dbSamples<-dbReadTable(dbConn,"samples") if (dim(dbSamples)[1]>0) { if (all(samples %in% dbSamples$sample_name)){ write ("OK!",stderr()) }else{ stop("Sample mismatch!") } }else{ write("Populating samples table...",stderr()) populateSampleTable(samples,dbConn) } ###### #Populate CDS table ###### cdsTable<-full[,c(1:5,6:9)] write("Writing CDS table",stderr()) #dbWriteTable(dbConn,'CDS',cdsTable,row.names=F,append=T) if (nrow(cdsTable)>0){ insert_SQL<-"INSERT INTO CDS VALUES(?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,cdsTable) ###### #Populate geneData table ###### write("Reshaping CDSData table",stderr()) cdsmelt<-melt(full,id.vars=c("tracking_id"),measure.vars=-idCols,variable_name="sample_name") colnames(cdsmelt)[colnames(cdsmelt)=='variable']<-'sample_name' #Clean up and normalize data cdsmelt$measurement = "" cdsmelt$measurement[grepl("_FPKM$",cdsmelt$sample_name)] = "fpkm" cdsmelt$measurement[grepl("_conf_lo$",cdsmelt$sample_name)] = "conf_lo" cdsmelt$measurement[grepl("_conf_hi$",cdsmelt$sample_name)] = "conf_hi" cdsmelt$measurement[grepl("_status$",cdsmelt$sample_name)] = "status" cdsmelt$sample_name<-gsub("_FPKM$","",cdsmelt$sample_name) cdsmelt$sample_name<-gsub("_conf_lo$","",cdsmelt$sample_name) cdsmelt$sample_name<-gsub("_conf_hi$","",cdsmelt$sample_name) cdsmelt$sample_name<-gsub("_status$","",cdsmelt$sample_name) #Adjust sample names with make.db.names cdsmelt$sample_name <- make.db.names(dbConn,as.vector(cdsmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) cdsmelt<-as.data.frame(dcast(cdsmelt,...~measurement)) #Write geneData table write("Writing CDSData table",stderr()) #dbWriteTable(dbConn,'CDSData',as.data.frame(cdsmelt[,c(1:2,5,3,4,6)]),row.names=F,append=T) insert_SQL<-"INSERT INTO CDSData VALUES(?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,cdsmelt[,c(1:2,5,3,4,6)]) }else { write(paste("No records found in",fpkmFile),stderr()) write("CDS FPKM tracking file was empty.",stderr()) } ####### #Handle cds_groups_exp.diff ####### if(file.exists(diffFile)){ #Read diff file write(paste("Reading ",diffFile,sep=""),stderr()) diffArgs$file = diffFile diff<-as.data.frame(do.call(read.table,diffArgs)) if(dim(diff)[1]>0){ #Adjust sample names with make.db.names diff$sample_1<-make.db.names(dbConn,as.vector(diff$sample_1),unique=FALSE) diff$sample_2<-make.db.names(dbConn,as.vector(diff$sample_2),unique=FALSE) write("Writing CDSExpDiffData table",stderr()) diffCols<-c(1,5:14) #dbWriteTable(dbConn,'CDSExpDiffData',diff[,diffCols],row.names=F,append=T) insert_SQL<-"INSERT INTO CDSExpDiffData VALUES(?,?,?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,diff[,diffCols]) }else{ write(paste("No records found in",diffFile),stderr()) } } ######### #TODO: Handle CDS.diff ######## if(file.exists(CDSDiff)){ #Read promoterFile write(paste("Reading ",CDSDiff,sep=""),stderr()) CDSDiffArgs$file = CDSDiff CDS<-as.data.frame(do.call(read.table,CDSDiffArgs)) if(dim(CDS)[1]>0){ write("Writing CDSDiffData table",stderr()) CDSCols<-c(2,5:14) #dbWriteTable(dbConn,'CDSDiffData',CDS[,CDSCols],row.names=F,append=T) insert_SQL<-"INSERT INTO CDSDiffData VALUES(?,?,?,?,?,?,?,?,?,?,?)" bulk_insert(dbConn,insert_SQL,CDS[,CDSCols]) }else{ write(paste("No records found in",CDSDiff),stderr()) } } ########### #Handle Counts .count_tracking ########### if(file.exists(countFile)){ idCols = c(1) #Read countFile write(paste("Reading ", countFile,sep=""),stderr()) countArgs$file = countFile counts<-as.data.frame(do.call(read.table,countArgs)) if(dim(counts)[1]>0){ #Reshape CDSCount table write("Reshaping CDSCount table",stderr()) countmelt<-melt(counts,id.vars=c("tracking_id"),measure.vars=-idCols) colnames(countmelt)[colnames(countmelt)=='variable']<-'sample_name' countmelt$measurement = "" countmelt$measurement[grepl("_count$",countmelt$sample_name)] = "count" countmelt$measurement[grepl("_count_variance$",countmelt$sample_name)] = "variance" countmelt$measurement[grepl("_count_uncertainty_var$",countmelt$sample_name)] = "uncertainty" countmelt$measurement[grepl("_count_dispersion_var$",countmelt$sample_name)] = "dispersion" countmelt$measurement[grepl("_status$",countmelt$sample_name)] = "status" countmelt$sample_name<-gsub("_count$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_variance$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_uncertainty_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_count_dispersion_var$","",countmelt$sample_name) countmelt$sample_name<-gsub("_status$","",countmelt$sample_name) #Adjust sample names with make.db.names countmelt$sample_name <- make.db.names(dbConn,as.vector(countmelt$sample_name),unique=FALSE) #Recast write("Recasting",stderr()) countmelt<-as.data.frame(dcast(countmelt,...~measurement)) #debugging #write(colnames(countmelt),stderr()) #Write CDSCount table write("Writing CDSCount table",stderr()) insert_SQL<-'INSERT INTO CDSCount VALUES(:tracking_id,:sample_name,:count,:variance,:uncertainty,:dispersion,:status)' bulk_insert(dbConn,insert_SQL,countmelt) }else{ write(paste("No records found in",countFile),stderr()) } } ########### #Handle Replicates .rep_tracking ########### if(file.exists(replicateFile)){ idCols = 1 #Read countFile write(paste("Reading read group info in ", replicateFile,sep=""),stderr()) replicateArgs$file = replicateFile reps<-as.data.frame(do.call(read.table,replicateArgs)) #print(head(reps)) if(dim(reps)[1]>0){ #Adjust sample names with make.db.names reps$condition <- make.db.names(dbConn,as.character(reps$condition),unique=FALSE) #Create unique rep name reps$rep_name<-paste(reps$condition,reps$replicate,sep="_") colnames(reps)[colnames(reps)=="condition"]<-"sample_name" #Write CDSReplicateData table write("Writing CDSReplicateData table",stderr()) insert_SQL<-'INSERT INTO CDSReplicateData VALUES(:tracking_id,:sample_name,:replicate,:rep_name,:raw_frags,:internal_scaled_frags,:external_scaled_frags,:FPKM,:effective_length,:status)' bulk_insert(dbConn,insert_SQL,reps) }else{ write(paste("No records found in",replicateFile),stderr()) } } } ######################## #Add FeatureData ######################## ##################### #Database Setup Functions ##################### createDB_noIndex<-function(dbFname="cuffData.db",driver="SQLite") { #Builds sqlite db at 'dbFname' and returns a dbConnect object pointing to newly created database. #No indexes are present drv<-dbDriver(driver) db <- dbConnect(drv,dbname=dbFname) schema.text<-' -- Creator: MySQL Workbench 5.2.33/ExportSQLite plugin 2009.12.02 -- Author: Loyal Goff -- Caption: New Model -- Project: Name of the project -- Changed: 2012-04-30 22:21 -- Created: 2011-05-02 12:52 PRAGMA foreign_keys = OFF; -- Schema: cuffData BEGIN; DROP TABLE IF EXISTS "genes"; CREATE TABLE "genes"( "gene_id" VARCHAR(45) PRIMARY KEY NOT NULL, "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "gene_short_name" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT ); DROP TABLE IF EXISTS "biasData"; CREATE TABLE "biasData"( "biasData_id" INTEGER PRIMARY KEY NOT NULL ); DROP TABLE IF EXISTS "samples"; CREATE TABLE "samples"( "sample_index" INTEGER NOT NULL, "sample_name" VARCHAR(45) PRIMARY KEY NOT NULL ); DROP TABLE IF EXISTS "TSS"; CREATE TABLE "TSS"( "TSS_group_id" VARCHAR(45) PRIMARY KEY NOT NULL, "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "gene_id" VARCHAR(45) NOT NULL, "gene_short_name" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT, CONSTRAINT "fk_TSS_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); DROP TABLE IF EXISTS "TSSData"; CREATE TABLE "TSSData"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_TSSData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "CDS"; CREATE TABLE "CDS"( "CDS_id" VARCHAR(45) PRIMARY KEY NOT NULL, "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "gene_id" VARCHAR(45), "gene_short_name" VARCHAR(45), "TSS_group_id" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT, CONSTRAINT "fk_CDS_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_CDS_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id") ); DROP TABLE IF EXISTS "CDSData"; CREATE TABLE "CDSData"( "CDS_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_CDSData_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "splicingDiffData"; CREATE TABLE "splicingDiffData"( "TSS_group_id" VARCHAR(45) NOT NULL, "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "JS_dist" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_splicingDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_splicingDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_splicingDiffData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_splicingDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); DROP TABLE IF EXISTS "TSSExpDiffData"; CREATE TABLE "TSSExpDiffData"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "log2_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_TSSExpDiffData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_TSSExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "CDSDiffData"; CREATE TABLE "CDSDiffData"( "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "JS_dist" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_CDSDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_CDSDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_CDSDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); DROP TABLE IF EXISTS "CDSExpDiffData"; CREATE TABLE "CDSExpDiffData"( "CDS_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "log2_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_CDSExpDiffData_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_CDSExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "promoterDiffData"; CREATE TABLE "promoterDiffData"( "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "JS_dist" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_promoterDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_promoterDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_promoterDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "geneFeatures"; CREATE TABLE "geneFeatures"( "gene_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_geneFeatures_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); DROP TABLE IF EXISTS "TSSFeatures"; CREATE TABLE "TSSFeatures"( "TSS_group_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_TSSFeatures_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id") ); DROP TABLE IF EXISTS "CDSFeatures"; CREATE TABLE "CDSFeatures"( "CDS_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_CDSFeatures_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id") ); DROP TABLE IF EXISTS "model_transcripts"; CREATE TABLE "model_transcripts"( "model_transcript_id" INTEGER PRIMARY KEY AUTOINCREMENT NOT NULL ); DROP TABLE IF EXISTS "geneCount"; CREATE TABLE "geneCount"( "gene_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_geneCount_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); DROP TABLE IF EXISTS "CDSCount"; CREATE TABLE "CDSCount"( "CDS_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_CDSCount_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "TSSCount"; CREATE TABLE "TSSCount"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_TSSCount_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "replicates"; CREATE TABLE "replicates"( "file" INTEGER NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INT NOT NULL, "rep_name" VARCHAR(45) PRIMARY KEY NOT NULL, "total_mass" FLOAT, "norm_mass" FLOAT, "internal_scale" FLOAT, "external_scale" FLOAT, CONSTRAINT "fk_replicates_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "geneReplicateData"; CREATE TABLE "geneReplicateData"( "gene_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INTEGER, "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneData_genes10" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_geneReplicateData_replicates1" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_geneReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "CDSReplicateData"; CREATE TABLE "CDSReplicateData"( "CDS_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INTEGER, "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneReplicateData_replicates100" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_CDSReplicateData_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "TSSReplicateData"; CREATE TABLE "TSSReplicateData"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" VARCHAR(45), "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneReplicateData_replicates10000" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_TSSReplicateData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "runInfo"; CREATE TABLE "runInfo"( "param" VARCHAR(45), "value" TEXT ); DROP TABLE IF EXISTS "geneData"; CREATE TABLE "geneData"( "gene_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_geneData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_geneData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "phenoData"; CREATE TABLE "phenoData"( "sample_name" VARCHAR(45) NOT NULL, "parameter" VARCHAR(45) NOT NULL, "value" VARCHAR(45), CONSTRAINT "fk_phenoData_samples" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "geneExpDiffData"; CREATE TABLE "geneExpDiffData"( "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "log2_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_geneExpDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_geneExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_geneExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "isoforms"; CREATE TABLE "isoforms"( "isoform_id" VARCHAR(45) PRIMARY KEY NOT NULL, "gene_id" VARCHAR(45), "CDS_id" VARCHAR(45), "gene_short_name" VARCHAR(45), "TSS_group_id" VARCHAR(45), "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT, CONSTRAINT "fk_isoforms_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_isoforms_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_isoforms_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); DROP TABLE IF EXISTS "isoformData"; CREATE TABLE "isoformData"( "isoform_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT NOT NULL, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_isoformData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_isoformData_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id") ); DROP TABLE IF EXISTS "isoformExpDiffData"; CREATE TABLE "isoformExpDiffData"( "isoform_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "log2_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_isoformExpDiffData_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id"), CONSTRAINT "fk_isoformExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_isoformExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "isoformFeatures"; CREATE TABLE "isoformFeatures"( "isoform_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_isoformFeatures_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id") ); DROP TABLE IF EXISTS "features"; CREATE TABLE "features"( -- GTF Features (all lines/records from reference .gtf file) "feature_id" INTEGER PRIMARY KEY AUTOINCREMENT NOT NULL, "gene_id" VARCHAR(45) NOT NULL, "isoform_id" VARCHAR(45) NOT NULL, "seqnames" VARCHAR(45) NOT NULL, "source" VARCHAR(45) NOT NULL, "type" INTEGER, "start" INTEGER, "end" INTEGER, "score" FLOAT, "strand" VARCHAR(45), "frame" VARCHAR(45), CONSTRAINT "fk_features_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_features_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id") ); DROP TABLE IF EXISTS "attributes"; CREATE TABLE "attributes"( "attribute_lookup_id" INTEGER PRIMARY KEY AUTOINCREMENT NOT NULL, "feature_id" INTEGER NOT NULL, "attribute" VARCHAR(45) NOT NULL, "value" VARCHAR(45) NOT NULL, CONSTRAINT "fk_attribute_lookup_features1" FOREIGN KEY("feature_id") REFERENCES "features"("feature_id") ); DROP TABLE IF EXISTS "isoformCount"; CREATE TABLE "isoformCount"( "isoform_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_isoformCount_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id"), CONSTRAINT "fk_isoformCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "isoformReplicateData"; CREATE TABLE "isoformReplicateData"( "isoform_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INTEGER, "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneReplicateData_replicates10" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_isoformReplicateData_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id"), CONSTRAINT "fk_isoformReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); DROP TABLE IF EXISTS "varModel"; CREATE TABLE "varModel"( "condition" VARCHAR(45) NOT NULL, "locus" VARCHAR(45) NOT NULL, "compatible_count_mean" FLOAT, "compatible_count_var" FLOAT, "total_count_mean" FLOAT, "total_count_var" FLOAT, "fitted_var" FLOAT, CONSTRAINT "fk_varModel_locus1" FOREIGN KEY("locus") REFERENCES "genes"("locus") CONSTRAINT "fk_varModel_condition1" FOREIGN KEY("condition") REFERENCES "samples"("sample_name") ); COMMIT; ' create.sql <- strsplit(schema.text, "\n")[[1]] create.sql <- paste(collapse="\n", create.sql) create.sql <- strsplit(create.sql, ";")[[1]] create.sql <- create.sql[-length(create.sql)] #nothing to run here tmp <- sapply(create.sql,function(x) dbGetQuery(db,x)) db } createIndices<-function(dbFname="cuffData.db",driver="SQLite",verbose=F){ drv<-dbDriver(driver) db <- dbConnect(drv,dbname=dbFname) index.text<- 'CREATE INDEX "genes.gsn_index" ON "genes"("gene_short_name"); CREATE INDEX "genes.cc_index" ON "genes"("class_code"); CREATE INDEX "TSS.fk_TSS_genes1" ON "TSS"("gene_id"); CREATE INDEX "TSSData.fk_TSSData_TSS1" ON "TSSData"("TSS_group_id"); CREATE INDEX "TSSData.fk_TSSData_samples1" ON "TSSData"("sample_name"); CREATE INDEX "CDS.fk_CDS_genes1" ON "CDS"("gene_id"); CREATE INDEX "CDS.fk_CDS_TSS1" ON "CDS"("TSS_group_id"); CREATE INDEX "CDSData.fk_CDSData_CDS1" ON "CDSData"("CDS_id"); CREATE INDEX "CDSData.fk_CDSData_samples1" ON "CDSData"("sample_name"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_samples1" ON "splicingDiffData"("sample_1"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_samples2" ON "splicingDiffData"("sample_2"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_TSS1" ON "splicingDiffData"("TSS_group_id"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_genes1" ON "splicingDiffData"("gene_id"); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_TSS1" ON "TSSExpDiffData"("TSS_group_id"); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_samples1" ON "TSSExpDiffData"("sample_1"); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_samples2" ON "TSSExpDiffData"("sample_2"); CREATE INDEX "TSSExpDiffData.TSSExpDiffData_sig_index" ON "TSSExpDiffData"("test_stat","p_value","q_value","significant"); CREATE INDEX "CDSDiffData.fk_CDSDiffData_samples1" ON "CDSDiffData"("sample_1"); CREATE INDEX "CDSDiffData.fk_CDSDiffData_samples2" ON "CDSDiffData"("sample_2"); CREATE INDEX "CDSDiffData.fk_CDSDiffData_genes1" ON "CDSDiffData"("gene_id"); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_CDS1" ON "CDSExpDiffData"("CDS_id"); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_samples1" ON "CDSExpDiffData"("sample_1"); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_samples2" ON "CDSExpDiffData"("sample_2"); CREATE INDEX "CDSExpDiffData.CDSExpDiffData_sig_index" ON "CDSExpDiffData"("test_stat","p_value","q_value","significant"); CREATE INDEX "promoterDiffData.fk_promoterDiffData_genes1" ON "promoterDiffData"("gene_id"); CREATE INDEX "promoterDiffData.fk_promoterDiffData_samples1" ON "promoterDiffData"("sample_1"); CREATE INDEX "promoterDiffData.fk_promoterDiffData_samples2" ON "promoterDiffData"("sample_2"); CREATE INDEX "geneFeatures.fk_geneFeatures_genes1" ON "geneFeatures"("gene_id"); CREATE INDEX "TSSFeatures.fk_TSSFeatures_TSS1" ON "TSSFeatures"("TSS_group_id"); CREATE INDEX "CDSFeatures.fk_CDSFeatures_CDS1" ON "CDSFeatures"("CDS_id"); CREATE INDEX "geneCount.fk_geneCount_samples1" ON "geneCount"("sample_name"); CREATE INDEX "geneCount.fk_geneCount_genes1" ON "geneCount"("gene_id"); CREATE INDEX "CDSCount.fk_CDSCount_CDS1" ON "CDSCount"("CDS_id"); CREATE INDEX "CDSCount.fk_CDSCount_samples1" ON "CDSCount"("sample_name"); CREATE INDEX "TSSCount.fk_TSSCount_TSS1" ON "TSSCount"("TSS_group_id"); CREATE INDEX "TSSCount.fk_TSSCount_samples1" ON "TSSCount"("sample_name"); CREATE INDEX "replicates.fk_replicates_samples1" ON "replicates"("sample_name"); CREATE INDEX "geneReplicateData.fk_geneReplicateData_genes1" ON "geneReplicateData"("gene_id"); CREATE INDEX "geneReplicateData.fk_geneReplicateData_replicates1" ON "geneReplicateData"("rep_name"); CREATE INDEX "geneReplicateData.fk_geneReplicateData_samples1" ON "geneReplicateData"("sample_name"); CREATE INDEX "CDSReplicateData.fk_CDSReplicateData_replicates1" ON "CDSReplicateData"("rep_name"); CREATE INDEX "CDSReplicateData.fk_CDSReplicateData_CDS1" ON "CDSReplicateData"("CDS_id"); CREATE INDEX "CDSReplicateData.fk_CDSReplicateData_samples1" ON "CDSReplicateData"("sample_name"); CREATE INDEX "TSSReplicateData.fk_TSSReplicateData_replicates1" ON "TSSReplicateData"("rep_name"); CREATE INDEX "TSSReplicateData.fk_TSSReplicateData_TSS1" ON "TSSReplicateData"("TSS_group_id"); CREATE INDEX "TSSReplicateData.fk_TSSReplicateData_samples1" ON "TSSReplicateData"("sample_name"); CREATE INDEX "geneData.fk_geneData_genes1" ON "geneData"("gene_id"); CREATE INDEX "geneData.fk_geneData_samples1" ON "geneData"("sample_name"); CREATE INDEX "phenoData.fk_phenoData_samples" ON "phenoData"("sample_name"); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_genes1" ON "geneExpDiffData"("gene_id"); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_samples1" ON "geneExpDiffData"("sample_1"); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_samples2" ON "geneExpDiffData"("sample_2"); CREATE INDEX "geneExpDiffData.geneExpDiff_status_index" ON "geneExpDiffData"("status"); CREATE INDEX "geneExpDiffData.geneExpDiff_sig_index" ON "geneExpDiffData"("significant","p_value","q_value","test_stat"); CREATE INDEX "isoforms.fk_isoforms_TSS1" ON "isoforms"("TSS_group_id"); CREATE INDEX "isoforms.fk_isoforms_CDS1" ON "isoforms"("CDS_id"); CREATE INDEX "isoforms.fk_isoforms_genes1" ON "isoforms"("gene_id"); CREATE INDEX "isoformData.fk_isoformData_samples1" ON "isoformData"("sample_name"); CREATE INDEX "isoformData.fk_isoformData_isoforms1" ON "isoformData"("isoform_id"); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_isoforms1" ON "isoformExpDiffData"("isoform_id"); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_samples1" ON "isoformExpDiffData"("sample_1"); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_samples2" ON "isoformExpDiffData"("sample_2"); CREATE INDEX "isoformExpDiffData.isoformExpDiffData_sig_index" ON "isoformExpDiffData"("test_stat","p_value","q_value","significant"); CREATE INDEX "isoformFeatures.fk_isoformFeatures_isoforms1" ON "isoformFeatures"("isoform_id"); CREATE INDEX "attributes.fk_attributes_feature_id" ON "attributes"("feature_id"); CREATE INDEX "attributes.attributes_attribute_index" ON "attributes"("attribute"); CREATE INDEX "attributes.attributes_value_index" ON "attributes"("value"); CREATE INDEX "isoformCount.fk_isoformCount_isoforms1" ON "isoformCount"("isoform_id"); CREATE INDEX "isoformCount.fk_isoformCount_samples1" ON "isoformCount"("sample_name"); CREATE INDEX "isoformReplicateData.fk_isoformReplicateData_replicates1" ON "isoformReplicateData"("rep_name"); CREATE INDEX "isoformReplicateData.fk_isoformReplicateData_isoforms1" ON "isoformReplicateData"("isoform_id"); CREATE INDEX "isoformReplicateData.fk_isoformReplicateData_samples1" ON "isoformReplicateData"("sample_name"); CREATE INDEX "features.features_seqnames_index" ON "features"("seqnames"); CREATE INDEX "features.features_type_index" ON "features"("type"); CREATE INDEX "features.features_strand_index" ON "features"("strand"); CREATE INDEX "features.features_start_end_index" ON "features"("start","end"); CREATE INDEX "features.fk_features_genes1" ON "features"("gene_id"); CREATE INDEX "features.fk_features_isoforms1" ON "features"("isoform_id"); CREATE INDEX "varModel.varModel_condition1" ON "varModel"("condition"); CREATE INDEX "varModel.varModel_locus1" ON "varModel"("locus"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_allSamples" ON "splicingDiffData"("sample_1","sample_2"); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_allSamples" ON "TSSExpDiffData"("sample_1","sample_2"); CREATE INDEX "CDSDiffData.fk_CDSDiffData_allSamples" ON "CDSDiffData"("sample_1","sample_2"); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_allSamples" ON "CDSExpDiffData"("sample_1","sample_2"); CREATE INDEX "promoterDiffData.fk_promoterDiffData_allSamples" ON "promoterDiffData"("sample_1","sample_2"); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_allSamples" ON "isoformExpDiffData"("sample_1","sample_2"); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_allSamples" ON "geneExpDiffData"("sample_1","sample_2"); ' create.sql <- strsplit(index.text,"\n")[[1]] tmp <- sapply(create.sql,function(x){ if (verbose){ write(paste(x,sep=""),stderr()) } dbGetQuery(db,x) }) } getSamples<-function(fpkmDF){ sample_name<-unique(fpkmDF$sample) #sample_name<-as.data.frame(sample_name) } getSamplesFromColnames<-function(fpkmDF){ samples<-gsub("_FPKM$","",colnames(fpkmDF)[grepl("_FPKM$",colnames(fpkmDF))]) } populateSampleTable<-function(samples,dbConn){ samples<-make.db.names(dbConn,samples,unique=FALSE) samples<-data.frame(sample_index=c(1:length(samples)),sample_name=samples) #print(samples) dbWriteTable(dbConn,'samples',samples,row.names=F,append=T) } bulk_insert <- function(dbConn,sql,bound.data) { dbBegin(dbConn) dbGetPreparedQuery(dbConn, sql, bind.data = bound.data) dbCommit(dbConn) } ############# #readCufflinks ############# #TODO: Add count and replicate files readCufflinks<-function(dir = getwd(), dbFile="cuffData.db", gtfFile=NULL, runInfoFile="run.info", repTableFile="read_groups.info", geneFPKM="genes.fpkm_tracking", geneDiff="gene_exp.diff", geneCount="genes.count_tracking", geneRep="genes.read_group_tracking", isoformFPKM="isoforms.fpkm_tracking", isoformDiff="isoform_exp.diff", isoformCount="isoforms.count_tracking", isoformRep="isoforms.read_group_tracking", TSSFPKM="tss_groups.fpkm_tracking", TSSDiff="tss_group_exp.diff", TSSCount="tss_groups.count_tracking", TSSRep="tss_groups.read_group_tracking", CDSFPKM="cds.fpkm_tracking", CDSExpDiff="cds_exp.diff", CDSCount="cds.count_tracking", CDSRep="cds.read_group_tracking", CDSDiff="cds.diff", promoterFile="promoters.diff", splicingFile="splicing.diff", varModelFile="var_model.info", driver = "SQLite", genome = NULL, rebuild = FALSE, verbose = FALSE, ...){ #Set file locations with directory dbFile=file.path(dir,dbFile) runInfoFile=file.path(dir,runInfoFile) repTableFile=file.path(dir,repTableFile) geneFPKM=file.path(dir,geneFPKM) geneDiff=file.path(dir,geneDiff) geneCount=file.path(dir,geneCount) geneRep=file.path(dir,geneRep) isoformFPKM=file.path(dir,isoformFPKM) isoformDiff=file.path(dir,isoformDiff) isoformCount=file.path(dir,isoformCount) isoformRep=file.path(dir,isoformRep) TSSFPKM=file.path(dir,TSSFPKM) TSSDiff=file.path(dir,TSSDiff) TSSCount=file.path(dir,TSSCount) TSSRep=file.path(dir,TSSRep) CDSFPKM=file.path(dir,CDSFPKM) CDSExpDiff=file.path(dir,CDSExpDiff) CDSCount=file.path(dir,CDSCount) CDSRep=file.path(dir,CDSRep) CDSDiff=file.path(dir,CDSDiff) promoterFile=file.path(dir,promoterFile) splicingFile=file.path(dir,splicingFile) varModelFile=file.path(dir,varModelFile) #Check to see whether dbFile exists if (!file.exists(dbFile) || rebuild == TRUE){ #if not, create it write(paste("Creating database ",dbFile,sep=""),stderr()) dbConn<-createDB_noIndex(dbFile) #populate DB if(file.exists(runInfoFile)){ loadRunInfo(runInfoFile,dbConn) } if(file.exists(repTableFile)){ loadRepTable(repTableFile,dbConn) } if(file.exists(varModelFile)){ loadVarModelTable(varModelFile,dbConn) } if(!is.null(gtfFile)){ if(!is.null(genome)){ .loadGTF(gtfFile,genome,dbConn) }else{ stop("'genome' cannot be NULL if you are supplying a .gtf file!") } } loadGenes(geneFPKM,geneDiff,promoterFile,countFile=geneCount,replicateFile=geneRep,dbConn) loadIsoforms(isoformFPKM,isoformDiff,isoformCount,isoformRep,dbConn) loadTSS(TSSFPKM,TSSDiff,splicingFile,TSSCount,TSSRep,dbConn) loadCDS(CDSFPKM,CDSExpDiff,CDSDiff,CDSCount,CDSRep,dbConn) #Create Indexes on DB write("Indexing Tables...",stderr()) createIndices(dbFile,verbose=verbose) #load Distribution Tests #loadDistTests(promoterFile,splicingFile,CDSDiff) } dbConn<-dbConnect(dbDriver(driver),dbFile) return ( new("CuffSet",DB = dbConn, #TODO: need to add replicate and count tables here and in AllClasses.R genes = new("CuffData",DB = dbConn, tables = list(mainTable = "genes",dataTable = "geneData",expDiffTable = "geneExpDiffData",featureTable = "geneFeatures",countTable="geneCount",replicateTable="geneReplicateData"), filters = list(),type = "genes",idField = "gene_id"), isoforms = new("CuffData", DB = dbConn, tables = list(mainTable = "isoforms",dataTable = "isoformData",expDiffTable = "isoformExpDiffData",featureTable = "isoformFeatures",countTable="isoformCount",replicateTable="isoformReplicateData"), filters = list(),type="isoforms",idField = "isoform_id"), TSS = new("CuffData", DB = dbConn, tables = list(mainTable = "TSS",dataTable = "TSSData",expDiffTable = "TSSExpDiffData",featureTable = "TSSFeatures",countTable="TSSCount",replicateTable="TSSReplicateData"), filters = list(),type = "TSS",idField = "TSS_group_id"), CDS = new("CuffData", DB = dbConn, tables = list(mainTable = "CDS",dataTable = "CDSData",expDiffTable = "CDSExpDiffData",featureTable = "CDSFeatures",countTable="CDSCount",replicateTable="CDSReplicateData"), filters = list(),type = "CDS",idField = "CDS_id"), promoters = new("CuffDist", DB = dbConn, table = "promoterDiffData",type="promoter",idField="gene_id"), splicing = new("CuffDist", DB = dbConn, table = "splicingDiffData",type="splicing",idField="TSS_group_id"), relCDS = new("CuffDist", DB = dbConn, table = "CDSDiffData",type="relCDS",idField="gene_id") ) ) } ############ # Handle GTF file ############ #loadGTF<-function(gtfFile,dbConn) { # # #Error Trapping # if (missing(gtfFile)) # stop("GTF file cannot be missing!") # # if (missing(dbConn)) # stop("Must provide a dbConn connection") # # write("Reading GTF file") # gtf<-read.table(gtfFile,sep="\t",header=F) # # write("Melting attributes") # attributes<-melt(strsplit(as.character(gtf$V9),"; ")) # colnames(attributes)<-c("attribute","featureID") # attributes<-paste(attributes$attribute,attributes$featureID) # attributes<-strsplit(as.character(attributes)," ") # attributes<-as.data.frame(do.call("rbind",attributes)) # # colnames(attributes)<-c("attribute","value","featureID") # attributes<-attributes[,c(3,1,2)] # # #Grab only gene_ID and transcript_ID to add to features table # id.attributes<-attributes[attributes$attribute %in% c("gene_id","transcript_id"),] # id.attributes$featureID<-as.numeric(as.character(id.attributes$featureID)) # id.attributes<-dcast(id.attributes,...~attribute) # # #Main features table # features<-gtf[,c(1:8)] # colnames(features)<-c("seqname","source","type","start","end","score","strand","frame") # features$featureID<-as.numeric(as.character(rownames(features))) # # #Merge features and id.attributes # features<-merge(features,id.attributes,by.x='featureID',by.y='featureID') # features<-features[,c(1,10:11,2:9)] # # #strip gene_id and transcript_id from attributes # attributes<-attributes[!(attributes$attribute %in% c("gene_id","transcript_id")),] # # #Write features table # write("Writing features table",stderr()) # #dbWriteTable(dbConn,'geneData',as.data.frame(genemelt[,c(1:2,5,3,4,6)]),row.names=F,append=T) # dbWriteTable(dbConn,'features',as.data.frame(features),append=T) # # #Write features attribtues table # #write("Writing feature attributes table",stderr()) # dbWriteTable(dbConn,'attributes',as.data.frame(attributes),append=T) # #} .loadGTF<-function(gtfFile,genomebuild,dbConn){ #Error Trapping if (missing(gtfFile)) stop("GTF file cannot be missing!") if (missing(dbConn)) stop("Must provide a dbConn connection") write("Reading GTF file",stderr()) gr<-import(gtfFile) gr<-as(gr,"data.frame") #gr$genome<-genomebuild colnames(gr)[grepl('^transcript_id$',colnames(gr))]<-'isoform_id' colnames(gr)[grepl('^tss_id$',colnames(gr))]<-'TSS_group_id' colnames(gr)[grepl('^p_id$',colnames(gr))]<-'CDS_id' write("Writing GTF features to 'features' table...",stderr()) #dbSendQuery(dbConn,"DROP TABLE IF EXISTS 'features'") #dbBegin(dbConn) dbWriteTable(dbConn,'features',gr,row.names=F,overwrite=T) #record Genome build .recordGenome(genomebuild,dbConn) #dbCommit(dbConn) return() } .recordGenome<-function(genome,dbConn){ genomeInsertQuery<-paste("INSERT INTO runInfo VALUES('genome', '",genome,"')",sep="") #print(genomeInsertQuery) dbSendQuery(dbConn,genomeInsertQuery) } .cuff2db <- function(gtfFile, out.file = NULL, verbose = TRUE) { #require(rtracklayer) #require(GenomicRanges) #require(GenomicFeatures) requiredAttribs <- c("gene_id", "transcript_id", "exon_number") if (verbose) message("Importing ", gtfFile) tmp <- import(gtfFile) #dispose of unspliced unstranded transcripts #tmp <- tmp[ which(strand(tmp) %in% c('+','-')) ] # fix the gene IDs #values(tmp)$gene_id <- gsub('CUFF.', '', values(tmp)$gene_id) # fix the exon IDs #values(tmp)$transcript_id <- gsub('CUFF.', '', values(tmp)$transcript_id) # split the object into transcript and exon pieces #by.type = split(tmp, values(tmp)$type) #browser() #make transcripts table tmpT <- split(tmp, values(tmp)$transcript_id) if(verbose) message('Attempting to create the transcripts data.frame') transcripts <- data.frame( tx_id=1:length(tmpT), tx_name=names(tmpT), tx_chrom=as.character(seqnames(unlist(tmpT))[start(tmpT@partitioning)]), tx_strand=as.character(strand(unlist(tmpT))[start(tmpT@partitioning)]), tx_start=sapply(start(ranges(tmpT)), min), tx_end=sapply(end(ranges(tmpT)), max), stringsAsFactors=FALSE ) #make splicings table tmpS <- split(tmp, values(tmp)$transcript_id) if(verbose) message('Attempting to create the splicings data.frame') splicings <- data.frame( tx_id=rep(1:length(tmpS), elementNROWS(tmpS)), exon_rank=as.integer(values(unlist(tmpS))$exon_number), exon_chrom=as.character(seqnames(unlist(tmpS))), exon_strand=as.character(strand(unlist(tmpS))), exon_start=start(unlist(tmpS)), exon_end=end(unlist(tmpS)), stringsAsFactors=FALSE ) #make genes table if(verbose) message('Attempting to create the genes data.frame') gene_txs <- tapply(values(tmp)$transcript_id, values(tmp)$gene_id, unique) genes <- data.frame( tx_name=unlist(gene_txs), gene_id=rep(names(gene_txs), sapply(gene_txs, length)), stringsAsFactors=FALSE) #create the db if (verbose) message("Creating TranscriptDb") tmpdb <- makeTxDb(transcripts, splicings, genes=genes) if (verbose) message("Use saveFeatures() to save the database to a file") return(tmpdb) } #library(Gviz) #myGeneId<-'XLOC_000071' #geneQuery<-paste("SELECT start,end,source AS feature,gene_id as gene,exon_number AS exon,transcript_id as transcript,gene_name as symbol, exon_number as rank, strand FROM features WHERE gene_id ='",myGeneId,"'",sep="") #geneFeatures<-dbGetQuery(cuff@DB,geneQuery) #geneFeatures$symbol[is.na(geneFeatures$symbol)]<-"NA" #grtrack<-GeneRegionTrack(geneFeatures,genome="hg19",chromosome="chr1",name="CuffDiff",showId=T,stacking="pack") #biomTrack<-BiomartGeneRegionTrack(genome="hg19",chromosome="chr1",start=min(start(grtrack)),end=max(end(grtrack)),name="ENSEMBL",showId=T,stacking="pack") #ideoTrack <- IdeogramTrack(genome = "hg19", chromosome = "chr1") #axTrack <- GenomeAxisTrack() #conservation <- UcscTrack(genome = "hg19", chromosome = "chr1", # track = "Conservation", table = "phyloP46wayAll", # from = min(start(grtrack)), to = max(end(grtrack)), trackType = "DataTrack", # start = "start", end = "end", data = "score", # type = "hist", window = "auto", col.histogram = "darkblue", # fill.histogram = "darkblue", ylim = c(-3.7, 4), # name = "Conservation") # # #plotTracks(list(ideoTrack,axTrack,grtrack,biomTrack,conservation),from=min(start(grtrack))-1000,to=max(end(grtrack))+1000) #plotTracks(list(axTrack,grtrack),from=min(start(grtrack))-1000,to=max(end(grtrack))+1000) ####### #Unit Test ####### #dbConn<-createDB() #date() #loadGenes("genes.fpkm_tracking","gene_exp.diff",dbConn) #loadIsoforms("isoforms.fpkm_tracking","isoform_exp.diff",dbConn) #loadTSS("tss_groups.fpkm_tracking","tss_group_exp.diff",dbConn) #loadCDS("cds.fpkm_tracking","cds_exp.diff",dbConn) #date() cummeRbund/R/methods-CuffData.R0000644000175200017520000011647714516004263017360 0ustar00biocbuildbiocbuild#methods-CuffData.R # #Author: Loyal A. Goff # # #################### ################## #Initialize ################## setMethod("initialize","CuffData", function(.Object, DB, tables=list(mainTable = "",dataTable = "",expDiffTable = "",featureTable = "",countTable = "", replicateTable = ""), filters=list(), type = c("genes","isoforms","TSS","CDS"), idField, ... ){ .Object<-callNextMethod(.Object, DB = DB, tables = tables, filters = filters, type = type, idField = idField, ...) } ) setValidity("CuffData",function(object){ TRUE } ) ################ #Class Methods ################ setMethod("show","CuffData", function(object){ size<-dim(object) cat(class(object), "instance with:\n\t",size[1],"features and",size[2],"samples\n") } ) setMethod("dim","CuffData", function(x){ countQuery<-paste("SELECT COUNT(",x@idField,") as n FROM ",x@tables$mainTable) nIds<-dbGetQuery(x@DB,countQuery) sampleQuery<-("SELECT COUNT(sample_name) as n FROM samples") nSamples<-dbGetQuery(x@DB,sampleQuery) c(nIds$n,nSamples$n) } ) ##################### #Feature Table ##################### .addFeatures<-function(object,features,...){ if(!is.data.frame(features)){ stop("features must be a data.frame") } colnames(features)[1]<-object@idField colnames(features)<-make.db.names(object@DB,colnames(features),unique=T) dbWriteTable(object@DB,object@tables$featureTable,features,row.names=F,overwrite=T) indexQuery<-paste("CREATE INDEX ",object@idField," ON ", object@tables$featureTable," (",object@idField,")",sep="") res<-dbGetQuery(object@DB,indexQuery) } setMethod("addFeatures",signature="CuffData",.addFeatures) ################### #Accessors ################### .annotation<-function(object){ featureQuery<-paste("SELECT * FROM ",object@tables$mainTable," x LEFT JOIN features xf USING (",object@idField,")",sep="") dbGetQuery(object@DB, featureQuery) } setMethod(BiocGenerics::annotation,signature(object="CuffData"),.annotation) .featureNames<-function(object){ featureQuery<-paste("SELECT ",object@idField," FROM ",object@tables$mainTable, sep="") res<-dbGetQuery(object@DB,featureQuery) res[,1] } setMethod("featureNames","CuffData",.featureNames) .samples<-function(object){ res<-dbReadTable(object@DB,'samples') res<-res$sample_name res } setMethod("samples","CuffData",.samples) .replicates<-function(object){ res<-dbReadTable(object@DB,'replicates') res<-res$rep_name res } setMethod("replicates","CuffData",.replicates) .fpkm<-function(object,features=FALSE,sampleIdList){ #Sample subsetting if(!missing(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } #Sample Search String (SQL) sampleString<-'(' for (i in myLevels){ sampleString<-paste(sampleString,"'",i,"',",sep="") } sampleString<-substr(sampleString,1,nchar(sampleString)-1) sampleString<-paste(sampleString,")",sep="") if(!features){ FPKMQuery<-paste("SELECT * FROM ",object@tables$dataTable," WHERE sample_name IN ",sampleString,sep="") }else{ FPKMQuery<-paste("SELECT xf.*,xm.*,x.sample_name,x.fpkm,x.conf_hi,x.conf_lo FROM ",object@tables$dataTable," x LEFT JOIN features xf ON x.",object@idField,"=xf.",object@idField," LEFT JOIN ",object@tables$mainTable," xm ON x.",object@idField,"=xm.",object@idField," WHERE x.sample_name IN ",sampleString,sep="") #print(FPKMQuery) } res<-dbGetQuery(object@DB,FPKMQuery) res$sample_name<-factor(res$sample_name,levels=getLevels(object)) res$stdev<-(res$conf_hi-res$fpkm)/2 res } setMethod("fpkm","CuffData",.fpkm) .repFpkm<-function(object,features=FALSE,repIdList){ #Sample subsetting if(!missing(repIdList)){ if(.checkReps(object@DB,repIdList)){ myLevels<-repIdList }else{ stop("Replicate does not exist!") } }else{ myLevels<-getRepLevels(object) } #Sample Search String (SQL) sampleString<-'(' for (i in myLevels){ sampleString<-paste(sampleString,"'",i,"',",sep="") } sampleString<-substr(sampleString,1,nchar(sampleString)-1) sampleString<-paste(sampleString,")",sep="") if(!features){ FPKMQuery<-paste("SELECT * FROM ",object@tables$replicateTable," WHERE rep_name IN ",sampleString,sep="") }else{ FPKMQuery<-paste("SELECT xf.*,xm.*,x.rep_name,x.raw_frags,x.internal_scaled_frags,x.external_scaled_frags,x.fpkm,x.effective_length,x.status FROM ",object@tables$replicateTable," x LEFT JOIN features xf on x.",object@idField,"=xf.",object@idField," LEFT JOIN ",object@tables$mainTable," xm ON x.",object@idField,"=xm.",object@idField," WHERE x.rep_name IN ",sampleString,sep="") } #print(FPKMQuery) res<-dbGetQuery(object@DB,FPKMQuery) res$rep_name<-factor(res$rep_name,levels=getRepLevels(object)) #res$stdev<-(res$conf_hi-res$fpkm)/2 #Not really available yet since conf_hi and conf_lo are not res } setMethod("repFpkm","CuffData",.repFpkm) .count<-function(object,sampleIdList){ #Sample subsetting if(!missing(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } #Sample Search String (SQL) sampleString<-'(' for (i in myLevels){ sampleString<-paste(sampleString,"'",i,"',",sep="") } sampleString<-substr(sampleString,1,nchar(sampleString)-1) sampleString<-paste(sampleString,")",sep="") CountQuery<-FPKMQuery<-paste("SELECT * FROM ",object@tables$countTable," WHERE sample_name IN ",sampleString,sep="") res<-dbGetQuery(object@DB,CountQuery) res$sample_name<-factor(res$sample_name,levels=getLevels(object)) res } setMethod("count","CuffData",.count) .fpkmMatrix<-function(object,fullnames=FALSE,sampleIdList){ #TODO: fix fullnames for CuffData::fpkmMatrix #Sample subsetting if(!missing(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } samp<-samples(object) FPKMMatQuery<-paste("select x.",object@idField,", x.gene_short_name, ",sep="") for (i in samp){ FPKMMatQuery<-paste(FPKMMatQuery,"sum(case when xd.sample_name ='",i,"' then fpkm end) as ",i,",",sep="") } FPKMMatQuery<-substr(FPKMMatQuery, 1, nchar(FPKMMatQuery)-1) FPKMMatQuery<-paste(FPKMMatQuery," from ",object@tables$mainTable," x LEFT JOIN ",object@tables$dataTable," xd on x.",object@idField," = xd.",object@idField," group by x.",object@idField,sep="") res<-dbGetQuery(object@DB,FPKMMatQuery) if(fullnames){ res<-data.frame(res[,-c(1,2)],row.names=paste(res[,2],res[,1],sep="|")) }else{ res<-data.frame(res[,-c(1,2)],row.names=res[,1]) } if(!missing(sampleIdList)){ res<-data.frame(res[,sampleIdList],row.names=rownames(res)) colnames(res)<-sampleIdList } res } setMethod("fpkmMatrix","CuffData",.fpkmMatrix) .repFpkmMatrix<-function(object,fullnames=FALSE,repIdList){ #Sample subsetting if(!missing(repIdList)){ if(.checkReps(object@DB,repIdList)){ myLevels<-repIdList }else{ stop("Replicate does not exist!") } }else{ myLevels<-getRepLevels(object) } samp<-replicates(object) FPKMMatQuery<-paste("select x.",object@idField,", x.gene_short_name, ",sep="") for (i in samp){ FPKMMatQuery<-paste(FPKMMatQuery,"sum(case when xd.rep_name ='",i,"' then fpkm end) as ",i,",",sep="") } FPKMMatQuery<-substr(FPKMMatQuery, 1, nchar(FPKMMatQuery)-1) FPKMMatQuery<-paste(FPKMMatQuery," from ",object@tables$mainTable," x LEFT JOIN ",object@tables$replicateTable," xd on x.",object@idField," = xd.",object@idField," group by x.",object@idField,sep="") res<-dbGetQuery(object@DB,FPKMMatQuery) if(fullnames){ res<-data.frame(res[,-c(1,2)],row.names=paste(res[,2],res[,1],sep="|")) }else{ res<-data.frame(res[,-c(1,2)],row.names=res[,1]) } if(!missing(repIdList)){ res<-data.frame(res[,repIdList],row.names=rownames(res)) colnames(res)<-repIdList } res } setMethod("repFpkmMatrix","CuffData",.repFpkmMatrix) .countMatrix<-function(object,fullnames=FALSE,sampleIdList){ #Sample subsetting if(!missing(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } samp<-samples(object) CountMatQuery<-paste("select x.",object@idField,", x.gene_short_name, ",sep="") for (i in samp){ CountMatQuery<-paste(CountMatQuery,"sum(case when xd.sample_name ='",i,"' then count end) as ",i,",",sep="") } CountMatQuery<-substr(CountMatQuery, 1, nchar(CountMatQuery)-1) CountMatQuery<-paste(CountMatQuery," from ",object@tables$mainTable," x LEFT JOIN ",object@tables$countTable," xd on x.",object@idField," = xd.",object@idField," group by x.",object@idField,sep="") res<-dbGetQuery(object@DB,CountMatQuery) if(fullnames){ res<-data.frame(res[,-c(1,2)],row.names=paste(res[,2],res[,1],sep="|")) }else{ res<-data.frame(res[,-c(1,2)],row.names=res[,1]) } if(!missing(sampleIdList)){ res<-data.frame(res[,sampleIdList],row.names=rownames(res)) colnames(res)<-sampleIdList } res } setMethod("countMatrix","CuffData",.countMatrix) .repCountMatrix<-function(object,fullnames=FALSE,repIdList){ #Sample subsetting if(!missing(repIdList)){ if(.checkReps(object@DB,repIdList)){ myLevels<-repIdList }else{ stop("Replicate does not exist!") } }else{ myLevels<-getRepLevels(object) } reps<-replicates(object) repCountMatQuery<-paste("select x.",object@idField,", x.gene_short_name, ",sep="") for (i in reps){ repCountMatQuery<-paste(repCountMatQuery,"sum(case when xr.rep_name ='",i,"' then external_scaled_frags end) as ",i,",",sep="") } repCountMatQuery<-substr(repCountMatQuery, 1, nchar(repCountMatQuery)-1) repCountMatQuery<-paste(repCountMatQuery," from ",object@tables$mainTable," x LEFT JOIN ",object@tables$replicateTable," xr on x.",object@idField," = xr.",object@idField," group by x.",object@idField,sep="") res<-dbGetQuery(object@DB,repCountMatQuery) if(fullnames){ res<-data.frame(res[,-c(1,2)],row.names=paste(res[,2],res[,1],sep="|")) }else{ res<-data.frame(res[,-c(1,2)],row.names=res[,1]) } if(!missing(repIdList)){ res<-data.frame(res[,repIdList],row.names=rownames(res)) colnames(res)<-repIdList } res } setMethod("repCountMatrix","CuffData",.repCountMatrix) .statsMatrix<-function(object){ statsQuery<-paste("SELECT xd.*, xc.count, xc.variance as count_variance , xc.uncertainty as count_uncertainty, xc.dispersion as count_dispersion, (xd.conf_hi-xd.fpkm)/2 as fpkm_stdev,((xd.conf_hi-xd.fpkm)/2)/xd.fpkm AS 'CV' FROM ",object@tables$dataTable," xd LEFT JOIN ",object@tables$countTable," xc ON xd.",object@idField,"=xc.",object@idField," AND xd.sample_name=xc.sample_name",sep="") res<-dbGetQuery(object@DB,statsQuery) res$sample_name<-factor(res$sample_name,levels=samples(object)) res } #This needs a lot of work... #TODO: Change this to remove lnFcCutoff but make sure that functions that rely on diffData have their own FC cutoff so that plotting doesn't suffer .diffData<-function(object,x,y,features=FALSE){ if(missing(x) && missing(y)){ if(!features){ diffQuery<-paste("SELECT * FROM ",object@tables$expDiffTable,sep="") }else{ diffQuery<-paste("SELECT xm.*, xed.*, xf.* FROM ",object@tables$mainTable," xm LEFT JOIN ",object@tables$expDiffTable," xed ON xm.",object@idField,"=xed.",object@idField," LEFT JOIN features xf ON xm.",object@idField,"=xf.",object@idField,sep="") } }else if (missing(x) || missing(y)){ stop("You must supply both x and y or neither.") }else{ if(!features){ diffQuery<-paste("SELECT x.",object@idField,", xed.* FROM ",object@tables$mainTable," x LEFT JOIN ",object@tables$expDiffTable," xed on x.",object@idField," = xed.",object@idField," WHERE ((sample_1 = '",x,"' AND sample_2 = '",y,"') OR (sample_1 = '",y,"' AND sample_2 = '",x,"'))",sep="") }else{ diffQuery<-paste("SELECT xm.*, xed.*, xf.* FROM ",object@tables$mainTable," xm LEFT JOIN ",object@tables$expDiffTable," xed on xm.",object@idField," = xed.",object@idField," LEFT JOIN features xf ON xm.",object@idField,"=xf.",object@idField," WHERE ((sample_1 = '",x,"' AND sample_2 = '",y,"') OR (sample_1 = '",y,"' AND sample_2 = '",x,"'))",sep="") } } dat<-dbGetQuery(object@DB,diffQuery) #diffQuery dat } setMethod("diffData",signature(object="CuffData"),.diffData) .diffTable<-function(object,logCutoffValue=99999){ measureVars<-c('status','value_1','value_2','log2_fold_change','test_stat','p_value','q_value','significant') all.diff<-diffData(object,features=TRUE) all.diff$log2_fold_change[all.diff$log2_fold_change>=logCutoffValue]<-Inf all.diff$log2_fold_change[all.diff$log2_fold_change<=-logCutoffValue]<--Inf all.diff.melt<-melt(all.diff,measure.vars=measureVars) #all.diff.melt<-all.diff.melt[!grepl("^value_",all.diff.melt$variable),] all.diff.cast<-dcast(all.diff.melt,formula=...~sample_2+sample_1+variable) all.diff.cast } setMethod("diffTable",signature(object="CuffData"),.diffTable) .QCTable<-function(object){ qcSQL<-paste("SELECT d.*, (d.conf_hi-d.fpkm)/2 as stdev, c.count, c.variance, c.uncertainty, c.dispersion, (c.variance/d.fpkm) AS 'IOD', ((d.conf_hi-d.fpkm)/2)/d.fpkm AS 'CV' FROM ",object@tables$dataTable," d LEFT JOIN ",object@tables$countTable," c ON d.gene_id=c.gene_id AND d.sample_name=c.sample_name",sep="") res<-dbGetQuery(object@DB,qcSQL) res } .getMA<-function(object,x,y,logMode=T,pseudocount=1){ if (missing(x) || missing(y)){ stop("You must supply both x and y.") }else{ sql<-paste("SELECT x.",object@idField,", sum(case when x.sample_name = '",x,"' then x.fpkm end) AS 'x', sum(case when x.sample_name = '",y,"' then x.fpkm end) AS 'y' FROM ",object@tables$dataTable," x GROUP BY x.",object@idField,";",sep="") #print(sql) dat<-dbGetQuery(object@DB,sql) if(logMode){ dat$x<-log10(dat$x+pseudocount) dat$y<-log10(dat$y+pseudocount) } dat$A<-(dat$x+dat$y)/2 dat$M<-dat$x/dat$y res<-dat[,c(1,4:5)] res } } .getCountMA<-function(object,x,y,logMode=T,pseudocount=1){ if (missing(x) || missing(y)){ stop("You must supply both x and y.") }else{ sql<-paste("SELECT x.",object@idField,", sum(case when x.sample_name = '",x,"' then x.count end) AS 'x', sum(case when x.sample_name = '",y,"' then x.count end) AS 'y' FROM ",object@tables$countTable," x GROUP BY x.",object@idField,";",sep="") dat<-dbGetQuery(object@DB,sql) if(logMode){ dat$x<-log10(dat$x+pseudocount) dat$y<-log10(dat$y+pseudocount) } dat$A<-(dat$x+dat$y)/2 dat$M<-dat$x/dat$y res<-dat[,c(1,4:5)] res } } #.getRankOrder<-function(object,x,y,logMode=TRUE,pseudocount=1,ratio=TRUE){ # if (missing(x) || missing(y)){ # stop("You must supply both x and y.") # }else{ # # } #} setMethod("DB","CuffData",function(object){ return(object@DB) }) setMethod("tables","CuffData",function(object){ return(object@tables) }) setMethod("filters","CuffData",function(object){ return(object@filters) }) setMethod("type","CuffData",function(object){ return(object@type) }) setMethod("idField","CuffData",function(object){ return(object@idField) }) ################## #Setters ################## ################## #Subsetting ################## #Example query #"SELECT * FROM genes WHERE gene_id in ('XLOC_000005','XLOC_000015','XLOC_000055','XLOC_000595','XLOC_005998','ucscCodingXLOC_018816')" .getLevels<-function(object){ levelsQuery<-'SELECT s.sample_name FROM samples s ORDER BY s.sample_index ASC' levels<-dbGetQuery(object@DB,levelsQuery)$sample_name levels } setMethod("getLevels",signature(object="CuffData"),.getLevels) .getRepLevels<-function(object){ levelsQuery<-'SELECT r.rep_name FROM replicates r JOIN samples s ON r.sample_name=s.sample_name ORDER BY s.sample_index ASC' levels<-dbGetQuery(object@DB,levelsQuery)$rep_name levels } setMethod("getRepLevels",signature(object="CuffData"),.getRepLevels) .getRepConditionLevels<-function(object){ levelsQuery<-'SELECT r.sample_name FROM replicates r JOIN samples s ON r.sample_name=s.sample_name ORDER BY s.sample_index ASC' levels<-dbGetQuery(object@DB,levelsQuery)$sample_name levels } #Useful SQL commands #SELECT g.gene_id, g.class_code, g.nearest_ref_id, g.gene_short_name, g.locus, g.length, g.coverage, g.status, gd.sample_name, gd.fpkm, gd.conf_hi, gd.conf_lo FROM genes g LEFT JOIN geneData gd ON g.gene_id = gd.gene_id WHERE (g.gene_id = 'XLOC_000001'); #SELECT g.gene_id, ged.* FROM genes g LEFT JOIN geneExpDiffData ged on g.gene_id = ged.gene_id WHERE ((sample_1 = 'H1_hESC' AND sample_2 = 'Fibroblasts') OR (sample_1 = 'Fibroblasts' AND sample_2 = 'H1_hESC')) AND ged.log2_fold_change>-20 AND ged.log2_fold_change<20 ; #Pivot table SQL for scatterplots #select g.*, sum(case when gd.sample_name = 'Fibroblasts' then fpkm end) as Fibroblasts, sum(case when gd.sample_name = 'H1_hESC' then fpkm end) as H1_hESC from genes g LEFT JOIN geneData gd on g.gene_id = gd.gene_id group by g.gene_id; ################## #Plotting ################## .density<-function(object, logMode = TRUE, pseudocount=0.0, labels, features=FALSE, replicates=FALSE,...){ if(is(object,'CuffData')) { if(replicates){ dat<-repFpkm(object,features=features) colnames(dat)[colnames(dat)=="rep_name"]<-"condition" }else{ dat<-fpkm(object,features=features) colnames(dat)[colnames(dat)=="sample_name"]<-"condition" } } else { stop('Un-supported class of object.') } if(logMode) dat$fpkm<-dat$fpkm+pseudocount p<-ggplot(dat) if(logMode) { p<-p+geom_density(aes(x= log10(fpkm),group=condition,color=condition,fill=condition),alpha=I(1/3)) }else{ p<-p+geom_density(aes(x=fpkm,group=condition,color=condition,fill=condition),alpha=I(1/3)) } p<-p + labs(title=object@tables$mainTable) #Default cummeRbund colorscheme p<-p + scale_fill_hue(l=50,h.start=200) + scale_color_hue(l=50,h.start=200) #TODO: Add label callout p } setMethod("csDensity",signature(object="CuffData"),.density) .scatter<-function(object,x,y,logMode=TRUE,pseudocount=1.0,labels,smooth=FALSE,colorByStatus=FALSE, drawRug=TRUE, ...){ dat<-fpkmMatrix(object,fullnames=TRUE) samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } #add pseudocount if necessary if(logMode){ for (i in samp){ dat[[i]]<-dat[[i]]+pseudocount } } #Attach tracking_id and gene_short_name if(!missing(labels)){ require(stringr) tracking<-str_split_fixed(rownames(dat),"\\|",2) dat$gene_short_name<-tracking[,1] dat$tracking_id<-tracking[,2] labeled.dat<-dat[dat$gene_short_name %in% labels,] } #make plot object p<-ggplot(dat) p<- p + aes_string(x=x,y=y) #Right now, this does nothing, because 'significant' is not returned from fpkmMatrix object so I don't have this as a feature to draw if(colorByStatus){ p<- p + geom_point(size=1.2,alpha=I(1/3)) }else{ p<- p + geom_point(size=1.2,alpha=I(1/3)) } #Add symmetry line p<- p + geom_abline(intercept=0,slope=1,linetype=2) #Add rug if(drawRug){ p<- p + geom_rug(size=0.8,alpha=0.01) } #add smoother if(smooth){ p <- p + stat_smooth(method="lm",fill="blue",alpha=0.2) } #Add highlights from labels if(!missing(labels)){ p <- p + geom_point(data=labeled.dat,aes_string(x=x,y=y),size=1.3,color="red") p <- p + geom_text(data=labeled.dat,aes_string(x=x,y=y,label='gene_short_name'),color="red",hjust=0,vjust=0,angle=0,size=4) } #logMode if(logMode){ p <- p + scale_y_log10() + scale_x_log10() } #Add title & Return value p<- p + labs(title=object@tables$mainTable) p } setMethod("csScatter",signature(object="CuffData"), .scatter) .scatter2<-function(object,x,y,logMode=TRUE,pseudocount=1.0,labels,smooth=FALSE,alpha=0.05,colorByStatus=FALSE, drawRug=TRUE, ...){ samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } #Setup query string sampleList<-paste("('",x,"','",y,"')",sep="") scatterQuery<-paste("SELECT m.gene_short_name,d.",object@idField,",sum(CASE WHEN d.sample_name='",x,"' THEN d.fpkm END) as x,sum(CASE WHEN d.sample_name='",y,"' THEN d.fpkm END) as y, edd.status, edd.p_value, edd.q_value FROM ",object@tables$mainTable," m LEFT JOIN ",object@tables$dataTable," d ON m.",object@idField,"=d.",object@idField," LEFT JOIN ",object@tables$expDiffTable," edd ON m.",object@idField," = edd.",object@idField," WHERE (edd.sample_1 in ",sampleList," AND (edd.sample_2 in ",sampleList,")) GROUP BY d.",object@idField,";",sep="") #write(scatterQuery,stderr()) #Retrieve data dat<-dbGetQuery(object@DB,scatterQuery) #add pseudocount if necessary if(logMode){ for (i in samp){ dat$x<-dat$x+pseudocount dat$y<-dat$y+pseudocount } } #Flag significant genes dat$significant<-"no" dat$significant[dat$q_value<=alpha]<-"yes" dat$significant<-factor(dat$significant,levels=c("no","yes")) #Attach tracking_id and gene_short_name if(!missing(labels)){ labeled.dat<-dat[dat$gene_short_name %in% labels,] } #make plot object p<-ggplot(dat) + theme_bw() p<- p + aes_string(x='x',y='y') #Right now, this does nothing, because 'significant' is not returned from fpkmMatrix object so I don't have this as a feature to draw if(colorByStatus){ p<- p + geom_point(aes(color=significant),size=1.2) + scale_color_manual(values=c("black","red")) }else{ p<- p + geom_point(size=1.2,alpha=I(1/3)) } #Add symmetry line p<- p + geom_abline(intercept=0,slope=1,linetype=2) #Add rug if(drawRug){ p<- p + geom_rug(size=0.8,alpha=0.01) } #add smoother if(smooth){ p <- p + stat_smooth(method="lm",fill="blue",alpha=0.2) } #Add highlights from labels if(!missing(labels)){ p <- p + geom_point(data=labeled.dat,aes_string(x='x',y='y'),size=1.3,color="red") p <- p + geom_text(data=labeled.dat,aes_string(x='x',y='y',label='gene_short_name'),color="red",hjust=0,vjust=0,angle=0,size=4) } #logMode if(logMode){ p <- p + scale_y_log10() + scale_x_log10() } #Add title & Return value p<- p + labs(title=object@tables$mainTable,x=x,y=y) p } .scatterMat<-function(object,replicates=FALSE,logMode=TRUE,pseudocount=1.0,hexbin=FALSE,useCounts=FALSE,...){ if(replicates){ if(useCounts){ dat<-repCountMatrix(object) }else{ dat<-repFpkmMatrix(object) } }else{ if(useCounts){ dat<-countMatrix(object) }else{ dat<-fpkmMatrix(object) } } if(logMode) { dat<-dat+pseudocount } if(useCounts){ myLab = "Normalized Counts" }else{ myLab = "FPKM" } if(logMode){ myLab = paste("log10 ",myLab,sep="") p <- .plotmatrix(log10(dat),hexbin=hexbin,...) }else{ p <- .plotmatrix(dat,hexbin=hexbin,...) } p<- p + geom_abline(intercept=0,slope=1,linetype=2) p <- p + theme_bw() + ylab(myLab) + xlab(myLab) #p<- p + aes(alpha=0.01) p } setMethod("csScatterMatrix",signature(object="CuffData"),.scatterMat) .volcano<-function(object,x,y,alpha=0.05,showSignificant=TRUE,features=FALSE,xlimits=c(-20,20),...){ samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } dat<-diffData(object=object,features=features) #subset dat for samples of interest mySamples<-c(x,y) dat<-dat[(dat$sample_1 %in% mySamples & dat$sample_2 %in% mySamples),] dat$significant <- 'no' dat$significant[dat$q_value<=alpha]<-'yes' s1<-unique(dat$sample_1) s2<-unique(dat$sample_2) p<-ggplot(dat) if(showSignificant==FALSE){ p<- p + geom_point(aes(x=log2_fold_change,y=-log10(p_value)),size=1.2) }else{ p<- p + geom_point(aes(x=log2_fold_change,y=-log10(p_value),color=significant),size=1.2) } #Add title and return p<- p + theme_bw() p<- p + labs(title=paste(object@tables$mainTable,": ",s2,"/",s1,sep="")) p<- p + scale_colour_manual(values = c("black","red")) #Set axis limits p<- p + scale_x_continuous(limits=xlimits) p <- p + xlab(bquote(paste(log[2],"(fold change)",sep=""))) + ylab(bquote(paste(-log[10],"(p value)",sep=""))) p } setMethod("csVolcano",signature(object="CuffData"), .volcano) .volcanoMatrix<-function(object,alpha=0.05,xlimits=c(-20,20),mapping=aes(),...){ dat<-diffData(object) part1<-dat[,c('sample_1','sample_2','value_1','value_2','test_stat','p_value','q_value')] part2<-data.frame(sample_1=part1$sample_2,sample_2=part1$sample_1,value_1=part1$value_2,value_2=part1$value_1,test_stat=-part1$test_stat,p_value=part1$p_value,q_value=part1$q_value) dat<-rbind(part1,part2) myLevels<-union(dat$sample_1,dat$sample_2) dat$sample_1<-factor(dat$sample_1,levels=myLevels) dat$sample_2<-factor(dat$sample_2,levels=myLevels) dat$log2_fold_change<-log2(dat$value_2/dat$value_1) #Set significance value dat$significant<-"no" dat$significant[dat$q_value<=alpha]<-"yes" #May need to expand filler for time-series data (when there aren't always all pairwise comparisons on which to facet filler<-data.frame(sample_1=factor(myLevels,levels=myLevels),sample_2=factor(myLevels,levels=myLevels),label="") filler$label<-as.character(filler$label) mapping <- defaults(mapping, aes_string(x = "log2_fold_change", y = "-log10(p_value)", color="significant")) class(mapping) <- "uneval" p <-ggplot(dat) + geom_point(mapping,na.rm=TRUE,size=0.8) + scale_colour_manual(values = c("black","red")) + facet_grid(sample_1~sample_2) p<- p + geom_vline(aes(xintercept=0),linetype=2) p <- p + theme_bw() + xlab(bquote(paste(log[2],"(fold change)",sep=""))) + ylab(bquote(paste(-log[10],"(p value)",sep=""))) p } setMethod("csVolcanoMatrix",signature(object="CuffData"),.volcanoMatrix) .distheat<-function(object, replicates=F, samples.not.genes=T, logMode=T, pseudocount=1.0, heatscale=c(low='lightyellow',mid='orange',high='darkred'), heatMidpoint=NULL, sigDigits=3, ...) { # get expression from a sample or gene perspective if(replicates){ obj.fpkm<-repFpkmMatrix(object,fullnames=T) }else{ obj.fpkm<-fpkmMatrix(object,fullnames=T) } if(samples.not.genes) { obj.fpkm.pos = obj.fpkm[rowSums(obj.fpkm)>0,] } else { obj.fpkm = t(obj.fpkm) obj.fpkm.pos = obj.fpkm[,colSums(obj.fpkm)>0] } if(logMode) { obj.fpkm.pos = log10(obj.fpkm.pos+pseudocount) } # compute distances obj.dists = JSdist(makeprobs(obj.fpkm.pos)) # cluster to order obj.hc = hclust(obj.dists) # make data frame dist.df = melt(as.matrix(obj.dists),varnames=c("X1","X2")) dist.df$value<-as.numeric(format(dist.df$value,digits=sigDigits)) # initialize g = ggplot(dist.df, aes(x=X1, y=X2, fill=value)) # draw labels = labels(obj.dists) g = g + geom_tile(color="black") + scale_x_discrete("", limits=labels[obj.hc$order]) + scale_y_discrete("", limits=labels[obj.hc$order]) # roll labels g = g + theme(axis.text.x=element_text(angle=-90, hjust=0), axis.text.y=element_text(angle=0, hjust=1)) # drop grey panel background and gridlines g = g + theme(panel.grid.minor=element_line(colour=NA), panel.grid.major=element_line(colour=NA), panel.background=element_rect(fill=NA, colour=NA)) # adjust heat scale if (length(heatscale) == 2) { g = g + scale_fill_gradient(low=heatscale[1], high=heatscale[3], name="JS Distance") } else if (length(heatscale) == 3) { if (is.null(heatMidpoint)) { heatMidpoint = max(obj.dists) / 2.0 } g = g + scale_fill_gradient2(low=heatscale[1], mid=heatscale[2], high=heatscale[3], midpoint=heatMidpoint, name="JS Distance") } if(samples.not.genes){ g <- g + geom_text(aes(label=value)) } # return g } setMethod("csDistHeat", signature("CuffData"), .distheat) .boxplot<-function(object,logMode=TRUE,pseudocount=0.0001,replicates=FALSE,...){ if(replicates){ dat<-repFpkm(object) colnames(dat)[colnames(dat)=="rep_name"]<-"condition" }else{ dat<-fpkm(object) colnames(dat)[colnames(dat)=="sample_name"]<-"condition" } if(logMode) { dat$fpkm<-dat$fpkm+pseudocount p<-ggplot(dat) p<-p+geom_boxplot(aes(x=condition,y=log10(fpkm),fill=condition),size=0.3,alpha=I(1/3)) } else { p <- ggplot(dat) p<-p+geom_boxplot(aes(x=condition,y=fpkm,fill=condition),alpha=I(1/3),size=0.3) } p<- p + theme(axis.text.x=element_text(angle=-90, hjust=0)) #Default cummeRbund colorscheme p<-p + scale_fill_hue(l=50,h.start=200) p } setMethod("csBoxplot",signature(object="CuffData"),.boxplot) .dendro<-function(object,logMode=T,pseudocount=1,replicates=FALSE,...){ if(replicates){ fpkmMat<-repFpkmMatrix(object) }else{ fpkmMat<-fpkmMatrix(object) } if(logMode){ fpkmMat<-log10(fpkmMat+pseudocount) } res<-JSdist(makeprobs(fpkmMat)) #colnames(res)<-colnames(fpkmMat) #res<-as.dist(res) res<-as.dendrogram(hclust(res)) plot(res,main=paste("All",deparse(substitute(object)),sep=" "),...) res } setMethod("csDendro",signature(object="CuffData"),.dendro) .MAplot<-function(object,x,y,logMode=T,pseudocount=1,smooth=FALSE,useCount=FALSE){ if(useCount){ dat<-.getCountMA(object,x,y,logMode=logMode,pseudocount=pseudocount) }else{ dat<-.getMA(object,x,y,logMode=logMode,pseudocount=pseudocount) } p<-ggplot(dat) p<-p+geom_point(aes(x=A,y=log2(M)),size=0.8) #add smoother if(smooth){ p <- p + stat_smooth(aes(x=A,y=log2(M)),fill="blue") } #add baseline p <- p + geom_hline(yintercept=0) p } setMethod("MAplot",signature(object="CuffData"),.MAplot) .dispersionPlot<-function(object){ dat<-count(object) p<-ggplot(dat) p<-p+geom_point(aes(x=count,y=dispersion,color=sample_name)) + facet_wrap('sample_name') + scale_x_log10() + scale_y_log10() p } setMethod("dispersionPlot",signature(object="CuffData"),.dispersionPlot) .MDSplot<-function(object,replicates=FALSE,logMode=TRUE,pseudocount=1.0){ if(replicates){ dat<-repFpkmMatrix(object) #repData<-sapply(replicates(object),function(x){strsplit(x,"_")[[1]][1]}) This is to color by condition and not replicate... }else{ dat<-fpkmMatrix(object) } if(logMode){ dat<-log10(dat+pseudocount) } d<-JSdist(makeprobs(dat)) fit <- cmdscale(d,eig=TRUE, k=2) res<-data.frame(names=rownames(fit$points),M1=fit$points[,1],M2=fit$points[,2]) p <- ggplot(res) p <- p + geom_point(aes(x=M1,y=M2,color=names)) + geom_text(aes(x=M1,y=M2,label=names,color=names)) + theme_bw() p } setMethod("MDSplot",signature(object="CuffData"),.MDSplot) #Not sure if I want to include this or not.. .PCAplot<-function(object,x="PC1", y="PC2",replicates=FALSE,pseudocount=1.0,scale=TRUE,showPoints=TRUE,...){ if(replicates){ fpkms<-repFpkmMatrix(object) }else{ fpkms<-fpkmMatrix(object) } fpkms<-log10(fpkms+pseudocount) PC<-prcomp(fpkms,scale=scale,...) dat <- data.frame(obsnames=row.names(PC$x), PC$x) #dat$shoutout<-"" #dat$shoutout[matchpt(PC$rotation,PC$x)$index]<-rownames(pca$x[matchpt(pca$rotation,pca$x)$index,]) plot <- ggplot(dat, aes_string(x=x, y=y)) if(showPoints){ plot<- plot + geom_point(alpha=.4, size=0.8, aes(label=obsnames)) } plot <- plot + geom_hline(aes(yintercept=0), size=.2) + geom_vline(aes(xintercept=0), size=.2) #+ geom_text(aes(label=shoutout),size=2,color="red") datapc <- data.frame(varnames=rownames(PC$rotation), PC$rotation) mult <- min( (max(dat[,y]) - min(dat[,y])/(max(datapc[,y])-min(datapc[,y]))), (max(dat[,x]) - min(dat[,x])/(max(datapc[,x])-min(datapc[,x]))) ) datapc <- transform(datapc, v1 = .7 * mult * (get(x)), v2 = .7 * mult * (get(y)) ) plot <- plot + #coord_equal() + geom_text(data=datapc, aes(x=v1, y=v2, label=varnames,color=varnames), vjust=1) plot <- plot + geom_segment(data=datapc, aes(x=0, y=0, xend=v1, yend=v2,color=varnames), arrow=arrow(length=unit(0.2,"cm")), alpha=0.75) + theme_bw() plot } setMethod('PCAplot',signature(object="CuffData"),.PCAplot) #This is most definitely a work in progress .confidencePlot<-function(object,percentCutoff=20){ res<-.statsMatrix(object) #res$CV[is.na(res$CV)]<-0.0 res$CV<-as.numeric(res$CV) p<-ggplot(res) p<-p + geom_point(aes(x=log10(fpkm),y=log10(CV)),size=1.5,alpha=0.3) p<-p + geom_smooth(aes(x=log10(fpkm),y=log10(CV),color=sample_name)) + #p<-p + geom_point(aes(x=log10(fpkm),y=log10(count),color=-log10(CV))) + #p<-p + geom_point(aes(x=log10(fpkm),y=log2(fpkm/count),color=-log10(CV))) + geom_hline(aes(0),linetype=2) + #facet_wrap('sample_name') + geom_abline(intercept=0,slope=1,linetype=2,size=0.3) + scale_color_gradient(name="%CV",low="darkblue",high="white",limits=c(0,percentCutoff), na.value = "white") + labs(title=object@type) p } .CVdensity<-function(object){ dat<-.statsMatrix(object) p<-ggplot(dat) p <- p + geom_density(aes(x=CV,fill=sample_name),alpha=0.3,position="dodge") + scale_x_log10() p } .fpkmSCVPlot<-function(object,FPKMLowerBound=1,showPool=FALSE){ if(!showPool){ showPool=any(table(.getRepConditionLevels(object))<2) # Counts number of replicates per condition and requires a minimum of 2. If any n<2, values are determined from pooling across samples. if(showPool){ warning("At least one of your conditions does not have enough replicates to estimate variance. Estimating variance across all conditions instead.") } } dat<-repFpkm(object) colnames(dat)[1]<-"tracking_id" dat<-dat[,c('tracking_id','sample_name','fpkm')] dat<-dat[dat$fpkm>0,] if(showPool){ subsetCols<-c('tracking_id') }else{ subsetCols<-c('tracking_id','sample_name') } #Option 3 (tapply on log10(replicateFPKM) values) dat.means<-tapply(dat$fpkm,dat[,subsetCols],function(x){mean(x,na.rm=T)}) dat.sd<-tapply(dat$fpkm,dat[,subsetCols],function(x){sd(x,na.rm=T)}) #write("Calculating replicate fpkm mean...",stderr()) dat.means<-melt(dat.means) #write("Calculating replicate fpkm stdev...",stderr()) dat.sd<-melt(dat.sd) colnames(dat.means)[colnames(dat.means)=="value"]<-'fpkm' colnames(dat.sd)[colnames(dat.sd)=="value"]<-'stdev' dat<-cbind(dat.means,dat.sd$stdev) colnames(dat)[colnames(dat)=="dat.sd$stdev"]<-'stdev' dat<-dat[!is.na(dat$stdev) & !is.na(dat$fpkm),] dat<-dat[dat$fpkm>0 & dat$stdev>0,] if(!showPool){ dat$sample_name<-factor(dat$sample_name,levels=samples(object)) } p <-ggplot(dat,aes(x=fpkm,y=(stdev/fpkm)^2),na.rm=T) #p <-ggplot(dat,aes(x=log10(fpkm+1),y=log10(stdev)),na.rm=T) if(showPool){ p <- p + stat_smooth(na.rm=T,method='auto',fullrange=T) }else{ p <- p + #geom_point(aes(color=sample_name),size=1,na.rm=T) + stat_smooth(aes(color=sample_name,fill=sample_name),na.rm=T,method='auto',fullrange=T) } p <- p + scale_x_log10() + scale_y_continuous(name=bquote(CV^2)) + xlab(bquote(paste(log[10],"FPKM",sep=" "))) + theme_bw() + xlim(c(log10(FPKMLowerBound),max(log10(dat$fpkm)))) + labs(title=object@type) p } setMethod("fpkmSCVPlot",signature(object="CuffData"),.fpkmSCVPlot) .sensitivityPlot<-function(object){ return } #TODO:Log2FC vs Test-statistic #TODO:log2FPKM vs log2(stdev) (color by sample) #TODO: Index of dispersion alpha (FPKM vs ?) #SELECT gd.*, (gd.conf_hi-gd.fpkm)/2 as fpkm_stdev, gc.count, gc.variance as count_variance , gc.uncertainty, gc.dispersion, ((gd.conf_hi-gd.fpkm)/2)/gd.fpkm AS 'CV' FROM geneData gd LEFT JOIN geneCount gc ON gd.gene_id=gc.gene_id AND gd.sample_name=gc.sample_name; ############# # Other Methods ############# .specificity<-function(object,logMode=T,pseudocount=1,relative=FALSE,...){ fpkms<-fpkmMatrix(object,...) if(logMode){ fpkms<-log10(fpkms+pseudocount) } fpkms<-t(makeprobs(t(fpkms))) d<-diag(ncol(fpkms)) res<-apply(d,MARGIN=1,function(q){ JSdistFromP(fpkms,q) }) colnames(res)<-paste(colnames(fpkms),"_spec",sep="") if(relative){ res<-res/max(res) } 1-res } setMethod("csSpecificity",signature(object="CuffData"),.specificity) ###################### # Exploratory Analysis ###################### .nmf<-function(object,k,logMode=T,pseudocount=1,maxiter=1000,replicates=FALSE,fullnames=FALSE){ require(NMFN) if(missing(k)) stop("Please provide a rank value for factorization (arg=k)") if(replicates){ m=repFpkmMatrix(object,fullnames=fullnames) }else{ m=fpkmMatrix(object,fullnames=fullnames) } if(logMode) { m = log10(m+pseudocount) } myNMF<-nnmf(m,k=k,maxiter=maxiter) return (myNMF) } setMethod("csNMF",signature(object="CuffData"),.nmf) ############# # GSEA helper methods ############# .makeRnk<-function(object,x,y,filename,...){ #Creates a log2-fold change .rnk file for all genes given an x/y comparison. #While this method will work for any cuffData level, it really only makes sense for 'genes' as this is what is required for GSEA... #Must provide 'x' and 'y' so as to provide a log2 fold change. samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } query<-paste("SELECT gd.gene_id,g.gene_short_name,(sum(CASE WHEN gd.sample_name='",x,"' THEN gd.fpkm+1 END))/(sum(CASE WHEN gd.sample_name='",y,"' THEN gd.fpkm+1 END)) as 'ratio' FROM genes g LEFT JOIN geneData gd ON g.gene_id=gd.gene_id GROUP BY g.gene_id ORDER BY ratio DESC",sep="") res<-dbGetQuery(object@DB,query) res$ratio<-log2(res$ratio) #Remove gene_id field res<-res[,-1] #Remove rows with "NA" for gene_short_name res<-res[!is.na(res$gene_short_name),] #Write to file write.table(res,file=filename,sep="\t",quote=F,...,row.names=F,col.names=F) #res } .makeRnkTest<-function(object,x,y,filename,...){ samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } query<-paste("SELECT gd.gene_id,g.gene_short_name,gd.test_stat FROM genes g LEFT JOIN geneExpDiffData gd ON g.gene_id=gd.gene_id WHERE ((gd.sample_1='",x,"' AND gd.sample_2='",y,"') OR (gd.sample_2='",x,"' AND gd.sample_1='",y,"')) ORDER BY gd.test_stat DESC",sep="") #print(query) res<-dbGetQuery(object@DB,query) #Remove gene_id field res<-res[,-1] #Remove rows with "NA" for gene_short_name res<-res[!is.na(res$gene_short_name),] #Write to file write.table(res,file=filename,sep="\t",quote=F,...,row.names=F,col.names=F) } .makeRnkTestStat<-function(object,x,y,filename,...){ samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } query<-paste("SELECT gd.gene_id,g.gene_short_name,gd.sample_1, gd.sample_2,gd.test_stat FROM genes g LEFT JOIN geneExpDiffData gd ON g.gene_id=gd.gene_id WHERE ((gd.sample_1 ='",x,"' AND gd.sample_2='",y,"') OR (gd.sample_2='",x,"' AND gd.sample_1='",y,"')) GROUP BY gd.gene_id",sep="") res<-dbGetQuery(object@DB,query) if(unique(res$sample_2)==x){ res2<-res res2$test_stat<--(res$test_stat) res2$sample_1<-res$sample_2 res2$sample_2<-res$sample_1 res<-res2 } #Order by test_stat res<-res[order(res$test_stat,decreasing=F),] #Remove gene_id field res<-res[,c('gene_short_name','test_stat')] #Remove rows with "NA" for gene_short_name res<-res[!is.na(res$gene_short_name),] #Write to file write.table(res,file=filename,sep="\t",quote=F,...,row.names=F,col.names=F) #head(res) } setMethod("makeRnk",signature(object="CuffData"),.makeRnkTestStat) ############# #Utility functions ############# .checkSamples<-function(dbConn,sampleIdList){ dbSamples<-dbReadTable(dbConn,"samples") if (all(sampleIdList %in% dbSamples$sample_name)){ return(TRUE) }else{ return(FALSE) } } .checkReps<-function(dbConn,repIdList){ dbReps<-dbReadTable(dbConn,"replicates") if (all(repIdList %in% dbReps$rep_name)){ return(TRUE) }else{ return(FALSE) } } ################### # Coersion methods ################### #As ExpressionSet ################### #Utility functions ################### #.volcanoMatrix <- function(data){ # densities <- do.call('rbind',lapply(1:)) # p <-ggplot(data) + facet_grid(sample1~sample2,scales="free") + geom_point(aes(x=log2_fold_change,y=-log10(p_value))) + stat_density(aes(x = log2_fold_change, # y = ..scaled.. * diff(range(log2_fold_change)) + min(log2_fold_change)), data = densities, # position = "identity", colour = "grey20", geom = "line") # #} cummeRbund/R/methods-CuffDist.R0000644000175200017520000000323014516004263017370 0ustar00biocbuildbiocbuild#methods-CuffDist.R # #Author: Loyal A. Goff # # #################### ################## #Initialize ################## setMethod("initialize","CuffDist", function(.Object, DB, table="", type = c("promoter","splicing","relCDS"), idField = c("gene_id","tss_group_id"), ... ){ .Object<-callNextMethod(.Object, DB = DB, table = table, type = type, idField = idField, ...) } ) setValidity("CuffDist",function(object){ TRUE } ) ################ #Class Methods ################ setMethod("show","CuffDist", function(object){ size<-dim(object) cat(class(object), "instance with:\n\t",size[1]," ",object@type," records\n") } ) setMethod("dim","CuffDist", function(x){ countQuery<-paste("SELECT COUNT(",x@idField,") as n FROM ",x@table) nIds<-dbGetQuery(x@DB,countQuery) c(nIds$n) } ) ################### #Accessors ################### .values<-function(object){ valueQuery<-paste("SELECT * FROM ",object@table,sep="") dbGetQuery(object@DB, valueQuery) } setMethod("distValues","CuffDist",.values) setMethod("DB","CuffDist",function(object){ return(object@DB) }) #setMethod("table","CuffDist",function(object){ # return(object@table) # }) setMethod("type","CuffDist",function(object){ return(object@type) }) setMethod("idField","CuffDist",function(object){ return(object@idField) }) .samples<-function(object){ res<-dbReadTable(object@DB,'samples') res<-res$sample_name res } setMethod("samples","CuffDist",.samples) ################## #Setters ################## ################## #Subsetting ################## ################## #Plotting ################## cummeRbund/R/methods-CuffFeature.R0000644000175200017520000001723114516004263020066 0ustar00biocbuildbiocbuild######################## #methods-CuffFeature.R # #Author: Loyal A. Goff # #Date created: 5-17-2011 # #Description: A 'data' object for a collection of cufflinks features, irrespective of type ('genes','isoforms','TSS','CDS') ######################### ################# #Initialize # ################# setMethod("initialize","CuffFeature", function(.Object, annotation=data.frame(), fpkm=data.frame(), diff=data.frame(), repFpkm=data.frame(), count=data.frame(), genome=character(), ... ){ .Object<-callNextMethod(.Object, annotation=annotation, fpkm=fpkm, diff=diff, repFpkm=repFpkm, count=count, genome=genome, ...) } ) ################# #Validate # ################# #TODO: Add validity constraints setValidity("CuffFeature",function(object){ TRUE #length(object)==1 } ) ################# #Class Methods # ################# setMethod("show","CuffFeature", function(object){ cat(class(object), "instance with ",length(object),"elements\n") } ) setMethod("length","CuffFeature", function(x){ dim(x@annotation)[1] } ) ################# #Subsetting # ################# ################# #Accessors # ################# .fpkm<-function(object){ object@fpkm } setMethod("fpkm",signature="CuffFeature",.fpkm) .fpkmMatrix<-function(object,sampleIdList){ #Sample subsetting if(!missing(sampleIdList)){ if (!all(sampleIdList %in% samples(object))){ stop("Sample does not exist!") }else{ mySamples<-sampleIdList } }else{ mySamples<-samples(object) } res<-fpkm(object) colnames(res)[1]<-"tracking_id" res<-res[,c(1:3)] res<-melt(res) res<-dcast(res,tracking_id~sample_name) res<-data.frame(res[,-1],row.names=res[,1]) if(!missing(sampleIdList)){ res<-res[,mySamples] } res } setMethod("fpkmMatrix",signature(object="CuffFeature"),.fpkmMatrix) #TODO: Replicate FPKM and Replicate FPKM Matrix for cuffFeature objects .repFpkmMatrix<-function(object,fullnames=FALSE,repIdList){ #Sample subsetting if(!missing(repIdList)){ if (!all(repIdList %in% replicates(object))){ stop("Replicate does not exist!") }else{ myReps<-repIdList } }else{ myReps<-replicates(object) } if(fullnames){ res<-repFpkm(object,features=TRUE) res$tracking_id<-paste(res$gene_short_name,res[,1],sep="|") }else{ res<-repFpkm(object) colnames(res)[1]<-"tracking_id" } selectedRows<-c('tracking_id','rep_name','fpkm') res<-res[,selectedRows] res<-melt(res) res<-dcast(res,tracking_id~rep_name) res<-data.frame(res[,-1],row.names=res[,1]) if(!missing(repIdList)){ res<-res[,myReps] } res } setMethod("repFpkmMatrix",signature(object="CuffFeature"),.repFpkmMatrix) .samples<-function(object){ res<-fpkm(object)$sample_name res } setMethod("samples","CuffFeature",.samples) .replicates<-function(object){ res<-repFpkm(object)$rep_name res } setMethod("replicates","CuffFeature",.replicates) #setMethod("diff","CuffFeature",function(object){ # return(object@diff) # }) .diffData<-function(object){ object@diff } setMethod("diffData",signature(object="CuffFeature"),.diffData) setMethod(BiocGenerics::annotation,signature(object="CuffFeature"),function(object){ return(object@annotation) }) setMethod("getGenome","CuffFeature",function(object){ return(object@genome) }) .repFpkm<-function(object){ object@repFpkm } setMethod("repFpkm",signature(object="CuffFeature"),.repFpkm) .count<-function(object){ object@count } setMethod("count",signature(object="CuffFeature"),.count) ################# #Setters # ################# ################# #Plotting # ################# .barplot<-function(object,logMode=FALSE,pseudocount=1.0,showErrorbars=TRUE,showStatus=TRUE,replicates=FALSE,...){ quant_types<-c("OK","FAIL","LOWDATA","HIDATA","TOOSHORT") quant_types<-factor(quant_types,levels=quant_types) quant_colors<-c("black","red","blue","orange","green") names(quant_colors)<-quant_types dat<-fpkm(object) if(replicates){ repDat<-repFpkm(object) colnames(repDat)[1]<-"tracking_id" } #TODO: Test dat to ensure that there are >0 rows to plot. If not, trap error and move on... colnames(dat)[1]<-"tracking_id" if(logMode) { dat$fpkm <- dat$fpkm + pseudocount dat$conf_hi <- dat$conf_hi + pseudocount dat$conf_lo <- dat$conf_lo + pseudocount if(replicates){ repDat$fpkm<-repDat$fpkm + pseudocount } } p<-ggplot(dat,aes(x=sample_name,y=fpkm,fill=sample_name)) p <- p + geom_bar(stat="identity") if(replicates){ p <- p + geom_point(aes(x=sample_name,y=fpkm),size=3,shape=18,colour="black",data=repDat) } if (showErrorbars) { p <- p + geom_errorbar(aes(ymin=conf_lo,ymax=conf_hi,group=1),width=0.5) } if (logMode) { p <- p + scale_y_log10() } p <- p + facet_wrap('tracking_id') + labs(title=object@annotation$gene_short_name)+theme(axis.text.x=element_text(hjust=0,angle=-90)) if (logMode) { p <- p + ylab(paste("FPKM +",pseudocount)) } else { p <- p + ylab("FPKM") } if (showStatus){ if(logMode){ p<-p+geom_text(aes(x=sample_name,y=1,label=quant_status,color=quant_status),vjust=1.5,size=3) }else{ p<-p+geom_text(aes(x=sample_name,y=0,label=quant_status,color=quant_status),vjust=1.5,size=3) } } p <- p + theme(legend.position="none") #Default cummeRbund colorscheme p<-p + scale_fill_hue(l=50,h.start=200) #Recolor quant flags p<- p+ scale_colour_manual(name='quant_status',values=quant_colors) p } setMethod("expressionBarplot",signature(object="CuffFeature"),.barplot) .expressionPlot<-function(object,logMode=FALSE,pseudocount=1.0, drawSummary=FALSE, sumFun=mean_cl_boot, showErrorbars=TRUE,showStatus=TRUE,replicates=FALSE,facet=TRUE,...){ #Coloring scheme for quant flags quant_types<-c("OK","FAIL","LOWDATA","HIDATA","TOOSHORT") quant_types<-factor(quant_types,levels=quant_types) quant_colors<-c("black","red","blue","orange","green") names(quant_colors)<-quant_types dat<-fpkm(object) colnames(dat)[1]<-"tracking_id" if(replicates){ repDat<-repFpkm(object) repDat$replicate<-as.factor(repDat$replicate) colnames(repDat)[1]<-"tracking_id" } if(logMode) { dat$fpkm <- dat$fpkm + pseudocount dat$conf_hi <- dat$conf_hi + pseudocount dat$conf_lo <- dat$conf_lo + pseudocount if(replicates){ repDat$fpkm<-repDat$fpkm + pseudocount } } p <- ggplot(dat) #dat$fpkm<- log10(dat$fpkm+pseudocount) p <- p + geom_line(aes(x=sample_name,y=fpkm,group=tracking_id,color=tracking_id)) if(replicates){ p <- p + geom_point(aes(x=sample_name,y=fpkm,color=tracking_id),size=2.5,shape=18,data=repDat) } if (showErrorbars) { p <- p + geom_errorbar(aes(x=sample_name, ymin=conf_lo,ymax=conf_hi,color=tracking_id,group=tracking_id),width=0.25) } if (logMode) { p <- p + scale_y_log10() } if(showStatus){ p <- p + geom_point(aes(x=sample_name,y=fpkm,shape=quant_status)) } #drawMean if(drawSummary){ p <- p + stat_summary(aes(x=sample_name,y=fpkm,group=1),fun.data=sumFun,color="red",fill="red",alpha=0.2,size=1.1,geom="smooth") } if (logMode) { p <- p + ylab(paste("FPKM + ",pseudocount)) } else { p <- p + ylab("FPKM") } #Default cummeRbund colorscheme p<-p + scale_fill_hue(l=50,h.start=200) + scale_color_hue(l=50,h.start=200) #Add Title p<-p + labs(title=object@annotation$gene_short_name) + theme(axis.text.x=element_text(hjust=0,angle=-90)) #Recolor quant flags #for some reason this doesn't work (ggplot2 problem) #p<- p+ scale_colour_manual(name='quant_status',values=quant_colors) if(facet){ p<-p+facet_wrap('tracking_id') } p } setMethod("expressionPlot",signature(object="CuffFeature"),.expressionPlot) ################# #Misc # #################cummeRbund/R/methods-CuffFeatureSet.R0000644000175200017520000010140514516004263020537 0ustar00biocbuildbiocbuild######################## #methods-CuffFeatureSet.R # #Author: Loyal A. Goff # #Date created: 5-17-2011 # #Description: ######################### ################# #Initialize # ################# setMethod("initialize","CuffFeatureSet", function(.Object, annotation=data.frame(), fpkm=data.frame(), diff=data.frame(), repFpkm=data.frame(), count=data.frame(), ... ){ .Object<-callNextMethod(.Object, annotation=annotation, fpkm=fpkm, diff=diff, repFpkm=repFpkm, count=count, ...) } ) ################# #Validate # ################# #TODO: Add validity constraints setValidity("CuffFeatureSet",function(object){ TRUE #Add test for genes with no expression } ) ################# #Class Methods # ################# setMethod("show","CuffFeatureSet",function(object){ cat(class(object),"instance for ",length(object)," features\nSlots: \tannotation \tfpkm \trepFpkm \tdiff \tcount\n") } ) setMethod("length","CuffFeatureSet", function(x){ dim(x@annotation)[1] } ) #Add dim method so you can find number of samples in CuffFeatureSet, not just number of genes ################# #Subsetting # ################# #TODO: Add subset methods to return a CuffFeature object #setMethod("[","CuffFeatureSet",function(object,featureID){ # # } #) ################# #Accessors ################## .samples<-function(object){ res<-fpkm(object)$sample_name res } setMethod("samples","CuffFeatureSet",.samples) .replicates<-function(object){ res<-repFpkm(object)$rep_name res } setMethod("replicates","CuffFeatureSet",.replicates) .fpkm<-function(object,features=FALSE){ myFPKM<-object@fpkm myFPKM$stdev<-(myFPKM$conf_hi-myFPKM$fpkm)/2 if (features){ return (merge(object@annotation,myFPKM,by=1)) }else{ return(myFPKM) } } setMethod("fpkm",signature(object="CuffFeatureSet"),.fpkm) .repFpkm<-function(object,features=FALSE){ myFPKM<-object@repFpkm #myFPKM$stdev<-(myFPKM$conf_hi-myFPKM$fpkm)/2 if (features){ return (merge(object@annotation,myFPKM,by=1)) }else{ return(myFPKM) } } setMethod("repFpkm",signature(object="CuffFeatureSet"),.repFpkm) .featureNames<-function(object){ data.frame(tracking_id=object@annotation[,1],gene_short_name=object@annotation$gene_short_name) } setMethod("featureNames",signature(object="CuffFeatureSet"),.featureNames) .annotation<-function(object){ object@annotation } setMethod(BiocGenerics::annotation,signature(object="CuffFeatureSet"),.annotation) .fpkmMatrix<-function(object,fullnames=FALSE,sampleIdList){ #Sample subsetting if(!missing(sampleIdList)){ if (!all(sampleIdList %in% samples(object))){ stop("Sample does not exist!") }else{ mySamples<-sampleIdList } }else{ mySamples<-samples(object) } if(fullnames){ res<-fpkm(object,features=TRUE) res$tracking_id<-paste(res$gene_short_name,res[,1],sep="|") }else{ res<-fpkm(object) colnames(res)[1]<-"tracking_id" } selectedRows<-c('tracking_id','sample_name','fpkm') res<-res[,selectedRows] res<-melt(res) res<-dcast(res,tracking_id~sample_name) res<-data.frame(res[,-1],row.names=res[,1]) if(!missing(sampleIdList)){ res<-res[,mySamples] } res } setMethod("fpkmMatrix",signature(object="CuffFeatureSet"),.fpkmMatrix) .repFpkmMatrix<-function(object,fullnames=FALSE,repIdList){ #Sample subsetting if(!missing(repIdList)){ if (!all(repIdList %in% replicates(object))){ stop("Replicate does not exist!") }else{ myReps<-repIdList } }else{ myReps<-replicates(object) } if(fullnames){ res<-repFpkm(object,features=TRUE) res$tracking_id<-paste(res$gene_short_name,res[,1],sep="|") }else{ res<-repFpkm(object) colnames(res)[1]<-"tracking_id" } selectedRows<-c('tracking_id','rep_name','fpkm') res<-res[,selectedRows] res<-melt(res) res<-dcast(res,tracking_id~rep_name) res<-data.frame(res[,-1],row.names=res[,1]) if(!missing(repIdList)){ res<-res[,myReps] } res } setMethod("repFpkmMatrix",signature(object="CuffFeatureSet"),.repFpkmMatrix) .countMatrix<-function(object,fullnames=FALSE,sampleIdList){ #Sample subsetting if(!missing(sampleIdList)){ if (!all(sampleIdList %in% samples(object))){ stop("Sample does not exist!") }else{ mySamples<-sampleIdList } }else{ mySamples<-samples(object) } if(fullnames){ res<-count(object,features=TRUE) res$tracking_id<-paste(res$gene_short_name,res[,1],sep="|") }else{ res<-count(object) colnames(res)[1]<-"tracking_id" } selectedRows<-c('tracking_id','sample_name','count') res<-res[,selectedRows] res<-melt(res) res<-dcast(res,tracking_id~sample_name) res<-data.frame(res[,-1],row.names=res[,1]) if(!missing(sampleIdList)){ res<-res[,mySamples] } res } setMethod("countMatrix",signature(object="CuffFeatureSet"),.countMatrix) .repCountMatrix<-function(object,fullnames=FALSE,repIdList){ #Sample subsetting if(!missing(repIdList)){ if (!all(repIdList %in% replicates(object))){ stop("Replicate does not exist!") }else{ myReps<-repIdList } }else{ myReps<-replicates(object) } if(fullnames){ res<-repFpkm(object,features=TRUE) res$tracking_id<-paste(res$gene_short_name,res[,1],sep="|") }else{ res<-repFpkm(object) colnames(res)[1]<-"tracking_id" } selectedRows<-c('tracking_id','rep_name','external_scaled_frags') res<-res[,selectedRows] res<-melt(res) res<-dcast(res,tracking_id~rep_name) res<-data.frame(res[,-1],row.names=res[,1]) if(!missing(repIdList)){ res<-res[,myReps] } res } setMethod("repCountMatrix",signature(object="CuffFeatureSet"),.repCountMatrix) .diffData<-function(object){ return(object@diff) } setMethod("diffData",signature(object="CuffFeatureSet"),.diffData) .diffTable<-function(object,logCutoffValue=99999){ measureVars<-c('status','value_1','value_2','log2_fold_change','test_stat','p_value','q_value','significant') all.diff<-diffData(object,features=TRUE) all.diff$log2_fold_change[all.diff$log2_fold_change>=logCutoffValue]<-Inf all.diff$log2_fold_change[all.diff$log2_fold_change<=-logCutoffValue]<--Inf all.diff.melt<-melt(all.diff,measure.vars=measureVars) #all.diff.melt<-all.diff.melt[!grepl("^value_",all.diff.melt$variable),] all.diff.cast<-dcast(all.diff.melt,formula=...~sample_2+sample_1+variable) all.diff.cast } setMethod("diffTable",signature(object="CuffFeatureSet"),.diffTable) .count<-function(object,features=FALSE){ if (features){ return (merge(object@annotation,object@count,by=1)) }else{ return(object@count) } } setMethod("count",signature(object="CuffFeatureSet"),.count) setMethod("annotation","CuffFeatureSet",function(object){ return(object@annotation) }) ################# #Plotting # ################# #Basic heatmap .heatmap<-function(object,logMode=TRUE,pseudocount=1.0){ dat<-fpkm(object) if(logMode){ dat$fpkm<- log10(dat$fpkm+pseudocount) } colnames(dat)[1] <- "tracking_id" p<-ggplot(dat) p <- p + geom_tile(aes(x=tracking_id,y=sample_name,fill=fpkm)) + scale_fill_gradient(low="white",high="red") + theme(axis.text.x=element_text(angle=-90, hjust=0)) p } ####################### #The following is borrowed from Malarkey and is not yet ready for prime time... #I would like to replace the clustering here with JSdistance on rows and/or columns and make #this package work with cuffSet objects by default. #There is no genericMethod yet, goal is to replace .heatmap with .ggheat for genericMethod 'csHeatmap' .ggheat<-function(object, rescaling='none', clustering='none', labCol=T, labRow=T, logMode=T, pseudocount=1.0, border=FALSE, heatscale=c(low='lightyellow',mid='orange',high='darkred'), heatMidpoint=NULL,fullnames=T,replicates=FALSE,method='none',...) { ## the function can be be viewed as a two step process ## 1. using the rehape package and other funcs the data is clustered, scaled, and reshaped ## using simple options or by a user supplied function ## 2. with the now resahped data the plot, the chosen labels and plot style are built if(replicates){ m=repFpkmMatrix(object,fullnames=fullnames) }else{ m=fpkmMatrix(object,fullnames=fullnames) } #remove genes with no expression in any condition m=m[!apply(m,1,sum)==0,] ## you can either scale by row or column not both! ## if you wish to scale by both or use a different scale method then simply supply a scale ## function instead NB scale is a base funct if(logMode) { m = log10(m+pseudocount) } if(is.function(rescaling)) { m=rescaling(m) } else { if(rescaling=='column'){ m=scale(m, center=T) m[is.nan(m)] = 0 } if(rescaling=='row'){ m=t(scale(t(m),center=T)) m[is.nan(m)] = 0 } } ## I have supplied the default cluster and euclidean distance (JSdist) - and chose to cluster after scaling ## if you want a different distance/cluster method-- or to cluster and then scale ## then you can supply a custom function if(!is.function(method)){ method = function(mat){JSdist(makeprobs(t(mat)))} } if(clustering=='row') m=m[hclust(method(m))$order, ] if(clustering=='column') m=m[,hclust(method(t(m)))$order] if(clustering=='both') m=m[hclust(method(m))$order ,hclust(method(t(m)))$order] ## this is just reshaping into a ggplot format matrix and making a ggplot layer rows=dim(m)[1] cols=dim(m)[2] # if(logMode) { # melt.m=cbind(rowInd=rep(1:rows, times=cols), colInd=rep(1:cols, each=rows), melt( log10(m+pseudocount))) # }else{ # melt.m=cbind(rowInd=rep(1:rows, times=cols), colInd=rep(1:cols, each=rows), melt(m)) # } melt.m=cbind(rowInd=rep(1:rows, times=cols), colInd=rep(1:cols, each=rows), melt(m)) g=ggplot(data=melt.m) ## add the heat tiles with or without a white border for clarity if(border==TRUE) g2=g+geom_rect(aes(xmin=colInd-1,xmax=colInd,ymin=rowInd-1,ymax=rowInd, fill=value),colour='grey') if(border==FALSE) g2=g+geom_rect(aes(xmin=colInd-1,xmax=colInd,ymin=rowInd-1,ymax=rowInd, fill=value)) ## add axis labels either supplied or from the colnames rownames of the matrix if(labCol==T) { g2=g2+scale_x_continuous(breaks=(1:cols)-0.5, labels=colnames(m)) } if(labCol==F) { g2=g2+scale_x_continuous(breaks=(1:cols)-0.5, labels=rep('',cols)) } if(labRow==T) { g2=g2+scale_y_continuous(breaks=(1:rows)-0.5, labels=rownames(m)) } if(labRow==F) { g2=g2+scale_y_continuous(breaks=(1:rows)-0.5, labels=rep('',rows)) } # Get rid of the ticks, they get way too dense with lots of rows g2 <- g2 + theme(axis.ticks = element_blank()) ## get rid of grey panel background and gridlines g2=g2+theme(panel.grid.minor=element_line(colour=NA), panel.grid.major=element_line(colour=NA), panel.background=element_rect(fill=NA, colour=NA)) ##adjust x-axis labels g2=g2+theme(axis.text.x=element_text(angle=-90, hjust=0)) #write(paste(c("Length of heatscale is :", length(heatscale))), stderr()) if (logMode) { legendTitle <- bquote(paste(log[10]," FPKM + ",.(pseudocount),sep="")) #legendTitle <- paste(expression(plain(log)[10])," FPKM + ",pseudocount,sep="") } else { legendTitle <- "FPKM" } if (length(heatscale) == 2){ g2 <- g2 + scale_fill_gradient(low=heatscale[1], high=heatscale[2], name=legendTitle) } else if (length(heatscale) == 3) { if (is.null(heatMidpoint)) { heatMidpoint = (max(m) + min(m)) / 2.0 #write(heatMidpoint, stderr()) } g2 <- g2 + scale_fill_gradient2(low=heatscale[1], mid=heatscale[2], high=heatscale[3], midpoint=heatMidpoint, name=legendTitle) } #g2<-g2+scale_x_discrete("",breaks=tracking_ids,labels=gene_short_names) ## finally add the fill colour ramp of your choice (default is blue to red)-- and return return (g2) } setMethod("csHeatmap",signature("CuffFeatureSet"),.ggheat) .fcheatmap<-function(object, control_condition, replicate_num=NULL, clustering='none', labCol=T, labRow=T, logMode=F, pseudocount=1.0, border=FALSE, heatscale=c(low='steelblue',mid='white',high='tomato'), heatMidpoint=0,fullnames=T,replicates=FALSE,method='none',heatRange=3, ...) { ## the function can be be viewed as a two step process ## 1. using the rehape package and other funcs the data is clustered, scaled, and reshaped ## using simple options or by a user supplied function ## 2. with the now resahped data the plot, the chosen labels and plot style are built if(replicates){ if (is.null(replicate_num)){ print ("Error: if replicates == TRUE, you must specify both a control condition and a replicate number") return() } m=repFpkmMatrix(object,fullnames=fullnames) selected_rep <- paste(control_condition,replicate_num,sep="_") #remove genes with no expression in any condition m=m[!apply(m,1,sum)==0,] m=log2(m/m[,selected_rep]) m=m[,names(m) != selected_rep] }else{ m=fpkmMatrix(object,fullnames=fullnames) #remove genes with no expression in any condition m=m[!apply(m,1,sum)==0,] m=log2(m/m[,control_condition]) m=m[,names(m) != control_condition] } m_vals <- unlist(as.list(m))[is.finite(unlist(as.list(m)))] m_max <- max(m_vals) m_min <- max(m_vals) range_lim <- max(c(abs(m_max), abs(m_min))) range_lim <- min(c(heatRange, range_lim)) m_max <- range_lim m_min <- -range_lim m[m < m_min] <- m_min m[m > m_max] <- m_max m[is.na(m)] <- 0 ## I have supplied the default cluster and euclidean distance (JSdist) - and chose to cluster after scaling ## if you want a different distance/cluster method-- or to cluster and then scale ## then you can supply a custom function if(!is.function(method)){ method = dist } if(clustering=='row') m=m[hclust(method(m))$order, ] if(clustering=='column') m=m[,hclust(method(t(m)))$order] if(clustering=='both') m=m[hclust(method(m))$order ,hclust(method(t(m)))$order] rows=dim(m)[1] cols=dim(m)[2] melt.m=cbind(rowInd=rep(1:rows, times=cols), colInd=rep(1:cols, each=rows), melt(m)) g=ggplot(data=melt.m) ## add the heat tiles with or without a white border for clarity if(border==TRUE) g2=g+geom_rect(aes(xmin=colInd-1,xmax=colInd,ymin=rowInd-1,ymax=rowInd, fill=value),colour='grey') if(border==FALSE) g2=g+geom_rect(aes(xmin=colInd-1,xmax=colInd,ymin=rowInd-1,ymax=rowInd, fill=value)) ## add axis labels either supplied or from the colnames rownames of the matrix if(labCol==T) { g2=g2+scale_x_continuous(breaks=(1:cols)-0.5, labels=colnames(m)) } if(labCol==F) { g2=g2+scale_x_continuous(breaks=(1:cols)-0.5, labels=rep('',cols)) } if(labRow==T) { g2=g2+scale_y_continuous(breaks=(1:rows)-0.5, labels=rownames(m)) } if(labRow==F) { g2=g2+scale_y_continuous(breaks=(1:rows)-0.5, labels=rep('',rows)) } # Get rid of the ticks, they get way too dense with lots of rows g2 <- g2 + theme(axis.ticks = element_blank()) ## get rid of grey panel background and gridlines g2=g2+theme(panel.grid.minor=element_line(colour=NA), panel.grid.major=element_line(colour=NA), panel.background=element_rect(fill=NA, colour=NA)) ##adjust x-axis labels g2=g2+theme(axis.text.x=element_text(angle=-90, hjust=0)) #write(paste(c("Length of heatscale is :", length(heatscale))), stderr()) if(replicates){ legendTitle <- bquote(paste(log[2], frac("FPKM",.(selected_rep),sep=""))) }else{ legendTitle <- bquote(paste(log[2], frac("FPKM",.(control_condition),sep=""))) } #legendTitle <- paste(expression(plain(log)[10])," FPKM + ",pseudocount,sep="") if (length(heatscale) == 2){ g2 <- g2 + scale_fill_gradient(low=heatscale[1], high=heatscale[2], name=legendTitle) } else if (length(heatscale) == 3) { if (is.null(heatMidpoint)) { heatMidpoint = (max(m) + min(m)) / 2.0 #write(heatMidpoint, stderr()) } g2 <- g2 + scale_fill_gradient2(low=heatscale[1], mid=heatscale[2], high=heatscale[3], midpoint=heatMidpoint, name=legendTitle) } #g2<-g2+scale_x_discrete("",breaks=tracking_ids,labels=gene_short_names) ## finally add the fill colour ramp of your choice (default is blue to red)-- and return return (g2) } setMethod("csFoldChangeHeatmap",signature("CuffFeatureSet"),.fcheatmap) # Distance Heatmaps .distheat<-function(object, replicates=F, samples.not.genes=T, logMode=T, pseudocount=1.0, heatscale=c(low='lightyellow',mid='orange',high='darkred'), heatMidpoint=NULL, ...) { # get expression from a sample or gene perspective if(replicates){ obj.fpkm<-repFpkmMatrix(object,fullnames=T) }else{ obj.fpkm<-fpkmMatrix(object,fullnames=T) } if(samples.not.genes) { obj.fpkm.pos = obj.fpkm[rowSums(obj.fpkm)>0,] } else { obj.fpkm = t(obj.fpkm) obj.fpkm.pos = obj.fpkm[,colSums(obj.fpkm)>0] } if(logMode) { obj.fpkm.pos = log10(obj.fpkm.pos+pseudocount) } # compute distances obj.dists = JSdist(makeprobs(obj.fpkm.pos)) # cluster to order obj.hc = hclust(obj.dists) # make data frame dist.df = melt(as.matrix(obj.dists),varnames=c("X1","X2")) # initialize g = ggplot(dist.df, aes(x=X1, y=X2, fill=value)) # draw labels = labels(obj.dists) g = g + geom_tile() + scale_x_discrete("", limits=labels[obj.hc$order]) + scale_y_discrete("", limits=labels[obj.hc$order]) # roll labels g = g + theme(axis.text.x=element_text(angle=-90, hjust=0), axis.text.y=element_text(angle=0, hjust=1)) # drop grey panel background and gridlines g = g + theme(panel.grid.minor=element_line(colour=NA), panel.grid.major=element_line(colour=NA), panel.background=element_rect(fill=NA, colour=NA)) # adjust heat scale if (length(heatscale) == 2) { g = g + scale_fill_gradient(low=heatscale[1], high=heatscale[3], name="JS Distance") } else if (length(heatscale) == 3) { if (is.null(heatMidpoint)) { heatMidpoint = max(obj.dists) / 2.0 } g = g + scale_fill_gradient2(low=heatscale[1], mid=heatscale[2], high=heatscale[3], midpoint=heatMidpoint, name="JS Distance") } g <- g + geom_text(aes(label=format(value,digits=3)),size=6) # return g } setMethod("csDistHeat", signature("CuffFeatureSet"), .distheat) #Scatterplot .scatter<-function(object,x,y,logMode=TRUE,pseudocount=0.0,labels, smooth=FALSE,colorByStatus=FALSE,...){ dat<-fpkmMatrix(object,fullnames=T) samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } #add pseudocount if necessary if(logMode){ for (i in samp){ dat[[i]]<-dat[[i]]+pseudocount } } #Attach tracking_id and gene_short_name if(!missing(labels)){ require(stringr) tracking<-str_split_fixed(rownames(dat),"\\|",2) dat$gene_short_name<-tracking[,1] dat$tracking_id<-tracking[,2] labeled.dat<-dat[dat$gene_short_name %in% labels,] } #make plot object p<-ggplot(dat) p<- p + aes_string(x=x,y=y) p<- p + geom_point(size=1.2,alpha=I(1/3)) + geom_abline(intercept=0,slope=1,linetype=2) + geom_rug(size=0.5,alpha=0.01) #add smoother if(smooth){ p <- p + stat_smooth(method="lm",fill="blue",alpha=0.2) } #Add highlights from labels if(!missing(labels)){ p <- p + geom_point(data=labeled.dat,aes_string(x=x,y=y),size=1.3,color="red") p <- p + geom_text(data=labeled.dat,aes_string(x=x,y=y,label='gene_short_name'),color="red",hjust=0,vjust=0,angle=0,size=4) } #logMode if(logMode){ p <- p + scale_y_log10() + scale_x_log10() } if (logMode) { p <- p + ylab(paste(y, "FPKM +",pseudocount)) p <- p + xlab(paste(x, "FPKM +",pseudocount)) } else { p <- p + ylab(paste(y, "FPKM")) p <- p + xlab(paste(x, "FPKM")) } #Add title & Return value #p<- p + labs(title=object@tables$mainTable) p } #.scatter(sigGenes,'P7_lincBrn1b_KO_Brain','P7_WT_Brain',labels=c('Arc')) setMethod("csScatter",signature(object="CuffFeatureSet"), .scatter) #Volcano plot .volcano<-function(object,x,y,alpha=0.05,showSignificant=TRUE,xlimits=c(-20,20),...){ samp<-samples(object) #check to make sure x and y are in samples if (!all(c(x,y) %in% samp)){ stop("One or more values of 'x' or 'y' are not valid sample names!") } dat<-diffData(object=object) dat$significant<-'no' dat$significant[dat$q_value<=alpha]<-'yes' #subset dat for samples of interest mySamples<-c(x,y) dat<-dat[(dat$sample_1 %in% mySamples & dat$sample_2 %in% mySamples),] #Labels s1<-unique(dat$sample_1) s2<-unique(dat$sample_2) p<-ggplot(dat) if(showSignificant){ p<- p + geom_point(aes(x=log2_fold_change,y=-log10(p_value),color=significant),alpha=I(1/3),size=1.2) }else{ p<- p + geom_point(aes(x=log2_fold_change,y=-log10(p_value)),alpha=I(1/3),size=1.2) } p<- p + labs(title=paste(s2,"/",s1,sep="")) #Set axis limits p<- p + scale_x_continuous(limits=xlimits) #Default cummeRbund colorscheme p<-p + scale_colour_manual(values = c("black","red")) p } setMethod("csVolcano",signature(object="CuffFeatureSet"), .volcano) .barplot<-function(object,logMode=TRUE,pseudocount=1.0,showErrorbars=TRUE,showStatus=TRUE,replicates=FALSE,...){ quant_types<-c("OK","FAIL","LOWDATA","HIDATA","TOOSHORT") quant_types<-factor(quant_types,levels=quant_types) quant_colors<-c("black","red","blue","orange","green") names(quant_colors)<-quant_types dat<-fpkm(object,features=T) dat$warning<-"" dat$warning[dat$quant_status!="OK"]<-"!" #TODO: Test dat to ensure that there are >0 rows to plot. If not, trap error and move on... #Handle replicates if(replicates){ repDat<-repFpkm(object) colnames(repDat)[1]<-"tracking_id" } colnames(dat)[1]<-"tracking_id" #tracking_ids<-dat$tracking_id obj_features <- annotation(object) tracking_ids <- obj_features[,1] gene_labels<-obj_features$gene_short_name #print(gene_labels) gene_labels[is.na(gene_labels)] = tracking_ids[is.na(gene_labels)] #print(gene_labels) dodge <- position_dodge(width=0.9) if(logMode) { dat$fpkm <- dat$fpkm + pseudocount dat$conf_hi <- dat$conf_hi + pseudocount dat$conf_lo <- dat$conf_lo + pseudocount } p<-ggplot(dat,aes(x=tracking_id,y=fpkm,fill=sample_name)) p <- p + geom_bar(position=dodge,stat='identity') if (showErrorbars) { p <- p + geom_errorbar(aes(ymin=conf_lo,ymax=conf_hi),position=dodge,width=0.5) } if (logMode) { p <- p + scale_y_log10() status_pos = 1 } if(showStatus){ if(logMode){ p <- p + geom_text(aes(x=tracking_id,y=1,label=warning),position=dodge,stat='identity',color='red',vjust=1.5,size=3) }else{ p <- p + geom_text(aes(x=tracking_id,y=0,label=warning),position=dodge,color='red',stat='identity',vjust=1.5,size=3) } } #gene_labels = dat$gene_short_name p <- p + scale_x_discrete("",breaks=tracking_ids,labels=gene_labels) + theme(axis.text.x=element_text(hjust=0,angle=-90)) # p<- p + # geom_bar() + # geom_errorbar(aes(ymin=conf_lo,ymax=conf_hi,group=1),size=0.15) + # facet_wrap('sample_name') + # theme(axis.text.x=element_text(hjust=0,angle=-90)) #This does not make immediate sense with the conf_hi and conf_lo values. Need to figure out appropriate transformation for these #if(logMode) #p<-p+scale_y_ log10() if (logMode) { p <- p + ylab(paste("FPKM +",pseudocount)) } else { p <- p + ylab("FPKM") } #p <- p + theme(legend.position = "none") #Default cummeRbund colorscheme p<-p + scale_fill_hue(l=50,h.start=200) + scale_color_hue(l=50,h.start=200) #Recolor quant flags p<- p+ scale_colour_manual(name='quant_status',values=quant_colors) p } setMethod("expressionBarplot",signature(object="CuffFeatureSet"),.barplot) .expressionPlot<-function(object,logMode=FALSE,pseudocount=1.0, drawSummary=FALSE, sumFun=mean_cl_boot, showErrorbars=TRUE,showStatus=TRUE,replicates=FALSE,...){ quant_types<-c("OK","FAIL","LOWDATA","HIDATA","TOOSHORT") quant_types<-factor(quant_types,levels=quant_types) quant_colors<-c("black","red","blue","orange","green") names(quant_colors)<-quant_types dat<-fpkm(object) colnames(dat)[1]<-"tracking_id" if(replicates){ repDat<-repFpkm(object) repDat$replicate<-as.factor(repDat$replicate) colnames(repDat)[1]<-"tracking_id" } if(logMode) { dat$fpkm <- dat$fpkm + pseudocount dat$conf_hi <- dat$conf_hi + pseudocount dat$conf_lo <- dat$conf_lo + pseudocount if(replicates){ repDat$fpkm<-repDat$fpkm + pseudocount } } p <- ggplot(dat) #dat$fpkm<- log10(dat$fpkm+pseudocount) p <- p + geom_line(aes(x=sample_name,y=fpkm,group=tracking_id,color=tracking_id)) if(replicates){ p <- p + geom_point(aes(x=sample_name,y=fpkm,color=tracking_id),size=2.5,shape=18,data=repDat) } if (showErrorbars) { p <- p + geom_errorbar(aes(x=sample_name, ymin=conf_lo,ymax=conf_hi,color=tracking_id,group=tracking_id),width=0.25) } if(showStatus){ p <- p+ geom_point(aes(x=sample_name,y=fpkm,shape=quant_status)) } if (logMode) { p <- p + scale_y_log10() } #drawMean if(drawSummary){ p <- p + stat_summary(aes(x=sample_name,y=fpkm,group=1),fun.data=sumFun,color="red",fill="red",alpha=0.2,size=1.1,geom="smooth") } if (logMode) { p <- p + ylab(paste("FPKM +",pseudocount)) } else { p <- p + ylab("FPKM") } #Recolor quant flags #p<- p + scale_colour_manual(name='quant_status',values=quant_colors) p } setMethod("expressionPlot",signature(object="CuffFeatureSet"),.expressionPlot) #TODO: Add csDensity plot for CuffFeatureSet objects #TODO: Add ecdf plot for CuffFeatureSet and CuffData objects ################# #Clustering # ################# #Kmeans by expression profile using JSdist #TODO:Make this function return an object of type CuffClusterSet #.cluster<-function(object, k, pseudocount=1, ...){ # library(cluster) # m<-as.data.frame(fpkmMatrix(object)) # m<-m[rowSums(m)>0,] # n<-JSdist(makeprobs(t(m))) # clusters<-pam(n,k) # clusters$fpkm<-m # m<-m+pseudocount # m$ids<-rownames(m) # m$cluster<-factor(clusters$clustering) # m.melt<-melt(m,id.vars=c("ids","cluster")) # c<-ggplot(m.melt) # c<-c+geom_line(aes(x=variable,y=value,color=cluster,group=ids)) + facet_wrap('cluster',scales='free')+scale_y_log10() # # #Default cummeRbund colorscheme # c<-c + scale_color_hue(l=50,h.start=200) # c #} .cluster<-function(object, k, logMode=T, method='none', pseudocount=1,...){ require(cluster) m<-as.data.frame(fpkmMatrix(object)) m<-m[rowSums(m)>0,] if(logMode){ m<-log10(m+pseudocount) } if(!is.function(method)){ method = function(mat){JSdist(makeprobs(t(m)))} } n<-method(m) clusters<-pam(n,k, ...) #clsuters<-pamk(n,krange=2:20) class(clusters)<-"list" clusters$fpkm<-m clusters } setMethod("csCluster",signature(object="CuffFeatureSet"),.cluster) .ratioCluster<-function(object,k,ratioTo=NULL,pseudocount=0.0001,...){ require(cluster) m<-as.data.frame(fpkmMatrix(object)+pseudocount) #TODO: ensure that ratioTo is in colnames(fpkmMatrix(object)) m.ratio<-m/m[[ratioTo]] m.log.ratio<-log2(m.ratio) n<-dist(m.log.ratio) clusters<-pam(n,k,...) class(clusters)<-"list" clusters$fpkm<-m clusters } csClusterPlot<-function(clustering,pseudocount=1.0,logMode=FALSE,drawSummary=TRUE, sumFun=mean_cl_boot){ m<-clustering$fpkm+pseudocount m$ids<-rownames(clustering$fpkm) m$cluster<-factor(clustering$clustering) m.melt<-melt(m,id.vars=c("ids","cluster")) c<-ggplot(m.melt) c<-c+geom_line(aes(x=variable,y=value,color=cluster,group=ids)) + theme_bw() + facet_wrap('cluster',scales='free_y') if(drawSummary){ c <- c + stat_summary(aes(x=variable,y=value,group=1),fun.data=sumFun,color="black",fill="black",alpha=0.2,size=1.1,geom="smooth") } if(logMode){ c<-c + scale_y_log10() } c<-c + scale_color_hue(l=50,h.start=200) + theme(axis.text.x=element_text(angle=-90,hjust=0)) c } .findK<-function(object, k.range=c(2:20), logMode=T, pseudocount=1,...){ require(cluster) m<-as.data.frame(fpkmMatrix(object)) m<-m[rowSums(m)>0,] if(logMode){ m<-log10(m+pseudocount) } n<-JSdist(makeprobs(t(m))) myWidths<-c() for (k in k.range){ print(k) myWidths<-c(myWidths,pam(n,k,...)$silinfo$avg.width) } plot(k.range,myWidths) } ###################### # ###################### .dendro<-function(object,logMode=T,pseudocount=1,replicates=FALSE){ if(replicates){ fpkmMat<-repFpkmMatrix(object) }else{ fpkmMat<-fpkmMatrix(object) } if(logMode){ fpkmMat<-log10(fpkmMat+pseudocount) } res<-JSdist(makeprobs(fpkmMat)) #colnames(res)<-colnames(fpkmMat) #res<-as.dist(res) res<-as.dendrogram(hclust(res)) plot(res) res } setMethod("csDendro",signature(object="CuffFeatureSet"),.dendro) #.csNMF<-function(object,rank,method,...){ # #Non-negative Matrix Factorization # require(NMF) # #Retrieve FPKM values # fpkms<-fpkmMatrix(object) # # #Remove rows with sum()==0 # fpkms<-fpkms[rowSums(fpkms)>0,] # #} # #setMethod("csNMF",signature(object="CuffFeatureSet"),.csNMF) ##Takes as first argument the object returned from csCluster (a modified 'cluster' list) #.clusterPlot<-function(clusters, pseudocount=1, ...){ # m<-clusters$fpkm # m<-m+pseudocount # m$ids<-rownames(m) # m$cluster<-factor(clusters$clustering) # m.melt<-melt(m,id.vars=c("ids","cluster")) # c<-ggplot(m.melt) # c<-c+geom_line(aes(x=variable,y=value,color=cluster,group=ids)) + facet_wrap('cluster',scales='free')+scale_y_log10() # # #Default cummeRbund colorscheme # c<-c + scale_color_hue(l=50,h.start=200) # c #} ###################### # Exploratory Analysis ###################### .nmf<-function(object,k,logMode=T,pseudocount=1,maxiter=1000,replicates=FALSE,fullnames=FALSE){ require(NMFN) if(missing(k)) stop("Please provide a rank value for factorization (arg=k)") if(replicates){ m=repFpkmMatrix(object,fullnames=fullnames) }else{ m=fpkmMatrix(object,fullnames=fullnames) } if(logMode) { m = log10(m+pseudocount) } myNMF<-nnmf(m,k=k,maxiter=maxiter) return (myNMF) } setMethod("csNMF",signature(object="CuffFeatureSet"),.nmf) .density<-function(object, logMode = TRUE, pseudocount=0.0, labels, features=FALSE, replicates=FALSE,...){ if(replicates){ dat<-repFpkm(object,features=features) colnames(dat)[colnames(dat)=="rep_name"]<-"condition" }else{ dat<-fpkm(object,features=features) colnames(dat)[colnames(dat)=="sample_name"]<-"condition" } if(logMode) dat$fpkm<-dat$fpkm+pseudocount p<-ggplot(dat) if(logMode) { p<-p+geom_density(aes(x= log10(fpkm),group=condition,color=condition,fill=condition),alpha=I(1/3)) }else{ p<-p+geom_density(aes(x=fpkm,group=condition,color=condition,fill=condition),alpha=I(1/3)) } #p<-p + labs(title=object@tables$mainTable) #Default cummeRbund colorscheme p<-p + scale_fill_hue(l=50,h.start=200) + scale_color_hue(l=50,h.start=200) #TODO: Add label callout p } setMethod("csDensity",signature(object="CuffFeatureSet"),.density) ################# # Dimensionality Reduction (use sparingly for Gene Sets) ################# .MDSplot<-function(object,replicates=FALSE,logMode=TRUE,pseudocount=1.0){ if(replicates){ dat<-repFpkmMatrix(object) #repData<-sapply(replicates(object),function(x){strsplit(x,"_")[[1]][1]}) This is to color by condition and not replicate... }else{ dat<-fpkmMatrix(object) } if(logMode){ dat<-log10(dat+pseudocount) } d<-JSdist(makeprobs(dat)) fit <- cmdscale(d,eig=TRUE, k=2) res<-data.frame(names=rownames(fit$points),M1=fit$points[,1],M2=fit$points[,2]) p <- ggplot(res) p <- p + geom_point(aes(x=M1,y=M2,color=names)) + geom_text(aes(x=M1,y=M2,label=names,color=names)) + theme_bw() p } setMethod("MDSplot",signature(object="CuffFeatureSet"),.MDSplot) .PCAplot<-function(object,x="PC1", y="PC2",replicates=FALSE,pseudocount=1.0,scale=TRUE,showPoints=TRUE,...){ if(replicates){ fpkms<-repFpkmMatrix(object) }else{ fpkms<-fpkmMatrix(object) } fpkms<-log10(fpkms+pseudocount) PC<-prcomp(fpkms,scale=scale,...) dat <- data.frame(obsnames=row.names(PC$x), PC$x) #dat$shoutout<-"" #dat$shoutout[matchpt(PC$rotation,PC$x)$index]<-rownames(pca$x[matchpt(pca$rotation,pca$x)$index,]) plot <- ggplot(dat, aes_string(x=x, y=y)) if(showPoints){ plot<- plot + geom_point(alpha=.4, size=0.8, aes(label=obsnames)) } plot <- plot + geom_hline(aes(yintercept=0), size=.2) + geom_vline(aes(xintercept=0), size=.2) #+ geom_text(aes(label=shoutout),size=2,color="red") datapc <- data.frame(varnames=rownames(PC$rotation), PC$rotation) mult <- min( (max(dat[,y]) - min(dat[,y])/(max(datapc[,y])-min(datapc[,y]))), (max(dat[,x]) - min(dat[,x])/(max(datapc[,x])-min(datapc[,x]))) ) datapc <- transform(datapc, v1 = .7 * mult * (get(x)), v2 = .7 * mult * (get(y)) ) plot <- plot + #coord_equal() + geom_text(data=datapc, aes(x=v1, y=v2, label=varnames,color=varnames), vjust=1) plot <- plot + geom_segment(data=datapc, aes(x=0, y=0, xend=v1, yend=v2,color=varnames), arrow=arrow(length=unit(0.2,"cm")), alpha=0.75) + theme_bw() plot } setMethod('PCAplot',signature(object="CuffFeatureSet"),.PCAplot) ################# #Misc # ################# .makeIdentityMatrix<-function(sampleNames){ d<-diag(length(sampleNames)) } .specificity<-function(object,logMode=T,pseudocount=1,relative=FALSE,...){ fpkms<-fpkmMatrix(object,...) if(logMode){ fpkms<-log10(fpkms+pseudocount) } fpkms<-t(makeprobs(t(fpkms))) d<-diag(ncol(fpkms)) res<-apply(d,MARGIN=1,function(q){ JSdistFromP(fpkms,q) }) colnames(res)<-paste(colnames(fpkms),"_spec",sep="") if(relative){ res<-res/max(res) } 1-res } setMethod("csSpecificity",signature(object="CuffFeatureSet"),.specificity) cummeRbund/R/methods-CuffGene.R0000644000175200017520000001453314516004263017353 0ustar00biocbuildbiocbuild######################## #methods-CuffGene.R # #Author: Loyal A. Goff # #Date created: 5-17-2011 # #Description: ######################### ################# #Initialize # ################# ################# #Validate # ################# #TODO: Add validity constraints setValidity("CuffGene",function(object){ objLen = length(object) if(objLen==0){ write("No gene set returned (Gene might not be in database?)",stderr()) return(FALSE) } if(objLen>1){ write("Warning: Possibly more than one gene returned",stderr()) return(TRUE) } } ) ################# #Class Methods # ################# setMethod("show","CuffGene",function(object){ cat(class(object),"instance for gene",object@id,"\nShort name:\t",unique(object@annotation$gene_short_name), "\nSlots:\n\t annotation\n\t features\n\t fpkm\n\t repFpkm\n\t diff\n\t count\n\t", "isoforms\t",class(object@isoforms),"instance of size",length(object@isoforms),"\n\t", "TSS\t\t",class(object@TSS),"instance of size",length(object@TSS),"\n\t", "CDS\t\t",class(object@CDS),"instance of size",length(object@CDS),"\n" ) } ) setMethod("length","CuffGene", function(x){ dim(x@annotation)[1] } ) ################# #Subsetting # ################# ################# #Accessors ################# #isoforms setMethod("isoforms","CuffGene",function(object){ return(object@isoforms) }) #TSS setMethod("TSS","CuffGene",function(object){ return(object@TSS) }) #CDS setMethod("CDS","CuffGene",function(object){ return(object@CDS) }) #promoters setMethod("promoters","CuffGene",function(object){ return(object@promoters) }) #splicing setMethod("splicing","CuffGene",function(object){ return(object@splicing) }) #relCDS setMethod("relCDS","CuffGene",function(object){ return(object@relCDS) }) #features setMethod("features","CuffGene",function(object){ return(object@features) }) ################# #Plotting # ################# .makeGeneRegionTrack<-function(object){ featCols<-c('seqnames','start','end','source','gene_id','exon_number','isoform_id','isoform_id','exon_number','strand') feats<-features(object)[,featCols] newColnames<-c('seqnames','start','end','feature','gene','exon','transcript','symbol','rank','strand') mychr<-unique(feats$seqnames) colnames(feats)<-newColnames feats<-feats[,-1] #print(feats) feats$symbol[is.na(feats$symbol)]<-"NA" #THIS NEEDS TO BE MADE GENERIC genetrack<-GeneRegionTrack(feats,genome=object@genome,chromosome=mychr,name='CuffDiff',showId=T,stacking="pack") genetrack } setMethod("makeGeneRegionTrack",signature(object="CuffGene"),.makeGeneRegionTrack) .plot<-function(object){ trackList<-list() myStart<-min(object@features$start) myEnd<-max(object@features$end) #Make the following conditional on network connectivity ideoTrack <- IdeogramTrack(genome = object@genome, chromosome = unique(object@features$seqnames)) trackList<-c(trackList,ideoTrack) axtrack<-GenomeAxisTrack() trackList<-c(trackList,axtrack) genetrack<-.makeGeneRegionTrack(object) trackList<-c(trackList,genetrack) biomTrack<-BiomartGeneRegionTrack(genome=object@genome,chromosome=as.character(unique(object@features$seqnames)),start=myStart,end=myEnd,name="ENSEMBL",showId=T) trackList<-c(trackList,biomTrack) plotTracks(trackList,from=myStart-2000,to=myEnd+2000) } setMethod("genePlot",signature(object="CuffGene"),.plot) ################# #Feature Plotting ################# .ideogram<-function(object){ myStart<-min(object@features$start) myEnd<-max(object@features$end) mychr<-unique(object@features$seqnames) p<-plotIdeogram(genome=object@genome,subchr=mychr,zoom.region=c(myStart,myEnd)) p } .plot2<-function(object,...){ #Ideogram ideoTrack<-.ideogram(object) #Expression levels expressionTrack<-expressionPlot(isoforms(object),facet=T,...)+theme_bw() + theme(legend.position='none') hasAxis(expressionTrack)<-TRUE #Transcript Models #modelTrack<-autoplot(.asGRangesList(object),aes(fill=transcript,group=transcript),gap.geom="arrow") + theme_bw() + scale_fill_hue(l=50,h.start=200) + scale_color_hue(l=50,h.start=200) modelTrack<-ggplot(as.GRangesList(object),) hasAxis(modelTrack)<-TRUE #Plot it all... tracks(ideoTrack,modelTrack,expressionTrack,heights=c(1,3,3),fixed=c(TRUE,TRUE,FALSE),main=unique(object@annotation$gene_short_name)) } .pie<-function(object,level="isoforms",pseudocount=0.0001,...){ dat<-fpkm(slot(object,level)) colnames(dat)[1]<-'tracking_id' #dat$fpkm<-dat$fpkm+pseudocount #print(dat) p<-ggplot(dat,aes(x="",y=fpkm,fill=tracking_id)) p<- p + geom_bar(stat="identity",position="fill",color="black") p<- p + coord_polar(theta='y') p<-p + scale_fill_hue(l=50,h.start=200) + scale_color_hue(l=50,h.start=200) + theme_bw() p<-p + facet_wrap('sample_name') + theme(axis.text.x = element_blank(),aspect.ratio=1) p } setMethod("csPie",signature(object="CuffGene"),.pie) ################# #Coersion methods ################# #As GRanges .as.GRanges<-function(from){ #featCols<-c('seqnames','start','end','source','gene_id','exon_number','isoform_id','isoform_id','exon_number','strand') feats<-from@features #newColnames<-c('seqnames','start','end','feature','gene','exon','transcript','symbol','rank','strand') #ExpressionValues (transcript) fpkm<-cbind(isoform_id=rownames(fpkmMatrix(isoforms(from))),fpkmMatrix(isoforms(from))) feats<-merge(feats,fpkm) colnames(feats)[colnames(feats)=='isoform_id']<-'transcript' colnames(feats)[colnames(feats)=='gene_id']<-'gene' colnames(feats)[colnames(feats)=='exon_number']<-'exon' colnames(feats)[colnames(feats)=='source']<-'feature' feats$symbol<-feats$transcript corCols<-c('seqnames','start','end','strand','width') myGR<-GRanges(Rle(feats$seqnames),ranges=IRanges(feats$start,end=feats$end),strand=Rle(feats$strand),elementMetadata=feats[,!colnames(feats) %in% corCols]) colnames(elementMetadata(myGR))<-colnames(feats[,!colnames(feats) %in% corCols]) myGR } setAs("CuffGene","GRanges",.as.GRanges) #As GRangesList .as.GRangesList<-function(object,f="transcript"){ gr<-as(object,"GRanges") grl<-split(gr,f) grl } setMethod("as.GRangesList",signature(object="CuffGene"),.as.GRangesList) ####################### # ggbio integration ####################### #setMethod("ggplot", "CuffGene", function(data, ...){ # df <- mold(as.GRangesList(data)) # g <- ggplot(df, ...) # g$.data <- as.GRangesList(data) # g <- ggbio(g) # g # })cummeRbund/R/methods-CuffGeneSet.R0000644000175200017520000000343714516004263020030 0ustar00biocbuildbiocbuild######################## #methods-CuffGeneSet.R # #Author: Loyal A. Goff # #Date created: 5-17-2011 # #Description: Defines a class of cufflinks data for multiple genes ######################### ################# #Initialize # ################# ################# #Validate # ################# ################# #Class Methods # ################# setMethod("show","CuffGeneSet",function(object){ cat(class(object),"instance for ", length(object), " genes\n", "\nSlots:\n\t annotation\n\t fpkm\n\t repFpkm\n\t diff\n\t count\n\t", "isoforms\t",class(object@isoforms),"instance of size",length(object@isoforms),"\n\t", "TSS\t\t",class(object@TSS),"instance of size",length(object@TSS),"\n\t", "CDS\t\t",class(object@CDS),"instance of size",length(object@CDS),"\n\t", "promoters\t\t",class(object@promoters),"instance of size",length(object@promoters),"\n\t", "splicing\t\t",class(object@splicing),"instance of size",length(object@splicing),"\n\t", "relCDS\t\t",class(object@relCDS),"instance of size",length(object@relCDS),"\n" ) } ) ################# #Accessors ################# #isoforms setMethod("isoforms","CuffGeneSet",function(object){ return(object@isoforms) }) #TSS setMethod("TSS","CuffGeneSet",function(object){ return(object@TSS) }) #CDS setMethod("CDS","CuffGeneSet",function(object){ return(object@CDS) }) #promoters setMethod("promoters","CuffGeneSet",function(object){ return(object@promoters) }) #splicing setMethod("splicing","CuffGeneSet",function(object){ return(object@splicing) }) #relCDS setMethod("relCDS","CuffGeneSet",function(object){ return(object@relCDS) }) ################# #Subsetting # ################# ################# #Plotting # ################# ################# #Misc # #################cummeRbund/R/methods-CuffSet.R0000644000175200017520000011047214516004263017227 0ustar00biocbuildbiocbuild################## #methods-CuffSet.R # #Introduces the CuffSet Class for analysis, manipulation, and plotting of Cufflinks data # #Author: Loyal A. Goff # ################## #Initialize setMethod("initialize","CuffSet", function(.Object, DB, #runInfo=data.frame(), phenoData=data.frame(), conditions=data.frame(), genes, isoforms, TSS, CDS, promoters, splicing, relCDS, ...){ .Object<-callNextMethod(.Object, DB = DB, #runInfo=runInfo, phenoData=phenoData, conditions = conditions, genes = genes, isoforms = isoforms, TSS = TSS, CDS = CDS, promoters = promoters, splicing = splicing, relCDS = relCDS, ...) } ) ################## #Class Methods ################## setMethod("show","CuffSet", function(object){ cat(class(object), "instance with:\n\t", dim(object@genes)[2],"samples\n\t", dim(object@genes)[1],"genes\n\t", dim(object@isoforms)[1],"isoforms\n\t", dim(object@TSS)[1],"TSS\n\t", dim(object@CDS)[1],"CDS\n\t", dim(object@promoters)[1],"promoters\n\t", dim(object@splicing)[1],"splicing\n\t", dim(object@relCDS)[1],"relCDS\n" ) } ) #This does not subset appropriately yet #TODO: Fix for multiple values of i # #Solution is to test i to determine if it is of type 'numeric' (index), list (multi-index), or 'character' (gene_ids) # #TODO: - Add 'j' to select on sampleNames as well # - Add ability to search on gene_short_name(s) or featureIDs #setMethod("[",signature(x="CuffSet"),function(x, i, ...){ # featureIDs<-featureNames(x@genes)[i] # if(length(featureIDs)==1){ # res<-getGene(x,featureID) # }else{ # res<-getGenes(x,featureIDs) # } # res # } #) setValidity("CuffSet", function(object){ TRUE } ) ############ #Accessors ############ .samples<-function(object){ sampleQuery<-"SELECT * FROM samples s LEFT JOIN phenoData p on s.sample_name = p.sample_name" dbGetQuery(object@DB,sampleQuery) } setMethod("samples",signature(object="CuffSet"),.samples) .replicates<-function(object){ replicateQuery<-"SELECT * FROM replicates r" dbGetQuery(object@DB,replicateQuery) } setMethod("replicates",signature(object="CuffSet"),.replicates) setMethod("DB","CuffSet",function(object){ return(object@DB) }) .runInfo<-function(object){ runInfoQuery<-"SELECT * FROM runInfo" dbGetQuery(object@DB,runInfoQuery) } setMethod("runInfo","CuffSet",.runInfo) .varModel<-function(object){ varModelQuery<-"SELECT * from varModel" dbGetQuery(object@DB,varModelQuery) } setMethod("varModel","CuffSet",.varModel) #setMethod("phenoData","CuffSet",function(object){ # return(object@phenoData) # }) setMethod("conditions","CuffSet",function(object){ return(object@conditions) }) setMethod("genes","CuffSet",function(object){ return(object@genes) }) setMethod("isoforms","CuffSet",function(object){ return(object@isoforms) }) setMethod("TSS","CuffSet",function(object){ return(object@TSS) }) setMethod("CDS","CuffSet",function(object){ return(object@CDS) }) setMethod("promoters","CuffSet",function(object){ return(object@promoters) }) setMethod("splicing","CuffSet",function(object){ return(object@splicing) }) setMethod("relCDS","CuffSet",function(object){ return(object@relCDS) }) .getGenome<-function(object){ genomeQuery<-"SELECT value FROM runInfo WHERE param='genome'" genome<-dbGetQuery(object@DB,genomeQuery) genome<-unique(genome[,1]) genome } #make CuffGene objects from a gene_ids .getGene<-function(object,geneId,sampleIdList=NULL){ #Get gene_id from geneId (can use any identifier now to select gene) geneId<-getGeneId(object,geneId) if(length(geneId)>1){ stop("More than one gene_id found for given query. Please use getGenes() instead.") } #Sample subsetting if(!is.null(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } #Sample Search String (SQL) sampleString<-'(' for (i in myLevels){ sampleString<-paste(sampleString,"'",i,"',",sep="") } sampleString<-substr(sampleString,1,nchar(sampleString)-1) sampleString<-paste(sampleString,')',sep="") whereString = paste("WHERE (x.gene_id ='",geneId,"' OR x.gene_short_name = '",geneId,"')",sep="") whereStringFPKM = paste("WHERE (x.gene_id ='",geneId,"' OR x.gene_short_name = '",geneId,"')",' AND (y.sample_name IN ',sampleString,')',sep="") whereStringDiff = paste("WHERE (x.gene_id ='",geneId,"' OR x.gene_short_name = '",geneId,"')",' AND (y.sample_1 IN ',sampleString,' AND y.sample_2 IN ',sampleString,')',sep="") whereStringRep = paste("JOIN replicates r ON y.rep_name=r.rep_name WHERE (x.gene_id ='",geneId,"' OR x.gene_short_name = '",geneId,"')",' AND (r.sample_name IN ',sampleString,')',sep="") #dbQueries geneAnnotationQuery<-paste("SELECT * from genes x LEFT JOIN geneFeatures xf USING(gene_id) ",whereString,sep="") geneFPKMQuery<-paste("SELECT y.* from genes x JOIN geneData y ON x.gene_id=y.gene_id ",whereStringFPKM,sep="") #print(geneFPKMQuery) geneDiffQuery<-paste("SELECT y.* from genes x JOIN geneExpDiffData y ON x.gene_id=y.gene_id ",whereStringDiff,sep="") #print(geneDiffQuery) geneRepFPKMQuery<-paste("SELECT y.* from genes x JOIN geneReplicateData y ON x.gene_id=y.gene_id ",whereStringRep,sep="") geneCountQuery<-paste("SELECT y.* from genes x JOIN geneCount y ON x.gene_id=y.gene_id ",whereStringFPKM,sep="") geneFeatureQuery<-paste("SELECT y.* FROM features y JOIN genes x on y.gene_id = x.gene_id ",whereString,sep="") isoformAnnotationQuery<-paste("SELECT * from isoforms i JOIN genes x ON i.gene_id = x.gene_id ",whereString,sep="") isoformFPKMQuery<-paste("SELECT y.* from isoforms i JOIN isoformData y ON i.isoform_id = y.isoform_id JOIN genes x ON i.gene_id = x.gene_id ",whereStringFPKM,sep="") isoformDiffQuery<-paste("SELECT y.* from isoforms i JOIN isoformExpDiffData y ON i.isoform_id = y.isoform_id JOIN genes x ON i.gene_id = x.gene_id ",whereStringDiff,sep="") isoformRepFPKMQuery<-paste("SELECT y.* from isoforms i JOIN isoformReplicateData y ON i.isoform_id = y.isoform_id JOIN genes x ON i.gene_id = x.gene_id ",whereStringRep,sep="") isoformCountQuery<-paste("SELECT y.* from isoforms i JOIN isoformCount y ON i.isoform_id = y.isoform_id JOIN genes x ON i.gene_id = x.gene_id ",whereStringFPKM,sep="") TSSAnnotationQuery<-paste("SELECT * from TSS t JOIN genes x ON t.gene_id = x.gene_id ",whereString,sep="") TSSFPKMQuery<-paste("SELECT y.* from TSS t JOIN TSSData y ON t.TSS_group_id=y.TSS_group_id JOIN genes x ON t.gene_id = x.gene_id ",whereStringFPKM,sep="") TSSDiffQuery<-paste("SELECT y.* from TSS t JOIN TSSExpDiffData y ON t.TSS_group_id=y.TSS_group_id JOIN genes x ON t.gene_id = x.gene_id ",whereStringDiff,sep="") TSSRepFPKMQuery<-paste("SELECT y.* from TSS t JOIN TSSReplicateData y ON t.TSS_group_id=y.TSS_group_id JOIN genes x ON t.gene_id = x.gene_id ",whereStringRep,sep="") TSSCountQuery<-paste("SELECT y.* from TSS t JOIN TSSCount y ON t.TSS_group_id=y.TSS_group_id JOIN genes x ON t.gene_id = x.gene_id ",whereStringFPKM,sep="") CDSAnnotationQuery<-paste("SELECT * from CDS c JOIN genes x ON c.gene_id = x.gene_id ",whereString,sep="") CDSFPKMQuery<-paste("SELECT y.* from CDS c JOIN CDSData y ON c.CDS_id = y.CDS_id JOIN genes x ON c.gene_id = x.gene_id ",whereStringFPKM,sep="") CDSDiffQuery<-paste("SELECT y.* from CDS c JOIN CDSExpDiffData y ON c.CDS_id = y.CDS_id JOIN genes x ON c.gene_id = x.gene_id ",whereStringDiff,sep="") CDSRepFPKMQuery<-paste("SELECT y.* from CDS c JOIN CDSReplicateData y ON c.CDS_id = y.CDS_id JOIN genes x ON c.gene_id = x.gene_id ",whereStringRep,sep="") CDSCountQuery<-paste("SELECT y.* from CDS c JOIN CDSCount y ON c.CDS_id = y.CDS_id JOIN genes x ON c.gene_id = x.gene_id ",whereStringFPKM,sep="") begin<-dbSendQuery(object@DB,"BEGIN;") #fetch records #genes genes.fpkm<-dbGetQuery(object@DB,geneFPKMQuery) genes.fpkm$sample_name<-factor(genes.fpkm$sample_name,levels=myLevels) genes.diff<-dbGetQuery(object@DB,geneDiffQuery) genes.diff$sample_1<-factor(genes.diff$sample_1,levels=myLevels) genes.diff$sample_2<-factor(genes.diff$sample_2,levels=myLevels) genes.repFpkm<-dbGetQuery(object@DB,geneRepFPKMQuery) genes.count<-dbGetQuery(object@DB,geneCountQuery) genes.annotation<-dbGetQuery(object@DB,geneAnnotationQuery) genes.features<-dbGetQuery(object@DB,geneFeatureQuery) #isoforms isoform.fpkm<-dbGetQuery(object@DB,isoformFPKMQuery) isoform.fpkm$sample_name<-factor(isoform.fpkm$sample_name,levels=myLevels) isoform.diff<-dbGetQuery(object@DB,isoformDiffQuery) isoform.diff$sample_1<-factor(isoform.diff$sample_1,levels=myLevels) isoform.diff$sample_2<-factor(isoform.diff$sample_2,levels=myLevels) isoform.repFpkm<-dbGetQuery(object@DB,isoformRepFPKMQuery) isoform.count<-dbGetQuery(object@DB,isoformCountQuery) isoform.annotation<-dbGetQuery(object@DB,isoformAnnotationQuery) #CDS CDS.fpkm<-dbGetQuery(object@DB,CDSFPKMQuery) CDS.fpkm$sample_name<-factor(CDS.fpkm$sample_name,levels=myLevels) CDS.diff<-dbGetQuery(object@DB,CDSDiffQuery) CDS.diff$sample_1<-factor(CDS.diff$sample_1,levels=myLevels) CDS.diff$sample_2<-factor(CDS.diff$sample_2,levels=myLevels) CDS.repFpkm<-dbGetQuery(object@DB,CDSRepFPKMQuery) CDS.count<-dbGetQuery(object@DB,CDSCountQuery) CDS.annotation<-dbGetQuery(object@DB,CDSAnnotationQuery) #TSS TSS.fpkm<-dbGetQuery(object@DB,TSSFPKMQuery) TSS.fpkm$sample_name<-factor(TSS.fpkm$sample_name,levels=myLevels) TSS.diff<-dbGetQuery(object@DB,TSSDiffQuery) TSS.diff$sample_1<-factor(TSS.diff$sample_1,levels=myLevels) TSS.diff$sample_2<-factor(TSS.diff$sample_2,levels=myLevels) TSS.repFpkm<-dbGetQuery(object@DB,TSSRepFPKMQuery) TSS.count<-dbGetQuery(object@DB,TSSCountQuery) TSS.annotation<-dbGetQuery(object@DB,TSSAnnotationQuery) end<-dbSendQuery(object@DB,"END;") #write(.getGenome(object),stderr()) res<-new("CuffGene", id=geneId, features=genes.features, annotation=genes.annotation, fpkm=genes.fpkm, diff=genes.diff, repFpkm=genes.repFpkm, count=genes.count, genome=.getGenome(object), isoforms=new("CuffFeature", annotation=isoform.annotation, fpkm=isoform.fpkm, diff=isoform.diff, repFpkm=isoform.repFpkm, count=isoform.count ), TSS=new("CuffFeature", annotation=TSS.annotation, fpkm=TSS.fpkm, diff=TSS.diff, repFpkm=TSS.repFpkm, count=TSS.count ), CDS=new("CuffFeature", annotation=CDS.annotation, fpkm=CDS.fpkm, diff=CDS.diff, repFpkm=CDS.repFpkm, count=CDS.count ) ) res } setMethod("getGene",signature(object="CuffSet"),.getGene) .getGenes<-function(object,geneIdList,sampleIdList=NULL){ #Determine gene_id from geneIdList #This is useful so that people can pass, for example, isoform_id to geneIdList and getGenes will return full genes geneIdList<-getGeneId(object=object,geneIdList) #Sample subsetting if(!is.null(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } #Sample Search String (SQL) sampleString<-'(' for (i in myLevels){ sampleString<-paste(sampleString,"'",i,"',",sep="") } sampleString<-substr(sampleString,1,nchar(sampleString)-1) sampleString<-paste(sampleString,")",sep="") #idQuery<-paste('SELECT DISTINCT x.gene_id from genes x WHERE (x.gene_id IN ',origIdString,' OR x.gene_short_name IN ',origIdString,')',sep="") idString<-'(' for (i in geneIdList){ idString<-paste(idString,"'",i,"',",sep="") } idString<-substr(idString,1,nchar(idString)-1) idString<-paste(idString,")",sep="") #write(idString,stderr()) whereStringGene<-paste('WHERE x.gene_id IN ',idString,sep="") whereStringGeneFPKM<-paste('WHERE x.gene_id IN ',idString,sep="") whereStringGeneDiff<-paste('WHERE x.gene_id IN ',idString,sep="") whereString<-paste('WHERE x.gene_id IN ',idString,sep="") whereStringFPKM<-paste('WHERE x.gene_id IN ',idString,sep="") whereStringDiff<-paste('WHERE x.gene_id IN ',idString,sep="") if(!is.null(sampleIdList)){ whereStringGene<-whereStringGene whereStringGeneFPKM<-paste(whereStringGeneFPKM,' AND y.sample_name IN ',sampleString,sep="") whereStringGeneDiff<-paste(whereStringGeneDiff,' AND (y.sample_1 IN ',sampleString,' AND y.sample_2 IN ',sampleString,')',sep="") whereString<-whereString whereStringFPKM<-paste(whereStringFPKM, ' AND y.sample_name IN ',sampleString,sep="") whereStringDiff<-paste(whereStringDiff,' AND (y.sample_1 IN ',sampleString,' AND y.sample_2 IN ',sampleString,')',sep="") } #geneAnnotationQuery<-paste("SELECT * from genes x LEFT JOIN geneFeatures xf ON x.gene_id=xf.gene_id ", whereStringGene,sep="") geneAnnotationQuery<-paste("SELECT * from genes x LEFT JOIN geneFeatures xf USING (gene_id) ", whereStringGene,sep="") geneFPKMQuery<-paste("SELECT y.* from genes x JOIN geneData y ON x.gene_id=y.gene_id ", whereStringGeneFPKM,sep="") geneDiffQuery<-paste("SELECT y.* from genes x JOIN geneExpDiffData y ON x.gene_id=y.gene_id ", whereStringGeneDiff,sep="") geneRepFPKMQuery<-paste("SELECT y.* from genes x JOIN geneReplicateData y on x.gene_id=y.gene_id ", whereStringGeneFPKM,sep="") geneCountQuery<-paste("SELECT y.* from genes x JOIN geneCount y on x.gene_id=y.gene_id ", whereStringGeneFPKM,sep="") isoformAnnotationQuery<-paste("SELECT x.* from isoforms x LEFT JOIN isoformFeatures xf ON x.isoform_id=xf.isoform_id JOIN genes g on x.gene_id=g.gene_id ", whereString,sep="") isoformFPKMQuery<-paste("SELECT y.* from isoforms x JOIN isoformData y ON x.isoform_id = y.isoform_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") isoformDiffQuery<-paste("SELECT y.* from isoforms x JOIN isoformExpDiffData y ON x.isoform_id = y.isoform_id JOIN genes g on x.gene_id=g.gene_id ", whereStringDiff,sep="") isoformRepFPKMQuery<-paste("SELECT y.* from isoforms x JOIN isoformReplicateData y on x.isoform_id=y.isoform_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") isoformCountQuery<-paste("SELECT y.* from isoforms x JOIN isoformCount y on x.isoform_id=y.isoform_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") TSSAnnotationQuery<-paste("SELECT x.* from TSS x LEFT JOIN TSSFeatures xf ON x.TSS_group_id=xf.TSS_group_id JOIN genes g on x.gene_id=g.gene_id ", whereString,sep="") TSSFPKMQuery<-paste("SELECT y.* from TSS x JOIN TSSData y ON x.TSS_group_id=y.TSS_group_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") TSSDiffQuery<-paste("SELECT y.* from TSS x JOIN TSSExpDiffData y ON x.TSS_group_id=y.TSS_group_id JOIN genes g on x.gene_id=g.gene_id ", whereStringDiff,sep="") TSSRepFPKMQuery<-paste("SELECT y.* from TSS x JOIN TSSReplicateData y on x.TSS_group_id=y.TSS_group_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") TSSCountQuery<-paste("SELECT y.* from TSS x JOIN TSSCount y on x.TSS_group_id=y.TSS_group_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") CDSAnnotationQuery<-paste("SELECT x.* from CDS x LEFT JOIN CDSFeatures xf ON x.CDS_id=xf.CDS_id JOIN genes g on x.gene_id=g.gene_id ", whereString,sep="") CDSFPKMQuery<-paste("SELECT y.* from CDS x JOIN CDSData y ON x.CDS_id = y.CDS_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") CDSDiffQuery<-paste("SELECT y.* from CDS x JOIN CDSExpDiffData y ON x.CDS_id = y.CDS_id JOIN genes g on x.gene_id=g.gene_id ", whereStringDiff,sep="") CDSRepFPKMQuery<-paste("SELECT y.* from CDS x JOIN CDSReplicateData y on x.CDS_id=y.CDS_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") CDSCountQuery<-paste("SELECT y.* from CDS x JOIN CDSCount y on x.CDS_id=y.CDS_id JOIN genes g on x.gene_id=g.gene_id ", whereStringFPKM,sep="") promotersDistQuery<-paste("SELECT x.* FROM promoterDiffData x LEFT JOIN genes g ON x.gene_id=g.gene_id ", whereString,sep="") splicingDistQuery<-paste("SELECT x.* FROM splicingDiffData x LEFT JOIN genes g ON x.gene_id=g.gene_id ", whereString,sep="") CDSDistQuery<-paste("SELECT x.* FROM CDSDiffData x LEFT JOIN genes g ON x.gene_id=g.gene_id ", whereString,sep="") begin<-dbSendQuery(object@DB,"BEGIN;") #fetch records #genes write("Getting gene information:",stderr()) write("\tFPKM",stderr()) genes.fpkm<-dbGetQuery(object@DB,geneFPKMQuery) genes.fpkm$sample_name<-factor(genes.fpkm$sample_name,levels=myLevels) write("\tDifferential Expression Data",stderr()) genes.diff<-dbGetQuery(object@DB,geneDiffQuery) genes.diff$sample_1<-factor(genes.diff$sample_1,levels=myLevels) genes.diff$sample_2<-factor(genes.diff$sample_2,levels=myLevels) write("\tAnnotation Data",stderr()) genes.annot<-dbGetQuery(object@DB,geneAnnotationQuery) write("\tReplicate FPKMs",stderr()) genes.repFpkm<-dbGetQuery(object@DB,geneRepFPKMQuery) write("\tCounts",stderr()) genes.count<-dbGetQuery(object@DB,geneCountQuery) #isoforms write("Getting isoforms information:",stderr()) write("\tFPKM",stderr()) isoform.fpkm<-dbGetQuery(object@DB,isoformFPKMQuery) isoform.fpkm$sample_name<-factor(isoform.fpkm$sample_name,levels=myLevels) write("\tDifferential Expression Data",stderr()) isoform.diff<-dbGetQuery(object@DB,isoformDiffQuery) isoform.diff$sample_1<-factor(isoform.diff$sample_1,levels=myLevels) isoform.diff$sample_2<-factor(isoform.diff$sample_2,levels=myLevels) write("\tAnnotation Data",stderr()) isoform.annot<-dbGetQuery(object@DB,isoformAnnotationQuery) write("\tReplicate FPKMs",stderr()) isoform.repFpkm<-dbGetQuery(object@DB,isoformRepFPKMQuery) write("\tCounts",stderr()) isoform.count<-dbGetQuery(object@DB,isoformCountQuery) #CDS write("Getting CDS information:",stderr()) write("\tFPKM",stderr()) CDS.fpkm<-dbGetQuery(object@DB,CDSFPKMQuery) CDS.fpkm$sample_name<-factor(CDS.fpkm$sample_name,levels=myLevels) write("\tDifferential Expression Data",stderr()) CDS.diff<-dbGetQuery(object@DB,CDSDiffQuery) CDS.diff$sample_1<-factor(CDS.diff$sample_1,levels=myLevels) CDS.diff$sample_2<-factor(CDS.diff$sample_2,levels=myLevels) write("\tAnnotation Data",stderr()) CDS.annot<-dbGetQuery(object@DB,CDSAnnotationQuery) write("\tReplicate FPKMs",stderr()) CDS.repFpkm<-dbGetQuery(object@DB,CDSRepFPKMQuery) write("\tCounts",stderr()) CDS.count<-dbGetQuery(object@DB,CDSCountQuery) #TSS write("Getting TSS information:",stderr()) write("\tFPKM",stderr()) TSS.fpkm<-dbGetQuery(object@DB,TSSFPKMQuery) TSS.fpkm$sample_name<-factor(TSS.fpkm$sample_name,levels=myLevels) write("\tDifferential Expression Data",stderr()) TSS.diff<-dbGetQuery(object@DB,TSSDiffQuery) TSS.diff$sample_1<-factor(TSS.diff$sample_1,levels=myLevels) TSS.diff$sample_2<-factor(TSS.diff$sample_2,levels=myLevels) write("\tAnnotation Data",stderr()) TSS.annot<-dbGetQuery(object@DB,TSSAnnotationQuery) write("\tReplicate FPKMs",stderr()) TSS.repFpkm<-dbGetQuery(object@DB,TSSRepFPKMQuery) write("\tCounts",stderr()) TSS.count<-dbGetQuery(object@DB,TSSCountQuery) end<-dbSendQuery(object@DB,"END;") #Promoters write("Getting promoter information:", stderr()) write("\tdistData",stderr()) promoters.distData<-dbGetQuery(object@DB,promotersDistQuery) promoters.distData$sample_1<-factor(promoters.distData$sample_1,levels=myLevels) promoters.distData$sample_2<-factor(promoters.distData$sample_2,levels=myLevels) #Splicing write("Getting splicing information:", stderr()) write("\tdistData",stderr()) splicing.distData<-dbGetQuery(object@DB,splicingDistQuery) splicing.distData$sample_1<-factor(splicing.distData$sample_1,levels=myLevels) splicing.distData$sample_2<-factor(splicing.distData$sample_2,levels=myLevels) #relCDS write("Getting relCDS information:", stderr()) write("\tdistData",stderr()) CDS.distData<-dbGetQuery(object@DB,CDSDistQuery) CDS.distData$sample_1<-factor(CDS.distData$sample_1,levels=myLevels) CDS.distData$sample_2<-factor(CDS.distData$sample_2,levels=myLevels) res<-new("CuffGeneSet", #TODO: Fix ids so that it only displays those genes in CuffGeneSet ids=geneIdList, annotation=genes.annot, fpkm=genes.fpkm, diff=genes.diff, repFpkm=genes.repFpkm, count=genes.count, genome=.getGenome(object), isoforms=new("CuffFeatureSet", annotation=isoform.annot, fpkm=isoform.fpkm, diff=isoform.diff, repFpkm=isoform.repFpkm, count=isoform.count ), TSS=new("CuffFeatureSet", annotation=TSS.annot, fpkm=TSS.fpkm, diff=TSS.diff, repFpkm=TSS.repFpkm, count=TSS.count ), CDS=new("CuffFeatureSet", annotation=CDS.annot, fpkm=CDS.fpkm, diff=CDS.diff, repFpkm=CDS.repFpkm, count=CDS.count ), promoters=new("CuffFeatureSet", annotation=genes.annot, fpkm=genes.fpkm, diff=promoters.distData ), splicing=new("CuffFeatureSet", annotation=TSS.annot, fpkm=TSS.fpkm, diff=splicing.distData ), relCDS=new("CuffFeatureSet", annotation=genes.annot, fpkm=genes.fpkm, diff=CDS.distData ) ) res } setMethod("getGenes",signature(object="CuffSet"),.getGenes) .getGeneId<-function(object,idList){ #Query that takes list of any identifier and retrieves gene_id values from db (does not report missing finds) searchString<-"(" for(i in idList){ searchString<-paste(searchString,"'",i,"',",sep="") } searchString<-substr(searchString,1,nchar(searchString)-1) searchString<-paste(searchString,")",sep="") geneIdQuery<-paste("SELECT DISTINCT g.gene_id FROM genes g LEFT JOIN isoforms i on g.gene_id=i.gene_id LEFT JOIN TSS t on g.gene_id=t.gene_id LEFT JOIN CDS c ON g.gene_id=c.gene_id WHERE (g.gene_id IN ",searchString," OR g.gene_short_name IN ",searchString," OR i.isoform_id IN ",searchString," OR t.tss_group_id IN ",searchString," OR c.CDS_id IN ",searchString,")",sep="") #print(geneIdQuery) res<-dbGetQuery(object@DB,geneIdQuery) as.vector(res[,1]) } setMethod("getGeneId",signature(object="CuffSet"),.getGeneId) .findGene<-function(object,query){ #Utility to search for gene_id and gene_short_name given a single 'query' string (e.g. query='pink1' will return all genes with 'pink1' (case-insensitive) in the gene_short_name field. geneQuery<-paste("SELECT DISTINCT g.gene_id,g.gene_short_name FROM genes g LEFT JOIN isoforms i on g.gene_id=i.gene_id LEFT JOIN TSS t on g.gene_id=t.gene_id LEFT JOIN CDS c ON g.gene_id=c.gene_id WHERE (g.gene_id = '",query,"' OR g.gene_short_name = '",query,"' OR i.isoform_id = '",query,"' OR t.tss_group_id = '",query,"' OR c.CDS_id ='",query,"') OR g.gene_short_name LIKE '%",query,"%'",sep="") res<-dbGetQuery(object@DB,geneQuery) res } setMethod("findGene",signature(object="CuffSet"),.findGene) .getFeatures<-function(object,featureIdList,sampleIdList=NULL,level='isoforms'){ #Sample subsetting if(!is.null(sampleIdList)){ if(.checkSamples(object@DB,sampleIdList)){ myLevels<-sampleIdList }else{ stop("Sample does not exist!") } }else{ myLevels<-getLevels(object) } sampleString<-'(' for (i in myLevels){ sampleString<-paste(sampleString,"'",i,"',",sep="") } sampleString<-substr(sampleString,1,nchar(sampleString)-1) sampleString<-paste(sampleString,")",sep="") #ID Search String (SQL) idString<-'(' for (i in featureIdList){ idString<-paste(idString,"'",i,"',",sep="") } idString<-substr(idString,1,nchar(idString)-1) idString<-paste(idString,")",sep="") whereString<-paste(' WHERE (x.',slot(object,level)@idField,' IN ',idString,')',sep="") whereStringFPKM<-paste(' WHERE (x.',slot(object,level)@idField,' IN ',idString,')',sep="") whereStringDiff<-paste(' WHERE (x.',slot(object,level)@idField,' IN ',idString,')',sep="") if(!is.null(sampleIdList)){ whereString<-whereString whereStringFPKM<-paste(whereStringFPKM, ' AND y.sample_name IN ',sampleString,sep="") whereStringDiff<-paste(whereStringDiff,' AND (y.sample_1 IN ',sampleString,' AND y.sample_2 IN ',sampleString,')',sep="") } AnnotationQuery<-paste("SELECT x.* from ",slot(object,level)@tables$mainTable," x LEFT JOIN ",slot(object,level)@tables$featureTable," xf ON x.",slot(object,level)@idField,"=xf.",slot(object,level)@idField, whereString,sep="") FPKMQuery<-paste("SELECT y.* from ",slot(object,level)@tables$mainTable," x JOIN ",slot(object,level)@tables$dataTable," y ON x.",slot(object,level)@idField," = y.",slot(object,level)@idField,whereStringFPKM,sep="") DiffQuery<-paste("SELECT y.* from ",slot(object,level)@tables$mainTable," x JOIN ",slot(object,level)@tables$expDiffTable," y ON x.",slot(object,level)@idField," = y.",slot(object,level)@idField,whereStringDiff,sep="") repFPKMQuery<-paste("SELECT y.* from ",slot(object,level)@tables$mainTable," x JOIN ",slot(object,level)@tables$replicateTable," y ON x.",slot(object,level)@idField," = y.",slot(object,level)@idField,whereStringFPKM,sep="") countQuery<-paste("SELECT y.* from ",slot(object,level)@tables$mainTable," x JOIN ",slot(object,level)@tables$countTable," y ON x.",slot(object,level)@idField," = y.",slot(object,level)@idField,whereStringFPKM,sep="") #print(AnnotationQuery) #print(FPKMQuery) #print(DiffQuery) #print(repFPKMQuery) #print(countQuery) begin<-dbSendQuery(object@DB,"BEGIN;") res<-new("CuffFeatureSet", annotation=dbGetQuery(object@DB,AnnotationQuery), fpkm=dbGetQuery(object@DB,FPKMQuery), diff=dbGetQuery(object@DB,DiffQuery), repFpkm=dbGetQuery(object@DB,repFPKMQuery), count=dbGetQuery(object@DB,countQuery), genome=.getGenome(object) ) end<-dbSendQuery(object@DB,"END;") res } setMethod("getFeatures",signature(object="CuffSet"),.getFeatures) #getGeneIds from featureIds #SELECT DISTINCT g.gene_id from genes g LEFT JOIN isoforms i on g.gene_id=i.gene_id LEFT JOIN TSS t on g.gene_id=t.gene_id LEFT JOIN CDS c on g.gene_id=c.gene_id WHERE (g.gene_id IN ('$VAL') OR i.isoform_id IN ('$VAL') OR t.tss_group_id IN ('$VAL') OR c.CDS_id IN ('$VAL') OR g.gene_short_name IN ('$VAL')); #getSig() returns a list vectors of significant features by pairwise comparisons #Depricated in favor of .getSig2 #.getSig<-function(object,x,y,level="genes",testTable=FALSE){ # mySamp<-samples(slot(object,level)) # sigGenes<-list() # if(level %in% c('promoters','splicing','relCDS')){ # diffTable<-slot(object,level)@table # }else{ # diffTable<-slot(object,level)@tables$expDiffTable # } # # #Restrict samples to those provided as x and y # if(!missing(x) && !missing(y)){ # mySamp<-c(x,y) # if(!all(mySamp %in% samples(slot(object,level)))){ # stop("One or more values of 'x' or 'y' are not valid sample names!") # } # } # # for (ihat in c(1:(length(mySamp)-1))){ # for(jhat in c((ihat+1):length(mySamp))){ # i<-mySamp[ihat] # j<-mySamp[jhat] # testName<-paste(i,j,sep="vs") # queryString<-paste("('",i,"','",j,"')",sep="") # sql<-paste("SELECT ",slot(object,level)@idField," from ", diffTable," WHERE sample_1 IN ",queryString," AND sample_2 IN ",queryString, " AND significant='yes'",sep="") # sig<-dbGetQuery(object@DB,sql) # sigGenes[[testName]]<-sig[,1] # } # } # #TODO: Add conditional return for if x & y are not null, to just return that test... # if(testTable){ # tmp<-reshape2:::melt.list(sigGenes) # return(cast(tmp,value~...,length)) # }else{ # return(sigGenes) # } # #} #Depricated in favor of .getSig #.getSig2<-function(object,x,y,level="genes",testTable=FALSE,alpha=0.05){ # mySamp<-samples(slot(object,level)) # sigGenes<-list() # if(level %in% c('promoters','splicing','relCDS')){ # diffTable<-slot(object,level)@table # }else{ # diffTable<-slot(object,level)@tables$expDiffTable # } # # #Restrict samples to those provided as x and y # if(!missing(x) && !missing(y)){ # mySamp<-c(x,y) # if(!all(mySamp %in% samples(slot(object,level)))){ # stop("One or more values of 'x' or 'y' are not valid sample names!") # } # } # # for (ihat in c(1:(length(mySamp)-1))){ # for(jhat in c((ihat+1):length(mySamp))){ # i<-mySamp[ihat] # j<-mySamp[jhat] # testName<-paste(i,j,sep="vs") # queryString<-paste("('",i,"','",j,"')",sep="") # sql<-paste("SELECT ",slot(object,level)@idField,",p_value,q_value from ", diffTable," WHERE sample_1 IN ",queryString," AND sample_2 IN ",queryString, " AND STATUS='OK'",sep="") # sig<-dbGetQuery(object@DB,sql) # # #recalculate q-values for all tests in single pairwise comparison # if(!missing(x) && !(missing(y))) { # sig$q_value<-p.adjust(sig$p_value,method="BH") # } # #Filter on alpha # sig<-sig[sig$q_value<=alpha,] # sigGenes[[testName]]<-sig[,1] # } # } # # if(testTable){ # tmp<-reshape2:::melt.list(sigGenes) # return(cast(tmp,value~...,length)) # }else{ # return(sigGenes) # } # #} .getSig<-function(object,x,y,alpha=0.05,level='genes',method="BH",useCuffMTC=FALSE){ mySamp<-samples(slot(object,level)) if(level %in% c('promoters','splicing','relCDS')){ diffTable<-slot(object,level)@table }else{ diffTable<-slot(object,level)@tables$expDiffTable } #Restrict samples to those provided as x and y if(!missing(x) && !missing(y)){ mySamp<-c(x,y) if(!all(mySamp %in% samples(slot(object,level)))){ stop("One or more values of 'x' or 'y' are not valid sample names!") } } queryString<-paste("(",paste(mySamp,collapse="','",sep=""),")",sep="'") sql<-paste("SELECT ",slot(object,level)@idField,",p_value,q_value from ", diffTable," WHERE sample_1 IN ",queryString," AND sample_2 IN ",queryString, " AND STATUS='OK'",sep="") #print(sql) sig<-dbGetQuery(object@DB,sql) if(!missing(x) && !missing(y) && !useCuffMTC){ sig$q_value<-p.adjust(sig$p_value,method=method) #print(sig[order(sig$q_value,decreasing=T),]) } sig<-sig[sig$q_value<=alpha,] sigGenes<-unique(sig[[slot(object,level)@idField]]) sigGenes } setMethod("getSig",signature(object="CuffSet"),.getSig) .getSigTable<-function(object,alpha=0.05,level='genes'){ if(level %in% c('promoters','splicing','relCDS')){ diffTable<-slot(object,level)@table }else{ diffTable<-slot(object,level)@tables$expDiffTable } sql<-paste("SELECT ",slot(object,level)@idField,", sample_1, sample_2, p_value from ", diffTable," WHERE status='OK';") sig<-dbGetQuery(object@DB,sql) sig$q_value<-p.adjust(sig$p_value,method='BH') sig$testName<-paste(sig$sample_1,"vs",sig$sample_2,sep="") #filter on alpha and clean table sig$testResult<-0 sig$testResult[sig$q_value<=alpha]<-1 fieldsNeeded<-c(slot(object,level)@idField,'testName','testResult') sig<-sig[,fieldsNeeded] #recast sig.table<-acast(sig,as.formula(paste(slot(object,level)@idField,"~testName")),value='testResult') #remove genes that do not reject null in any test sig.table<-sig.table[rowSums(sig.table,na.rm=T)>0,] sig.table } setMethod("getSigTable",signature(object="CuffSet"),.getSigTable) #################### #QC Visualizations on entire dataset ##################### .sigMatrix<-function(object,alpha=0.05,level='genes',orderByDist=FALSE){ if(level %in% c('promoters','splicing','relCDS')){ diffTable<-slot(object,level)@table }else{ diffTable<-slot(object,level)@tables$expDiffTable } sql<-paste("SELECT ",slot(object,level)@idField,", sample_1, sample_2, p_value from ", diffTable," WHERE status='OK';") sig<-dbGetQuery(object@DB,sql) sig$q_value<-p.adjust(sig$p_value,method='BH') sig<-sig[sig$q_value<=alpha,] fieldsNeeded<-c('sample_1','sample_2') sig<-sig[,fieldsNeeded] if(orderByDist){ #This does not work yet... mySamples<-colnames(fpkmMatrix(slot(object,level))) sampleOrder<-mySamples[order.dendrogram(as.dendrogram(hclust(JSdist(makeprobs(log10(fpkmMatrix(slot(object,level))))))))] } else { sampleOrder<-rev(samples(object)$sample_name) } sig$sample_1<-factor(sig$sample_1,levels=sampleOrder) sig$sample_2<-factor(sig$sample_2,levels=sampleOrder) p<-ggplot(sig,aes(x=sample_1,y=sample_2)) p<- p + stat_sum(aes(fill=..n..),color="black",size=0.3, geom="tile") + scale_fill_continuous(low="white",high="green") + expand_limits(fill=0) p<- p + stat_sum(aes(label=..n..),geom="text",size=6,show_guide=FALSE) #p <- p + geom_tile(aes(fill=..n..)) p + theme_bw() + labs(title=paste("Significant ",slot(object,level)@tables$mainTable,"\n at alpha ",alpha,sep="")) +theme(axis.text.x=element_text(angle=-90, hjust=0)) + coord_equal(1) } setMethod("sigMatrix",signature(object="CuffSet"),.sigMatrix) #dispersionPlot on cuffSet objects actually draws from the varModel table and is the preferred way to visualize the dispersion and model fitting from cuffdiff 2.1 or greater .dispersionPlot<-function(object){ dat<-varModel(object) p<-ggplot(dat) p<-p + geom_point(aes(x=compatible_count_mean,y=compatible_count_var,color=condition),alpha=0.3,size=0.8) + geom_line(aes(x=compatible_count_mean,y=fitted_var),lwd=0.5,color="black") + facet_wrap('condition') +scale_y_log10() + scale_x_log10() + theme_bw() + guides(color=FALSE) p } setMethod("dispersionPlot",signature(object="CuffSet"),.dispersionPlot) #Find similar genes .findSimilar<-function(object,x,n,distThresh,returnGeneSet=TRUE,...){ #x can be either a gene_id, gene_short_name or a vector of FPKM values (fake gene expression profile) #TODO: make findSimilar work with all levels #TODO: Possibly add FPKM thresholding if(is.character(x)){ myGene<-getGene(object,x) sig<-makeprobsvec(fpkmMatrix(myGene,...)[1,]) }else if(is.vector(x)){ sig<-makeprobsvec(x) } allGenes<-fpkmMatrix(object@genes,...) allGenes<-t(makeprobs(t(allGenes))) compare<-function(q){ JSdistVec(sig,q) } myDist<-apply(allGenes,MARGIN=1,compare) if(!missing(distThresh)){ myDist<-myDist[myDist<=distThresh] } myDist<-sort(myDist) if(!missing(n)){ myDist<-myDist[1:n] } mySimilarIds<-names(myDist) if(returnGeneSet){ mySimilarGenes<-getGenes(object,mySimilarIds,...) return(mySimilarGenes) }else{ res<-as.data.frame(myDist) colnames(res)<-c("distance") return(res) } } setMethod("findSimilar",signature(object="CuffSet"),.findSimilar) ############ #SQL access ############ ################ #Misc Utilities ################ .getLevels<-function(object){ levelsQuery<-'SELECT s.sample_name FROM samples s ORDER BY s.sample_index ASC' levels<-dbGetQuery(object@DB,levelsQuery)$sample_name levels } setMethod("getLevels",signature(object="CuffSet"),.getLevels) .getRepLevels<-function(object){ levelsQuery<-'SELECT r.rep_name FROM replicates r LEFT JOIN samples s ON r.sample_name=s.sample_name ORDER BY s.sample_index ASC' levels<-dbGetQuery(object@DB,levelsQuery)$rep_name levels } setMethod("getRepLevels",signature(object="CuffSet"),.getRepLevels) .checkSamples<-function(dbConn,sampleIdList){ dbSamples<-dbReadTable(dbConn,"samples") if (all(sampleIdList %in% dbSamples$sample_name)){ return(TRUE) }else{ return(FALSE) } } ##################### #GenomicRanges ##################### #.makeGRanges<-function(dbConn,id,idField='transcript_id'){ # txQuery<-paste("SELECT * FROM features WHERE ",idField,"='",id,"'",sep="") # print(txQuery) # features<-dbGetQuery(dbConn,txQuery) # #res<-GRanges(seqnames=features$seqnames,ranges=IRanges(start=features$start,end=features$end,names=features$exon_number),strand=features$strand) # res<-GRanges(features[,-1]) # res #} .makeGRanges<-function(object,id,idField='transcript_id'){ txQuery<-paste("SELECT * from features WHERE ",idField,"='",id,"'",sep="") myFeat<-dbGetQuery(object@DB,txQuery) #res<-GRanges(myFeat[,-1]) res<-GRanges(seqnames=myFeat$seqnames,ranges=IRanges(start=myFeat$start,end=myFeat$end,names=myFeat$exon_number),strand=myFeat$strand) res } setMethod("makeGRanges",signature(object="CuffSet"),.makeGRanges) #.makeGRangesList<-function(object,id,idField="gene_id"){ # #use .makeGRanges for each sub-feature of id to create GRangesList #} # #setMethod("makeGRangesList",signature(object="CuffSet"),.makeGRangesList) ##################### #Add FeatureData # ##################### .addFeatures<-function(object,features,level="genes",...){ if(!is.data.frame(features)){ stop("features must be a data.frame") } colnames(features)[1]<-slot(object,level)@idField colnames(features)<-make.db.names(object@DB,colnames(features),unique=T) dbWriteTable(object@DB,slot(object,level)@tables$featureTable,features,row.names=F,overwrite=T) indexQuery<-paste("CREATE INDEX ",slot(object,level)@idField," ON ", slot(object,level)@tables$featureTable," (",slot(object,level)@idField,")",sep="") res<-dbGetQuery(object@DB,indexQuery) } setMethod("addFeatures",signature(object="CuffSet"),.addFeatures) #TODO: Add method to purge existing feature data table to allow 'refresh' of feature level data ############## #Reporting ############## #runReport<-function(){ # if(!file.exists(".output")){ # dir.create(".output") # } # file.copy(system.file("reports/runReport.Rnw", package="cummeRbund"),paste(".output/","runReport.Rnw",sep=""),overwrite=T) # myWD<-getwd() # setwd(".output") # Sweave("runReport.Rnw") # tools::texi2dvi("runReport.tex",pdf=TRUE) # setwd(myWD) #} ################### # Coersion methods ################### #As ExpressionSet cummeRbund/R/tools.R0000644000175200017520000001317214516004263015366 0ustar00biocbuildbiocbuild# TODO: Add comment # # Author: lgoff ############################################################################### JSdist<-function(mat,...){ res<-matrix(0,ncol=dim(mat)[2],nrow=dim(mat)[2]) # col_js <- matrix(0,ncol=dim(mat)[2],nrow=1) # for(i in 1:dim(mat)[2]){ # col_js[,i] <- shannon.entropy(mat[,i]) # } col_js<-apply(mat,MARGIN=2,shannon.entropy) #print(col_js) colnames(res)<-colnames(mat) rownames(res)<-colnames(mat) for(i in 1:dim(mat)[2]){ for(j in i:dim(mat)[2]){ a<-mat[,i] b<-mat[,j] JSdiv<-shannon.entropy((a+b)/2)-(col_js[i]+col_js[j])*0.5 res[i,j] = sqrt(JSdiv) res[j,i] = sqrt(JSdiv) } } res<-as.dist(res,...) attr(res,"method")<-"JSdist" res } JSdistVec<-function(p,q){ JSdiv<-shannon.entropy((p+q)/2)-(shannon.entropy(p)+shannon.entropy(q))*0.5 JSdist<-sqrt(JSdiv) JSdist } JSdivVec<-function(p,q){ JSdiv<-shannon.entropy((p+q)/2)-(shannon.entropy(p)+shannon.entropy(q))*0.5 #JSdist<-sqrt(JSdiv) JSdiv } JSdistFromP<-function(mat,q){ #row_js<-apply(mat,MARGIN=1,shannon.entropy) res<-apply(mat,MARGIN=1,function(p) { JSdistVec(p,q) } ) res } makeprobsvec<-function(p){ phat<-p/sum(p) phat[is.na(phat)] = 0 phat } shannon.entropy <- function(p) { if (min(p) < 0 || sum(p) <=0) return(Inf) p.norm<-p[p>0]/sum(p) -sum( log2(p.norm)*p.norm) } makeprobs<-function(a){ colSums<-apply(a,2,sum) b<-t(t(a)/colSums) b[is.na(b)] = 0 b } .plotmatrix <- function (data, hexbin=FALSE, mapping = aes()) #Modified from original ggplot2 plotmatrix { grid <- expand.grid(x = 1:ncol(data), y = 1:ncol(data)) grid <- subset(grid, x != y) all <- do.call("rbind", lapply(1:nrow(grid), function(i) { xcol <- grid[i, "x"] ycol <- grid[i, "y"] data.frame(xvar = names(data)[ycol], yvar = names(data)[xcol], x = data[, xcol], y = data[, ycol], data) })) all$xvar <- factor(all$xvar, levels = names(data)) all$yvar <- factor(all$yvar, levels = names(data)) densities <- do.call("rbind", lapply(1:ncol(data), function(i) { data.frame(xvar = names(data)[i], yvar = names(data)[i], x = data[, i]) })) mapping <- plyr::defaults(mapping, aes_string(x = "x", y = "y")) class(mapping) <- "uneval" p <-ggplot(all) + facet_grid(xvar ~ yvar)#, scales = "free") if(hexbin){ p<- p + geom_hex(mapping,size=1.5,na.rm = TRUE) }else{ p<- p + geom_point(mapping,alpha=0.2,size=0.8,na.rm=TRUE) } p<- p + stat_density(aes(x = x, y = ..scaled.. * diff(range(x)) + min(x)), data = densities, position = "identity", colour = "grey20", geom = "line") p } .hclustToJSON<-function(d,...){ require(rjson) d$call<-NULL res<-toJSON(d,...) res } .dfToJSONarray <- function(dtf){ clnms <- colnames(dtf) name.value <- function(i){ quote <- ''; if(class(dtf[, i])!='numeric'){ quote <- '"'; } paste('"', i, '" : ', quote, dtf[,i], quote, sep='') } objs <- apply(sapply(clnms, name.value), 1, function(x){paste(x, collapse=', ')}) objs <- paste('{', objs, '}') res <- paste('[', paste(objs, collapse=', '), ']') return(res) } .specificity<-function(mat,logMode=T,pseudocount=1,relative=FALSE,...){ if(logMode){ mat<-log10(mat+pseudocount) } mat<-t(makeprobs(t(mat))) d<-diag(ncol(mat)) res<-apply(d,MARGIN=1,function(q){ JSdistFromP(mat,q) }) colnames(res)<-paste(colnames(mat),"_spec",sep="") if(relative){ res<-res/max(res) } 1-res } #multiplot <- function(..., plotlist=NULL, cols) { # require(grid) # # # Make a list from the ... arguments and plotlist # plots <- c(list(...), plotlist) # # numPlots = length(plots) # # # Make the panel # plotCols = cols # Number of columns of plots # plotRows = ceiling(numPlots/plotCols) # Number of rows needed, calculated from # of cols # # # Set up the page # grid.newpage() # pushViewport(viewport(layout = grid.layout(plotRows, plotCols))) # vplayout <- function(x, y) # viewport(layout.pos.row = x, layout.pos.col = y) # # # Make each plot, in the correct location # for (i in 1:numPlots) { # curRow = ceiling(i/plotCols) # curCol = (i-1) %% plotCols + 1 # print(plots[[i]], vp = vplayout(curRow, curCol )) # } # #} #THIS IS NOT MINE....I MUST REMOVE IT PRIOR TO SUBMISSION (For detailed GO analysis, check out clusterProfiler and goProfiles) #ClusterProfiles <- function(geneClusters, onto="CC", level=3, orgPackage="org.Hs.eg.db") { # require(goProfiles) # require(plyr) # require(ggplot2) # clusterProfile <- llply(geneClusters, as.data.frame(basicProfile), onto=onto, level=level, orgPackage = orgPackage) # clusterProfile.df <- ldply(clusterProfile, rbind) # colnames(clusterProfile.df) <- c("Cluster", "Description", "GOID", "Frequency") # clusterProfile.df <- clusterProfile.df[clusterProfile.df$Frequency !=0,] # clusterProfile.df$Description <- as.character(clusterProfile.df$Description) ## un-factor # clusterProfile.df <- ddply(clusterProfile.df, .(Description), transform, Percent = Frequency/sum(Frequency), Total = sum(Frequency)) # # x <- mdply(clusterProfile.df[, c("Description", "Total")], paste, sep=" (") # y <- sapply(x[,3], paste, ")", sep="") # clusterProfile.df$Description <- y ### label GO Description with gene counts. # clusterProfile.df <- clusterProfile.df[, -6] ###drop the *Total* column## # mtitle <- paste(onto, "Ontology Distribution", sep = " ") # p <- ggplot(clusterProfile.df, aes(x = Cluster, y = Description, size = Percent)) # p <- p + geom_point(colour="steelblue") + opts(title = mtitle) + xlab("") + ylab("") # p <- p + opts(axis.text.x = theme_text(colour="black", size="11", vjust = 1)) # p <- p + opts(axis.text.y = theme_text(colour="black", size="11", hjust = 1)) # result <- list(data=clusterProfile.df, p=p) # return(result) #}cummeRbund/README0000644000175200017520000000175614516004263014567 0ustar00biocbuildbiocbuild######################################################################### ######################################################################### # # # cummeRbund: An R package for exploration, analysis, manipulation, # # and visualization of Cufflinks high-throughput RNA Sequencing data. # # # ######################################################################### ######################################################################### Authors: - Loyal A. Goff (1,2) - Cole Trapnell (2) Maintainer: - Loyal A. Goff Creative Contributions & Support: - John L. Rinn (2) - Manolis Kellis (1) - Ron Hart (3) - David Hendrickson (2) Affiliations: (1) Computer Science and Artificial Intelligence Laboratory, Massachusetts Institute of Technology, Cambridge, MA, USA (2) Stem Cells and Regenerative Medicine, Harvard University, Cambridge, MA, USA (3) Rutgers Stem Cell Research Center, Rutgers University, New Brunswick, NJ, USA cummeRbund/build/0000755000175200017520000000000014516027267015006 5ustar00biocbuildbiocbuildcummeRbund/build/vignette.rds0000644000175200017520000000045614516027267017352 0ustar00biocbuildbiocbuild‹Q]KÃ0M×nÚÂ@¾bÿÀö'Ûƒ ²9ð567–¤µi¬úä/_M»dm‡ ó!÷Ü“sî½yŠBøøæêOÌ62ëb£Ðœ7‰VÏZ’)¼c‘q˜–i¾¥<-g+YZÚe‡&°Ô˜7ɾÖÕºy·ÜØI9™Û6µQÇKÍœRRFèï%ÕɾÖõŸíYÒ䇿j¸ÑÙë¡ÎÙŇV"j%,2~cÊ(±O\°T:š‚W 2aòÅ"a¢)åLn•Îk€0ê:æàß/×ÿ2 ê–<‹% Ž*Œƒ#<²âøó…½zn¦gsÈ@’ƒÑ|˜¹›¸oææœÙ¸ì—ÙªªÚW”p¬\EŒ.ðŒææ½‰vß=TzuñcummeRbund/data/0000755000175200017520000000000014516004263014607 5ustar00biocbuildbiocbuildcummeRbund/data/sampleData.RData0000644000175200017520000013072414516004263017606 0ustar00biocbuildbiocbuild‹ì=<•ï÷!i(¤¢A©{¯{/*ž#DKV¤%Y)!+mí¥ÒÔŽ•ö.å¶÷Þ[{ Måÿ¾ïó¾/w…¾úæûÿÝÛGç™çÙã=ç<ç¸Ù÷âWéU…Ãá¨rTk¨pTÕg%Uâ?N%ŽÕ]:;wåqTÔêJE¨ûÿë ÑîÕ­‡—ËåYð¥W ðŠŽˆäpÔt -:kU:¾’ß ^…ps8ÕÈz© «çUÐÓôö½ úñRTõU Ú"¨§úU@åqqQ¾ëi*èyu”ÕSý\AäÛ§Õ‰¼:!*P×]ÚÏä#ºê1ñgH¸ˆ¿½ÄßZâ/Žø{GTMHÀÛRþâý§ÒêßpH–©áæT}Rs, 6,´B¸9œêd½Æ}!þçh®þS™[qôÄ)íŸôܲþ7tŸ \\àа2 uh¨GÃ:4l@CC KÊ/Õ6‰-ëÿ]d[鼂y$ëX%Ú¨ú@ÿ¡mø*$ô·Cþ·ÚWÉÅ\$øÃnóR¹%ëUÝ;¹.¸\%÷?Ê+‡P©³ÛÃÝÏöê¿å–Á'u õJ^©FÔ¢+G Ãát¢È(߈(Ú£êÏ„öÄàŒŠðe£4"â#ü˜™5"<€EæÁzÂùF2ž*~!¾‘‘>ă Ñ&OuŸÐè¡"è Í €ÐŸ`¦-ÊKV–ÉàK\‡£|"™‡uf«egï^”¹JpdX`XÄТªD'ùE„E‡“a’]¥6¼ Ó]äù¯Ç¡~U¥û”jGò_Åß7Ê·M`YSç§ô5ž®I¤œï*¾¡¡aQ¾QÁ䇺äפq«–iªKæ)ÝǤVu¶-æ’ŒS|ø0)äOYÉ4’W–â1¿Þ\%ÓÖ&?5Úñ¹VB++…á°°ärÍKˆ¥‡“œDõFrð•IUεïwz˜9…įüuxi{õµ•œºôôUÐVrVbjUSኑZ’ ¬9(,"ªø•\eŠõb+¹(zH˜_4³1i„„±;Pe¿°˜€ß ùU+m *]ª‚©^S/,šQÄ*¦ ®Áôféö„JáC†Ò+^ƒÎ©Q!BŽZ5ºNjÅZYÌ-Ñ¢¯bB˜ýPÙ”ƒ]Ü™†rp·cVP§àa‰‘ŠŠTÐk¾~Qa¸Ç¨Ù«É]wš?ˆ ÛðýeÈL˜¤‚á †}…¯¹UÅšSôÃù6lÈ?:§¯ ÄÚè/Dc ~Áد÷š^e·è| þ—©x™|sïØÂ×BøŠ%Äo)Äà™:Ñ6¹ô³Œx»o,›/1Æ»éöJ¹ÈýÕÆ5·µs­×<§–rJéŒù êÞ%Ù¹²ÅŠkÑèõ):Œ×‘µì¼D§jhXñ@ÉÝB[ánQ™Þ-xR~æJ£Aoônã]”˜ö2iuB‚ø>a!þ>~ƒ|CÙƒX+ŠÅ¯”÷ÅÿÇ4¿j… È|å|U’í8lWÊé_¡wÕ™TœR“êjÈ .™6gg/6§Ã‘¤IK ØøŠA—“·Ri”´»?C»Óaz]R„·\©vòðÿ.%¯´o¿-¨Ô;T:ET=6Ÿ*"ª“M'E¥ûU¯xŸ—'õNr¥üGèvå9é”´º2O$ÉIÌN^†Ö¦˜†‡šœ"“OMN OQ>†&§ˆ†ÇäSD“SDÃcò!íªc‡µ8¬‹2æ§WÑx]ˆFèÕ ¸r-2Üѧ]SäzÃç˜O{ÖÉ5ï˜y,\$5&ŠIq%:åÓê$Wøÿ2•®ôï×þÉÖRªíç?GSÊе¿Ô²ß ÀI•S: ÙoPà$Ë)%…ì7(p’å”’Bö¸ÿeŠZ‰w¸ÿEZZ9Üÿú™:™"º“OL]óOég èdŠèjœòÿ`Ñ,ídÿ¤œi…G„ #Öd¤ýL…Z©ŽäHµ‹#…¬rws»’'Ëm‹L ™¦h ˆæ)Ù­2VU÷—]_®UÓ®¸U«Zq«V­âVíßY•#Éó–Ô‚ôÛëñ_ìåúS®¿ÿ_ëO#" Dš›TQ{D¹ú”«ïÿÅêc9¶šR9ä°IòPqv¢¬Ÿ¾Ìç(2¿æªÄáö‘.* ø„ÌÇÄ_gÆÑ$³ÒPÈ0âÔäuré‚0#¢8âßà¶©Aʹû$¹ F­Ò0~ж¾WM ¶oÇÔª8’d Å=SƒÅƒ(êÄŒ`;Ý¢›—Œ©sÙø`R3á3ÂÔÊ2è2Œ°rô“Ûõos¸JœôT’æUÑS’g¦(3eiÈÄg–“áI2FÁ\7ÌQ˜½—dt´‚}ÎR–ûãdh°œ‰‰u0geÊóm†Ç—­‡IÝ»_}¿¡vÇ{QgÊ–å}‹-`"NÃCÌQsv ‘a#ŒôÁå¦U®KIb¬iБäP0ù~“sPžQ†ú_òÉõß"ÿ—‰¾*Cþÿ''£$‚RSñÕ`Ï LýNðÂl)Ij½šmû†o¨É.^kJM^Iª¼Ú¡(ŽÊÃOzÓµ-,ìþ _WNÑç·Ðû@å?4³ã$©ìe»ð(¸úþBz™6ðêÒ©* âY)øŠ©L~Å8íûmB5Ü$÷€(9 7Õ‚ý¥ä*f~-›2ó‰+²jÚÚ°Èk)áåq…^ž¤×œ/áò$½–^ n1//ôŠø’^sI¯PÂkeQÜknn%áXJx…’±’˜ÍE’±’•ðxMMpjÊ‘øeÎh3æ#¬˜> ž…•¼P¹z.øžÜP¾ÜPs¹¡y¡V–rCåÕÌœ/¯æ" 9¡¾¼Ò|¡ÜP‘ÜPùxåÕW ‹ÁBN¨¹¥…œ>#Båô*§D¨œV¡òK“Ó "TN+Ì­äÍs+yó•3D¨¼¶YYÊk›•¥œú ¸VrZ,àYÊ©¯€Ï“‡Ï“Ób"T.¡œšÓAN‹‰—W3¾¥œ± BåÖÌR^ÍäÎ("TÎXæòj&0g¨:Ì*×.¶w–&Ȳü‚ˆý¸4A<Ù sÙ›„÷gƒ,e‚,¸RAä1P‚DÒC@å$=ä &Dœb2Aé.,mP—l½Ìeæ*yþý^qRþ~äò’Ôέtý—\’#YÉÁÝÅYŽ[ÍÅѾ´ÎJÝ;9óå¸5]Ül»;tb擺C''{&NÝÅÖ¾3OÒ#û8HâÄl» Ì;2¾žø]øÄ'¿|M;^XD q¾•*Xý›ßÖB:±»‹­‡-{›ûµ·’»½Û\[wžÛ®n¶æ>~)|š»ñùn¶¼²y%'Žº‡»»•yqOñç¤<öL/£OÈUì“x°Êc·gêUœ9WÂÇ+µOá0Se˜[Jz­þ”—½Ñ^Ë_z­¤ceëÎç …Å½<ž¹„—½ò—ÆË^h¯$f IÌ약^¾PÊ+,Á+9 ÿƒVJG©-l4Ãwè)3¾CGJ‡DøÉ„øK„ð¸a¾CÚð¤BB$Bˆ\Q¡mÌ‹‡XÅ„KcŽ,kø iC¾ƒ¤Ëò “ — &‰Ù*&| TY}‡K‡ø–®¡Œá_‹M¾þa2!á2!ÃdB"dB"%C¬bBü¤û'8F&Dº¾Á±2!2ã>ØOzt††I犕é2£<"TznøI×y o€ô˜ô•N3Pº]—É+Ý?áÁÒã$'Xf&D ”ÉEÎ1É£GÉ"ˆ–Ä? 3‘Ï+zÛü«8,ÃÀã „V\KTÕÊçrÿ­X>WÀå›[˜ s¡¯L±–BžP 4#">_ªEB â›ÈŠkF8„"KöȤc-„æ<ŸˆµZð…\^ňµ˜ øæVf¹,¡òÎe •ß;e •ÏÈ.K¨<¦wYB0È˪€™^–PùŒ÷²„ÊgÒ—%T>C¿,¡òƸ ¡ Ê*_¨ ,¡ŠÊ*_X¡,¡òkV†PùBe •/0Q–PÂe •/ˆQ–PùBe •;BeU$ R–P¹‚#e U dR–P9ûÎ/Bñ»RÍ‚µuJ·ÒýÇSMEg¡å³ï‰AÐ×ï½­a_htJE'Ù"CÿÀo#ÖìÑ|ùð¥C\¶ÃÙžU)A÷#)5l°àÙÛâÊ¿¥0–‡ahNj0Ò·ÉCöÇm ºó<—b*'*ãCm/A›{»WÂ:kJP¦í‚üjâ|~ °J¤ÙX¥«h·v¥ËCï5œ/.m ɦ¸ü1iípi”*#6ÝÝ•›o$ ¿Æ3´T²áWÝž|Úîè7î~èK^¤¢vÙ܉6úðZd„tVÃä˜g¡á͵œï©PfD‹Ë-“3A5åîÚ‚µ­dúƒ_‰Ö+e*Êö9àÇŒ{èË¥Ö_û9'€}§¬Œí}¼P!ÝÏí߸ֽ¨émù£vü<1¸?:;“}:]Øò‚÷%ÚïÆP¤ÛÜàÈ¡u >a\rÒ¥:l9ú©ãÎÍkg K²°*È X%ÓÈF¯c¯ÿÈ·lnO¾ïhèxt¾÷ÎË`VmRw•öгQü¶ÀH=|`ñyÝßo´zy,ÃÛ};ŒÛ¥ÝyeÓÚ’^ÀíÇ=`Ú“À6z2øŠÌª{Vª nÁ÷8$Ÿû/¼æ¯co€½ÍÁŧžLé÷´çäk<°:ûòFॎP?wœÑùYOa-Âõ–¥ãñ¾?Ú Ъª¦„&Îêñº6wz•Òð%z)ä¿Üy;Ý̺ëö9ŸÅo÷³Íöãü³Ð½ÙÔù?«ùaj¯èÄÄ“gÆÄçI×Gf^åÕúôʤó:Eñ°« ”Òij˜‡ž,r”~ð!‰ç±«°¦÷ñDh3þкšË3×?ášD8:Xæ@Ê^ÜÞÉ-ºžLÉ…h7ò}‰_±ƒèQ™r«ŒËŸ¸®ýlP Àª±DÕ©õÁ–÷Ù>gÚþá“¡Þ‚½­]W#ÞŸ–΃¡¶%?&êŠ_I톪I“·OvÚ(' ïY«ÄsRR]hÕ_Ü>ýÎ; ›ÐéDCR¡}}bµ¶Í‚ë¾ÔÛ8äˆ×ñòkŒ1ùå¯éŽU¢M 5…EÂ_²*AÒ[<:× ã º>yéƒÇ~½Ûõ±JÕx3<§O«LÌȲáX_t:6Lå…Çõ*¥) BæâýÁ£[w•vóրϼ¾#m°J¼þM‰n }sñ¸ùO­·êpÌ™~’Gdëz º Þt‰×ï.×Í2«Õ[7|£TÄ%wÃZA§Å‘Ó´-DÄãþI„|õBä¶Ð TÇ÷ÖÜé–ŠòïåM-ØoÌâ¨Ï±^ks7“‚0~ÙÙŠÚ¶º)g6??tmê³ ãíž@{ËèyÜ/ZÊpNÇqI¶øïÖ¡xŸ°ªr½u‡•ïÀZ#WcÖ¾ƒ°£Ã 꼞€û+î4±KŽý‰[¨·?2øâ ñ› á·aƒ7Û·Ÿ¤&±êASŽ6[-f8' Êòšašp¡#4I}íÛXi|2ø> ·C9QÔþÁ¦«?ÅsÓC”.úþ$·wvÁÞKqnÆ*ÿ¦g«Üau‰õ¢Ní§%¦KX…Nî@Ü::CTêá ïm*a´C!žù1žØ‘Ø¢ÿmr;êTR¾¿õ›é·MOjQêô.Ý{6tªÄt3â7mcn’ס4+ù¬x¢Ì¾ö§~Ðî¤åï.ù%§Tn*^ ™ÓÚ„qx÷öwÉ Lk‡÷¯ämÂúN‰øøª¾£ëßuýÝú(Ä›:ïo b±väx+jßV”½o7­ùÆÙ» éí±£5/‡*>X%çÂWx]ÏÁ_¶¤Î›Z?ôqïë_#ÙúªvøÑ5wIŸ€R‡SÄáú÷Ui*]J—Ò¥týÿpÉWjS*áå«×fê?Òk£xøU¨Ràü)˜P¥Àªx C•\¥ÀC±P¥ÀW)ðPªx C•Ü$ð ÀdšÒ­tÿqE¢Sé2‹k­Uº•nÚýÇËʬ5œ{x8¸{È„—%Eɹ~åûwðT´ÚþW|~¦T„ñÿ[®¿Ù‚ÿs¾"Ìž²®Œÿ¶ƒE'QM2"œŒ¨&NZT“…´'GÁÕd #ÂɈj2ádD5ȈpÒ¢š,¤E8QM²åÒ¢š,dD8iQM²"œ´¨&N…í¢E5Y‘MZ„S&-ÂÉŠjÒá¤E5Y‘MZ„“Õd #ÂɈj2ádD5iȖψj2ádD5H‹pÊÔŸádE5Ȉp2¢š dD8YQMÒ"œ û“Õd #ÂɈj2á¤E5YH‹pJãeD8QMÒ"œŠêÈj–$²ÉÖŸÕ,‚X„“Õd ›žÕd #ÂɈj2áTX.-ªÉBF„“ÕdE6iN™ü¥á”óÃû½_0"à¬(8½_ȔLj|3"à4TØ>f¿`DÀÈìŒ8™ý‚g #ò͈€ÓPa¹Ì~Áˆ€ÓÙ/¤Ó—´_Ȥ§÷ Fœì~A‹€³¢àô~!SOFä›gEÁ™ý‚g!½_0"à4dñÑ"à,dö FœŒÈ7#Î@f¿`DÀÈìŒ8™ý‚g #ò͈€Ó°¨ÝXœ…Ì~Áˆ€3Ù/p2"ߌ8 ™ý‚§!+ò͈€ÓOZ¼´¢à2ãȈ|3"à4T˜žÙ/p2"ߌ8 Ù|´8 ™ý‚§aIû#ÎÀÛG‹€ǢߟbÆ‘®Xï­f—á Åõ¦a‘âê~+úw±äæx°… zð=)« U6\ÝoÖH”s¸Ñ.C³ ËU›Ö$Ä×ÍÔ×<ž²XX]~X-0÷ÒãŒ|§Ã»w\¿žq:àpÒÆ]чUI™gtÿÉš‹ë$ʃY#.¯A¢›uª²}àS"wèCðQÒì6š™¦žöÊô³tý˜rQ¦~?ϔ͠~w21qƒÊ 3#çýÉYk›NO¥Ì/cæ˜áÆFçö¢‚8›7†K7¢‚½¢ (œŸ{·ÍN]{©WÆîþ Þž©é™qrªÇÇá}Æ£Üþ¦Çšš‚Ñ mÛóVÛ¤ÿÊúZŠê)®Rg„õq~bõÇwGi[ÕE™wÛÛÆ†‹U¦S*]¾LþÖ+(‘ð’Ú'CïŸoü~5ò&pújÅíè¨ ê±'ì†ÌY&®–TË{å­S2ëÌp¤NfS½âúéº?ªiŒ«ímr£Ãƒ[ ûõ[vl4÷EƯú•ÙÏÊØ“¸öüµ gЖ]Ë=ú¼@v‹šÝzYÇ?c¨£sCûþã2òW¾µP,Ö™HÙ×Xýü¡þÙ¡ÏŒm¦Ölq²«‘žŠÍñ _¿ÜÁN¾Q4>ù½6oZÕs™Ø 32©rÐA\¿—ïúj~è^VYï®O’·>XoIœJ;oP¿]ëºëmGÍ6Þuκ®MAN‹qéƒeæïûgV7ž­Íx5êrïO'—Éî[»4§ûZóÑe«èù)5AϨó¨(½u(µAÔÆó§Žgˆgn[}v鱌½îì~ÝgDÆÉ6æ9ïªe\ç´Û7pǘŒKKT—>û(`Û1§eð¦…öILù»­¾ç{PC\Ý}Ä·ÄÇæâwÉ-2Î6îx00¢ ãQášý[ªdÜŸÜouÄ”¶ÒõÏÈÍ9µf±aÌ˽,oñÚ=ãÅþ w½ÇtÉÈý°nmð-Aƹ&z݈#$CÜÒZø6ªJ{r*óú‘ÙO;Z8.x£™ñ~›ðk›SYç÷g}²T83®™Ï1¹EƒŒÇ³êRӌܥ3NAWÄC¨sJ¬Õ·Ñˆ ³o2>nH%6°=âæÖ[g}^'VíukE•  «}øì¦ýdðÞq{i–Üô;:·jj®Ñë7èÚQ§>ü„.8èŸl÷DQ}ʺ u‚êߦ4ë¤yˆö}Ý.®ù!aÓ.g…óóÈ;nîÀëÚhŸ ;_ÿ]´Ïñ «fQoĵ-É㬚XïµÕ›ÞUÕ=2í¾ÝïÀ”xfHN¿þÝVÚØWEß^Vo]kó„’ö4ÂðÄé®;w–Ô>Eû:êxßbÍ=´öíÑ>ÞGß 1ç÷¶ìrþ6jõêTßky5ÑÎ ê-û½«o]ýIË£q ¿wØÆQy°âÔ5ëy•Å©Ý4›£øzŸšÍÜxåÒý( ÷®iìáÝpºk?ídÕŒVè]ÆëowÔDÙøA9©óyÉ(çÕꬖ;RÐÉ}.?n3 ©5õ¥ëT¤W· ÀpÁ”™m, õFoç»·e=å|h’ve2:§“þýíJ2åžr9Û ÇXÇÆJ»“EÁ–9ÖÉÇùè®\‚žOJz¦³‡‡.ŒUõïOÜßÖÔᤜHsD—]¨{:9aÁRO¯ïè†×…Na.õ¶+'¯Ù³î1(çç[³*ÆPNá•û·4ª¢´žÑcz¯ÜÎÜo~ÿé2tùA#÷Ô†GÐý¡7Wp[Ô@·‡äÙgÞMFë¦ÛïÍÈw¶)lš®õ(p z½xá¬eýÙ$éy¹óÊ>ïüefb,ÊÚùfgP2z{4OýÓ ôïèEþ¨…^Ý+Ø­‰îå_2^øx,ÊYžpüá‘£èQø²ÈÙCk£ ÍG™Ümõq_½`0ªù1ãBë€)è͵·ç|l‰žf˜O­­å…žœºr°³:ôfzŒð¥:3¤_§Ö‚öèj¼èîÔ¤Hôïcèá\ÍoIö[ÑÕ©ÕÖÝÍÞ$}Ê?ƒ²Î46;ºí ÊžVù¼W_ôxbŸµ²BБèãÝgèÖÊæÛ—=:4Ø» _E¦54¹žlÌiÙlºfâ™’8EN«ÝðêõÍ€~ מkv {¨õ¸áœËÇ;òÑ"ïe£O§Ž²7®ka“·]œÙ7#o¸ª·mrhð`ô¢Åª¬%ï· 7Óœ'Ö»ª‹^‰<õµBo„™Ÿ €­Ï£sÛõ˜Ú‚…÷wXñ~_Æ~++dðY^;µ¦Pào“”ÚLµÝû2×gWÑþ]ZGÙ¬w^|¯ R›‹^CTVõaó½¬ó:|Ø#–WýË9Rœ|Öxªb3ª¥‹—›ôßpýÉ:T„ö•{KJüoŽTEr•aýµ±¨¨ãøÿaŽÈ·;-ûí¿izºLܤMO«T§S˜RÜ*À3¹ŠñЮ"<Õ«ý*ÀsÁ ñàðï?Y¬+À³ÉŠñð²"<ݬ?+ÂóÑ ðµ"Ãí·6kPšî£;…ŸmòF84ÌðÓqI˜{€² szPŠŽ`›e2¥ÐtÓ¢¤­s8Õ+Ž=êØˆÔÄ >}(ñÐÒyJpÜMRß®=Ló;™’³bŒ ¹Ljp…ÉÍ«ÆåÙþÍïéz3>¸m‰íŽÃ0<Ãy´?a4†ÛÒi¨'™ö‚æbS¢£ªƒÁOßK?·EËà7ëÓ6ËóÆeÖßH£÷e÷ô’êUÚ´\{Ywƒ)—ñ#åÚŒ“‡¿ÍÕ±õ㯜•›™Ì_»¤÷ÖØBä·ÓáQ<*,Ìœ‘³c‹/W*½ M9rì¼®LC/öcÈàÑ¡¡á̇èà­ LÕTz¸¯N»ÚtìígÈ–ëºÃ4æFåM-Øo ÆÎ/x_’ÀyÂCΕ½àòíÑZôü 8…æjÌÚw¼Ró‚Ío”fêÐýå™ö·ÝsãÒÆ «XôS¬ð6&+ž†mÊ/ ÄŠw×UÅë.Õl%5?M¶àzØšz“á·©»¸[uv°a>øÞïL.ðýL­#™ò;›‹ë‰ž¼4ÜÍcÀÆÒ‡÷×"Mׇ©·øí»oöPkTðâ.ÕmÁ~ÓjRXÑxè~¬ÝÏjÑwh*…×àÄ—n›½ÒÁ W¥ÇÌ^³–Ïì‡Æ V’Ö™päòÃiá2Í^%Õ_ú‡¦ß¨ö4Ûu‚Lxç“C–¾~üÍùÚÓ‰ûšßê¯ÑŽÃÜ;Ì =qÓr 4ðüü”˜Jàq/Ñ8Ê}ôh%Y#5(€>j­s(°ÔñšpmRÌGhºÈøAÛzI½‡Ø`@èüY=µ÷—içlóôÁc¿ÞƒÙcH=ûá´+Págšãþ¾ðl'µOÞ~>å·î=Ì%.>MÀ¡™ÞÓôk}`ÂU,œ¾}a^\¿„|?ÚôΈ˜þÃ`g“ŠÙuíq»4{?LMôëu¬ûlj2¾· þ6k›üWÖßp·úåo½>—u\Ößd_Žàfò@Æ• ¼g÷/›/Lõ×ë¬0ݬYOÒøF¨·å½ù4V£o;ÝRí⦱ørw:µz•nÀ¦§gƒ©=¥ñ1éA³±Cæ®ÇÀó¸ y€~ÚÄ-zì7PÒW­ÐÕ:5býnmhâбA¥Ž“A»íè…àð™hŽïsèKåcËíY}â3¢'Áú`»ÖëF‚Q¾K'=ÀÙœ´'` ®-(Åâ`ï‡ãû§HÌhúñc¦EUÙsß4ÆíPQMÖs›Ò 1Èíó6H°(Ïûä9x_L;Ní‹`zqmê³ÓÝ›™6 ¼3p:÷!Ôú€~ñ})`u_—)ßéƒÝϾs¯:óŠl0®$®¡‹Á÷‘jUâÆ­ÈÛJÛúPób¯5míç‚}tnX°}tÛéBtØNðöÄ4¢(Ã9,ÞæºÝ×nÔº ¼Y§À,òÎL&r‚¨+¾G´¿…דÃÑcg²Ï}Ô¯§ÀûK@0YíZÞ¯·ÐfÄnÓýš¢yÄ–ëÝ÷[—T|Ÿ¨ýt㈃›@}ÓœŸ$‚Ë{Ó+à˜Ž 9ô¿† #ø%â~ëCi–‡.}soÛ_Öƒ„k¨õ7{<6h4'ß7ÞÃçÃÛ.FVâ,pš‹÷“¤ÇÏŠذË`]|oOáQTo”kBݳ˜ùɶÇÍž¼Ö÷7¼¯û™aC#þÑÄõêúOèù²9Pà©Öƒ´ÌSRÿ Ü›{ÈP&ügÊeRIùËúƒ)Mð~wÏëÄä|jŸ]²÷öø;o{ð+2Bz½—ˆ¿ÉaROvèó~<<”P„'©{<ðZSç0´èû´@\b—íz ‚í‰ÏêãËay]ŽJ‡™KsÈ‹≯BNw!¬|IŸ5¯üÊà [þ¬4âó öTðœw½u‡•ï ÅÆ»ûó½wÎñv)ËÜN8¥8çî%­k¾ˆÍ§+þ4¸gåpлº¬eZG¡‰¹LXP§’Oï;ƒƒîWó~Æ+–Ïì‡Æ®½€ GÆÞ£–{—¶Ù|3>ÅèN˜\&¼Kݳ†?D3¶Ûzj¯sfƒý~±ØÍaîVÉåm-ÛQ סë<õt•5¡`¿d¾væCvÝ¢Ã5£6_ÂûlÛSô÷Ž6^OþB¹ë–\ÁçÿR<ĵúSß]âUqTüépLÿ¸Þ{@YÛLåïc׫›.±‹VÝ ±™˜ž0>߇†÷§è0Õ‹ÚŸØ|­ÆQ†- ÎØC u^²÷<¨ýr_Âuû¡a;?DŸŸÁªÕô¼?3‡¢o¬³Âí]=ŸóIØðБSñÔºòï¿ÁMq»c*cOqNØ0WT-|.Lš^ü~ *¸ßKlïĶx_¥‹÷¿iL_™¢F^ûzÃúëxŸÛêHÕ—ÍgûŒ¼x Ÿ4>-è:ê"—FÍd ¿´ãQß­¬_wµCþæE)Òé~÷ÂT=?2æízœ5,g“'Êz:¸£Âü5›r ¾T;†\=–=Mºxå_{rÓhÖZ_Á¬-䛾ñYüò4éÛÜsÓCÆÇ¤ÝãFŸÆ9ƒ³ÞWÜùÔyBàÇûD ÃuÍ.,³©xÞÛ¾8üh-"î•_¥4|± øÔ´³`Ëum·¢3tŒépÜý÷È`°Ë×2þe%蔆ÏKظFݽyð®!Aÿ®9eXB¦ýÍVSûëŸ8 Ó3&¼Âçî´Føœ™õï›Ë÷às-eÒ}jÞŠÞäèfOo®•¦xwÉ{7aƒi½úQ†:Àw¤„!&¶<}éÕÒ¡*e0ŽÁœúYbºÅD+’à†Q–Z ½6žŸ?x6{FxìÅ÷‡à=’ó“ÿ¨Ó«”F`îCNPh»Ÿ÷üv$ùÃDG)Ã<à¶Óc»,Æë²¯¾/õíNŸÛÓ±!«Akß‘˜¢yÄ–ë1¯'‡sø^d4×Í4 ¹C +â–Y£%8Ü* -XòIXtpñið6Çt¥•ð}%¸-î_Ïé3ˆ¤7LéŠñM2¡öC˜~Ç܇8Ü-8-jçBOÎô¤n°È¯ãùöøû!ÀÓg£wQ÷?EõFÏûíŸT/̓™Ÿl{|Úãý§ÿâ¸\¶¼½1Ý·O•UdGëKrù5ן=¬¤þAo§©7X!óÝUŸjGð»—”¿¬?˜÷ß×âw`:Þk|Mø‰ûyÓ·nÔ>›‹ CJ­÷ñ·ñÄt´¦d[µi ­OãyÔ|çìÄÍŒêÆ_v\ ¦vÓlíÑKðü’éVlð½rü~|ß\b‡ýë›ýêžÈ–?­#>Ü¢ÄÅÐ íñwHƒÛNÏp|‡òLk¾qö.ôÉ|»fÔ ö{ tšSšõ¡É-ƒ›{ú€Ùz þÔȨëbÞ¨èxÔ\ç"c@®¨ýô~Xï^ßÑ·³5Ë”Ý/Í »”¶Ù|‰UOô/”ás [á®9Â]ÏÑä«b=Ý>B“ñ”á sïhÖi)qñZzaoœ ,æbz)o9EoeñÜãÖ[gC“–”0TzÓ%^‚Ôˆk{ÎJðåËß§¬ÇûÁ‚;ø¼=0^L…< ?¶ß;.{%aYÛ ž«MÈQpÖ"—±/D{b:ÌØzxžDާ ]ÁÄQû8§Ûoÿ•P+[4§r'C6¼f§ÏFÌMý7[L"]‰w1ÿ$® õ!3ò0}uª?>ç×<Æå¬ïÓ¹ר,1¸tÅûUß,¼? Àó­w-|/¼Ÿº·°åª8jÇ/(±½±õ«“7o¦ŠñŒkN~†ƒÑxß_~×gÍ>ßâû hyÌ!.R_Ð+ýùÏ¿+@_ ÎÏz’&ƒ¿ÍpÉóO³—÷é3üêÒé~÷­øµÈZÆ ÅÕë¾üŽñÛ¼ì:¡ùþtņKµ z¶+uqºj]¥ß>ôné„a1l¼*E†Wgý/OwíwÞZ- Éø6¡0<ûv[Ë”o9÷g[3|¾÷¾ˆï==ÍHrE ´ÑÁû°nÌ9w-3àí¥è `y·qp/. ž¦_ë=Œ£èÕExãÈŸ“×™n Ü~…¨˜,²“°~Ôs™µæipj†ù-¶v˜á¶ÍždÜÛuü}áÛ™¦‹W+½£[ôPâ ÷.ØÐ÷Äz¾èòå xhÜcÉpaÃ…;pÿ¹VÍŒþô£)ôLÃý:îæë†„áûê*ÌЄåõñý*i&Þ÷Ö?Àß'G’Ý6ºÍQÛº÷µÌ1Âý5ã)¾'ô«CZôÜCWQtEõF/²®Îåei£<#¿^EíqµÂt(W-Ê‚"t›éKÎ1˜þfwü´{½¼ø”Ô?èæà‘§¶[#Óo•t)a%å/ë–…á~[pß?óð}m©þÎÛ±ú®Úu‰šw(Wý—†…eð›ö”û@‹LÌÏ3ÿˆ×AÛXÌÏ3ñÆß¼Ð–ÆÚ±j0b¾¿‡OÇ÷ )Ëñz›üÏ·• ñønP:¾Þœýø»°WL?…YØß"òòèI»€jî;ëÉËgZïµìÕì÷ÔÛð¨fDŽ6èÞ'N“æ¯ÁpÆê~³F\aãU LvĽo ªbÅê6f Ë7œ„ë]mä{ÒR#Žl¯%×6õº´ýÈæ›>nàž-c€.ŦΡïãrÉTš«•P •P •P •P ÿäH¾ŸUíÑUéRº”.¥KéRº”.¥KéRºþe—¤ÅÄ*tŒ¬ÅDmÚBb(idiE„‡ûùF1•‰É¾Ã}#|ƒmTúÁ¡Q¡¾!>‘~¾!þ’‘±Š#+†J»uü¢‚c|BBƒ¢ÑáŒÑF¹ÆIµW¥7žX1ž¨É‘´Ú[L=t…0}X1ÌšÿãЊ`°¯Ë«†ê*‚‘¸ ` íïG« †É*‚Q°Š`«ê†¨*‚¨¿o€©b?ª†‡*‚ÑŸ apçﻩ†fþu#/’7t9Jp‹ëÈ-¦FW™R™R™R™R™R™R™²4)9¤àg*zªuªðaDMp³ô¼qiãEhæJ ðrè {D¾Cié‡<×^â‡ø§yS‚ö³}(…??˜œxLYŽ;¿ŽÛÒXÏhø}þôÝPsG_ëìØ:P³[Æö>^Ž/Æx7§bAà„óX0v|6Vp0ù'Xïÿ•R ]z6kÞ÷º/ù°-¾&%H9w~ÐiDÊí³Ð`2öÙ“¡N óÁõÈüE  ^ÞÙ<ùQjè×ò%få1iüÌÏæÕ#QÈùkȸVèr§±Pÿù¾´ z³Ó9fòâ> kÜ]¥ÝÜžùD5êàw+òr3¥¨ LÝz³?k©hœÙy‘RÓÕ·¾ÌÃ=ÿv;,½8 OŒ¦ ËàaƽÕaüÔ|~ÈÕÀ+ÖËdÇxHÕ¤ZÀL!~0æƒ~`¾‡R S®Zwí=gÅã¾ëÏV‚F?/½Þ›Ñ˜¯Ñ÷žÅ™¥¯¡þ)j¾#{û|[çìÐÖ@âa†Âv5ºæhÍ©¯äDáýƒn!Làây&õÄÕÄÍôÓÛ1‹IXßzœ ™+Y¾-zœG¥»ç \‹5ÚØ:6¤u@òM\Nr÷[“Mùß÷ ¡”½Õ‘ãaÛ+ø;~˘Ã-ƒ,2^ºö2~9ø#~hž|ßÃ'ÜÄx|pøÍXñËÚÛ8ßÌÁøaæ~gù <δÁ튯\ø.ÁŠ–¾e…Sñ—F½ ÎõU p»OjásþfØ Ôj)¾̹C¥K†Û½&ôµ¯Uº‡©ZÔCNEñåvÿ¨—B]°`w>w“»àúÞü¦+oAô ¼ïšž¢ƒ÷~ Ï|¿4º6zÉ–y=PÏ ÷¦ß9A¥þ~á.i:H놜(N§¡bp)]J—Ò¥tý÷\’¢§štL©DOÕý¢C£hOå߈`ßP?&R;špGDù‡F`úG†DD‡…Ò!¿%?1K/,J¦R-žªº]t``§D€{@NUC—_ôСn£Cý1.ŸN!GE­.vWfQ+Ó¹ ˜ú{¸»óX>år‹ûDŒ˜ƒ&é³2·”ôZOke!i)å•ÌjiUÌËç …Å½<ž¹„—ïÃ^!OÒ+™×B2¯EñðùB)¯°X øæ\ OÂÇ!©>+óâÛ«ŽV!ñûÂÿõ§—n¯n=ì(Év–±A<®P&ˆ'Äã ¸%qyìœ(J%’d^š võ°AææÒµç™ ,e‚„²©dÑ›‹dSYÈ´QÀã•Ä-Ze âÊT‚ ’<5G{ÚY©{'g¦;5]Ül»;tb—dÏŽü.|¹>u‡NNö|vnÐùíxa–"©` ÷nv|[ éÄî.¶¶¬pu%w{§Žì^`ëÎsc ¶íêfak.áckܹŸïfË“ïUw±µï,呬D%wg ·dGÕöÁkÇã „V\Ká°äò¹\ÉX>WÀå›[˜ s¡O*ÖRÈ „f¤CÄç3íÐñ_dF8,¹"‘P2ÖŠÈM4ߌpXŠŠN!&–ˆã ‰¼VDß’+kN œ%kNVZ"–/ˆÚr͇ˆÈÎ+C,ÏBhN4•è} ¡_È-XÜË"%ñÏÂL$äó¸\ó_Æá{Añߟúã`2œÁß~ÿûïø%.®•éþ¬J\(|‚"¢Ë®®UüB|##}üÂü™ËiõÐ߈€È(Ÿˆ€À¢tšA¡EÞ”7rPXD”Ä­7$Ì/šÎÐxûTÙ/,& Â7(@Á…Ö ,Z-æÒ©A§vP|éü•OòBú+{Yý•OþEö×^«Ry%/Á¿òÉ¿ —éúük¯U©½ÒWï_{¥/æ¿öJ]Û핾ÔÿÚ+,ƒWúƒà×^Aé½2¥ûÔøµWއȯ|¼Rûø¥ðÉ~Ü(ö~áá¨U£V<á ÷j¯Pºi7¹;VaöP5æÞ[$DW\bNB Nþî«èëF Ÿÿä¡èç:cž@z ?J)ã"#Ì3Z¦NñŒf…c¥Å“,)%Ωzï¨á|qikhÿÆ•´bmùO¸?:;“}Vnżɷ±²Ö±50/*[ƒ1±ìPTæáµ7ÄÊá æ±šöôÞyyôdX·ãYþ+«i‰e˜ÜÓ°1«³/o^êõsÇŸõ½ò_nf]ŽuûœÏÔì~¶Ù~œº7£”(‚«9¥|˜xò̘x–òj}zeÒyì*¥xs‹y˜§¾xˆ\¥‡è±«°¦÷ñDh3þÉ$^{ÜN®I„£ƒelhÖ†Â39ó.cvJÈ¢Ïö9ÓöŸ õìm횸ª&ë‚óÚ PÛ’uÅO¦¼/º+7ßH8¤êC›;ÑF^‹ŒÐU÷·V«ú‚ÉHJ©)ÊŒhq¹er&¨¦Ü][°–5r„ÎBËgß‚ ¯ß{[þÐ蔊N²Û~ðÛˆû·9i2Îe;;_n¥Qóåð,ó¶r–ÚÒ !šŠ•VÎ ˜nÑõdªt½¡:=?†Ð<\[}Òö@[p;•»¯Ÿ†eå¦wÄJ‡§ÜÇÆhRýgP<©ñU±Ñº±o1O'd.VïÑâ‚Ïl\iÛþå”Òùä\Ì >+%’‡eº H]ÎÝÁå:)j1 TÇ÷ÖÜé–ŠòïQFÙúÔÇJ×{­¥Œ0æñ·¢¦]76?óîíÆJž—½Åý’Ü2%Ó—d‹ñ`ŠeH­ª`™Ek l„p‡Û%Ü“°,àÏ%Å•ECõ ,kÙ²!VšßÈžó=uÂh’úþÚ;·±2åiÍ ”|ƒ1ÙÍêé(7ögNÿÓUѹ”Vk@á”Q@ô=;óã9/ÐW5¯¯;_²V‰ç¤¤º¼Å#2ò ílWrUÄ:5VçöŸ#ÖÙÿ-ñ1wF~/ÊrØ 32©rÐA\¿—ïúj~çšèu;ÜhW†¸¥µðmT/”öäTæõ#³Å•§ûZ󈵓®{¶Ñ*ÌÈߨîʬfÙ×Ì猘ܢAÆãYõ‰‰Ö4#wéŒGЙþ¾ãöÒ,¹éwtnÕÔ\£×oе£N}ù ]p4Ð?Ùî Ó”zlïÈžÜ]ì<['¨þÝaJ±Nš‡hß×íâÚ‘6írV¸n޼ãæ¼®ö ²óõðÑEAûðÏ1(KaâÚGÄö-»ÿ×Õî5[4§2úö²zëZ›'”4_Ð 7‡s÷£{5Ze½»>I:=Ê¿˜äR æãÐé9Ž×aò¾óÏ“{ËàyÿLÃêÆ³µŸoü~5ò&pújÅíè¨ ê±'ì†ÌY&®–TË{å­SŠæK‡ŒÂBUçYFÖâœÕžB ³ì}{e† ‡VÛO·³Y´ZßtÁ»¦6ç/î ›pl?:§“þýíJæÒó%û¼3ùreí¦,¢·GóÔ?Ð@'R>^ ×ï€j4™rAK÷¨ÍOï¹Ö¯o„N¹œmc¬cc¥ÝÉ¢`Ëëä‡ã|tW.Ao’>åÆŸˆAYg›ÝöeÏ «|Þ«/òÛ½ &çS$êØd`ƒ U·¡“cî¯Ýn|½"Ÿ+™ÜGO6æ´Žl6]3qˆLIœŽ.Î웑7\„NÕÛ694x0zÑbUÖ’÷[ЛiÎë]ÕE¯DžƒŽúZ¡7ÂÌÏ€î;QLQö1ò]TôhÀÜv=¦¶@ÙïýO™ä¯@ƒÚIƒu›Ùôt7ÚÄà ]¤ ¾rYÈôCVØ|áÕÎÏлEšï5ÊFo4o~¡†Ö­Œ‰mí;ͦ렑cF´gýÍá$//~Ú{ Öîç&Ñè«9͵|‹NÝ\Y;¨íësט“ƒV/ëö…ãeƒÕ¼TïH7ô|RÒ3= ë9ñ6žú—·Þ »A™ÁèÖȨvþãîÛŒºÛÓÊSe½uîè~ñySî W“ç|öF9Çó¯yºŸeñNíÛxµ nUýsð–0tóÖàÝqãÞ¡ìF«ZÄêUG¯ï¶h90 Ê|üÚÄèù>Åõ¤ñgkìÝØìömb>ä²Í8\b»¸·Ô_{®¹c³ðuª‘^nUÅéÓÕß¿žÍ—s&}¸že¼^ÿ¥ù»M6³û¿™=ÒÇÆN;tÇÑ,…xþ4¼60£æ×æ§YÿJëq Ó"Ï™WïOq·e­ƒ,Íßè¢Ä´—I«Ä÷ ñ÷ñäĪð"eUIDL¾p*'ã&áÕŽ   öó *–XU†%V…N=ƒi[ÙXb‚yVÎl¶?ËûÜ»?Äêû³LÁ?ÇAüCìÆ?È›üƒŒÌ?Çõüƒ,Ò?ÆOýƒÌ×?Å©ý“lÝ?Àþ£ ã?ÁZ._&ôŸaW—W»”ɳ½ƒQ¯Q!ßQa§§§§§§gipJžÉ*ÌEG…'ãâ*s)s)s)sUè\’;œ:±eúp‹{Øï0r×”ò1 «Û2Ù$\%~%~%~%~%~%~%~%þ2ãÇÂ03`6mý"+’†3'1<‹ øÀUlŽnl Î߆Ãç&`¸Ã=Ž‚Ûnaxº?¶„ò3?”ßÓõf|p[N ?0œù¼µ„颚‚Jo ÷áÕiáCʪ›ÎuÖ0¢+ jÁȵX»þ¢l¥i©6ÖP°Á§OÛ1„ŽÆÕ‚ðp çÑþ„ÑnK§¡žd½š¿¾¾°Žéè’J ÍÅ,ìÜnßS:çLÀ"`Ë Þ—dðsÇ zñ›°`+ÌßO÷WÖ°d~ɾ¨b×÷yíËMÑЀÿóÄоßÁe;©¨ džä5nb)ÙæN0`8…WQ¿±Ö0¤ûÓ•nŸ›C¿úã”Л†nq’ø ¯œ×©>ø‡L9ymlBºyG³ø' 0‚ab&†Khë&»°Â|Øì QÏÒþ  kÓPDC éç@ë¼€à$ }q{`&Vv3–c¸)Ôê~¬ÝÏjÑwi+7`pâK·Í^é`«Òcf¯ÙL8š~£ÚÓlWÖ XÐи¡æé®ýΣ9?B{:qßËࣧh.6]Â=\ ~ú^ú¹-š#õƒöRþFj®½öµøÆøm~¬Ž­E¡•¨Ç]Ò{kl!òÎÛépÈ(fÎÈÙ±‰oíIÌ^;3h8x°J³%ï g-Röº8ßmgrjD‘õ±\¦Üo—„‚Q—³…C͵ jÖTjOiÑ—S¼¯$ÔÁÚÖ*“ ú™‰ø‘ÀÙKX«ûÅóX‹üó­©ðñøñIÂ[¬d‡ÑSê‘ÁvµÝ”’ã €ªÏ)7(^Ê›5ûLŸÂJŠúƒmw‡Ž *uœ ‚ÜmFí(‡Ï‚›É¾Ï¡C,e®‹M׳úÄgͶ¼€‘AX;þˆØšÃ"KÜŽ¥=°¦‰u°ýíµpýbÂñc‚°4œn^üø !ïC›ÞQùv6Y a¨¹n÷Áµõ€.oEÖ)p‹¼3¤Y5u}2Ón´¿…ëáߊ²nù¤Œ²5ÌŸŒ£Ì}‡ËY8 —³4ÃÚO7Ž8¸ùÔ7ÍÙ±ñI"¸LÁÖÓ±õƒþ×ð£¿Ä-¿zœ€rMÈ7öè¶ÀÖÛÍ^wƒ)·'¸é =qÓr ø™ÑÖÁ¢›¿Ž½þz¾$¶ÇÎÀS­GµIÝUX|?S(anÙrnîé½4®3‹Jlµ î4ÖÊŸ˜Œ5Ñ,ÙƒçÕöx¾l~EF ÜN­^¥”4ŠæÃáAgßD>ïÇÃC uAx[¹ãµ^™•±½´èû-íÎ+àÒÖegµˆ9î’fnÂhf<&q¨Âú‡ß¨sgÓeÜÿzW—µ¬Që(4ñ"‡µÈúCJ>½ï  º_Íû¯t`Û?ãSŒî„ùÇÙt¢ãèù™†ú`ìzŹýš±ÝÖS{ 4Bvk6®ý¾Q÷s¹ Ùûaj¢_¨cÝgS“ñ½eÚÛ¡ 5¯YÃÝ^zûÏ bü6_˜ê¯=ÖY:›¾nÖ¬'i|#ÔÛòÞü«‰ùà–j77[€çAÏÏO‰£<î%G¹Ï­D#k$°£ÐG­³u¶€:^®MŠùMœQÑØ:_è|Raˆ¿œ*à}eÙd¼?, ÆëL|?ŠÒ¬sd_jœ1ÃëòFmʪ$ÏÅg–Óë$徬GÕ[¾‹ÊLg—ĺT™§Nª,RÔEížêæ1`cؾ8üh-zÖ•_¥4|± ø”‘ 6«ˆz<Sæa+#“ß“F$aVzûaë0Éö¸]›Þàýbb[lµh”.^¯Ó”u˜¢FvSoX?jÚêHõ [Ÿ¶’iî£ñiA'h»¯~;òúb¢£”æf3˜ˆ0ß·Ô¼‚éñºº?Ê›;—»0×Ãh®›ir‡Vëwk×h ·°µEä“°èàâÓàmŽ5) ¨DibRÔoèy¿ý“ê¥y ükŸIU6l½}Úãzô‚­6y{c P}ªàGˆ®Ø:%¸þ¤Y±ùª>ÕŽàw—)çí4õ«"ЬGÎ{‹ï]ñ;VfŸ`Ž5Öô”ð÷ÿ¦oغ\Z,uOC³¶ž’æ‹¿'¾6m´ ÛªMch}ï[ÍwÎþHìô`T7Fø²ãR0µ#¯‡= æ~¼rš÷0¡3e6ÆÇã»z¥Y Ö§ß§45¹ epsO0[/ñè jdÔu1oÔtµüòÔ»G/hòÕ±žn¡É„þÔMX[j`ûŒÜXÐÏGäô‰u‘K£f²Îœ $Ö+è®éòˆñÛ䉲ޟ–yŒÉ¦¯Ù”[ð¥Ú1äê±ìiÒÅ£Ä|xrÓhkÕ¬:c+£-Û‘Ó©tÅëì—Ì×Î|ÈZ›A9†)(jFm0¾„Ïõ¶§ðº¢5>ù Y§ÁûÊ"üho!­ñìà=Ü߇º5§æËqÀóâòg+êܙүà ´µÀÙs±F¦øtlµtíö+Ô}?U}gqk3 â¨ÿ½ @Q°éŒÞ[Ù¤K³ov?ûÎA£•õ+/US]jŸdÓ9zÎö0x3ŒuÅóxÌ(\IØêØ4U¼Ž‡âù½ú!m­>¶^;L•Ú¨`\sòZ0F{àÇ—ËÏàï©5û|%Ö™ebœ€ØéÁñy³NUÖwávê|‹¬ÅäFÖˆÛ‰æiˆïá°5Õ¤ÆqTþNø;huMl5(µÞ_êù¢Ë—ƒâ¡qYäØÐû¥pÞï]«fFúÑz¦QßwŠú ½Èº:——¥òtŒüvxõ§«eu\µøäÆÝfãsÛ9ß÷ì.ãG£v¯·MOjáÆæ«¤;â[âckAèæà‘§¶c­RÁ²0ÚºíE¼¿$æá~^ªƒï»"¶Qûô®K”&8”«N=*-i°øÍ ˆÛHGâ^’‰¿?Í?Rö™ m,þþ4ñ¾×”Ià…¶4ÖŽUƒQëHãsÕa˜±‹4Hƒ)[ñ¾4¥ çõ?ð#ÝMmñ9£{ŸX^Í_ƒáŒÕýf¸Â–«j`²#î}kPí+V·1cÛ?}ÜÀ=[Æx²é 'áó¬Ú¨éÕz÷Y„bEß·>€îPâö×n>›NËc΢/è•þüç߇ /…F牛…L{;\ŸMLì¢}K³×Š÷mÞ3~›—]'4ߟ~Naiô>>lW,êâtÕºJ¿}èÝÒ ÂbØøf°µb½”õ]°˜KYùÞrÒHbÛyŒwZo MZR«À”R¤§AjØ:—/Ÿ4XWN¨}åo«•VB%TÂÿ?#É_þûªd”.¥KéRºþ?º$_MV¡cJ©óS+" <$ØÏ7Š ¨LH&ðîáÄHJê‡FD„ú†øDúù†øKFÄ*Ž,®_T' 00À/*8&ÀG˜ǯmÓÍà”áe5æ¥&G©ST©ST©SôJ§¨ÄŠ—#ð]\¼˜È¸2¥2¥2eEKÉèh»¾“·Ïšxc6¼£9±ˆxlŸÙ®óÒõŠ³É˜z6kÞ÷º/ùÐY³Qm;ywÉ˽ fŽØ€Å¦y˜ º¸ Æ;’ÏÙ_“"Ï…Ù¹‘F˜lmùÔJüöÝ7°³Àì%ƒQï_½¨¬ ‰_0y~Þ^LÎî¿ ‚ð]ÉÌÝRpþ: ¿ÏŸ¾ÛP¡ûžùD5êàw‹3¸™Rd@”©[oöçq-Ùve§Ôtõ­¿¶ÛuĺÓ0ywb´Eד)¹2ýÀ¥ou‹ù0FéxÅz™ì¼°øÀÌNX·_ÀJ|‰­cd¾þ©±Ïž u‚Æ¡:'„œUdd Rp:®GæïL±yuÀHrþzy÷Â"h9eÖ¾§jýà3yqÐ5¦ ¨°õ}ªuªðaDMp³ô$î"4sunAÈÄ€a0;¡1f'2óÅv¼óž8ÂaÛP3J÷tèhr~Øz7ˆ ÃáÃöñÔx¾Pï@†+œ/÷߉©ü#ÃqyqѶÍêݤüÔ1;÷”ˆšŸ¶-(’3ˆGÎ¥æÍžñ)ƒ âÍqTøTš3)ã©„m·Àu‡$ ®yƒÓ] œ³ÇOæâz)š/×0L‰Àp ]ß‘q’ãá€ý¶&‡) 8‹»\~XUn?0óÅþ©ÊS…//-&µ‚Ù6šÛ—³sÐ`Ï\‚D›°Cš[žz2ö#÷Íi¸ž(—öëÐУ'©ül.%ÆÄ†Oàbv‡cÕÄì–€NëÜ +ŒÑϽf½hxa¯±é¬{qTmÄχŠâ¨<ü¤7ý Ge\+»äC€¡üÚ“õëtî»þî(èóh-z~„Ë'í¾) Wˆ§™Ž¹0Àº¥ýeÝ ¦Ps=)]cþ´A$ï˜-ÖÜ* Õµc¾àû ‹¡¸¼r^›z¤'èŸÜ8{—_gEøýЉsUUCŽ(ßú§¿CAu8^¼VÖ:5¯ ÛËÓ_qTχl:Äă~ ¥Ë’ñwÈpR5l“ø@:œM¯³Ó(vSÕéPóÆ“J!1]mò¶ˆ\¿+ÊOß\/ú‚t8è,¢t>Êàéáó5ÂÑÁ êëÙúøî/Âñþ2Fu+Û(ùBx’DB[¯Ë >†¿¦ö—çx}I—Çî/â>!Ô¹íIJ!:„²mªŽñ^ÄÆCáXõ†$;Ráþ’|œ6@tâñ5¢Ø?¶* qþ«½>Rì¾õƒR±¸[,î_‹]ø.¡Ä™ï/s°8\Ê0|ή ÅìÑ‘£$ØÖà E±1ËmiÐ œÂ³û[;ê\^]GÒs5º6zÉ–y=€»øˆÇ™É¹%žG&]ü~±Ø-suì–{Ûþ²^‰çѰ:XìÎ’’†¨ÏâO8Ï}¾«ï³Ïå©ñ]éRºþM—$qQ“Ž)%qQÝ/,:”ÑžV9Æ7"Ø7ÔÕ—M¸#¢|ƒC£FÐAUüƒ#Ã""ƒÃBé_“ˤOL¥ZakU6F靨¦’ÌP)FdÙôªþ’7*͵”Š-ž·oñW¼«_óÅû5çP’ïU¼À2)„(8“ôüEðÚ‰–Ä? 3‘ÏãrÍKW›ŠãqBâ*0#–\>—ûoÅò¹.ßÜÂŒpX˜ -xR±–BžP 4#">_ªÎB b“¶âš¡È’O¸µ<ž¥ßÊœDlÅ7üÝ8+KÑf|ž¹Ï‚_.qV\‘¹¹ÐÒŒˆ ¸Éž±šóD|¢g,„|!—W–X‘ÈŠÀË7ã‰,ˆÞeoü¥Šý'åZW}>_DÄš[rE"¡d¬Q2ѱf„ÃRT´K…ÙŠÈɘ­ˆœ|K®t¬91E-ÉXs²+Ë-–øØˆø"®áEóþ­X®¥…¥•9ÏŒpX»y€‘߯qÄ郩±Æ[èµ¢C)ZŽsÙÙ»Qqªø…øFFúø…ù3tšê¡¾¤&üˆ€À¢tšA¡EÞ”7rPXDTq<:‘zH˜«™_CBø«²_XL@„oP€zqYè=Z MFƒNÂÜͤh2ŠÜ¼’Ý4EnA)ÜÂR¸E%º%hDŠÜÅiGŠÜ%¸eiMŠ=V¥òHÒ§{x¥óðK呤v)öJç–ÂSŒv¦Ø#MUSä¶,Á-K…Sì1/Ñ#E¹Säf)zŠÜ²”>ÅQ‰žâÔAEnYª¡beéø¬°tÌXµ-©ýP5iòöÉNöm5—µ²üåRë¯ýœÀ¾©ïÅ âuÄ‘^gƒnL'*œ íë×hq°mÊZ%ž“’êðv!)›Ü>ýÎ+®ûbEF‡q{—_Ãó#é-†ë†qÝ‹Ÿ¼tRã†Âv¬éŽ%«&`IÆ!¾d÷T‚m!­°B¡©XrrfU/™üÕéyŸê?ƒÂ3¾*ùÎ?ƾŒÑéx½8Dáß®U)E0êb"©É|t°„b_ ¬ cÍ,‘2•‡ÞL®ŽË2K0Úê“úÚ‚Ûù“H¯–„~•”Xqói:Hë„Ìý¸Ç!ùxt£$>ÀçÆ7$+Øé* ßUw—ëf¤4غ+ÔIîF)P€iqX1†êøÞš;ÝRQþ½¼©ûKš(7ögNÿÓUÑ›æ;>pÍׂ€†™²Îù¡kSx”(™Z3¶žáøŒÉ檧³å|}ä¹ëq#à®ÂûÓ¡Ý(‰Ñeôø'÷£yÈàã¸$[|Œ÷@ß³3?ž³ñ}õWóšñŠ$B­Cñº±ªr½u‡•ïÀZ#WcÖ¾ƒWˆ4¿‘úìÀÛ+¤ØÑKLNÀŠŠâNGî$n¡ÒËôO–× Ó„ ¡I*i¬ul‰íoø€œî† ã«a‰ß– 3œˆªòHÁ]!tvŠqt[7>ýÑhGzõýIÍ?|õ§xnzˆØ~†½—â0ÜŒçLÏ¢$€Kª·ÂúQ—ä…ÅÚX¡Îô«¸ßF„•Âüóâó4v$^7þ·)…}e®ÇÌgxóBä‡àS”â’ßlVéË›Šçç‚G’¥ÿ•¤NÁûÂXÕ?ºæ.éSÖú)¬÷ǽ¯k|pdñÛLLj0)–D‡SD¢©²OJ—Ò¥tý7\’´m æËT‚¶-GB±ø“dM¿°Ð@ŸAÁÞÆ@mÕaѾ¡Ø¬ByIJЧµú´6GIŸVÒ§åz”ôé"’>­¤OK{JKŸV¡ÿT•îÿ‚ûOÒ§Ù9¡ÊÁ4q5¥û¿àþ£< ޼oO çy–œ¢ä\åãû'÷ç§”?çªõÿcúÿÏWÑÖÅŸÁó_ž¿jM gx¹,dx¼ /— —áå2áñÒ¼\Ò<^Ž‚ËËe Ãã¥y¹,¤y¼ /—,†—Ë@†ÇËðrÈðx^./ÃËe Ããex¹ dx¼ /—†l}^./ÃËe Ãã¥y¹,¤y¼ÒýU—áå2áñ2¼ÜÒòt^.Y/ÃË¥!Ëã¥y¹EóxY^. –GóxY^./ÃËe Ããex¹ ¤y¼%µ-·”<^™|4/—åéÒ<^†—Ë@†ÇËaÖ½®dðÑ늑¥`e*˜uÅÈR0‘`d)h¨°¾Ìºbd)ÈÈN0²4Tˆ‡YWŒ,™uÅÈR0YWŒ,™uÅÈR0YWŒ, ÙòiY 2늑¥` ³®Y 2²Œ, ™uÅÊRÐPQ?0늑¥`à/'<<ôº’ §×•Lÿ3²Œ, ágÖ#KÁÊT0늑¥` ³®Y 2²Œ, ÙrhY Ò늑¥``IýÁÈR0YW2éÙ Z–‚fU÷[Ñ¿‹%¿0§°Àëì„- DŸb(-!b½·š]†7H×›–ÒðÅÒë zkyª²iäê~³F¢œÃvš­ÈÈw:¼{Çõë§'hÜ}èP•d"+¬¿Ú´&!¾n¦ ¾æñ”ÅÂÚèòÃj¹—£Ç^ÍâŽU.þYÒêúº¿ðfõÙÒõcÇ?S¿ŸgÊfP¿;yêü‹A写‘óþdôž¿ðõãm3@ëU¥EA»?€ ó`3úÐFë甉@½k ÿ‘K?ô%ØêÍïªèQöõþs'_B…vCæ,Ó­>;îK¸±nFÆÌæV=Ò^ Yß‚kDoúp_öbê‘‘KšJ²\6Žé·üeâg7Y„r·¶Ó»x¼QƵmÙók/F?[PÚ[@ûãóèv6bôUlµé£å0Py€Íh´GëŒDc­ QL‹7×iðÕûÛò¬ÅÜ[Ä2¶ý ´[ß­íÄQbíÚsSú^>¨¨ßý2²Ö6žxì–t>±Î•/I f™Òá3Ç 76:·ÄÙ¼1\ºì]øx@Q¹Òí«D‰ëïÃC{·ÍN]{©WÆîþ Þž©é™qrªÇÇá}Æ‹«Ôa}gœŸXýñÝQÚVuQæÝÁö¶±á(·¿é±¦&† Etf۶ĸk›ô_Y_KQ92å¶^AÉ>”Ô²õN ¤tû f¸VëKCžfÜôÑyág¸Ö¯Ë-·±÷Fqµ¤ZÞ+o’é¿Ï·N~¿y8}µâvtÔõØä ŽÔÉlª×B\?]÷G5bµ½Mntxp mٵܣÁ d·¨Ù­—uü3†::7´ï?Náx~ËŽ­ƒæ¾ÈxãU¿Ò ûY{מ¿6ጘÃù4¸gåp±^Љ4ÇúNâZó‚½}Þ­W4nù½6“VÍÄ‘I•ƒâú½|×Wsð˸ÜûÁò¯Ý3^ìßp×{L—ŒÜëÖßdÜKÖºì×»cFöœÓšoœ“‘3mu@n~rÆÇyD7œ,Wï÷¸ïú³•Ä5|  v¥6ˆÚxþÔñ ñÌm«Ï.=–q¢×ݯûŒ`÷£9-ƒ7-´ObÆ!ã\½nÄÖ“!ni-|Õ ¥=9•yýÈìŒkæsFLnÑ ãñ¬úÄBlš‘»tƉ#èŠXcµ_‰µú6"­Še|ÜJl {¤Ç7ãŽÛK³ä¦ßõ'ê·k}Bw½í¨Ù¦Ñ»ÎY×µ)Èi1Î!}pY׺W£UÖ»ë“döݤð’“Lø:AõïSˆuÒ/å¼ZÕrG £]Mî]ÓØÃ»át×~Úɪ­Ð»Œ×ßîþ¨‰RZMl?ÝÎfÑj}ÓïšÚœ¿¸7l±ýèœNBø÷·+YÈà9år¶Aޱޕv'‹‚-s¬“ŽóÑ]¹½Æë=œ«ù-É~+º:µÚº»¹£Ñó“«½ïÝÝ8hÿ¼jÿèú±6‡½C&¢ó®©Á ‰Œ:w;üÌaªýE5ßví ”}ÞùËÌÄX”E*‘ JFoæ©: îå_2^øx,ÊYžpüá‘£èQø²ÈÙCk£7IŸrãOÄ ¬3ÍŽn{ƒ²ç„U>ïÕ½"uS™ÜGO6æ´Žl6]3qˆLIœŽ¢N§Õnø õúfÀ??…ƒÎkÏ5;Ð=]œÙ7#o¸ª·mrhð`ô¢Åª¬%ï·(ìÏœ¼fCκǠœŸoͪwB9…WîßÒ¨Šî;QF^X¨(?ŸOJz¦³‡‡.ŒUõïOܯÖÔá¤;ºìBí×èä„K=½¾£^:…¹ÔCÙïýO™ä¯@ƒÚIƒu›Ùôt7ÚÄà ]Ôoºþc>—… þ´žÑcz¯ÜÎÜo~ÿé2tùA#÷Ô†GPVØ|áÕÎÏлEšï5ÊFo4o~¡†žU™Ón™Æx”3Èl”_÷Í(çÉ9ò"‚æ MÛtBßɦߑ“D£nÚLÕô‚äO¯Ùr©:ª6d¡h_Ÿ»Æœôè{žÊñ‚F(çÖ‹ð'GZ•ØI—[œ34öcáÞµv?79ˆF_Íiv¨å[tpêæÊÚAl ›¦k= ƒ^/^8kYÿE6Iz‡Fî¼Æ®³>gŒ+ ^ëA®[§Ým‡n̨ùµùi¶¼dµ•Ü¢ëXë&OùT;^ËúÅÆeÝõú,D›Ûö;¸ükR‰õ•†—£/hïy„^œÔÉ}­}š˜_wû¥££³Û´Š>as»ªù¡ÙèÒäåU_!²Tˆçná‹ñ³slÆo>ZP£ù ëüÁu,Û>oÎâ{uw“£­&=¹lžcPv§s‹†¼Ü†žÍÃôgFO¾ÕU]2$&< yŒyásâiÔ¥ûPÁ÷MX<ÒPá|W>'nÍüìþÙ(Ë$Çõ zê6,ýÞa´ø€³ƒæ°êh‚ᙵF¼Ðó6ct]k—¹?ÿdÚ'œîh¿pÿq›å3tnÚ0ë·ñ”¶Ÿ·‹uã^صYí9ÍÍØÀæ¬ÞÅ®­æuaã_xSÚûXø§ûAðÕìœè(ë·ÉÍßè¢Ä´—I«Ä÷ ñ÷ñäÄZU‰"_Ô“ˆ˜|á>TNÆ;L«ìçU²‡UÙÃ*têÛtêÒÊ–“|b¹É0–—œcyÉB–¼d¹ÉT–—Üe¹Èf–·üf¹Šy–³4hù –«li9‹ –¯¤j9 ´–§Ük9‹Ç–‡my‹Ù–›4nù í–‹`oy ÿ–›Œp9Š—·¸qùJ%—«ðr¹Ê8—·(tùJL—¯`u¹É_—‹˜viÜ’·ÔbbŸ $@Jƒ* RâTâTâTâTâTâTâTâTâTâTâüÓ81 û6ÿ˜'€œbP® W†ÿópNÑ÷³:±p}¸Å=¬éríJù˜„ÕŠ-\6‰D W‰_‰_‰_‰_‰_‰_‰_‰_‰_‰_‰_‰_‰ŸÆŸÜ7ÁÛ¥¡`ÔåláPs-ˆÚ4(b›á µ§ ¿s¤~ÐÚóÉÛvfÐpð`•fKÞAÏZäËÐà|·É©)L:F„âsðSí9ëñÜÓsëR†ÛO?¤ÔÐ^y-¦Ò]Ï’xb†Û/nmÖ .4ÝG=é, ?Ûäpþh˜9à§ã’Òõ+éÎS'ŽêbÔ>,á®ö&ªaµä3œ°ºïñ†”zd˜ZhÕKg 3Ì߆óÍMÀp‡{·ÝÂðt=~lI\ñrP~O×›ñÁmK¬O4ÎááΣý £1Ü–NC= M½Åoß}³‡Z£‚w©n ö›V“ö¡Û ¢5-gAÿþX}ùà°Z¡‰³\ÀdË Þ—¤°5!_¤‡ƒŸóœ¾-óAƒz«Çœ˜Ñ¤Öä¾>«Ç¾‰R£ ÃÏŠ'Ö ƒù~X}yb ηnèê)zêw¬FØpæCtðÖ¦‹j *½N\òå|8thÓ±w¶Ÿ!ÛN×ÉFÖo”fêÐýå™þh»çÆ¥VÉ„7}}aÓ%Ð%µžˆ˜`±Ï«vûœÒ9gdC“AÿÝçµ/7ECþÏCû~—í¤vôp’׸‰ ¤^Þw‚ÃIÍ Í ¯VÒµ_«kÇ|ua®öÏæ7½ü|@G˜—‡ûe^J]²¢qdç{I^ÂZ®½¬»Á”ËâX®Í8©q˜ñÛüX[?þŠŒÚuTxå¼NõÁ?þañŠë¥GCÍŦÄ©?}/ýÜ-“άOÛ,Ï—Y#5ŽÞ—ÝÓâ,Àp<Öl‰™.‰Âp¶ð›(Èôóo·£wIï­±…È;o§Ã!£xTX˜9#gÇ&6¾ kÓPDC iå-@v€æiX yÍ .Xmúœe^6›D#“dQõþÔž,^%¬h< ñóy¤¶y˜ùÔŸ´'3fb*«'áõµ>#÷WóÅ;÷4^¯n_Vtv £N,hhÜ`%©{€ G.?œ.ÓìUÚ~cóM¿Qíi¶«¬ÙÎ'‡,}ýøšó#´§÷=4)¾Õ_£è~¬ÝÏjÑwh*U/ƒ_ºmöJƒ\•3{ÍfñäÒñ•ièEþb ™ü:,*|ŽÕñšpmRÌGhºÈøAÛzI½‡ØpŽ@è|RK¾¿t}ÁlÁÐ7-§@ÏÏO‰¥÷£Üç@V¢‘5X•/è£ÖÙ:‡[ÀlsÊ ÌCj$§]©ªÀ™æxü/<ÃûáíçS$Ï1ý‘±!MAÓ©?+où^d¤A¥}£îçr¡ÉÉÞKã:˨V)é=Ì%ê&àÐLïiúµ>0á*žW3faU3£n¡TmÄϢԲÂø%Ô¹›ðïã;ŒžRê÷·«í&Í,Àñ¸=§Ü x9(oÖì3} +•XŸ˜p¬ª$, Ÿ'ózà}4!Ÿ›ÞQåíl²€º´¢¬SÔ‡š{­ik?ì£sÂ탠ÛN—mFíoÏ;µ‰¢°j$Ó‹”¹ €i¤5Šaà×€R}ˆS{ô»¹qôÙ!™„ë» ·3æ¥Óæsq}wáú%?Æëfó6T?5qèØ RÇÉ È%ŠßQŸ7“}ŸC‡Xòå«jzVŸø¬Ù–¬¿éÇ™UÈô‡iŒÛ¡¢š2áÍu»®Ý¨tx+²N Xä™L´D]_†Ì´[íoas&µŸnqpó¨oš³cã“Dp™‚UÏ8¦S÷2è «BñKÄãÜ/÷C—¾¹·í/ëAÂl^aöx¬kN2V÷¿ðÞ/Í$ \RSŽ=ú¶3(é«Vˆ¢t%Γ}9Ddñ *5+Ä;¥ ^q§ñ|KLΧÖÕ’=xØÞ¯¿íÁ¯È”»Ó©Õ«tƒßnGݬYOÒøF¨·å½ù4Vãå–j7or˜Ô¬ú¼%ÔáIê^¼ÖÔ9-ú~#u‹W›“i±ñîþ|ï] s¼]ʲ÷.<äÚæpÎÝKZ×|QQÿ‰)UlO|&_ÈëfT:Ì\šCêÐWªv&nÒ°òåHÊͦšWä©“iϬ´Ï‰žó(³-2ñ¢ãèù™†ú`ìJ}Ÿ0áÈÃÂØ{Ôrï²öšñ)FwÂüã2á]ªèÖ˜5ü!š±ÝÖS{ 4ìô‹Ånлº¬eZG¡‰¹lYÕEP§’Oï;ƒƒîWó~Æ+X<ôø‚fclæÆó8µ@?mÊL ³¾@WëÔˆõ»IÍëø3¾„÷¶§Ü<l €!ÚxŸòJ˜ bË·êLnöвVýÖuž:i_ì—Ì×Î|ȦG9†)(jFmXrŸKuðü×êO€xU…ït8þ>»Þ{€D9­Æݯ÷ êŒ=”Pç%{o€Ú/)Õ<аÆ¢ÏÏÊ:ÐÇ«^sÓ%võª;!6ó2yÀøx|~ï¿Ã¦záó7y.Þ¯—¿ÃûyÊ·!\?×_¾‹:_Žéì’Põ¤‚û¥ÄúLlK™uQºx&Àf‚¦¨‘׈ްþ:ÞG·:âóÅb¢ùA†Q:† ½6Nßñó‡g³gD€Ç^¼ŸïÁéEoÈÏèfO6Ǽ;bÕXnµ©sBÓð÷I¸6þþ˜ÜŸßCi3;ýI+T#`NOŒwE\ïÔî^DÀZ0›Šçí‹ÃÖ¢`]›âSÝjÁ¶ÓUDZb÷_àš“ÏZ™þh¶šZÏ2áüGmœ^¥4ÛpO :AÛø|â·#?Ïì@tÔwtý»®`4×Í4 ¹C +b–×h · Hk€|\|¼Í±J·•°Y­à¶ø<óœ>ƒØzÔ®x<&™Pó¦ßÃªÜæ>ü¥ùô¼ßþIõÒ÷­æ;g$nR`T7Fø²ãR0µ›°`k´_|êÉ[h°‘2;†òPfŠÐ'óíšQƒŠÎGæ”îˆ^‚××lü?Áß›ÆïÇ÷©%vØ¿¾ u-±=Ó:b•ŽnQâÃJ&¾Á§Vƒ_Þ€z÷ú޾½˜UŃ\¦ì~ifØ¥¬ý‡«žè_(C§C¶Â]s„»ž£ÉW;Äzº}„&ã)•]Ðä‚–ÁÍ=}Àl½$½­FF]óFí@Ç£Fà:v½0㠺nj>sg|λó©þaÖÔ0\×|áBòÍ/>Çš´¤T€© i§‚ÔºžLÉY ¾|Ò:_]™~iÖi)q𯽰7N s1ý‰·œÜ~[Ÿ»`¼ÓzëlX°Ÿ î`ՈƋ)<c3rÇVãsì²÷W²å§Ûoÿ•P+[4§r'C6¼f§ÏFÌMý7[L"])ë8€çjò g­¤n¾퉿CÇÖÃó*r<6S6qµÏ”Føœ˜`‰óÏžKvc+ˆOÇ÷ªµÛi:›úÎâû¨8jÇ/(±>±õ«“73¦ŠÏÓqÍÉφq0Úƒ8>boÀò3¸^köùRçOÚŒ¡nÌ9w-3àí¥¾›Áòn b£^]Ÿ™½§À€q˜^a&Â÷¾ŽjoÈ› ¸¶ÃôT§Ùxð¾Çñýrt ®ÇH[êûÆ'„’öë`ò¼žçßÄôá¤ØoôÞÊÎ íXš}³ûÙw­¬_y©*˜êR÷¶Žž3H{~Eó(ÌöC­[‘2ýÑ`¿õq÷Ê„[&Æ‘ Ÿ7ëTe}7n¿âÜþ‚,²“X?ê¹ÌZó4ÔóE—/ÅCã³H#Øàó„;ð¹îZ53úÓ¦Ð3 ß{ÇÂtå0¼^VÑôÛåõñ¹4ÏÛõ:Ê3'ÊüЋ¬«syYÚ(OÇÈo‡WIîx>´â×"?8Y¼†âêußNfïÙ6/»Nh¾?ýœL¾Jº#¾%>þcfî@Ëcqqü‚^éÏþ}XúRhtžø²‘I×f8Õo¬_³—÷é3üê ñ. Ãý¼à">Ïóð=b©¦GìŠØFݧv]ªTsէΨpJnGAïãÃvÅ¢.NW­«ôÛ‡Þ-0Ð!,†7/ 59ß]™˜~mþ¯›¶±˜~mâ}¼ð/´¥±v¬À,|ßkyyô¤Ý@5÷õäå³@­w‚Zöjöþõ6<ª‘£ #àu>ŸÛS–có¤“?ãûóʆx¾m ×|­L{æìÇå÷jÂ|ŸHÆNÂx«|¯*jߌ G¶×’k›Œz]ÖþCÓÇ Ü³eŒ¬Y[óaªÙoš…£X‘Ç÷­Ï K‘ñ‡ƒî}lŽÕpÆê~³F°û5¨˜ìˆ{ßT;ÅŠÕmÌX<¹é­Ü I‚ØEбòRg/8ªølôzSàƒ±«Aµûô™m–“ë€:ÇÆå’¹5W+¡*¡*¡þ— GRÞþï›ÈQº”.¥KéRº”.¥ëÿ¯KR¿e:¦D3ØZá!Á~¾QL@e"@2ïpŸÀß æ¯~phT@D¨oˆO¤ŸoH€¿dd@¬âÈâ&·uü¢‚c|BBƒ¢1þ¥™íÛœ2¨º¬Æ¨ºÔä(Íl+ÍlËõ(ÍlyÌKô(Íló(ÍlKm«r4>WQLg„2¥2¥2¥2¥2å+%mþ†Cÿ`Ø#,CÑ˦¡§Z§ FÔ7KÏ—6^„f®Îí/SáÚKJøNò¦dDfûœLÉY±Ïhø}þôÝPsG_ëìØ:P³e­‘£à“ó±LÔ”å˜÷ÚùuüØ–ÆÚpb/PñÛçcÙßyéf'™z6kÞ÷º/ù°-¾&Å›; ËG‘¢"‘¸˺9} db¡éà§/ŽŸH„aï° …O®‡E»,+ØYËþÚvòîB¤3Ç)¤ðèî<йà ¶=ºÕI»¹j`ùË4ÚY`Y=ƒQØÌ¤ïjRØ>º¥àúÕ¡ºËæÝÅ2 50½§ i¬>zƒe\Q¦)§®id‰²S6¯‰BÎ_CÆ}´B—;…úßHQä*ÒéPvJMWßú2²Š2ãc2öÙ“¡N óÁõÈüEo_ÞÙ<ùQjè×ò%få1Øn×›ÿMò£åšãE™;í¾™^{M´Ë9fòâ> kÜ]¥Ý¼5ly­cÙZóø-a¯X/“ãA­;i%i8pVPfö ÑÏK¯÷f4†TM,{3SˆßúßÀãí¿G<±Vèb™òííóm³@[ Y…íolO­›êÈõ&ŸYg¶-(ùœKÕÏø‡”ìóÛwï$º“±0ÈÁÏÂ`_]üveñkj}ÚZRï¬àJ@&ݺC•ÿ˜ò Çù&¦bøj‰d¿Ç×ÁP¼™j8L¥eÀ&Åbxy$®ÏœÅt}¸ØëPðÒ"œ/ ¿‘+ë:cÆ‹·ŽqrÓƒüp™tÍi’éÙ7\€¡­Éaꜿƒ÷ßË«Ê/f1õ“~;fŠ´î­Â®³Æ—“ðàIVï.Æé Àå?§äa÷GžŒÅÔm ŒosäüØre¤žåÿ€oyêÉPøÆŒihHCC¤•ßðNÉ>+\g=|¾F8:XAa½3[ßU .bY¾¯0ìåô9àÇŒ{Ðjõ‡$Œ?úA£U{–LJR(£ –âócÁùFÔºðŒ§öñCQ•‡Ÿô¦rᨌke—|0,]ïÃñË{¼ÂoµZ×à¹`L,37è)~³ ÏI«Î10mõV"c±¬ë®Z¤?xt:÷]wt‰y´=?Âå“vß?‰ Ia°}eC¶¼Fµ¶_¶šéhÌÚwàX·´'×BÍõäqo¾Ïð[—WÎkSôý“gïòë ýšcÙ©Î ûˆëY€É‹O :Eʼy,ég“·å@Äàú]‘¹÷²(Þê©P/›´öøÛB| ³Ó(vSÕéPóÆ“J!1]™p”p½u§P¯tç‚¢z‚Î"ÊÌt‰õP›©ðj^3Piý̉Æ0¸ßèEŽ^¶î©ûÙð^”ì§4ä¾Ëqéû  ŸB™c.©\&½Âz•Gz%œÀ÷8¾«ï³Ï?Ù{ã°:ø®%~«h;ºòàçYêq>dŽP£î;'…øÞæ7 ¿xŒ’íUT¸m›wø<¼ýl—×§Ö›­×J.>†¿¦ð=Çû¤L?”tž=HÀ²Ïc/ã7’ƒ?bÙë—a/¨}wþ|/+$ŸXVµm,Чðœ] <Ò·GÜ'„Jí‰ßtE‡à·‡Ó3´XYRèóËÀ&Ç÷Ÿ 7±L½¯.÷LjŸ‡øÚøˆïüVî[V8•ÿÒ(\¯U ¨ùûï‚ÌþG¿XJ§-ÊŒ`IøØ{£IêíÛï̽±m):8´Ì癢{£¢ó,zÞŸLO‘ÖÞ[ƒ÷~*Þ¶^ uðÃî,¼_'wÁãyó›®¼71¨gÐ{ÓRß¹‹CšÒº¡0ž¹76º6zÉ–y=~qžépŠèqƒ/¥t)]J×Ã%ÉCÖ¤cJä!«û…E‡2æ +ÇøFû†ú± £ wD”ophÔ:¨Špdx@DdpX(SÄ/¹¾e2pH¦R-žªº]t``§D€{mD±† .¿è¡CÜF‡úc\ ¾Z…µºØ]Yš£¬Ç4²W·v>\â'²’ ²” âq…2A<Ù s¾L'd)dÁ• âñ²A"iôD¹lt½x|+ é ssé6òŠxHEABÙT²%šËt!Ï\¶AG«øU`øßª'îêJî.δ[ÍÅÑž îÞÉ™™8š.n¶Ý:±LV‡NNöE,e[ûÎ<7½Î;Ùv˜wd|=;:ð»ð¥ÒhÚñÂ"-EÒYÝ»Ùñm-¤»»Øzر|ÝíXì¶î<7Öt«mW7 [s ÛŒÎÝø|7[žTèù Šàµ ,‰f"!ŸÇå2jSq<®@hŵ˜K.ŸË•Œås\¾¹…á°0Zð¤b-…<¡@hF:D|¾f¡±4¬¸f„C(²d—k!4ç‰øD¬…Ђ/äJa¶˜ øæVf_ÈY Íø$kœ«ÀqV\‘¹¹ÐÒŒÈ+p’íñD\ .Ñ_D ê]"ˆÈÉ'b-ˆžâI÷¹@È狈2·äŠØMŒŽµ"r 4#–"žP:–ˆã ‰¼VDß’+kN »%kNVZ²wQ[®áÙÉ9EezqÄåùÇÁßÔz[Þ½dyx¹w Í €Ð€¢KE¿ßÈH¿0æÚP=4À7‚´”X”®•-rPXD”Ä$$Ì5ˬ!!OVÙ/,& Â7(@ÁÝB¯,w -æü× Sw(Íù_º Ù[Bé‚äÝ%J$çÆQº 9÷’ÒÉ»½”.HöŽSº ™‹Cé‚äÞ—J$ïVUº 9w¯ÒÉÞÐJ${+]¼Û^é‚äÜ K$çæXº y÷ËÒÉÁUª ÙÉTº OzÞ+ â¨U£öÂAîdlêãÀMîÁU˜Z¹›Ê·E$ilHî¯èëÁÁß{äqÚ…–Ͼ'„@áÇ=Éç€&îÁ¹Î˜¤š^ÃbM.2Â$Ûõaê zV8V›2ÉrI‹åHýÐ{G ç‹K[C²)Æ7¦3f=G¥Q${”!kë<tÆê¶ê™cmuIå¨=˜üÀ¯Ä?ë•2å?£XMèË¥Ö_û9'€}§,Jf¢TJë²V5Æj¦x`‘…q±Ÿö†í¾Ë8CécÓžÞ;/ž ë“4WtÁùF¦bu}LzŽŸ‚ÕFtmîô*¥áKôRȹóv&º™u9Öís>[?»Ÿm¶矅îͨgýàj~A˜Úk:1ñä™1ñ,‹åÕúôʤó:ØUJ±ó°:¦ÅCä>“G]…5½'B›ñ‡HðÚc’?×$ÂÑÁ264Ãê©&§cVHÌNܾªÉºà¼v4Ð íµ¦­Ô[°·µkâjvœ³V‰ç¤¤ºÀà¬ÊnfIÝJ£Æùð,b±rf½o i…Õ+NÅê fL·èz2Uº¾PO‘ª!ÕÅš_«û“š9yS ö­Æ»‰Þ±¾¶ë:»NØ0¿¨Ã1 Áø%&AWå‘’ Bèì„ÕJé¶n|ú£ÑX¥ `ú9Ì ˜š†Ç;d.ž·Ý(’7øüÀjN··ÀêV·ÀjG¦?Á,¾ˆxÜo ƒp{{!røZêøÞš;ÝRQþ=²ÂÆlýêcõQ½ÖRêÁ?³[QÚ®ºÍ×P¬>òÐn¬fÙ[ÜÉý¢Érdúã’lñ1Þ¬Cñ<´ª‚Ep¬5r5fí;;Ü.Qíœ> «Ëžà‰×_#{Î÷Ô C Yþ¥VN‚– 3œÆ›ÇŒ3‹ß7Œ¡aý{'cuØû[a¼3›`VÊbmZí×UÌ iBê’®/‹gþC,ú;÷«ÿmJ;¯eÅúÎR”_ŸÍôÇÛ¦'µ`ý ¡x=NxˆÛ=¯_…ùàz,²Çõ²ÜŠÕSto×µîEM˜ÖÏBjþ•X¾*¥V¬Ät©S°:Ö±¸ÿâ­¨u¢(=zߎRMo­ñx9TñÁ,¬eñúŸ‡EË|#%Ç­²óȽžvjèãÞ×5¾F8r$ï჌ªtýÿqI~¾jÐ1RŸ¯rhâÅß:iú……ú –ð†„Ñުâ}C£|~IïP–¯Tmæ+U›N-}¹ý÷©Ôÿ€þ\QˆÍÊ.TváßïBüégÎ)²ôø·ÿTÿùߟü¬cû«êI}ŠV€¿?ú¬Ã):04œ{x8¸{”§٭‡—½­‡mÙ#ÿ Ö2ùj§lóßl3þ4üc•¿üSŽOÅþQãƒ.®o?hæÝ¥Í„–o¨©þ„õk2íàå+ºÿ´2(s#¥ ·ÔéSëíñß4Ê®¨^YÓM÷Äçüãz¼¸ªqzXÑ¥N¿0¨oÛM"ÖŸ|‘ÿ³wµù¿ÊSÊŸrýTì^?§ú¨õ¹Q+Kúuó“ñ?'E·¾Ä¦Ó1`ð¡§ Ó+ðË„_¥y„–¾ó…W;?saÓ¿<÷¢Aá[ÍZ›g_vO{:è}©ëñ"‰z-À¦øF8ßçØn…éKY3>¹òÓ)áß…ÉoÕÐ0¥ëÐ%I˜Õf.ù’„ÙÊ4a–'åg¥iª+9Æ7$º(1íe¥»¸ûøG2rÎZQ¤t™Ÿ‰÷¡20Þa^íÈà ÐàÀ`?ßÐ(D^ó²y«2D^ŽTOp¤°sÊ‚µÚÁZÞ"ÙzòD²+Ó¹ ˜¡õpwç±{(+AHùDŒ´¡&é³2·”ôZOË’ÿp¤¥”W2+KÃ$½|.+]Hyyž„•Ù%|Ez¯H€íÕ¿/œüO„šÿûõ§·‘J)/›zú?Y«(Äóƒ~_BQ§äà•NŠž‘Š—ç£%ì+ŒÀ¼\/-ù/ᑬDñ§Ø-ÙQNº¾Rîrã~-•ÿÏäã÷ÿ_>¾ô±%¼zø­Ø_½ñ‡ï?qœò•ç/þÇÁ_ [v¿œdþ+ÓýY•¸PøE„E‡—]ð_ê^_þï þÑ;Å—Î_ù$/¤¿ò±—Õ_ùä_díµ*•Wòü+Ÿü r™®Ï¿öZ•Ú+}õþµWúbþk¯Ôµý×^éKý¯½Â2x¥?~í”Þ+ó1QºO_{å}ˆüÊÇ+µ_ ŸìÇbà,R@®ñÍýÇ%ôÊM¿ýR ÖÚÒÛÜÉ>+·b ÖÉ·±áƱ5°DªÉ}…’õëÖ`<ËŸ`IÜ‘–XÙ{%* Vg_Þ¼ÔêçŽ3:?ëéE²žÍÿÙ>gÚþá“ÉzVâ¾¶%?&ꊟLy_tWn¾‘p4H‡ªmîD}x-2BWÝßZ­êW&#¿M(LD™-.·LÎÕ”»k Ö¶bó3/3}ýÞÛö…F§Tt’-ØöƒßFÜ¿ÍñKv¾”—DÿZÙ’­>É-i nçO"½Z°~–ÀŸÞ‘´CÛ ¦ÜwH>+ž¨ð€" ýmû—S†Ç“s±2°éS°æ!yXÙeWi×µ;¸\'u„ û¯HèõcV‚IKè³’ûMRß_{ç6V¦<­”Aa0&»Y=åÆþÌéº*ú1—²p (üpµw-g¡ïÙ™ÏÙx¾ú«yÍxµØùÂ¼ð€·Ø0(·O¿óÄÌañºA7´¯_£ÅÁ¶Yì|)§—Š~ÐVÚŠÇ9äýÌ9ÿ]L9¾Q\*ÛßÿŒÁ¥²Èôÿ1>¤lóŸn³Ò IEÿ)ǧbÿ$ .1OJ›mÔß‘³)ï럢Q{iŒeÈïV†1¸Ä<9(u¾Ý–OcúŽÙÊú—~oáÞÊ•:¿”È>cp‰yBPj7ŠÒË"—?ž’ñÿ‰ÿW{ëOâùç¥Ð_·,uŠ ÕŠ¡N1¡ZÑÔ)ÒT+†:Å@ýcm;3¡ZÑÔ)ÒT+–:EC–jES§X*Mµb©S d¨V uŠ ÕŠ¡N1¡ZÑÔ)ÒT+ŽÔ¡Z1Ô)ÒT+†:Å@¶hêTÄT+†:Å@6=Cb Cµb¨S d¨VŒíhÒT+vœéqe¨“,•’W†:É@†ÉP'i(Ýl}™qe¨“ dÆ•¦N²TJz\eð0ÔHš:ÉR)™qe¨“ dÆ•¡N2W†:É@†ÉP'iÈŒ+K¤!Kd¨“4dçMd Kd¨“4TØo̸2ÔI2ãÊP'ÈP#ê$ Ùqֺг᠓óÅõšF7ëTe½ØhÒœ;?D_@5Ýá\z«…P%xÚœ)õ|Qöný™Æ­F½šÅ«\*äpL9оî/¼Y}AvaNa×Ù [ȶ7S¿ŸgÊfP¿;™è˜Å rÃÌÈyrÆÏUžÍž!ÖMk¦i8y‡¸reR0ت‰©|Òø f¸VëKCžfÜôÑyág¸Ö¯Ë-·uE™›»¶pÈh ÏÍkgr }Þ`ÊíÉ÷EùˆEÏn²ånm§wñx£ŒkÛ²;ç×&ʯm§º«F¨¿™dYyrôÔU5=âI ètVc0á:úÞgQËsWŒÅªÏÐó3 õÇÑå3å: ¾z{§Œ‹IIy·6_Éx]£Çüô*šƒZxNi4Ÿ©¯XÓÜrØ€…!L¾Œ™c†Û‹ âlÞ.݈ öŠ.|< °ßön›ºöR¯ŒÝý¼=SÓ3ãäTÃûŒGï~þ¬š¹_´Ú ƒC½Ae iÔ] íÜ~r¯Vm“Œ¬yzäªöÍÈ©üØ¥fBWfœÅ:çŸÝ4£TZ䇭%½·ÆŠ aú¾sõÅõ–$ÇÞ‘y/}:u”¸q] ›¼èâ̾yÃEèT½m“Cƒ£-Ve-y¿½™æ<±ÞU]ôJä9訯z#Ìü\Pè¾Ó‚ãŽÇª¡ìcßL¯½n‚ ˜Û®ÇÔ(û½ÿ)“üˆcP;i°n3›žnãF›x8¡‹úM×Ìç²é·¬°ù«Ÿ¡w‹4ßk”ÞhÞü3B ­[ÛÚwšM×A#ÇŒh=Îú›ÃI^^üô®ã‰'ĵЭM]#NÔ‰®VŸq¨ßqfœQÓ¦Õ^Û7°øy¯¾…îö6³Öm¨{l ëŸÖ»æf‰Ç ”z›MÃkë¢=äã!ãmNÕ]>¿-'ÖæÓ’E/ïõQ(~µº­¶_•¹6ÃÎäW/3ÎúéÜîßÄæŠ_ <9Þù^–ñxÖ¿ëÁɺþ÷‘ÑMëÕq£™p›K϶-ûfÒ]µü¸`úd±ïF%ÿo‡P‹\—½>™¢¬œµó,»¡ì©fõÞZ_A9Îêj¡ÑâY#z\hˆúéy7û™]ú–×bÒ'ëcÛ|< 3LQÊØ»W"º·yÛð\ðÌý ë™õôÇÍÞzÑÛ¶['/01@Y[^u¹µ@Öès†;ä=Ï÷÷ÉIÒ³‰÷Ya™§¢0}vÏ7§x¡ì¬9ÑîÁ”µâ¡E¯>OЮçN{ï¶™·AmtB¢hMìÔ®®GKüg¾ÕF0ÂFE¢áÅKt–”«´âèÿ,w KX겯7Ê©i¯S÷¿þÒ@'$,ˆïâïã7È74ˆaf”ÿ“ƒ214Ø'UèÔ±LAÿœ¡ñ¯sBþ åßç½üûL›¿Àíù×ÙDÿ6éo0¦þGëßg…ýë<´ùö¸vÿ>»ïßçþã¿Î™ü×Yšÿ/ô·ƒ$ï;Å^ x_ ù` ƒ”8•8•8•8•8•8KÍÇrð~áƒÊðÿá:œ¢û‡:1q|¸Å=Ì¥Eƒœ;R>&aµb‡M"ÈUâWâWâWâWâWâWâ—ƒ3šcA@ÉàÑpD.†?¨gyúÇ0.aöm Öbxk©„³30¼•IÁ[€‚ó·áð¹ îp£à¶[ž®‡Ã-‰ãû¡üž®7ãƒÛrJøA4ÎááΣý £1Ü–NC= ÛÓùô¤Ú]‡†Rø¥Uí Måׇí§Ê4ô¢a_±~СáˆËަý‰øe$,¥ë¿ÁÃÍ’5ƒæ¯¯/¬cºº¤R‚$`± èµÛwà”Î9°Øò‚÷%üU·_¶¼&‘rmã`ÁñFä»D˜7 ?;]®‚áwÅ~ç8 “«c¸ü>†a¸ã"¿¤ûA*\i¼ntø ÀПÆÛ›†nq’ø ¯œ×©>ø‡L9ymlBºyG³ø'ã ã±VHÌÄpI†»&`¸ÙA¢ž¥ýAÖ¦¡ˆ†Ì<¢E]¡ ƒ“0ôÅí™øå2ÌXŽá¦` S`ÈÌ˦4dæ—†u$ã9ì:ÎÔ%Eã€;àÊ^ƒ^O`DŒlÛ¶ÞªÃÙÄè£ÖÙ:‡[@Bó”`gBe,øzf"ô<{i} ñƒ‹çïP‚¾wη¦ÂÄcÁß„·øy𣧔 èvµÝÔ3ßã €ª×)7(Þ_(oÖì3} +•د1áÔ{_KÃõ™×?7MHÁórÓ;#ª¼MP‚œÚL|ÖlË Ðµß7ê~.¸×ð<®cSX׿ú¶3(é««Šåîtjõ*ÝÏ@tœS{ JׇIš2w=nžÇm:öÎöƒ~ÚÔ3^?èj±~·6Œ|oÑõdJ.ŒüŠŸ™.z‰?—Áë½ úu{`.ùœ•­GsÝîƒk7ê]ÞŠ¬Sàyg&熃¨ëË™v‹ =Ù¬5·Àÿ Æç™Ú»AZe,˜M÷Ó&,@œØ—³ü½Žßv1²gÓ\\¯¤Ç[(Ñ-púÁºæÔóÚ‘ñÔó^Eã‚rM(A[éþ7{<ßÜt†ž¸i9ṵ̈À¯4% =_ÛQçà©Ö£Ú¤îì7!ú™B Ê–ssOï¥qYüSšÌ±­ Ä~@N`HLÆÏÉ—ìÁóv{<·¿"#¤Ç·ÄùÖäðˆ ³o¢@Ÿ÷ãá¡„º í©ùýŸà{‚·7V+ѧ ®ŸëKrØ‚ëOjÿaóU|ªÁï.SÎÛiê VE°*‹aÞÛ@jþÅïÀjæXcõ ?ñ~´é[7j^¦ÅRí•ßç[O|ïiÚhA¶U›ÆÐú4îßæ;g$vV0ª#|Ùq)˜ÚM X°µÄ<ÀB®áy7¡óx²B0þ8žŸ«wPê$`}ú}r ¡Éí9Sê ¸fëq;˜ùÖ¬¥túîPµñh2¡ÿu!‡YÇæXíŸçyp>¥ÞüÈn`ÏCtŒwZo ‹tðþ¾Vrð.ÿP·æT¹ÿ×Þµ5uDá¤p:¡hÕ‚ŠÒ2<êAsÂJ™J±@­Õƒ $<XjmE|€(ˆPTdÐ*Ö¢Î_ñ‚¢ŒNGD_ƒ/¬¯Ò{÷[Ó\DlÕ?ɟݽwïfïžÝ³{¿söÛC€íÔøÐ™è½Å#±¦;a;,ÏÂy'³ZN ²6Tž$ô› Ó^zÞÆ™OžŠûlW¥Ù»4ÏÄpé‰ZáúqAí{ ŽÒÃÂJw‹H½]N/ψi‰^n00Û:öø`q‡à7bó ¯I‚[ùkçnF3åsÇ&د¨1`ÒS®ùdvÝ<°Ë¡—µöZýª³Ú.ç$‚!(×€ÛÀ»4/ xs©iîÆmAGExÕДà~ºd鸂ãÒ‰ížòöëEW°]~ŠÀñ’…ý¯t¡Uaêá”K©Ýšfðn§÷KøÃ¤Ê“Óê'Ô›yôÀ× 3×¹´|jš{v¢Ï㬰DZŒ6¬ßìaHÓUDæýÞä"¸róT–ýMcÁ}¾eØŽàä5Ãù½@¼‰´¢ÿå8/Äã:ɽ7¸wÐl ÌsLç^Ô¢Ø4G$1µ”É·N†z0玃Üû¨çóù8ßí”o'￳l´t2}õ3¦|‡§ÔlëFÍ»­ø=ãpï:½â€ñJüž± ýc ÕÁ^jý¡±R’7¢ñ¤F­ùX¼ õÀb#ì§›žáF¥Šñ(ÓŽo÷d¦XƒEFÉìe‰'Áb‘sÿ›J¯NƒS€¸ÊïXw˜FQ«•©4}Ço›íPêB]ø_ØB5ìMo ².¦‹ébºX_1Í­F=wú¦‰âÉÅÑ‘’0Q¬úÂ@ê‚fQœp¹h¾Ú cˆD+–KE‘sa¢Hñ<Í›beï7Ÿ§¤â‹ÃÃÅa±’xñ ºäw^HC¥ìÏ® æHõa :ª7´1AGCõ\èu4T¯ÃÙû ÐPiêm¿¶çÝÞžóŒÓåÔåÔåÔΩÞòÞÆ«ín‘›@|Tíz‹ãºžî†ÓkùxÂËBt+;ºÊ6PÑ…ÈXÞiD“ RïÔæ¼ÿÆ­Çà>åéË’š|‡f`†ü±ˆœ­*@$®!ÅqD‹âÁô&†G u=­¶œá¶ Æb3¸L6q4€°“Hèh »R¥‚VÓ–?\hÍ´Ãí2“"³ PéC[°¾ßÇ ¡V»©ß×n/Z"Ñ2`¬ ¶Ù‘åÁˆ`.õBK³¸ž6@¼£¤^¾+#CN›Õ¦\¾åÃÈ¹çŸ g¾wP;Íäò¹0- *•º.a¸’Üo‹Z@ËUj.§¯ÃÝÊ4"·+.ôõÞä,´ö!²ƒýIYDÞUi-¤=Õíå<ÝpŽì”Ì2ÓðpžcGÏ ¾êk?§‰ñ0/äSËYhÅõ ÷ëRIx¤ûçþ­˜þ±‘_„ÎÌBÃu„ÔÎðIýË'c¾ÃF˜¯Y†itœáô*禕–É1,Æ0)U£ÀÓB›½ÄGêΡE¿±ek»©åìQ›Áã¶è1rÕ§èÞ2B82ë+RN•–¿Ñ‘_§ÚKé°¦[È$óÀ‚)Rƒ(Û•ÏÑž¶€IKdÝñC:›\×$t‡¤T_p áp§ïoQÅrôZº/Q}ÆÑ[hç¾^þ»¾}ý\âËõ×/;XÝÊÑ;_XÛTÝ€Ô(ý-G·ïñ£÷Û ÔõPQ%¨DþéðŸ˜nÁÕڣѴÜL6•ÑP4øçÿ9eg‰#´J-ô…QªBÇúÑýýßÞ~‚šãƒ¸‘ŽõóÕ~ªùÃ8ÁžövjyU_ãpë"+T.û|¸ãrϳ´£¦Þ^mŒ,O‰ã€ë~™Âï¸Û€Ê 4¯'.9p1²˜…Ás‰UîEwñÐŽýSë}ûÏZzÛ§ˆô_õóðe Î#R³ëºö:õ:žÇx•ü'*ÐÒöûžT’^õ^z3‰‹,‰eXÈÝ>—ÜorÆqU–Žúô0ÓÍ2ç±çˆþï}<¯@›²œ¿J¥*bQKJ&ÔuL>O±ìüoãÙÜ<š”óÛã©d-†óᄼAGèdôöȦkɦŒàst„èºØëŠ½Ôy^,H—A˜,Nªæ/’KDÒ0†1$ŽŠËcEilbÏ%£yE´X®È¤=W^ŒMõ‹QDë`Pcú`Poê^áTP&ßÚ×CÁa?”íÛù¥ €ˆ¤`AƒX>óÙ56œG cbXà–ïpí/ü‰í3_ÁaÃØ´>6Qú™“ÑíÀcummeRbund/data/sampleData.rda0000644000175200017520000000023614516004263017353 0ustar00biocbuildbiocbuild‹mP»Â@ KKËÂÀ‡$÷j;Ó ‰é6ÄÀRÿá)f¸\âKlç®k cE¤•®Aìö-B#½ ¸‡íþz?§uC±Ç9üvõ|9ÞT-–è¡°LÔ 4X2ue#®L\Z˜~R‚ÔÓC‘LÄ4{(›ø£˜i0’ (úÿR3Z[gOo!)ÊϡϿ´cummeRbund/inst/0000755000175200017520000000000014516027267014664 5ustar00biocbuildbiocbuildcummeRbund/inst/NEWS0000644000175200017520000003727514516004263015370 0ustar00biocbuildbiocbuildv2.9.3 Bugfix: - Introduced CHECK error by adding to .Rbuildignore...this is now fixed. v2.9.2 - version bump to let BioC nightly build grab commit. v2.9.1 - version bump for BioC devel release 3.1 v2.8.2 Bugfixes: - removed reference to sqliteCloseConnection() (not exported by RSQLite 1.0.0) in vignette. v2.8.1 Bugfixes: - Made minimal changes for compatibility with RSQLite 1.0.0 v2.7.3 Bugfixes: - Fixed sigMatrix legend argument to comply with ggplot2 deprecations. No longer throws an error. New Features: Notes: - Trying out a few more indices to speed up queries using sampleIdList. v2.7.1 Bugfixes: - Fixed 'fullnames' argument to cuffData::*Matrix() methods so that it does what it's supposed to do. - Added 'showPool' argument to fpkmSCVPlot. When TRUE, empirical mean and standard deviation are determined across all conditions as opposed to cross-replicate. This is set to TRUE anytime you have n<2 replicates per condition. - Added stat="identity" to expressionBarplot to comply with ggplot 0.9.3 enforcement. - 'labels' argument to csScatter is now working as it's supposed to. You can pass a vector of 'gene_short_name' identifiers to labels and these will be specifically called out in red text on scatterplot. - Added repFpkmMatrix() and replicates() methods to CuffFeature objects. - Removed unnecessary Joins to optimize retrieval speed for several key queries. - Fixed bug in csVolcano matrix that forced ylimits to be c(0,15) New Features: - Added csNMF() method for CuffData and CuffFeatureSet objects to perform non-negative matrix factorization. As of now, it's merely a wrapper around the default settings for NMFN::nnmf(), but hope to expand in the future. * Does not adjust sparsity of matrices after output, must be done by user as needed. - Added csPie() method for CuffGene objects. Allows for visualization of relative isoform, CDS, and promoter usage proportions as a pie chart by condition (or optionally as stacked bar charts by adding + coord_cartesian() ). - Added 'method' argument to csCluster and csHeatmap to allow custom distance functions for clustering. Default = "none" = JSdist(). You can now provide a function that returns a 'dist' object on rows of a matrix. - Added varModel.info tracking for compatibility with cuffdiff >=2.1. Will now find varModel.info file if exists, and incorporate into database. - dispersionPlot() method added for CuffSet object. This now appropriately draws from varModel.info and is the preferred visualization for dispersion of RNA-Seq data with cummeRbund. - Added diffTable() method to CuffData and CuffFeatureSet objects to allow a 'one-table' snapshot of results for all Features (CuffData) or a set of Features (CuffFeatureSet). This table outputs key values including gene name, gene short name, expression estimates and per-comparison fold-change, p-value, q-value, and significance values (yes/no). A convenient 'data-dump' function to merge across several tables. - Added coercion methods for CuffGene objects to create GRanges and GRangeslist objects (more BioC friendly!). Will work on making this possible on CuffFeatureSet and CuffFeature objects as well. - Added pass-through to select p.adjust method for getSig (method argument to getSig) - Added ability to revert to cuffdiff q-values for specific paired-wise interrogations with getSig as opposed to re-calculating new ones (useCuffMTC; default=FALSE) Notes: - Removed generic for 'featureNames'. Now appropriately uses featureNames generic from Biobase. As a consequence, Biobase is now a dependency. - Added passthrough to as.dist(...) in JSdist(...) - Added 'logMode' argument to csClusterPlot. - Added 'showPoints' argument to PCAplot to allow disabling of gene values in PCA plot. If false, only sample projections are plotted. - Added 'facet' argument to expressionPlot to disable faceting by feature_id. - shannon.entropy now uses log2 instead of log10 to constrain specificity scores between 0 and 1. v1.99.6 Notes: - 'annotation' and "annotation<-" generics were moved to BiocGenerics 0.3.2. Now using appropriate generic function, but requiring BiocGenerics >= 0.3.2 v1.99.5 Bugfixes: - Added replicates argument to csDistHeat to view distances between individual replicate samples. - Appropriately distinguish now between 'annotation' (external attributes) and features (gene-level sub-features). - csHeatmap now has 'method' argument to pass function for any dissimilarity metric you desire. You must pass a function that returns a 'dist' object applied to rows of a matrix. Default is still JS-distance. v1.99.3 New Features: - Added diffTable() method to return a table of differential results broken out by pairwise comparison. (more human-readable) - Added sigMatrix() method to CuffSet objects to draw heatmap showing number of significant genes by pairwise comparison at a given FDR. - A call to fpkm() now emits calculated (model-derived) standard deviation field as well. - Can now pass a GTF file as argument to readCufflinks() to integrate transcript model information into database backend * Added requirement for rtracklayer and GenomicFeatures packages. * You must also indicate which genome build the .gtf was created against by using the 'genome' argument to readCufflinks. - Integration with Gviz: * CuffGene objects now have a makeGeneRegionTrack() argument to create a GeneRegionTrack() from transcript model information * Can also make GRanges object * ONLY WORKS IF YOU READ .gtf FILE IN WITH readCufflinks() - Added csScatterMatrix() and csVolcanoMatrix() method to CuffData objects. - Added fpkmSCVPlot() as a CuffData method to visualize replicate-level coefficient of variation across fpkm range per condition. - Added PCAplot() and MDSplot() for dimensionality reduction visualizations (Principle components, and multi-dimensional scaling respectively) - Added csDistHeat() to create a heatmap of JS-distances between conditions. Bugfixes: - Fixed diffData 'features' argument so that it now does what it's supposed to do. - added DB() with signature(object="CuffSet") to NAMESPACE Notes: - Once again, there have been modifications to the underlying database schema so you will have to re-run readCufflinks(rebuild=T) to re-analyze existing datasets. - Importing 'defaults' from plyr instead of requiring entire package (keeps namespace cleaner). - Set pseudocount=0.0 as default for csDensity() and csScatter() methods (This prevents a visual bias for genes with FPKM <1 and ggplot2 handles removing true zero values). v1.99.2 Bugfixes: - Fixed bug in replicate table that did not apply make.db.names to match samples table. - Fixed bug for missing values in *.count_tracking files. - Now correctly applying make.db.names to *.read_group_tracking files. - Now correctly allows for empty *.count_tracking and *.read_group_tracking files v1.99.1 - This represents a major set of improvements and feature additions to cummeRbund. - cummeRbund now incorporates additional information emitted from cuffdiff 2.0 including: - run parameters and information. - sample-level information such as mass and scaling factors. - individual replicate fpkms and associated statistics for all features. - raw and normalized count tables and associated statistics all features. New Features: - Please see updated vignette for overview of new features. - New dispersionPlot() to visualize model fit (mean count vs dispersion) at all feature levels. - New runInfo() method returns cuffdiff run parameters. - New replicates() method returns a data.frame of replicate-level parameters and information. - getGene() and getGenes() can now take a list of any tracking_id or gene_short_name (not just gene_ids) to retrieve a gene or geneset. - Added getFeatures() method to retrieve a CuffFeatureSet independent of gene-level attributes. This is ideal for looking at sets of features outside of the context of all other gene-related information (i.e. facilitates feature-level analysis) - Replicate-level fpkm data now available. - Condition-level raw and normalized count data now available. - repFpkm(), repFpkmMatrix, count(), and countMatrix are new accessor methods to CuffData, CuffFeatureSet, and CuffFeature objects. - All relevant plots now have a logical 'replicates' argument (default = F) that when set to TRUE will expose replicate FPKM values in appropriate ways. - MAPlot() now has 'useCount' argument to draw MA plots using count data as opposed to fpkm estimates. Notes: - Changed default csHeatmap colorscheme to the much more pleasing 'lightyellow' to 'darkred' through 'orange'. - SQLite journaling is no longer disabled by default (The benefits outweigh the moderate reduction in load times). Bugfixes: - Numerous random bug fixes to improve consistency and improve performance for large datasets. v1.2.1 Bugfixes: -Fixed bug in CuffFeatureSet::expressionBarplot to make compatible with ggplot2 v0.9. New Features: - Added 'distThresh' argument to findSimilar. This allows you to retrieve all similar genes within a given JS distance as specified by distThresh. - Added 'returnGeneSet' argument to findSimilar. [default = T] If true, findSimilar returns a CuffGeneSet of genes matching criteria (default). If false, a rank-ordered data frame of JS distance values is returned. - findSimilar can now take a 'sampleIdList' argument. This should be a vector of sample names across which the distance between genes should be evaluated. This should be a subset of the output of samples(genes(cuff)). Notes: - Added requirement for 'fastcluster' package. There is very little footprint, and it makes a significant improvement in speed for the clustering analyses. v1.1.5 / 1.2.0 Bugfixes: - Fixed minor bug in database setup that caused instability with cuffdiff --no-diff argument. - Fixed bug in csDendro method for CuffData objects. v1.1.4 New Features: - Added MAplot() method to CuffData objects. Bugfixes: - Finished abrupt migration to reshape2. As a result fixed a bug in which 'cast' was still required for several functions and could not be found. Now appropriately using 'dcast' or 'acast'. - Fixed minor bug in CuffFeature::fpkmMatrix v1.1.3 New Features: - getSig() has been split into two functions: getSig() now returns a vector of ids (no longer a list of vectors), and getSigTable() returns a 'testTable' of binary values indicating whether or not a gene was significant in a particular comparison. - Added ability in getSig() to limit retrieval of significant genes to two provided conditions (arguments x & y). (reduces time for function call if you have a specific comparison in mind a priori) * When you specify x & y with getSig(), q-values are recalculated from just those selected tests to reduce impact of multiple testing correction. * If you do not specificy x & y getSig() will return a vector of tracking_ids for all comparisons (with appropriate MTC). - You can now specify an 'alpha' for getSig() and getSigTable() [ 0.05 by default to match cuffdiff default ] by which to filter the resulting significance calls. - Added csSpecificity() method: This method returns a feature-X-condition matrix (same shape as fpkmMatrix) that provides a 'condition-specificity' score * defined as 1-(JSdist(p,q)) where p is is the density of expression (probability vector of log(FPKM+1)) of a given gene across all conditions, and q is the unit vector for that condition (ie. perfect expression in that particular condition) * specificity = 1.0 if the feature is expressed exclusively in that condition - Created csDendro() method: This method returns a object of class 'dendrogram' (and plots using grid) of JS distances between conditions for all genes in a CuffData, CuffGeneSet, or CuffFeatureSet object. * Useful for identifying relationships between conditions for subsets of features - New visual cues in several plot types that indicates the quantification status ('quant_stat' field) of a particular gene:condition. This information is useful to indicate whether or not to trust the expression values for a given gene under a specific condition, and may provide insight into outlier expression values. * This feature can be disabled by setting showStatus=F. - csDensity() is now available for CuffFeatureSet and CuffGeneSet objects Bugfixes: - Fixed bug in getGenes that may have resulted in long query lag for retrieving promoter diffData. As a result all calls to getGenes should be significanly faster. - CuffData fpkm argument 'features' now returns appropriate data.frame (includes previously un-reported data fields). - Replaced all instances of 'ln_fold_change' with the actual 'log2_fold_change'. Values were previously log2 fold change but database headers were not updated to reflect this. - Fixed bug that could cause readCufflinks() to die with error when using reshape2::melt instead of reshape::melt. Notes: - ***The structure of the underlying database has changed in this version. As a consequence, you must rebuild you cuffData.db file to use new version. readCufflinks(rebuild=T)*** - Updated vignette - A 'fullnames' logical argument was added to fpkmMatrix. If True, rownames for fpkmMatrix will be a concatenation of gene_short_name and tracking_id. This has the added benefit of making row labels in csHeatmap easier to read, as well as preserving uniqueness. - Slight speed improvements to JSdist (noticeable when using csCluster on large feature sets). - 'testTable' argument to getSig() has been dropped in lieu of new getSigTable() method. v1.1.1 Bugfixes: - fixed issue in which there was no graceful error handling of missing CDS or TSS data in cuffdiff output. - Fixed issue in which distribution test data (promoters, splicing, relCDS) were not appropriately added to objects on creation. - Fixed bug that would sometimes cause csBoxplot() to throw an error when log-transforming fpkm data. Also added pseudocount argument. - Fixed bug that would cause diffData() to return a filtered subset of results by default. - Adjusted indexing of tables to improve performance on large datasets. - Fixed bug that caused diffData method to not be registered with CuffFeature and CuffGene objects. - Fixed bug that sometimes caused over-plotting of axis labels in csBarplots. New Features: - added getSig method to CuffSet class for rapid retrieval of significant features from all pairwise tests (as a list of IDs). By default the level is 'genes' but any feature level can be queried. - csCluster now uses Jensen-Shannon distance by default (as opposed to Euclidean) - Added 'xlimits' argument to csVolcano to constrain plot dimensions. - Enforced requirement in csVolcano for x and y arguments (as sample names). Notes: - Changed dependency 'reshape' to 'reshape2' - Changed the default orientation of expressionBarplot() for CuffFeatureSet objects. - Changed output of csCluster to a list format that includes clustering information. As a result, I created the function csClusterPlot to replace the previous default drawing behavior of csCluster. This allows for stable cluster analysis. - For consistency, the 'testId' slot for CuffDist objects was renamed to 'idField'. This brings the CuffDist class in line with the CuffData class. - CuffGene and CuffGeneSet now include slots for promoter, splicing, and relCDS distribution test results. v1.0.0 - Official public release. No changes from v0.99.5 v0.99.5 - Significant speed improvements to readCufflinks() for large cuffdiff datasets. - Tables written first then indexed. - Added slot accessor methods to avoid using slots directly. v0.99.4 - Second beta release and submission to Bioconductor v0.1.3 Release 2011-08-18: - First Beta release of cummeRbund and submission to Bioconductor for review and hosting. cummeRbund/inst/doc/0000755000175200017520000000000014516027267015431 5ustar00biocbuildbiocbuildcummeRbund/inst/doc/cummeRbund-example-workflow.R0000644000175200017520000000635314516027227023161 0ustar00biocbuildbiocbuild### R code from vignette source 'cummeRbund-example-workflow.Rnw' ################################################### ### code chunk number 1: init ################################################### options(width=65) ################################################### ### code chunk number 2: loadLib ################################################### library(cummeRbund) ################################################### ### code chunk number 3: read ################################################### cuff <- readCufflinks(dir=system.file("extdata", package="cummeRbund")) cuff ################################################### ### code chunk number 4: model_fit_1 ################################################### d<-dispersionPlot(genes(cuff)) d ################################################### ### code chunk number 5: model_fit_1_plot ################################################### d<-dispersionPlot(genes(cuff)) d print(d) ################################################### ### code chunk number 6: rep_boxplot_1 ################################################### pBoxRep<-csBoxplot(genes(cuff),replicates=T) pBoxRep ################################################### ### code chunk number 7: rep_dendro_1 ################################################### pDendro<-csDendro(genes(cuff),replicates=T) pDendro ################################################### ### code chunk number 8: rep_boxplot_1_plot ################################################### pBoxRep<-csBoxplot(genes(cuff),replicates=T) pBoxRep print(pBoxRep) ################################################### ### code chunk number 9: rep_dendro_1_plot ################################################### pDendro<-csDendro(genes(cuff),replicates=T) pDendro print(pDendro) ################################################### ### code chunk number 10: boxplot_1 ################################################### pBox<-csBoxplot(genes(cuff)) pBox ################################################### ### code chunk number 11: boxplot_1_plot ################################################### pBox<-csBoxplot(genes(cuff)) pBox print(pBox) ################################################### ### code chunk number 12: diff_exp_genes_1 ################################################### sigGeneIds<-getSig(cuff,alpha=0.05,level="genes") head(sigGeneIds) length(sigGeneIds) ################################################### ### code chunk number 13: diff_exp_genes_2 ################################################### hESCvsFibroblast.sigGeneIds<-getSig(cuff,"hESC","Fibroblasts",alpha=0.05,level="genes") head(hESCvsFibroblast.sigGeneIds) length(hESCvsFibroblast.sigGeneIds) ################################################### ### code chunk number 14: diff_exp_genes_3 ################################################### sigGenes<-getGenes(cuff,sigGeneIds) sigGenes ################################################### ### code chunk number 15: diff_exp_feat_1 ################################################### sigGeneIds<-getSig(cuff,alpha=0.05,level="isoforms") head(sigGeneIds) length(sigGeneIds) ################################################### ### code chunk number 16: ind_gene_1 ################################################### Pink1<-getGene(cuff,'PINK1') Pink1 cummeRbund/inst/doc/cummeRbund-example-workflow.Rnw0000644000175200017520000001165014516004263023515 0ustar00biocbuildbiocbuild% % % %\VignetteIndexEntry{Sample cummeRbund workflow} %\VignetteKeywords{cummeRbund,visualization,sequencing,cufflinks,cuffdiff} %\VignettePackage{cummeRbund} % %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %\SweaveOpts{prefix.string=graphics/plot} \documentclass[10pt]{article} \usepackage{amsmath} \usepackage[authoryear,round]{natbib} \usepackage{hyperref} \hypersetup{ colorlinks, citecolor=black, filecolor=black, linkcolor=red, urlcolor=black } \usepackage{theorem} \usepackage{float} \usepackage{ifthen} \usepackage[OT1]{fontenc} \newcommand{\R}{{\textsf{R}}} \newcommand{\code}[1]{{\texttt{#1}}} \newcommand{\term}[1]{{\emph{#1}}} \newcommand{\Rpackage}[1]{\textsf{#1}} \newcommand{\Rfunction}[1]{\texttt{#1}} \newcommand{\Robject}[1]{\texttt{#1}} \newcommand{\Rclass}[1]{{\textit{#1}}} \newcommand{\Rmethod}[1]{{\textit{#1}}} \newcommand{\Rfunarg}[1]{{\textit{#1}}} \bibliographystyle{plainnat} \title{cummeRbund: Sample Workflow} \author{Loyal A. Goff, Cole Trapnell} \date{} \title{CummeRbund workflow} \author{Loyal A. Goff} \begin{document} <>= options(width=65) @ \maketitle This document is a work in progress and will continually be updated as new features or analyses are integrated into the cummeRbund pipeline. This guide is being released as is, with the understanding that existing gaps will be completed in due time. Please bear with us as we work to expand this resource. \tableofcontents \section{Overview} \section{Workflow Summary} \section{Reading cuffdiff output} <>= library(cummeRbund) @ <>= cuff <- readCufflinks(dir=system.file("extdata", package="cummeRbund")) cuff @ This example uses the 'test' dataset that is included in the cummeRbund package. Importantly, if your current working directory contains the output from your cuffdiff analysis, simply calling \Rfunction{cuff<-readCufflinks()} will automatically find the default files and begin parsing your data. \section{Quality Assessment of data} \subsection{Evaluating model fit} <>= d<-dispersionPlot(genes(cuff)) d @ <>= <> print(d) @ \subsection{Identifying outlier replicates} <>= pBoxRep<-csBoxplot(genes(cuff),replicates=T) pBoxRep @ <>= pDendro<-csDendro(genes(cuff),replicates=T) pDendro @ <>= <> print(pBoxRep) @ <>= <> print(pDendro) @ \subsection{Determining relationships between conditions} <>= pBox<-csBoxplot(genes(cuff)) pBox @ <>= <> print(pBox) @ \section{Analysis of differential expression} \subsection{Identifying differentially expressed genes} <>= sigGeneIds<-getSig(cuff,alpha=0.05,level="genes") head(sigGeneIds) length(sigGeneIds) @ <>= hESCvsFibroblast.sigGeneIds<-getSig(cuff,"hESC","Fibroblasts",alpha=0.05,level="genes") head(hESCvsFibroblast.sigGeneIds) length(hESCvsFibroblast.sigGeneIds) @ \subsubsection{Creating significant gene sets} <>= sigGenes<-getGenes(cuff,sigGeneIds) sigGenes @ \subsubsection{Visualization of significant gene sets} \subsection{Identifying differentially expressed features} <>= sigGeneIds<-getSig(cuff,alpha=0.05,level="isoforms") head(sigGeneIds) length(sigGeneIds) @ \subsubsection{Creating significant feature sets} \subsubsection{Visualization of significant feature sets} \subsection{Analysis of individual genes} \subsubsection{Subsetting individual genes} \subsubsection{Creating a CuffGene object} <>= Pink1<-getGene(cuff,'PINK1') Pink1 @ \subsubsection{Visualization of individual genes} \section{Data Exploration} \subsection{Identifying patterns of gene expression} Partitioning around medioids as e.g. \subsection{Similarity analysis} \Rmethod{findSimilar} \subsection{Specificity analysis} \Rmethod{csSpecificity} \section{Analysis of differential splicing} \section{Analysis of differential promoter usage} \section{Linking with additional analyses} \subsection{Gene Ontology Analysis (clusterProfiler)} In this particular example, the reference .gtf file that was used has the official gene symbol (HUGO) stored in the \emph{gene name} attribute field. This value is carried over by cuffdiff and cummeRbund into the \emph{gene\_short\_name} field for each feature. We will exploit this ID and use it to map genes to their \emph{Entrez ID} to be able to use the very nice \Rpackage{clusterProfiler} package. The first step is to translate \subsection{Gene Set Enrichment Analysis (Preranked)} We will generate .rnk and .gmx files for use in the GSEA Preranked analysis. \subsection{Principal component analysis} \section{Visualization Tips/Tricks} \subsection{Faceting} \section{Session Info} \end{document} cummeRbund/inst/doc/cummeRbund-example-workflow.pdf0000644000175200017520000060204414516027227023530 0ustar00biocbuildbiocbuild%PDF-1.5 %ÐÔÅØ 154 0 obj << /Length 1306 /Filter /FlateDecode >> stream xÚÍXKs£F¾ûWpª"Â<£ãݸ’JU[•69`Ë“ Pñ°­ýõéy€’"KöÚ¾hF3Я»¿é!ô^è]ž…{ÆægßÿHCGÁœyó[0 "öæM"ož{_ÐE·\Ê«›®ÌýÅ=øD ªþ÷¯òJÏü¿ç?ƒ(ìa$œ-ЇÇ›‘8ˆãØJúÐZÿ¤ƒwÏ;^V ŽZA$ñ’ Dh93LH€#âͨbî$ÍïTãÏH’ ¼‚1FY·”¥“Ö.÷Û©ôØì6KP†hUW‹ZúÁÃæÇ¼¡ý4諸°³¬²¢•º´(ÖvãÆè–öO·2ÿò´•NBêD–Ò@¾° a Fƒ“uåV¦mWKý¨ `£Ó2-Ö]Å(­¥]¶´rQ;-Ok•ý×Þ¹G³QØ´Œ•²öÉB•Pg$µãÊ" _Zt*ïU5ÆæpÓZç±*0áªe!ÓÆ˜Âcë0Œªù& Û;»dí‚ $릘½—¶Vœ|TM;¬/Ò•èbO@‘]jkA'ÖÓR]. ›M€Ûr>ÂAvs · XëåRS y,„ýêîŽëœÄáöSîÎu»vÀ™)”¬û\*îl¦ªÃߨãc1ÝÆ&Bô¹Ø 9E6Ÿ€&ë¥*\€¹!½ª²¹S«fƒ[¡¥8é8NÀ\™§§f özþïò˜ðxÂ}³¾²Æ%Îm‰Ÿ›3Õpñ¸– ŸÈÚº2Il躟·íâa‚Äé•·Jß™±#‹Ì–í74 èÓéQŸÆ4éΗ…,·ó™3òmëyW°Ä¡ô„^. ã-4 ˜1tQËó(jÔ¢ÔX°,í{;‚ö×= Û-Ç5÷¿aï‚!:’Á4Ä!ð‡jôIôÕÔ¦c°Û—ÀÁ“×΃“\ží=yÍBZé©…!ÆoqrE§¥?9.ý—ûC7·Ÿú#ïOOýƒP0Ž?dÚ÷§òèHy«à°½WygŽ"]áí»8^@Óþn­ÛN}'a´Ñ@‰t¨ŠëîbûT›ðì9ÿ"Ì>HÏv|IС$6 !µÃ…¹]:Úg¨‚¾sô̶n‚’whü_ z˜ž• 1áo‰l\iÄ,Ùl\…m\?éë¦iJ??®Šª¶8Lo½TıÓzRW*þ¿+]¥-Ü J÷¤Çÿ©ùØß/o¶¢o›vñ‘­˜:’kµTEZ+sZ»ìézš`œ~#¸†œéO²k÷u1ÓØôI­»³ æÀè€BÐwÿq´¾S|Îu5:åºÚèºX§V‰„MÍš’H*„7c"ˆúoõxãÏó³ÿ¸Qm- endstream endobj 173 0 obj << /Length 1234 /Filter /FlateDecode >> stream xÚÍVÝÔ6¿¿"º© vœ8I•(ªÄ•[µЇx÷¬ÍÇ*v8¶}g<α»·´”ª¨/‰=¶ç{~3,Ø,xqÁüŸÃ—Ó& Å›?®.>ÏdP%•Le°Z\ˆ¤e ó"IE¬ÚàmXFq•æá“¡îöF›(¥Ç5ý[ýŽ ¡&5D" ­®;¢ï¦±­šh7›z£¢ßW¯î´ ÞÆ<­xÜ‘|_9øÆ)O*H‹Ÿõ°ÕÆØÞj{C«ºmµÕã°ˆ¯²ÊÜ“)yÊ>+óáó´:ôF–Tbjä‹ bÎÒ4|¡„_QZ†vìÆÍ)ú*âa; KCôw,gM7pÌÕ4‚ç²NM@ä§zf¬“(Îûg¿¬ª¾ìæ©_ò²ðnù|¾`HŽ}‘Þóŵ²´x6LºA¿ÜôizúAÁr5©©¶xWµçœQfÙÿÊ|¹˜/¼ùW“½sÉF5c¿‹b0g¥ÑëÅôé…`_ìç‚/öKõ7~9Áx)›Ãêå \³ðWmæºÓÔP¬PVk®ôÎ<\E• 1gG¶÷ ·’÷ª|Uár†•›C´žG²ˆ#'bò¬üoü­úÂË)¼×Ê@aÂà—Ãz<•˜ÊLH |sŒ”ÈdŠŒ¡ºD ¬…g µÅAé×"ÁC5}Ðꟹ¾P$Eå«0õ÷~‹ª4§-€j>FPQ· …”áõÜ÷õ´?÷Tø§oTÝRO‘EØ@ZÎˆÛØ×`M ŽÎÆÙîfKÊçìÀ)Ô«J^ã0Ñò°Óï'í@î‘g¯Þ¼Ÿ‡;»ëqÇïšy½¦Õ£˜þhø¨F.ÃÖ ÏVOÍzIŸ¬u§„§—ê£mk[_~Gowu³…îûøòX‡KTâP‘Ãb9T„BUݳöNkTÌÁ>>у±µS²QDÁ&ý½’ ƒXItÉÔý®£v} ³ctgMÆœÓZºg£Í¸§þì-)Sº´º¾>w^1IçO:{ÎÙÂàÓlƒýÜÕªô¼Ì®ÓÇ™{ý£bKt;/óÇâÅcÎÝ=[ݸæÉòP}t^ÃM#–òd{ãI¬2ö1#ŒëÍp`ojKdb•AØ`,iUë©ÃrORǧ @NaK߯çì‚dÀ2|¹ôÁÉÖÔa$d€Ì̈5dyÜöx4Îíšyšî&$Üºã‰Æ>$@â«ÆŽPÔ°Í]ÅŽô †ô£;Nu\øšuëµ 6žþ\Øôh3þRþ™Ìîú7ª_0Ø÷÷tÔÔ]çÃ|R,\ʺ Èr2°¤ÅXϨ Õ´¯ç¥O›`d&Š…Á­î:¯ÎlÇ)üÌ’ªÌMB½ö˨%2?XãØ  J›V­ë¹³ŸnuÊ,‹¿ÿÞ…Qm\bÀ~WO†S†ÏqƒDKþ ßS_Ö|ÁyÀ"Æï dŸÈdƒC#ЬÞ5yë ÅBkÂ< s©æ^„›Õ9Tس‘sº¹¶¤v‘‡ýÀwÕÑ-ÿ ¶ó2å1F·âV›?¸œ®ºÑbJä¯×_€±íQ‹<½„!SJRTKÇ;|ñluñ'²LS7 endstream endobj 2 0 obj << /Type /ObjStm /N 100 /First 837 /Length 2232 /Filter /FlateDecode >> stream xÚÝZÛrÇ}ÇWÌ£ý2˜kÏL•ÊU²d:ªrÊŒ¨ŠH|€@f,´¤|}N/— °XÄÆJ0ƒ½õœ>}ÙîÝÕB /¬$¢Ih­…VÂ(/´ÆbrÂR:›0Eá]F ÍÈA) ãE°NIia’H–X¦Ö³Ú(Ì¢pØBˆããQh" E#g ç;,™4fÂ*å _“¨œJ–ÃNÏ B¨ ˜#VVÄl‘ &¨§±(–²&&$È f+¬×˜¡gPN(ÊÚ„ˆ&2-6’E#œÂFô€ | 4‡HgHAuá,„$+œƒœä  ‚#ÈOQ¸Èʃ)Œ4ÀzåxÇÈ× É[b*=˜ƒ-¼8kxR8Y³ÊàäâO[l“Äô²URP#ÍvQØÒÀGÊãr؆xÐLhCC5r •9&ÙÞð‚¤ÚjAüjËö¼ÇŠ€+Fš‰1„ðŒà*Lçá.³róCÞ·È—X ôyÅêÄIæû÷v“Ÿücü¾”ÚÂô‡ é"cžoŸp¹!¡Wƒ»½*/J4—™Õp;f—ž¿Ú>u•wß–§NK Õ£Iƒó¾Ì¯KJü-š¬Jrw̲ÌUÞó[>p›÷= z_âø˜77A´}QzóîÂíâ÷Ùxž¯ÛøÛçŒõzu‹ÏïDó¬djÇ[&{®Yõ)ó´jÄ--;mê‰Þûç{ çegyÕÇ‹®Ê•ºœ¿à¢‰å²½™eÃÿU— ±¹Ÿ&› ¢7ApF Ùé拾6%þwFk»{ÿéÊgÍÍÿ£__6¸áýÎåýNa¾7?@“/÷zó¿åõGç"a‡¸…]7ÜZ7ÅùE¹OL˶É_7úûbº<÷OÀožo“í }¹s™yúW>6í¨mKôö¿LÛ§VZªÝ­Žd[úež—e£¢ÑI”^·%”’}q@pwÝXwRSHœe ›æb^vÞ-]é䀤փǶà¹-¦)­T(|­ÝÇ][³¹å“íjůU­K/ËçëæÆû>ãšlâ¦]ï´¯÷O%i7qý±t³ßöÜ좿ÓÝW¹ÛAxbšRX×}èçÒË2‘^5?mú®ñNùÍ#€yi¦;ž–ö¾,3ζ½½î!Áü1ÎÊR¥¸¿,ÊL7ÍÖîz²ö¥,–!²*}âf·éå¡!…ž–ú,ÊdqÛì—Ó2 oK?n!áiÙV«kœ7 ϵÆùÀ޵oúÃN«¦¸;ÉX¦¥ƒ”—u[‰Ý~ƒßVñUÞSÒro¡·üJE‰×b|r½>神=ß|¾‰ñéäj6¿X.Ö³ÅúNhïøÌÑøõìny¿šÎx—}Øõ×ÙÅõäûå'ñVai#B2ç#ˆXáZ¡©>ïùb±„¨·Õ ^–ßßT³Uõ¬ëÙÔ³­gWϾž©žC=×òl-ÏÕò\-ÏÕò\-ÏÕò\-ÏÕò\-ÏÕò\-Ï?È;UúŒÆg÷ï×ÕöO׋›Ñøûåêb¶ª¨Pç㿌__¼ÕÕ“7]ƒukdF8dâ·E‰d™Ž0§„óž‹î÷2Ç…aTQ—¤ªÞ:£ëDa@¡äY$¸àù¥LÔM†=> ›”4üÞ6’$~ï©´TÞvÂpG„á‚  ¢4‰ÙÐ2:a#lÓf“ý×1Ç…ƒXËo¨½ôÄo˜ƒDàöc1`ñNÚhV ؼÔá^†ðÌŽ¢°¦B[g¥ ¦ÓSü”%½%."yŽÕÒ*ÛG‰?ª«%ÉÀ*Jï0S¤Q¸ØŠ¥é1ÿQdVRìÃH.¸‰X¤Mö@@8°‰Nî2Ö'Išª r6ö[Ë @N0Hqì¸pdÎxVºx7fc‘’Ár‚Aæ÷à AîM<ÐÆâІ¿ÉÁ­3ŒæÛ"|ÿ ïqɱ$#ª5k,nüQ€…ƒÈ±ƒXË LàŒ™|âï­$‘9Ð?¾²ÎËZ`*¨Cà¡nRêÁt\Þ”QùÎß‹u@íà˜®døKµ$£¥>/¦!j M5&(ñ ˆ?ž (5u?”‚[{¤xô%ã¦QJ$s-CxŠEDð7È3ü*peº%l£Øîä~ýÇ?E%¥IP^BÞâ~>?o?×VçL£Q?t²KÈŒaGò zÅ ï ?é;Ëê ·Xo áã/ø6øsIÒüÍÚC›yãÓÕrz6GèD_žˆñ›Ù§õnÿµÛ¢»×¢ý¥-ª¯[G_·ŽT·ŒT·ŒT·ŒT·ŒT·Œ”†h‰ _.dØ5н¾mÉ­xª{\˜mÄ]ˆ›5Ô „šW§îš7?v¯¸÷$TQ 0€ ‰Õö¦‘4DF#T”É üF£Æ_£VȨÊÍ£ØõUQ’¿Rfh0T?–2šŽÛfÔpÀ„G7­u?ÙPP‚ºŸÉFq¤Pãº^Jò³¼ãr‚:›»"cá½Þ£¾í~΢3ŒÿñnÒ7 endstream endobj 182 0 obj << /Length 384 /Filter /FlateDecode >> stream xÚ•RMO„0½ó+z’¥Ûi)”D=lÖ5zÓpS,–d•íFý÷öt×p1$ÌLûæ½×vªA÷#è?A€ 8ŠXJ1ŽŠÖ{÷pÌbYÄYj·¦¾qaùÐZ÷Þ“þ¦­pâ ÏHW™·Üp­8圢¬BÀNbXaÆPV¢?Â4(÷JÙŒúJ×~S}5]~„,á~RûF®äaß¹’Çà-{Ô"¥8il4ˆv#0ÂÑß!×܇Uÿù,×aq4ìº:ì{õJ8©e'&)NU¥#, àWâ&3‹FÈRÛÃÌQOªðG|-»rè'qWÍkðmÇ5^½¼†s'W¥gŽ)M5ÐJKTy;CÆõ£¦t‚ÎqÁâ£Q;gº°ò®Øé÷²UÞ•.‰]he»•öäùª7…Ê÷‹±A¹¸“M½s‚i,8ĸùòå†^Ú= ‰ g]´ÜeÞ7QÇ endstream endobj 170 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-example-workflow-model_fit_1_plot.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 185 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 186 0 R>> /ExtGState << >>/ColorSpace << /sRGB 187 0 R >>>> /Length 58167 /Filter /FlateDecode >> stream xœì½»ŽnË’êϧ¨'(òž9Ün $haMÀhQHЯF~—Ȭµûp,ú¨––±×žQ_füÿ?F^âš?þÍGþøÇÿùëßÿßùßGúL‰ÿiµ\ÿ÷¿þëÇüø¿þÕ?ý‡ýw¿ÿéW~™éãþï?ý¶øïÿáŸÿÃßÿ»Íÿû×úÏéã¿üÊÿæýß?þʘîßþúŸú×Çß…‚m}ÎöQóç“?ž÷¿ï¿çül«aú|Jù¸ÿ»5ü?À}ü·ÿ¯>{= ýápì1?ß¹¾~å–>ÇùßýƒÄy–ÏyÉEŸ?(s}–zþ@ôùƒºêþ¿øÑûzýÌþt_¢Zz>k†x¥ÏšBLêçô~#ä"ï?¨ís”ó$ï?øöëççó™×&}}àÒ?Ûº>0éë×÷÷»þ@ôþƒ1ö—g…H]ú<õs­“ºÕ-¯ÂçûyýÁ;ϬïÓÓþ[&ž¡¿åòÙ˜ùûÃýñ1Ÿý äY?ËþÁ£íÞ •—èŸùùXï܉ßò™gHëgêQñ§b¼ˆ¸üYVŒ ª9Á°6À}Óõ÷¯¿{ÿ¸½ßç_OÐåóy>Úüóý)>×ô;‰ïIÚó¹Šèþ~/Iýãí¿>W¦¼ÏÆÐxü7ÆÃ\’Qb.ýþÒø_JãœÞ‡g¼¯éÚoû×Íy¡÷9Le?IåŧúRï•MýÆ_·ÏòyßÏk`Ealþµ8s/²Æ–ñ™KŒMŠ͹-—^ÂÞzó³Œý¼Ïüèø$¢Û^GFþ¬íã}ÿFúå³eý{Ï3êg{,{_Êi ÿñðw¤ËgŸÆäÏñx<üǹ(£Ä\úýØç¥`Õ*õÙ¿Â×Åy—óônKܦޱòûÓ½+ª(ü¦ïÏ÷~9!_{C ,)ŽÍ¿g~>5°/µWHMŠ͹-—¦ÂÞzó³¼[È»wåçýðÅŒµWÿ§}®w”çùìÏÇÓßC‡‰=×çPÒ¹÷"ãD`Tý)ã³Àõ½÷yTøSÍI©´!îÖõÇ><ùÝÁÞ—vôýË}ÝœñY;¨÷WxÌʹîíM~àÜöò¶¿“ÀŠÂØþkpÞU&lý¬×Ø ~KÌ-¹ôöÖ›ŸeÍ}lÁÞˇnj‚]}}®ýwï÷ž@ø™ßá²/±ãL`Tý)iïê§ŽJ§Î)©´î›®Tÿ='? oÔX<̈ñþ¸ïõþw¿Ïçhû,±Ç%¡cÞ(0ÞCÉÊÆ™˜~ ÍŸ#®¾'. bÿ©ç¤TÚ÷MW©¿>{† ‹¿ûÉ{öØõýÒÞGoÎ=ë»êŠN½…ô]»‹q"8ªŽm`à‰îUãU\£’øÍÃàž“ «Ü7]µò-m¯ê¢|¡¨óÈÇ>€VT9O“8y?Mû‰±“Ÿ§˜[ré%ì­w¼ÆûÇÂñþëÐ}èÁÝtì¯f»Òšþ­×˜ÏÑ«ûžm„á¿›m¢ë¾l Söa@ãßé‡wî'Yb.ýôÁ±–¾®¯‹Ñöûî}ß2û^‰ßÝb Þ_ZHá­4NF• |WƽG‡£‚ sR*mˆ»u]«òž^b×£næàe¬iÁ5-ÖÄw÷i)¤0Ò'"–E3ò¶ê—¶N5ùóœ”Jân]Ãð±/²{Õ6|€1öÅý¼ _~è÷ˆõŽ»¿AºXî붤k¯éƉÀ¨ÞŸ7£í/θº`„ ˜“RiCÜ­k˜\÷w¯ºÍ&W0¬‹´ó¿¯|ƒÉu[JIüæs¶= dgb†5CŒ±g6®cÓ¨ ~SÌI©´î›®z['vã¼°¯C—ý‹¾oÚ»P?ð€mnÖ¿ñ%@Ï,û܋ѿ1þŽtÚ§b^}߆ãñßz«ß¹$£ÀÜúIãsZßGÀ¯C½¼£në~Ýw¶§ëßФèþ°eE†¾£c<ýM„cS÷Š¡ñªÍ2š ´tæÖ/ÌÚ°µÖ8VŠ“Ð¾ÈE…ƒc&deéÕŒ½ÎDõ±Ò l“Æe½Ø5_¯=æÌZzà¾é×Â9y•x|-œ¼y4lÆ»—\{Þ'y± &sö6¹Ã/ˆ jy… ΄»CØ} mš„ï0=¤R Ào Ç[:hpÍÝo)ØÛáïï—Ó~÷ÚKB¯Þf<´·g£zÝæ#ÍÀ%¹[0jŠà ÍI©´î›®ç|3vÝÖâ|NÙ§=œFìø.ì}…&Çvä8ŽVTì>ÁIX¬…-X¥ˆNDõÓ Ä™—·‚5[}ÏI©´!îÖõ8¬zª[F8¬ºnn|"߇ ÷4~ ïC-ÊOó{@yßon`Iqlïà,8r„Ý‘/)Æ&åaÏm¹4öÖ;l¶{Ízÿ¼„ß |]Û'OÇ~†ßüÉ&tèyVH Ý÷À™˜þÈf ¥žºÊˆQ»?¯çì: =ݸoºþÔ¯÷ßû.”"ÆÈ \­_-°>›·ïBÕ„ÞÇ‘C:¹ç'"bŒÌ€=Ý8Úá5*ˆß¼óµRiCÜ­«^ÝŒkÌÂEþëbÀ¿c®ß±Ìï9m_ŽH辯N’6\ª„Ñ|À7£*ð 88î=*û0'¥Ò†¸[×?Å·ÿóvªŸ§ñŽP`Ä8Ñ׎‰°»}HÚ×͈{ a‡M )ŽƉ(^1ÌÈ09—öùУ&A='¥Ò†¸[W+ÄÈì5V·-1ß¶ïE4a=¸Oíˆ}¿ùIçiÝÂ8U:‘R³qïÊý<•„ïpÙ kÜ7]c}©\žX_À˜¸ÖœA¶•æ€}S%¡EcÛ\%…ÓÌ8=t£ÁÇ%\ƒ…X£‚З‚9)•6Äݺ†9sïÎ;T§Úœ †/°^˜wÿÛ¿ÝcB_)<8”¶}k3NDCYßpYßP{LhyÄœ¾Cân]ãR²{=9ÐŒ¼ÿïýÔûrÜËþ¿÷Soc( ]Jv–¤÷oáD¤$ã}_G2n¿°Å£’Ð¥dÏ))µîÖ5žÖ±Á8 MŒµ÷ É6±`=Û·qþJWH;YâDŒCëþݹuÇ_M£žßTsR*m¼U]Ã!´·¶† ¯¯‹QqP*¸s7~-Fÿ¶ˆ-{ÝžIF,œˆˆ-3#ÃV%\ÚÖ(šl«òœ”Jân]µ·f^å²Ðf”=ß¾ð.±íyÕ§Wí÷³ÑdAi‡ [8Ùh3âR{ú˃òßºŽ—b™T!èVôøþwœCÚ†¡¯‹‘ìýîÄûBÐè¥ï&äô›5¤0!'"ÙºMŒÎM¸mtîC£ŠðV²BÚÍHÜ­ë¹o[O©ÛœþusÚÞ6õÐÿÖi”PP[·+ß:M(©¬(Œíû 87c3^j ÊfÈç9ré%ì­·Þ‚˃4­¯`ìÏ»ík¿I…ÉÛ?Lh±Ë5¤xD…#¡Qõf‚ô;â¶q¾v*BæÂg™aõ€û¦«ž¤ûÂ6€rÿ5ãAøã1Ò¦Û@ëÛ[¦eCò«¡A­càgÒóHlöcË€kXqëJMùÇÊ~ xïêZl('Ó><1Ú»Úïpø÷¼'#eÓßVFòœ ¨°¦’3ÜÌi¸IÛp•ôؤ86ç¶œz{ë}9xL®#o‚Iv(êsÁ«‡Úv^޾ñf< + c‡ƒ—f×Þ–öhÎË¡¹“_è%ì­·?ËÜÓîï5>‹8Ò‡FÖ.]‘/*¾éò÷ 0R`MÏbõ1Vºjìë³hnÉ¥—>Ë­wÄÊ"’yEȾÏNy¯P;´¨$¥àæB®™mr&c›’q&V„ì‹ÕV¸÷%XÝ£’еM‘Þ«‡6À}Óõ§Þl.ûOë´[É“!»U;¶%R°[µtÛ­z¹íV­Çk#»U·Ýª=·ÝêòdÈnÕžÛnUçôŽ[Za„ù‰vÛŒæ¤ñ6ƒkp¯A$®Ã¿¤ˆ§3ŽGµ]È}‡‹+ÅZ•„Žï¹„Têwëê+¬®„ú º«P0 "? õ!õ•A‘¡>]ĉ(^XÍ` LwŽDY1jrˆç¤´8È/ﺆ·gÚ]³ ¸`téT™X’ànÓ„Î@½…[›q"0ª¶,0*®^Â!Ù£Çüx΢O mˆ»u=Ç¥B—]Éq\§!Ð"Ás^j·•»4S^µk9r< Uosoá:žëÁfrK3å#æÎ>æB/ao½Ï'ãI“Æ ø÷F×gåÕv˜8×HK;/¾Ä‰XW4¡.Û5÷Þ]Zõ¨$|a~B*m¦’ÙŽ®qã,¼ð­î'ÔZHÑÛw¼…«J&tãÜˆG6NÄòÊnÆÜ¯€p;^.yTºqî9%•6ÄݺžsÒ+Áé#Å9is^­pÁUwï‚ÆæÚM*ÎI9äï‹]’XQÛ»78Ë×m{õØ-¢b=·åÒtÙÑ{ôv2fAdòÌNB ŽNqËðvõ0„vïö¤¨]ÇÍÈòßXQÙ©hÁIüäÄžâ4öWƒç¶\z {ë}Ý{W|ïÃßpqäÏ…‰µ¼¿ò¶±ŠòYf_²,‡Í7°¢š·êàT¸.Œ•;Xc›©bî㢞{ëYÉ–Ž5ƒv®Æ ëówgö ãø`€6¥“ ùtpN÷¨¾Æ2Õ˜1à JŒ B놂ÉYmˆ»u«õ~üö…iøj Æ£Uy‡Hhz†ozZ:w’Á ébqË‘^¾ú-ÇWí|à¶Õ£ŠÐZ¶_I¥ q·®ç­Ø!š3Ù*†ïøðŽç<3Ö¯VS~+Z:ò±7‰ÀŠŠÈsös^;Bì±Iù­Øs[N½Œ½õÓ¢ÍYÛ¶eøCõ>J$„n¯jÂV£Rœ-‘½m› Â-€Ð¨$~sµ‡Å™RiCÜ­ëu~U´Ë)MÑYl¢s3mÜ:7ÚÞLy#åÈ{œ}{PÛçWA׳±eò´Ë±IùüÚæ‘KSao½#(j2»'EM&zwX9v¬ãD²ä¶’72¨ïÔF2ö)6g£Ê ‚`Ë{1qïÓ²cé9* Y9_I)µ!î›®ñR?ÌVªÊ,†âÓ²õdz©Ÿ'¤ w}áD,»i͘{«.ÁR¦QIè¥^-¤Ò†¸[×8º»š#WŒ…ÈÈ çãûáG› }û9›ÁübáLÌH·cìwÆ8$xÔÈKñœ”Jà¾é;Úú~›¾.¾”§Ñ)„_ía<- _ JH'ýNĉè±yL{³èÀÌ^+F­qùiö‘­Ú49ÌŽ®‘º±~ï¯ãÛƒK¹Uø™|i+Ò†¯¹™±ÏÃØ=Þ jz! Îp°ãJr{„jÚ[Ý0ò æóôi# Ž¿§—üp)HŒ•|ÎRÁð$Ë l,„5õIœá‹ñdFÐÈgìn‹§ÃJùMeO`\ü-ç²÷ßûø;÷ý}Ÿ©ïI¶ZÉÎÛÄðßö-ºíÓ¾08Åi¼êEJsQFˆ¹ô QÔ¡ìUíëbÔr7hùÜuËú^F•‡¡‹U(¥IU8ÅáÊfäýÈ—Tþ £&Ç4xNJ¥ q·®Í«„­ÞÍ;èå{'Ù«Ã_½ûKÂo=ÍÁ–Ò ªz1ÄÆÒ+¡¡s”®YN–bé¨DoÆ­ðBÊstéq²gÐ2< Ë03¢Hùd½§·üÙî³ÀŠêç6,NãmJØJ˯ƮÇ2¬¹%—^ÂÞzŸÛ[税¸½uÞ‹­–ÛLÕµ[¸±ôt’y8x$w´öÖÔŠds&µ#¶!ÑÏc“òímÏm¹ôš¶y½cI*ÌUîC9Ù1Ú‹ËFi¦ü¸Ôr丳 T?—#qXtÃØê|âÒLyÅžfX) ¿©|>óaå€6c`/y˜s<¹Tâd+ÊŸ¢Ì#/ÌŠ4¨ˆNãR*,BtcìöÔ`X©¦Uö¨|ÎÙ&]yÌ@²Îâg†oœ„ÎÙk…”º 'bøÊcÏ Â!…Ì£6;–<'¥Ò†¸[W_yp4Û•š â4&Ì"¤|W?ªLSÚ6RqYŽgƒÀŠªq*7§8ÝØ ·ºÇe—æ–\z {ë}gÄí¾ž+%nøwbžÚþðïwÀ$6XÛ‘áf).õƉhö5›Q‘ #*ÌxÔ(bã9)•6ÄݺF|ãƒ^]ýE÷}ƒ(¥4Ç>X Ü–øoLR÷qR²¶OÆÂðßÍ—~ÑußÝ…×]ãßø5eÔ˜K¿°GÂH>b˶šD/ÉžÞ™ÑTLèYSHñx'"ê˜b¢Æ!™ß£F½ÏIiv$P[ßuý©_ø{Xypžuê6ids½W¶¥Õlí°|P@c¡9‹ÒЍÂøï)K¤'‚ÄzPj#òßø;LGZjs«(¥ñ›ìHtˆÆ";´Pvw4%T¥8*æe®GÂðßËA[¢‡^òŒŸê½¯q<þ[?£àÓcˆ¹ôû©î¾¿4þ¿¯qGªáÈv¨Š.û0×Ç^¹öf”?:Rùoh‚Úv’=ÛL/ ÿíDb^λr<þ‡¹$£Ä\úIã]ßxz¥^Þ‡öѵ}å£céá¿1Ò²$kú¦7ÿæxø;Ò°ÕÓpqæx-îæœK2ê4õ›=g¼ŸùTü¥ñ¿À›÷×sü×SñÏ„¸ ¿~Ç5§%Šƒ(é}ÏnŒÂý ¦(ßÑ?…;<NcM•o—Ƶí;º±)G’)[>Z9réEì7½OÜÚ6iרÊœHƒÜ¶À:X4·Qv`lë¹å(ÜXQQ"8•1 ÂÇ4ÌÇÿZsK.½ªã%ŽÞï’é#ï’éAšp!&Z‚Ýs7¡£~)!•389ò/ÄÀ!Üz¶áS£’ÀŸrNI¥ q·®'ڈΨÔ#ÚHŽ3D@d9Î`}/̈́ԯ9¤Ã;× "@Œ]Èw·e(„ȉñœSRj#Ü­ë)ŽËĹ<¢8®’üX¡@I~¬]MÀrÇ’¥¬ÞIœ‰é°3ÆvX×·©È£v[=gWA“Þû¦k…¨0÷™þëb íó0Á¥8ÞËL[¦Â:޼0sb1žFÔ´{!8òô «´oÝãGÐÔ`X) ¿©üSo–?oùÿyï…¶°FBaN/¬£€Gt ¤ýE&n%›ò¦RÖ‘?ûµ ¬¨voqtó¶ðñÖØ%Â…WhvÐm›íže_ÌbL7aWÍ*æÀe—Œ *ž½à––=Œ4t<€ž8Ëa •Š\¹Gás€h NR š¾}n=.U›¦|€híÈ«¨jñØþõب@¦Æ6!rj®sAPÕmBž~ôöÖ;êøì£’]¤ÍŒ‚ÚPð íÊ9…F·•ö%dˆñîK;Ε8Ù3àÄîÝ9êð¨$~s)¤Ò¸oºF°Éâ_Oq00J$0CxÇ#ðÁøÃ¾õ‰ bKuoœˆÌ2£*¼¸²/"þTsR*mˆ»u=«ÔS¼Ê|ÝF'ì´ :õ†Ó­eÊ«ÔÓ)þu­iâ4¾ùÂ6†PjìvB(5·äÒKØ[ïóY݆×gIÄ$®lÇ{øÔ?Ó”?KêG'w`EÕ{}'û³«pP}…ƒjîìϽ²?ËÑû§îw‹åöæpÕ3æþªò~µR?³ ¹Æö3,é@‹p"†Ýuf ªÔ¸†þµE÷ÍÙÔýÚwëꇇ)}}¸êep&oY¨ÄT:ÂKìê§ßQÎÌš‘U Œ5uú™Ã$McY{Åc·•®¹U›EzûMï†lãx¿Å™¼óô»“0§RMÅ0yc›°¢Æ)e)N§[ØÆÛ¯ÆnÇû­¹%ÖqåùƒÞ‘K´ãUk·×É D-M†¶VÄ3M6 ¡Es ÈØkþ2ÎD91à±4KZTá9)•6ÄݺJ}† ìaÚÄhÒiÁõ“oHøÖ5CÊR‰¨.Ùh ‡—÷ÿyÔìèGÏ™õI¡ pßt Z¥'^þb3–BY á*½Mµ›òOÝÊ‘3éРæ‰ág¸¨]ãIKa.µ›Ò­L3¬ßTÖÒ”áEÜ>rþf w!Ö~rftøºškigžq"Z1ÄÀÆýxµ\?-æ,úák Ü­k\ò÷vÏ®š_áøûdPA{? éENBìªß+iCõ#áDÄöiꇺ5ºyNJ¥ q·®zC•ÿ¸ˆ¶žÁÉ$ìw;­¸,ïm”„®Ò{"Im%Ä­0ºD' Ì*(4ÊVúÚò¨$tiÈ#¤R¸[×(|Ïj)z¨<ÿÀ;žP¨ž_8³ló[VöoMŒþ¥æEÙ"LUÙþ™õoíÜ£‰–ÀÜúE%ºÊÚz-¹]eL6Ö(jeÑ#a¿^5ê©\ÏE5Jó¨Úr ë²±Fe@6ÖØ£Îøm4§¤Ò&©±ÆÑõK,ÌsPH w€7Žœ}˜¼o<Ó”÷lý’ÉXQW›GqXÃX¥dkìjlÌ-¹ôöÖ;µÕQq.3PÈ‹½ ¶µ /5:¡Cí|úR{áLDY.3 Ї —QVT£fõœù4Mî›®?u­Ü­ËxöRX¦Htz”Úüล´æ'èÁb_ckNČީb /ªqèºåQ{tÑœ”J›¡cÚÑõx(2k㇑Yaí”íåM,››©ð —#Çå.°¢®ÞJâ—¨(ô9¨|ÆÎQˆÁsg'UA¯bÅÑ;ìý*)ª¾hfÀ°»TEvÝň„,eó ){® '¢º’‰E';øÔ£æ(s¥Lë mŠ*,]êÉfG=-Ô¾Y§¶úBý›5i·Ï<Ñq=‘¹”Âq½o£9¤~LáDÄËm}ÏÂÙ+]š ½Qy„TÚ%']{ð.i`§„9J«+pÌä®ís™¢ËÎêw¬!ÆŠºRòÄaZ°ƒ)w{œ”<Ím¹ôöÖ;Ž÷…§êÒ k#æÓyó¥ïK1u[º-g¡8cE%_:ÌÉ‹QaEOgì|ÜPîºT„©LC¿)­wEhweWÝÙͨjò·¾ŽƒãBÞ…ˆß²dÕ¢žªq"ŠyfàXi\RïÁ4L蔊9)•6ÄݺþÔýë/ÿEÊ|¶ êÕ!ƒ …NÜ]}Ò;Ú¿¹¤ŽÒÁZĉÈú5#©ªÖ`Ìi_uE}yÍ)©´Iªâut ‹û+ÌYô³½¦3ì¯ï¢7áca·Æ )-©„ñß+.H¶²î¨ÊÙ«Fä¿e%|ªeTƒ˜KÅSKg‡e'ªWŠ3ÃSàrÙÕqºš­S^®÷Þb9|9%űù×â0_ØÁÚÓ›ÿšs[.M…½õ—í¶ Äf|] xˆV¢•õ0–_ò¡ÕÒJCþ’òaµÑ$¯ÿ5VÔŠÂÛæÀdiìn…ÖblR~~÷Ü’[¯é'òèýSOG{ÛI¬{9\– \ ~§šì 0Lè.¾ßjI'û'bFg1†"ú€C!AÚ½=xή8AhCÜ­«ž†Ây­D)Ks*­ ¼y:j‘d¢ì8lߢ:÷ýÖXQ%–3s²#TM.Hޱӱ hnÉ¥Wöksô7õTCòe7õ¤›ºá¨5覮ðtÏdB·ô¹Ì@ÜÜ0ÐTº±ÄYê£0é¦nŧhþ«i%•†ÄÝêÞöÏŸÔ5åxlP78qØÆ7¡”ߦv_ÞÅ–HyËåÈé±ÖT›¾9•Ê…m,U®±Û¹éknÊ­±ßôþKzš´¤çv[ÒS¹-ééxneIWáXYÒóeW¿úº‹£.žaIÏù¶¤çã””%=_¶sao½Ã‹4y`èѯzò 4ÅÑnÓÙ¯ú1!/Âá)eµ5áDdW(4õš„c¹&šâ’¡9%•6Äݺž;Cã9|Æ¡ñì¯Yæ5‘u%™ÐA׋ °®,ª",Gf ð½q°çxÔ0yN0¬ pßt ÓbV9îeÓb.WÛÆ”®¶*¯wÚ6nƒS´mLõjÛ"ê›á¶À…O}þ¡mcJWÛFhã¶GןjËEOf6üîÂANe)ÏŸÍ“ÏTS¿µéÍtälcc,)Ží œå^üSc—y\fœÛriºOpôþ©g ¿4þKãÖn¸h&´_] ÄJ<Õ•±é9Ÿ Ù UU»b½œ'¢\nÈI“_-Knÿô˜Ýp–Jân]#ŒdïµE11ºúÚ'f?d$ìm„„ö•B!)*)'"zT˜}ݸ¢¬ñÜMàO5'¥Ò¦*ýèAî»!YînhâUß=kNÐûÓÐD»ï™¤h-œ‰áìD3ºÌwÀuö0j÷-Øs‚am€û¦ëO}ÜÑ©…9¹3Å霅ž`(õAÿ2g}>ÞQª2ùDÚ…±¢âÄ6¶3†Cc÷³ainÉ¥—°·ÞzxªO° T6MÎgõ :èiè {Ç·4R’ËbDYµa{ˆJñ^WjŒÚ®ÂjO ©´!îÖ5òS»ú¹U†Hu\¸Cà~Œ7®/zG){Ð '¢F« 1`’1.»Bï2¡×sR*mˆ»u€¤Á.¾nÎ(î1ŽÉh”ˆz£šð—C*Ç q"¢¼¢Ùw½Œ(£ç‰QS4Õœ”Jân]êéqW Gœ¿ÑXÍÞ³TÈBRêú·ü9¹Š~çIYý;E·,Ð ë1lžÉñNgMÎ%t æÖï§~LjªíXÐJ‰åœ‡-ühm̶´E F$/¯#Ç]3°¢Ö±m‹Ã aë`³ì¯Q1l°’K/ao½Ã%T™…:—]Bõ‰¬pŽ’1ædø= ݘwÅlI©¾p"0ª6ÌJ+ÇLÕģ&Ç£xNJ¥ q·®'Ÿ©+ÃÈ6?qг&´}@‡šÏ{2e[D_GΘtcEuw» Nc÷a+¼»:Þ.æ–\z {ëæ×x»Pêëb <Ôb˜ÿB´å¢§„̯{Q–”ɉÈh1#©¼ðÆM4YÓ¨3º¹iNI¥MR9ã£k˜,‘ [ÜÂÓ Dõï¶üæ ÜÍÊüu—ljÁ…þ‘4\; ªç‹8);‚&%xbà‡oM›tø+p·ºç½Þå4Z:7oq2oÏ}z Îþ•åd`© 9}hÆŠJç CNe a÷!鉱Iùу `ùfŽÚ\ÂÞzŸòI‹½>£¦vg¨P…￱<’2&z3å'wä#W{i@ƒš§,˜8ƒ ’Âv›Ÿ{3¥Ÿº 3¬ÔP«Ÿ£ò1é/=ö&ýźó£ß@ X†KLô³v>éÈû_ +ªÛœÆ® ÂVû4v=¹š[ré%ì­÷yº:Wæç<]à,a‘,³\̦=¦âP=Ž|ò`¼|šmÍc‡3ƒç5¶ÑȪ±›E1w³VI>kþAïã N¬zUêÄÉ¿ä¥åt÷z9äK+ŽëV`MECjsÚãY½aWŒM*~ó~äÔKØozŸße𛾠 ¾]*`„ÉŒv=†–îFèL›\Àh¤ƒµîFC!ì+°uø7Í”—>\zM0:zGÐÞŽ+îÃ-J̘*‰±ã‘;Ê”-IBûÂë(ŠƉÉ1])ŒCS ÚŸî9)•6Äݺ†©¼³ÒÂÌ6•wÖb˜(Ý2`´èÕ„®%û5”ç<ãD´ðUŠë¦qèwéQ‹½Lž kÜ7]Ï[ÑXݱŸ‰Æ Zqv±¤Î˜¯í-{Lù9‡“‡òíÀë5uÅE‰ǃ±í±k¢>¦Â]YŽ\z%¯tGï0û'UÛ ³?6p„ºïm57Á‹Ù?"ÀÔ8ËGa3¦n7.íÏÏ2!;ZJQ*mˆ»u=>#æ6_>£„tæ¡ÎîJÞaÂ>£R6oND¿}F›ÑN$JVzÔ(hé9)•6MiHG×Ó‘"âäëæL6ú.ø2êâ nrQÞ›Ò8òŽoÙXQߣY¸W”z°Û½Æ¾¢Y4wóq Õƒ½õŽ€è¥ŽÁËÑ‹e¿Ô^ñ$]…Ò¦)φº¢Ñv~–ƒ•îãpc'bø†iFÇ­W¸¦†÷ÏcBÏ'ælŠÒN5p·®—¯†þŒÔÂ/˜›O¡cnW.‚L*|5íÈÙ¼ÂXQÙ=nÍáÆeìK)Ó÷™¦Â{ò9õ2öÖûoÊC¯vŽK,ýð$àòÐòB%Sq\šGå¡åµPyèuByUzŽƒm<Ékìæƒþ]z½„½õ>µ ¦ó´üPû¢Éƒ+±>‹ïŠòÁ´¬#¶JZêAU/iW“%yzÍÔNcçS[sKM–Órô¾c$÷[Sâ. FßoÓíb¨42ì#j#ÓÛ-iãkKœˆæàA3ê~mC€”G ,ÏI©´!îÖõ§žùðhòçÌëÜø“.ø{èÖܯ !žídO¼x–#ô=°¢Ê 'GÁ†s•rÆN' TsK.½„½õ¾¢ùY¬ À£Æ ”γÐ},÷p¦ü°¶zä(°XQãT§Ó=,lc½`ÝN=aÍ-¹ôêv=½£aÀ61ö%pÄ*f³ƒ¡:¦ŠBͨӑ{-)Cô…eŽÍh 9aP3ª`õˆæÇœUUr  q·®ú) &kB¦Ì×Íakû‚ú™•ΈýB½ï£(|]-JCÞ·µ °¢Z$Úšƒ~çe.ŽÇ.áÓõÜ’K/ao½êK½M€ÑBâëbL%_à´…ÃÀD,zxž'¤læ"Üp„SˆVQÆ¡¦€G=)ª'¤Ú4›2¯vªª¸—܆cî×ÅèJ.¬ú :Ú6î°Ëh†t°åq"0*þt¸!É“7¬G-‘H¬9)•6E ÈGWó°!첚òb’QvÝí†ÔÝâAmÔÃO¶Ûmß^ )â|Œ¡Qå2k(q™—Ž*B—óÜC*õˆ»uý©»¢·wG·ãR•â÷ÏÅ€ÉHk¸]­“|TžRF '"GÚœiB—?û#jTz ÷œ’Jân]Ïù 1lÃñðÁ™.>¿cAšÂ’'®Ûí”yTçeË\ÞuÊ<š£°eaýö»Ù.s7¶¯öÖûoïóoîíÜ”V]2!-?µ#?w„öíŽpÌþ#<÷AåtGÈÇ<¬;‚n+¾#<Ðû £Qö$3*ìBõRS’©›â{Û/ç )R†ŒQž$FV)’Ì¥¢·5…ïYsR*mˆ»u=§¡‡ç›žã4ô0§ëÒÂÓUãUþɦüÓ?Ï‘OdVÔr,apÔ Ø:h¯æØ¤âBÔŽ\zM·¦8zGèÓÃ8Æ2úôÐ^WQxgۅƳ½½kÑæö¸ü×6Ñe3öKøgb†Z ¤%×QI^£v—Tòœ”Jà¾éª[Íëd²sØXÞ\aïbв™³¿§ à |‹&GI+¬‘‘ਲdÁŽ>ÄM¸£4* ý6cšaõØAèÖõÏ÷죫&kà„ÙEœÎ… .TÅaxô^IÑÞ‰ú!!‡ÅÜXS-Ì.æðXflYÅc—»7æ.®$½Š{‡½{7#»«LpX.c“,ƒEà2vIQ¶ZïÐrÖ×1VTÔ‡ NIKW5ŽÝ¯QsKn½ˆý¦÷ÙèM=¶‡ŠTQÝ{?ÉÌ*E‡ÞFH|«Â‘à¨Þhëcãu›fn)G%áí!‡Têwëz~ŠÄ’OkÆO‘ØÝóaÝ·g*x‰òƒ’Ëí`ÀcC¬©m Í‘ƒ¡Ä#™ÏØýDù>ñHç£W8ŽÞy]•ü6y]éáoj¹Õ˜G»r-¦Â ýyuk½*]£T Ëؼìr®Å”ýð¥™#µý¦´ö ú¿Êtž(ê0˜µX°ÜÑs$Bkû»—tÑ4Eœˆq'b â¨q(êàQ»m‘ž“RiCÜ­k\|FuÙS""\ôßäÄEìo„ž]zS÷AM86k†cá€c”œF­á)Ñœ”Jân]ÏÙu¨CÖ9»6¿PL~§Ñ¦©#ì4.û~äƒÙdŠª÷ÓS/cÔ` „ U}šòS×Ó‘K¯â‰£÷1ë%fÍ­ÚX¼BEær);+%SÞÒÒ"?Oã+h>QŠžû‡îð×t4ï°ÎòßІIÉ`—†ÿŽC4àÓöì¯Å'ã\”Qb.ý~êwüóªÈ øYÞ·WKèg_¼.ï;Ÿ Ë¢)NlÀÛ#ü@Âðß+–:Òc_ˆÙ^­GãñßúØ@;=Ö˜K¿ŸúTÌÆ¬ÔÇÝÝÅx/•ÊHà=ë½¹ÌÁRÙ–•9ªO)J€G‚£âOÅX{£nÛŒ‡G%a'd©Ô#îÖõäfgçr rÓ¤WáäÙ!÷;¥yH;ç„Ü8{fIqô4NDd ›1e§Ë4öÕäQIàO9§¤Ò†¸[×;`çÔ—+`1_ «dY[ Øç¿õD>Ã2X…„ῳB¢QÙZ è<¡€Ç™òJxô>Õ˜K¿±}xQÍ!¶` ÈÌN f{ÔάµO¸çìöª×U #‡Ù)ì}6ç*í±IÉܱ§&ÃJùMåX•±DAãºòŸ1jØL='¥Ò†¸[×0˜NZ<©,Fee«Ä×Í™#³›Š½ye)maE›‚“¬Jjì«d æÇjúMé°Á? Y]aƒ¶Ê¦]‹6EfЮeBïâ3BŠeÙ8Ýyf´}«4¾ñž³*Õÿ©»uš§¨<½™á"¾;"©âc/ö¨aï](a)3k„1½™1”9YiHݹ² ü©æti`•Hžã»®'ˆv»#J=ÕsÅi4f:äÙá*ÑèOÊOF~޼a97VT=EçÄa¡Scé'ôØù„­knÉ¥—°·ÞÇôžY쵄é=3ÊçÙ׊ʾÁ žÓíl±Šnz )k> '"GЦX…«X.5jµTsJ*mˆ»uÕ‹~¹º#ãÍ`!vÉ[,"Äy$~s«ÛÚu•2NDwèœã2}c„C‘%ED´q"¢¡A%ÂÁSàQ›ož“RiCÜ­ëIY,/äÆ…æ¨µBaG\ð±žOSáÑîGÞY˜5Ú2Ìê±í&Ùœ]¨Ö­j”.:E˜fú¸Z/¬r°·Þq®@ñ¬äÖHfdÕÒØ[Èöqã\±† š¸šƒJ'ð™œôhozxÔÏ˧Sü‹ÓJªœ‹Gå;ŽºQظ¡(ñˆÂÆ›F¡…\Ö…ü‡O”iœ¬zº@þ®WËgxD'5doa§ö]Rõñz˹$£ÀÜúEü]f¥iÕ 3ù©KkhûÒMèJžWHQÍ8ÉbÌGÕ^7n×%K•„w¼Rj#Ü­kduÆö<³Š:ë¢%´šl¬{ò ‰M[&~sÃî#¤.câLD†p~+ƒG Ï †µî›®W1W9ÐN¬Ë¤M;)܃ß ÅX¯¦}óÈ'‘ËŽ¿Ñ=¶ï…ƒ G=Øîä°™LyeåÈ¥×ð~ô>'ŠÉÔy΂3ÙO,³îíŠ6{ÉTœ5ב7´ü2VÔ8çXqºƒmTœÉ”O*æ›ÛÑKØ[ïãNžQ&íëæ4¹ìl@è_išŠu²ù°+Øa—o-v û—P™µyÆÎÇ«¹³Sg>Ø[ïH­í ªK‘Z»ô-?Ðq´ðš‰Ð=|?êd<Œª NGµï“/ÐSȔը$´èµÜÒéö©ßuý©×ãÒº“KJù}Ýv=ɰ^îºt;W2³„){~rvm4VTŽúæ„3®².ÝÊ16)þ5ç¶\z {ëýSË£<ð3l‹æ‰'ʼ´ªºYâ…¶²Úbš¦|dÉýÈávluuÑ+žHE=k lžŒ!áØyžÎMŽõtKã´>Ç´áB5!Ì(ŠÓqçÁMF–âìÌô˜ƒ¼ÃidPùÄm“³·z`÷gzh:ÉÒ’¦U"ð›Â~ŸFœ‰¿n΂ 9#‰w?Îà@AŠOëDj»å 9‡ÆŠš>8ÇãÀ"8'ÆîÑþÅsK.½„½õ>[‚ª_öÓÁVÕ1u´N\zU›/=¦¼%äyäÃù´}*;°<8‰Ï±çØSñæ#/®ÊÙÊôŽp€ÁuHµSÌ`ÙCÖ!gç剶"t¾AÑ0,œÂ™®šbFßÿg+&jÔ¨qé9)•6Äݺ†ú•‘ºqš1˜ô‘­}§Ü§ ©_›‹É‰Ä™qã£ï›£qM=ÕqâtpÌOH¥ q·®aø*43Ù€'FÃ5gðõë*&˜‡ ¾J éã&‡%Q£ÔàMGà×­QOÔ·æÌ*Dmˆ»uõKæW;r×éæ°#|FÛ¬²OÀ¬±ER|ñÐt+äðôVT‰Äs2nƲΩÇN§ä«æ–\z {ë·Ÿ]TêýõëbÀB»¸4<(º{™-IŒ–rMNÄpÇg3ð×”}à®lqûÁœ”Jân]ÃqSy#[7`T×2 Ý×Ê0!o l ”²Þr}%cb`6Ε\Ê0¡S`~B*mˆ»uý©á?ï0ºè«ËIùf`=[Óçû‚hÂÑLàY¤W˜Œ‡câL¬Ëaיޓã–>:¢·æ”TÚwëúS¿ð¿4þp@N†ê½}]Œ¹w9®È¨´cvY&|ÚÝÎqrö)½T#ƒÂÀ6€ÓmWÖ;.†n‘­¦‰›Kÿ¿)÷X$úûu1t"L(JVtZÌn6§ÉBóGõͤ·ƒ…¡ÃdÐx)ÍaˆÝcçë4ɹɱZI—–£´hõ\f9å¢ÄA—-$ò¼7F7JQ¾‘î-Ûò±¢Ê)%Nf¡,aÙ7ØcŸjž;EžK?Ø[ïðìxê5l3%¥¦‹/X³YƒY„6Éö„”n[áDŒÈ—eOCÙSÚ"_¢x—ž=´!îÖ5ÔïôÿŒeõÁ@o¶‡ÕQ¸?ˆ[!õÑqRô³4NÄ óýÅïçQãÇõœ”Jân]ÏÁ²é(x–à4,Q6­û`‰’iý>Xî!–7¼sÆŠª÷Áœâƒ%°ÙKŒïƒeyŽ\z,Þ'CkûvˆöI–'Óò‚6X{„Á€¾ULq>æ;[N׊±¢Òy‡Èé4 ÛiÖØ¤~ë[-äÒKØozÃngQH’ƒ3"+ë©¶Ð ¢Bžî¬àÕGò†p%cEuŸ•ƒÓhø¶:c«MS^ŸësäÒKØ[ïÏNöçæ;Ùza"0c¨É B6ö…•„®Ž³›±MfÕ8õºù‚juÆ¡¾ÝƒÎ8Ñ«—§üZh¶THâD”ØÈÄ`>Šp( íQS¤]g_¶TÚDË8£JýL´;T‹‘á@E·Ó ¨˜(MR›î%E‡UãD¤èPMÆD ©p“Õ!9ê¼kG>OH©p·®~PÝÍŽNC±ÉfIª;˜‘Û™ì¸Ï3¤âÅë!ÏôIkªDÍYsèn2–ý_=v:5g5·äÒ+»^íÑûª·4àÏyüR‹Þ*ýPnôV>þÐèí´~CÄáü¸½Õé±íyªô(­ì´v‹±¿5zÃÜÑè­«ÑÛÑ;"ö¹'P˜‘q­a‹ëçÂ¥QÄïs’”WáD„qAŒÓ§pï6?•ÄošЩ˜Rj#Ü­ëO½£ÕéD©M•É 2ž÷´»žÏ]³šòÞ»#…-g¹dc»Ëx>Þ×»Ë|®ç`‘0c§gÇÜ’K/ao½ã.$ßh˜dÊè?‹†yØßµÇ„OÊÈ'®ìª—iÿ/ìª'êê–$Žò2“+†?ÉC§¨Á¯‰%•J~SØ¿²êö7¨X:sfò/yjÞ¦§ŒàYQþ†·çÇrùˆ„%űoÒ`«taÇô¯]DU{nË¥©°·Þ^h+ÓkºøwÇT@j&|°Î!eŽ€p"¢õ€8¾W•]ŒQkœw5'¥Ò†¸[×Hílå­.>f rc18`n í¥}„”!ËÑ ­yT¬¶ª<› 0á¨$dÅiÙ iCÜ7]ÏYÕö»cé‚Ã6 )³âþ´óy4SáÄÏGÞxo®/Ö템泓w^Uþ͔ߟ>Ž\z {ë±!ª&Ó#6ä¡ã{ §'NT ¿‚]®“¾´Œ9$¥ë•8*Ê~÷>ì£zT:A®l†Õ[êàwtÕ“Ô±³²\Æ×Å@ªÅ,ÉbU§ M‰>=*y³¥š•8Q–ÃŒ"3öÃFLµÄ¨QÿßsR*mˆ»u= ûôÝààüº9*Ò1ÙY2¹Üd›¦~ë¾´Oþ’çäŠ:µl6Îd¹IbÛÀáTc“ŠãÈsäÒkº”åÑû¸™ 'b: Ø ”1Ýv-}ü¯ÿúñ?þǯõOÿá_ÿÝÇïúµ/Xåãþï?ýþ¿þOø_ÿMð¿ÿ‡_ù3í4ë¿ÿð÷ÿîô}Ýÿ÷¯ÿôŸ?ÒÇù•>þͯüñ¿2bÏþ­8+|ýÚ›œDþ÷_ÿ`ù.03¯?}ýEaóÍø Ñ×_ÔUÙ E!Ñ êGSdÛiå™0a²Š? yýÁþßõÿ@äýI»ñ$ï)öRß“?wFÒáùܤïÏ]TÖÛŸ›ôý¹ß§û¹þB4þb 9>É[©mOMçHÞ+£æO|,’×$<»2Ìó±÷ ÏÔßrù¨¼G†ó¼Êû¥²`«²0‚3ÜBUU§·G´?.9íÀì‘Ùm‘ò‘ƒ¬f°O÷ØþëGárã` ä±k$znÉ¥±ßôÖI Á{V@3ØÅ¢Á7Ëu.~»¸É6ØY,…9Æ8±šEM8µ¯Ð3K¡æ´”ÚwéúçPw™d—Œ4§¸…j¥ ­VræòñíìVÅãÈyY3VÔ‰Ü5‡Í+…MlX©±Iñ¯9·åÒKØ[o~4o)ì~Á“LpèzÛ•™j-šøÐY£ù”»Íuµ9» k*¼ÁÉÈ 0–n;Üp)æ¦ÜzûMï?Çcõ³Õ߸ýÖ*WœÁ¼X¶½´1\xŸ2Há×®Œr°Ù¾Õ¢´UlÅaÕcWÇ[ÇÜ’K/ao½õYvŽ}Fçûàƒ¤¥I½LS|Î+žlËi;6VTò)ßœ÷¨ùäÀn·J±Iù+éÈ©—±·ÞŽÇª úÌn…¡¼‡à4öâBlÆnÃQ™Õ»)|]FìÃXQÕ‰Á)ˆª76Ûs±³bnÉ¥—°·Þú)ŽÏvȽd{Êï]&™Â·ûóÈÙ¯ÏXQ'K՜ɮ„ÄNö”ÓØ3bw<·åÒkºÙâÑ[Ÿeç?è¶¢ÎÚÁaŽø6³ÜÃ)_n¤8ŠüY¾S7S`M5ÇV§Ò‡!,|æ1v¸ÔcnÉ¥±ßôöga_´ëé×Ía!ÊÅŽj±ò®‘²v¨f!9[µ kjFGsÔöAXµõØÝqý17åÖKÍn½}8á={» }8!g¢°óþ÷¥|²ÑðdùpRœO5Í)ß9¡=°¢86ÿZvAv ¾³Ç&Åà ç¶\šûMoN¢ú‚Ö®àt7{ÔÔŒµzR5Å›XŽi+* ô§²°†°…•54vñ"sK•!T”ãèíg¬{‰r@™3YžÖ̆ü“ý”®jÊÏô“Ž&µÀбR˜ƒT“À6–Èר‘¤sK.½„½õö:¶ø…";çëæ ˜Â¶ÜL~ øn””ÞÎw—QÝò“&°AU;¾ƒ“Y«DXÖçöØ9²m=wfƒJéìw½½Õ/œ ZÙ}Ýœábû”°&}x(ü*Š{ÃL-g —°¦º[ϧѫ'lÒfÅ·zÍM¹õjîý}ôö3†R´»Õ|—»ÜldðÀ.Oé̦¨ÝŸ”É 9½ÇÆŠj.œŽÛ^Œ]"‰ÍsK.½„½õÖg¬7qjE‹ƒšâ2Ö`2è¿S\i’‹ªLù?³¡"N¡h1Xë™Àm.‹qIðV¿TˆÉþÏdÜ­îŸâàõ—úÿ¿ª¿xoÉ÷òà°kåwd;°Á˜å2MyIWC°ÁCO)+*ET®8»ÜBlemcMÊËÄžÛrêeì­··qqöÅFµ(ƒÓÛ—p Ú)Ž×ZMy«Ý­-ïNOéPÕ)‹Á—+°ðrÅØÙ¢˜[ré%ì­÷9ÂWØå¸Ê'qlð¯œ2¹VËcÊGx… váQ=GXR§vfp½#Äî“RޱIù_Ê‘KSao½ý» Ë Å.tµ2gñS™aû ʒ阢â›~Ž|0x¹jYž›-΀[ÑØÎÒd»;-æ–\z {ëíß…ž}Ì¡Gòam†‡Éý)ÎÇÊä ¨a36¨c«0g ÜÂXXbì°UÄÜ’K¯Á«Î­·ð¼©äê:„Áih…±Kï3¼6¾ÎÝ~l€¼SY>í*VT”ª NÁŽm,*IÅØQ­*æ–\z {ë}ž±Êœírž±J³Kå3VX"¤ð«É”Ÿ±:I¢•|©4§(êØ²ȧ±IùÛƒZN½Œ½õöïòàêøò”àœÌ—>áÚYY`¡‘(öµÕòŠ“±¢R”v§<ߨ²˜‡Ê±KæznÉ¥—°ßô>W+uAW8bpp¥(§‹zg·”}-qAŸï|äË™ÀŠŠ„ùààJXV€ñØq‰¹%—^ÂÞzûÝï¾Ù»¨9èÊÓGáˆ1,%™òû)äÞcEÍȽ2gÐì",šºÄØ=bc=·äÒKØ[oÿ.ÃåŠUœÉ>{h³©‡ßô¦l3Gi3Ê3ªkª;¥8÷"a«û¼a*~óuäÒ«ùò}ô>VÔÌÐýt¬¨àd¶š‚ÿvQ•8¦lEÍõÈjA+*Ù?gN{\™=¾û_qlRþäÏ:rêeì­·ß}/‚ÛTçIqŠ2-p?Þ­zeÌØ÷òrb¤'ƒ-øþ KŠcÿöºÒÕ²j`ódì&ÇÎ'Ž\s[.M…½õö3ÆØò‚Œƒ¯›Ó¸ß1ä¢tÇÌ)5öJß 9BŒŽnm#žš¡NWÏÁâÎcGO¡˜[ré%ì­÷1Cvv€ž%Ìà°Wüеƒ¯ø¾6öÓgþa-É”Ó5ÖÔ©`dOÕÆêT­±OŸyϧî^ûMïóY ËU¨f]pX"t©gåõüaé‹zδþKþÐO ¬©5hÌa¡7b÷â6’ÇåÏ’ç‘K/b¿éí59»›\Wö¬9HÒÍ®Š^y:CŠ¡(Ÿe•“йR¦y°Q&ÝÆ1s?ysÒÁ¨16)`Uö\ߌ#}kGïcŠ`ál—½ãq€t“ñ¡ÐdPM…)"‡|"ÅXP+v"1h¢&Å{5.‰0EŒR!ânua¨Óx£¢¾Áa7»Å¦]•Ýì^0Q¾ñ¡*¬äl&f¬¨¨Àœê›*°¨|c—°©xnÉ¥—°·Þç-Ùß]oîÄO}ŸT9¶;Þa ¤ü–¬rõôÖT “µ9,½j,Ë­zìÓ)ØsK.½ˆý¦·Wb¤^mïyõJ,Ìý{nŠ÷æ#¼ „-JNà¡}BÎC¹±¦šÝ"Á©¼ ‹F•1vq²aÌ-¹ô"ö›ÞçfŒ@½Å¬‹Ã®„LÇæÊÚ/}˜òIi´#Ÿ &VÔò½ 8ž)aÙÚc“òjÒž#—^ÂÞzûä ƒ÷©Ð ,8<ºfô4ÞÑ®U‹Ô2å³È‡°¼£«ž±¢†o`Áá±×Xt=v kˆç–\z {ë}ExT<2 gh|ÅÌèùDaÌØ‘w”Æ8ò‚]GXSÝFáà„v•OÍHgìê]%æ¦ÜzûMïãÜÚšcÆ×ÍiŒžAÌãn Yx®Ú¯!)ß’r ùÂÐXS5ÜzæD1 Ì3]]gì|nÝš;ûÖ ½ˆý¦÷¹å/ÞÒݕܜ ÆDm„ó·ª)Ÿúžtä“IñŠêÑ•Ü4 leß]£–ˆç–\z {ë}Ö±íïØ¥Às¬c‹‘>‹¿åö޼kÉd]½NÊëØÎΗ|G—·ÀšJa§òº"ì¶;õ›”×1”•œz ûMï?‰á˜Å_[D7s:‹Ÿ3¥©un·ƒ5ÆûÙŽY¦Ör&N+ªF¢›9Ìð1V©A”˜[ré%ì­÷1aKXNÿ ÎC_ ,³Ûq¦øi$Ý¥ðŸ¥î¾ ‹Í]¶ÁXQ׃"Τ»‘Ø<ìªD1™q.ÚœÛré%ì­÷¹t=ô ·—®gÞ†E_vcG†§šò5*¥#g‡cPYËcû¯}ÙÚ¼}Ù½œ±Ë1™knÉ¥—°·Þg«ï4[;Ò:òúW¤‘nË#)oõ}ùtu`E¥€gç?ôÀî<°c“Š­¾9õ2öÖû,Ùù/jóœF‹yÃ3ͪš0ˆVSalMGiµªÆAÄœB3°>#êÅsK.½„½õö»ðJÓýî‹3}°Gk Öê8nœqÞÏ2Ž|à|d¬¨sz¸ Žê—{Š”Í™9¹ôöÖÛÏØ Å¬¹èOpàñÞOÅŒ“<ûÅ”Ít²ýád˜\qpŽC5§B§:óXÔª±K8À<·äÒKØ[ïsýü¦òŠë×à· ÿ^¼ýMg:ÔvÜ )_¿öb93ŒÕ#˜ÜœF3³°ÕffŒ]ãùõÜÕ~+èÕ„ÝÎØ†íñ‡«¿›jp=‹È›jbbþ~fêû#ss6å•w/¹–O7H+(Žíç<óôúÔÀN†jì9Oä ç¶\š {ë}¢îš²­"Îc{ýßÈðÙWoÔaVœûj¾–ÓŒ ¬©S…ßJ„í(ë±û©Â¯¹%·^Ä~Óûr?ò+—û‘ɨJRmt/ÂäD#ÑóIòÂ3ã¤l¸Ù5ƒ$Û<ÒÁv–\ÕØý-5·äÒK‰À·Þþ,*£—ÈœÂ?féªLKÎÃn 9 ¾(ñù€gÝXQ§‰¼9‰ñÄnkD±Iýö9£¹ôöÖû˜!ÕS\™)8hLLeŸYågz®#gS(cE…É$8™¶TaùpylP~"G=ré%ì­÷FQ~…QTX šÂ(h_( £€•§ûÔè8òÎr+Šª®‰ÆGˈ#nÚsK.½„½õ¾vw.WkœÝ‡Å‡þðɇg›7ÄäËú©X.w6K´×«›™¨fçKpÐL#°…&=¹é1·äÒKØ[ïË<Ü•§þu1‚9P‘u<͸ٔÍÃ}…|¢ú¡ "VÄh‹1ýÜôå$xŽK"ÌÃ5¤Tˆ¸[Ýód¹4P‹'KOGb.(ª5ÞuØåŒ”Ÿ¬2¼³°=еx²\@hl¢SQcŸäÏ-yŽ"Aózs—’Žâ-YNJ’¡s»öÞJ#èž” e9‹Ì kªÄ[bNv°‰qC;·DsSn½ˆý¦÷qlïXš†Þ±½xÏ<îNöZè\Ë&šbåG'[ÉQ¯/°¢Æq¹ˆÓ¹º ËšnûÔ|óÜ’K¯î•ñè}î¿jW±ž¸ÿª?Þ£ð_ÞQ«v¨¯Þu;ÏýÈ'ã±…ng±Ž«Z--V l^ìñ gÑ:O¤ñJ^Ý´b•?è}>K£®é|–Æ~“YÏ4ïãImc‡)–V|Âzo¬¨èœÌ÷IXsÄØ6sK.½„½õö3FƒYB)“¯›³h3ga‡ôxeŸÍ”ßÏ•œE#Œ5ëXœÁa‘Óc÷ã:ÖÜ݇§¹Œý®·Íö !ƒùÙgb¢Ì€ówm4æl7 )¾Í“5ù%ŸXrŒ5"=ÑœÎc‡°Øôcìæˆä˜[ré%ì­÷9ÃA<™·}qXNn»›™…²3‡Ÿä“ós\ÕpNKÎÔOaMͰ̙ÃrrƲԜÇ>¥è<7åÖ‹Øozÿ).]8ÜD-í¯›£È1y¯9†Â¼¢â(5Žf“ÀŠš®€œáE‡¶kìðhÄÜݧÎ÷w½ýº#m­½¥ˆ3t¶jÐyøy²)ŽžuäÊûVÔµ¥ˆ£mAØæ„´'›òñyÕ#—^ÂÞzŸCdÎ~Z¿nŽbXžmߨk¦¼áÉØyJÅØ rx¶ÌIÔ‡ØÅx½N¼„æ¶\z {ëíg †Ìoø8OœèL¾‹PÑKŽUo˜²—cû-Gm¼ÀŠŠn攇›)±ey3mÔŸÈºŽœz{ëýýÖqV¾`}º‹}f-¡¥Ø«eê>‚YÎ#–°¦"'#8,hb,‹˜xìæe1æV‘é¥b(·Þç¹X&$.ÃâT^h jNÍÆ-ªòÚÖÎe¸1 «Å<¬¨r.Ãâ0ÌÈX†yìt.Ú[ré%ì­·? ]룻ò^p¯·Ì™ÚESxÎÅ”/ßÛ\m9s½ŒÕ‘_œ±•×[×͘[ré%ì­··zVÀgÏI[½8h¬¸·ÔÅ­<ñL»–)>5ÃGÄ3ñ>°+j8r78q”Ã[yngìhÊsK.½„½õ>Ÿe¼G(s»#øÉÔyafSþ,sùd0aEõ"NÃŽalÅ‚à±AE$C=ré%ì­÷I§ÛïÐjöЇт™ïßbÛ²Â+)ÌWøþZÎw[XSÍúàTÜ!e´ Ç.'*CsSn½ˆý¦÷Ù_ðøåˆš2§Ð‚@gÎ~1i­ËÝ”÷—RÍÙû‡ö¦'*;j*8‰ÖbwˆÑбIyNëȇ_YMŽÞçÊ2Ta>Å•eбWxeélš¹ªbÊ{ÀLGÎH`cEEŸíàðînlv¯QLùÊÒû‘K¯â¾_Go?co®óî‹óøýݳo³6o};ž†”Ÿƒíü—¼0ZXS+Þ}sCMìŒCÜè¦üví¹gâ ×ôºqô¶ñˆù;ÊÅÁ…âб5˜Ñ.:𔊢çA¸äû±¦zä™ÃÞÆÒqå±£ysÌ-¹ôöÖûzÆØ³ æóŒ±nåéµÓá]ä`ï¦â+GŽŒÊÀŠª'{CË€#cÕóÜ’K¯OÜsÆö»¯M·¥lÒM ;´WW({6åw_[|åÛ.[y«‡ªG»µÖÁÊ!¾˜ÚÎ\[|KG¯('}ô>¹ˆÍŽÅ û&ï3cf:#Æ0åoy’/çŒ~¨q2C–³ z:XYò5vs¢zÌ-ysAOÐûäEîǯ>çZLNãb±ÅCcÂ7ÛË‹²Óº—#Gù¹À’âØükq˜?/¬šhlRvÓÖyäÒTØ[ïcz‘1¤­0½È`Ò™ÜÞi'lt fʦ—YŽ\AtŠ'$¤:aRÎ%õ©€ãh¦üDöiNèÕùÄÝzrW©&äΣWå]´ñfê õd*ÞÏuä´+êiÍ©n0Ùi«­õŒ]¢Œç–\z {ë}rp2ó\"/RœæÒ‰ôõï’ÚO^äãlÆÉ;HzkªF^¤9Åž/`3-c;Ÿ¼HÍ-¹ô*þAŽÞßö—§Ge1зS+üîâÕ½¸öI¹u'¢GM1ÐzȸJ‡-G­áöÒœ’Rá.]OÚÍŽÍì)šp™“YSz ’³3ãÝgáµ=‘sѳ+ùƒyŒuU §=Ȱ¶1üCc“â_snË©—±·Þç±Bèa˜^‚3¹øM*v^FçcÊ•;ƒiÕ©~”C…é%8ª;-,ÃØˆè™W?¼Š*ç8)Ž.!Â&n@;›æNÞ V=Ø[ïcz™4¬¦p/pÈ7Ú+§\Ïr;zîAê[È›OìrFì±mzщ}ÖƒíXõªÓ &[Tì )nf û´|0E@XQå8å‡SÔ X'xìæÏ-¹ôöÖûϱÕ/tßgq{&Ì)¬,ÒN®¶mLØ"å³z.G¾f¬¨èƒœäF˜™õOúбIùd¿ç¶\z {ë}«Ý£E)1PElÿ°ï ¸èÿ “DáÔ,dE;‘1Ed7SúYhƶq£$öõ;oŠ/Ø|ãv•š…õ§!C~ã½àë%­(·§±ÂRšÉ:;•ù¿nb»ÖŸ3%ÅúI;ý"öõ;¯Á.:·4³ û® kfEfMf}ˇl‘•Ý„…„±µrÍAö°ßOÿ¨16$…ÙO »<öÃï‡#¬{é÷-Ɇ"ý R»Òì t`n‡¤·Ö\iŸô–R”Œ…¡ra½+ÆŽ’±˜›vúEìëwÆ’ßÞ-bÉ‹Ô%xŸ[NÍpîJÏë8’ô¾^+í –R{IP\ãùv-z×ûØY‚­¹i§_ľ~çolãªt´øm°U’PË¢XtVÁ•Egµ¡Wk™õª‰¥t¢@Gšë`¿_*cÅØô›'ìò Ø¿ó”âÙÙWwÒ Û­³vïIÛq’°[OH:¥ØÏWö¥3‹c!alR\ƒJ bçÆr†±!é“ó\Âdæ ÷ú‡ß?ãU;˜„ãv54ÄÔ¼Ãýy&PãvÕ“L[Ú·8Ij]‹ÆÆ_oJ´‘X¿=±ãv5榽‹ó¸?üΟUÇW¯7j¾‹¹>­ŽñÕ[$ý¬ì5%»óҌˠÐ0ØÉ< Œ I?«6ÓNOOä(í[›ùŽMqé±™ïØÌWR¥#!ö’âzJÒËÛs¥»ºÜô’Ø­¬êòÜÉc[Ã.7[žrr좃IÌM{Wžõ]ø|4¼%Ì ÍAÿ¢æE=ýâ+Eª…S¶TÖ’öéåCÂRÊòiÐðTØ Â Žå š›vúEìëwNm «;=i@Àv§x]Y˜¾›$=û¦ý¨Oé)Íä銞s;PDZGòtpnÚƒ‚‡Ùéw3[cöàÕ’†e3¨ÄTI [ÏìKÓ=d"ûpÒ+a)õ¨Ü•m|„­ˆº4mT¹«¹i§_ľ~+C ­¤óy ‡¬ÃðpÉ©–Q˜Ï‹ºTÑ~P¡E¬¤x^Bƒ—·°àOÑØñ¼ÄÜ´Ó/b_¿Ÿ+ð#|½4†=޲ռ`káŒi=èM+ûÖ…y=)exTšê¿Aa‹ØÍK“Wà#íô‹Ø×ïÌÜs6«“MR©AñèFñh+A*s%áßîø£(; W…¥t²I*5Ñ/Ã{G¿ ÒoþBJM;ý"öõûG„¶m'fûPú}½2OJ¶}ÛA ŽV!ié)v´{°’fÖãQƒ"(aQö¤±û[‰xwØå×PMyú¯o,å_¯æ€ª§ƒJìàÜá=(é%ÑOÚ—ÏÊMigF75çb'/Ž=óñë"5++ý"öõû¡ÝÀŠøäL“Hƒ9ÓÔÌ™nM’^ǽ¤}¢6x(%­ñ dI·ì†^À1v}s¦IÒÁœé¶ûú½1ŠÀëÞ …à{ê÷¯³âg}ô:fÓÄŠ`퉥´rc@ÍÄ2Mì@Éǹ1àܰïh¨è¯‡×ï§Ž„ %ã© +*{P\¯S)ŒynIOiÇE‡°”znª¨‰:_Ç"«Uc×H6ÕÜ5ª£jb_¿õ½4¯­Þ”ôëÕt,~ÝkHí8DÎÙ%é7m熥ÝA…¥ÔT½š*²ÄƒîÓ$Rô±KðëjnÚ鱯ߙxhÛS<»_æû¥ÄtVûMÛɉ‡ýHÒiṵó§M,¥\)B³µQªl±!á{ÁܲÓS`?üþƒvceBhZœ‡vã¨÷áî’ô|²@`?´ÄÉÆÓM‰õû¡Ýp£ûƒ.i-iÂ/4’øð;“ŽíU€¤á¯Wsð+ÝJÊ,Hl·~Hñ¸a¯Î±.¬¤LQ–fâúˆX}5v¦(knÚ鱯߹ëØÊÄ‘…šîËýAÏ–1°©Z(I¾è½XÃŽî0Âui‹•‰šª&3[°¶sìènsÓN¿ª6dé÷s”ÄMÍÚy”Äý9+ê6Öš6%E¸§}ûâ/,¥š¤tÔ•tDœw±!i#KƮ鱯ߙ’ø½.^ÿ°_ּ̡»ýB§‡Šžá°¯rv;Yó¡Æ.— lØ;•ë>*Ýu ±•ð¦¨ä=|}.Vº%Y®'Íø[N¾å I(ù–×ÍCÐDÈ]pãûÇ*U7*¦è~íI\CSŒÚâ”sÒÚ˜:÷§¯I*mýhFVªI³Á¨»<;Àuv¼2“’~ç¶ÒËŽvÂRŠJµÐ ÚLXT¢iì¨T‹¹i§_ľ~?ý#°ÐÊ+ÍÍÝ »ºì% ‡íâo5Ú¨¯VÒÈT|jºÒéúÇœgì]‚4w­ ûKìþ‡ßú,ø—úþÆD;) È"Dš9ÔédVIð®¡EóP§Ï'–RË^9Ô ·°¼û2Π ÂÎÝÒ¯ªþ2éw–H4$9ë / b‡ö<¡Ìá‚wÃbBOséëLÈaÇý¡°”V䥭Œ°ˆ;jììùš›vúEìë÷Cv†]ZËJèÊŠcÞî¤üBQ=$­¼­½”`lEÝnJ5Š„¤!å°–“²blHZyþŒvútaé÷³³žé/ÊYj6V;Û]£ôÜï3¼«¥ØÙï´w4((Êm¨ScÇÎ$·vR–c¯¤œåÜ´ËS`?üþdß GuÞüI×àZ]´ë σӬRR@rÍ´{qw`)Í|^¨éøÍ‹+yÝóyáÜ´Ó/b_¿“5¤ õõP@’š¼Q;ˆ¶,Ï ’ÿ¦ºÓÞÐ)œXI>¶þÚ5 ´FÄV„ä9v²KÍM;ýöÃï\“;Ž§ÄšÜ¹•E§­†“7߬bŒ÷‹G ÂÞÁáUÄBںƎU'ƒXÛôÎ’ÖäVÂ.OÙÇ÷õû‡Üqm1$èJ[š­Ü²†ß¾ÿsóù>!H,ÌÖ!x2 ééAÍod‡Ó9öˆ+mÍ=”·6аŸ~gÌÞ~jãªRMšY|¾Š<k6‡_—9 )Âr3í]i 'I‰0¶þšéJÜ7Ɔ¤#Ù-i§§Ä¾~?UªÇëJËŒãÀšÆŽã#Œ–IÆYÃnñƒXI+é^¨:0NTòÀèc¶Í•vú5t`L¿óuãÝt³Ææâˆ­ÇÂÂIzã]$éuŸ´#y@XJI_!MÁ/Ø}ñkÆØ;é+8·ìô‹Ø×ïŸñ¸ÿuÿ?+K&){¯ òõh¬‡2âÓ½›ùˆ—.I4ÛÅÊî‰Ç…„±õל„|Œ}Œ„è€wî1·ìô”Ø×ïçâ:Zl|½šma ¿<Æ-C«qï I‘šrÒîw¯¥´"Æ*ÍD̈X\/hì1VÍM;ý"öõ[/Ï=n¸€øz5ŒlÇ#·Èœ‘Œl^,;‚2ÂJj*$MU¦€c±kì’:œ›vúÅë…×oíßÑcÍØOt©H ÈÚ7šÞöëb‘¤ó‚§À~ÐŒ—XIUY“¡)Z7½ÜõgŒcCÒ…¥Í-;ýöÃïOæ¯z²Ê–Pö’} Í«ÄΕͭÄÞE;™½ˆ•t¢ÖVš¢Y`+({96$E̼'üR5®ûEìë÷ÏXºšw•èÉðX[ó+›×Í7ýáÀn~ û¶Ó@`)%¶4àÀŒF;9°57íô‹Ø×ï$_ݸ~Ê¢fª§Rö°WSJß“ÑÓÞ¬¤‘™SÔt%npØÏ“c·¤ãÜMMãÝ/`?üÎ}âDð¾—Ø'NðÜô ÿ¶_ÃãJŠùvØu…¬¤ 4Cg¬ ¶’>sì æ¦~ûú,3T´J}¤f©·±ý‚­Ç 3Öº$x7<Qöéa)È“¦+'DZ]=—}ìžW*œ»ë*Ìýêº&K¿ó7VÑÎ1.|¨éñòÆ5>÷çæ$$ýƼkí 'ÒîSj¯w—|w'¬Y;ÛÀkîƒØ¿ÄÒ%抙þKÓDÔ]CfÄÙ2°•žö‹|b%å§alb¿vwÆØÍvŽ+‚ñÚûá÷s'J*Gׯ.›üÒ±¨Sï½%[ ,=îÈ“½ƒÓŽØ®Á:K3Á÷MìPË%– ì ¬*Mø5ÕÎi?cëX8ш«g7ä‰ôµHdꎅ#"êX8WÚ‘Hö´H[ÇBÓ<-ׯ§E∆‰:z³Ül‘ؽ-{Ž$lË÷õ!acrRÙ,ÚüÉô¤·&I;£qÓîoÉÀBÂØøkjò3€­àœæØ5“>9·ìô”Ø×ïäZöÊ×fAȯWÓÕµê‚Íyba-K£åìU²ãº_XJ-“©©è˜E,®×5v´йi§_UݶÒï¼eظŸUÔTD>Ë@>¢¢öc=’t˰WÚ72Oˆ¥”QSiùQQQSÍM;ý"öõ[¿1o7S›/_¯UÛãG•«âñ¸U}ÍSµ¿xlö ¬¤ …†=â‰eÿxޤ˜vùì‡ß™s3‘¶,&&j²Gw÷<²QÁ¶jxH¿ùtÍžöbAb!õ›|LÔO ¶sAÀØðט[vzJìëwæ¨mT¡5(®(ØÖrá|füöJûD øÒ½×[çt–—–Ø®»)> Ñê†sÓN¿†ÊŽÓïñª÷6 àM;ÙÈ}bŸÅäɦÃr+Å…¤]—åqÈŽ6òÄJz²¶©aE±¬ãØ5cßœvùÕÔH(ýÎGd`#Ñj<"›† /‹¥oDìÞkônlº ÕÒ.;^ÂR*Ž¡f g±V ·blHñˆÔ´Ã/a_¿ÄÏêïWñ_ÎWq'rXN”-RsÙãtaÿWtW0¶¤¸¤i¿¸"ÆþÍÍ5³uü>à(“çî’6¤£¤}*çÌ?üÖÁ¯ÑïO%ÍKõ~åÉÒØ[l ’ÎL;)ˆ¥Ô3õššŠC±Ueh>v¥ÌM;ý"öõ[¡:ðþ]ãëÕL/;Ø`,Á7ß±QúÍÊXeC¡°”züd¤i|ÖÙ;bìÿNšvùì‡ß?‚šÐ_KÃ÷È"…•¦"¬ƒÀôBÁfE¶4$Flã.ûò°”JЉR3/.ᵚÐcCÒþÝæ–~ ûúýdÖTß;êzZ\ØaX ùà¦ÎXHÚÅZ†‹ì? ,¥“×ÔlTMk»ØÌLJ¤H¹äÀ.¿€ýð;oLü‘ÚYqMgõzãqpž2­)Iw ä<9È«]5±”vV\Sµæû©SçØ3k>8wÔ±»_ľ~gïuÏÖ2Lw¥ñf˜¸³¯È¸M’Ö{¥±ÈÁÙ†9E¡ÿ«°eµ»gÙ-ç¦~ûú˰ý¡õk± »¦ëÖཊÒbûȤ.ËŽ´fa)µ D—¦êܱø€»d•=ç¦~Uݶ¤ßOïü¢DÖKÍ(bh8Wmä~2?Zd½gaÿ@ûÆÞ‚XH=R BÃJL`;+11vÍ-{W߈µÿðû¹ý¿ÐäëQ,ß-Ž}מývlÁ„ ›#ÏÝÊ«3Ž]à(d*†RášçA{[uŒ=H4'­ð†¸Ç×ÌFiȉ0 5‘âmÖšš{¶–a”Ž‚zÚÑ)KXJ%Ã(Ð|oü ñ.»Ì/ÁØ"º\ßü“Öûú?«Ñlñ³Ú¤ FÙíÕÓ@‘îZ’ô³"UÔ@I¯-MÂR*™®¼µ´y Ø¢*Ž I?«yÒÞµ¤Žñ‡ßy ¿Ð°+åŸ'a~î):.áW•¤èùºi;1Rjo?c×T$¦["œT%)Üäs—G­Ä¾~gB03y»Ú;R3£ÅeöÕê’æd¹tGU´ghÏh­w5¶þúpá=‰mØpsì§Ó;çnÚß“Ø×ï§D$%o².È` R|ˆ`.Y׆$ÝM•öZTC]vJ%ïW GM žIÝ!I½³Ò¿ˆýðûa[˜ô™» “­÷.êÆ.èg7Z¨ïàë䡇U¸x½#¥öR°-ý"öõû'Þ|_¼s|دWÓA‚rñ¾x÷V¼ÏF¾›Þw´7¼ •Ôâm$ ÜÖS;cìHýŒ¹‹º_ ¼~?Wa×7zïKsèVäûâU€Våô~™-í¨7–Òs¹µEÙ¸kbÁg–M Ñ*žž~-½þÒ´óÏvßK#«ß¼¬,ÛtM¬vÜ‘êlIz_ß‘öë ‹°”Z¦èSSÕ‡úâFh×»$Iç."‘r¿ˆ}ýΊMk{¾;×0žM4+‰þõvÝIo­½Ó~°1­­©±ã®lz×Z‰ÚùØ3wAœ›vúµÄ´–~?¤ÈßÜIû^P«eÿ(¢ð߸å¬8Éî¼mê©Í[Ro¬¤lY/ÍP‹&Çväßrì.ŠŠ˜vùì‡ßyªï¸SQÇ`iXÂ*nƒ;º\£0$êGMû@\šXJOÇ`jŠ0ï{‰±!)"í·É´Ó/b_¿ŸVËß’%w*í6*v*GîBªÈ*I¿ƒqÓ¾ÀÊO,¥“ ÑÔl$5kéÓ#Ɔ¤·»xñGúµÕî$ýÎÏR¹?ȶ"ó±­ˆ·ª:j+R›$}–VҾЪjkVŽÆÖg)Á²­HÃe?ÛŠÔ&IŸ¥Ì´Ó¯©¶"é÷áèmhúq²¤Žš+¦ÏNjvÒH½^2ÐÆ>Kdí3±”ž--5 —iÀV´•çØâgÕÒN¿ˆ}ýÎÚ§jÕ±£ö©ãÌ>qIBÿâô¶$éØÔGÚ·šÌÆÖÕ¢kŽ8SHÆäy³’®ùëM;=%öõ[K~q»gÙ&5(ßùþg°Ê—=qY¸ýä é7C~ölÈŽ xa)%y¿4ÍßmÂ6\/pì$ï×Ü´Ó/b_¿õYÀüµVtD’4FÕ ÍLb;ïxò𱫧½ùiwDDeV­#Ædö|IlÄO”yŸÞ>7ìò Ø¿õ½Dw졬µ£‚‰tŠƒÉŽŠ‡[%E 礫ha.#¥{BiÈÁ]#“dçØ5Öœ»¢ˆŸ~¡K؇ßIÂd‰Lõê{‘Æ’û˜YVdé€(i]Ix7gÉ~ýí&,¤šå¸ÒK[7nñ1vÍr\Î-;=%öõ[ß NzVÈÏBÍ.øü8û튤Âî%æ"ˆ[Ò>5Nõ®ñBéï§yã °|wH:Õû>ƒöãË«°”NrQ³ñÉ]K•‡žK¿ÞÊÄ1ÒN¿¶x¥ÒïÌ7( L»ÚóS³tMgOd[¨¨ÃÓÚžÑ êiÚqq*,¥‘­2©éøÎ‰mºÂó±[´¯ÓÜ´Ó/b_¿õ~qž–¨•©CÂöñŒ(r¢—-i%•ƒº·¨%'²¢m–RÆCÒàRØïÓÕÚ16¤ßôÄæ–~ûú­Ï‚WAñK·¯W³•Kf/´Ë³“©í‚ ékI—²{Ô"°”âŠ/4h—'lÇK‰c÷h»¢¹ûûÒöõ;÷É {ѲcŸÜÀ\ˆ’Wõ­JÒž©°?Íöb!VR4: î´„mbumU’~‘µ§~u]A§ßyÉ}pºÚ™opëÈÍÔFǶ§;URœzOÚIAH,$Œý†âëQöÐÁBÏ\†S%éÊ‚KÄéé)±¯ß?#¢WŠõ—îéB³qË¿ELâ\{…AŠ[‘v£z.•´¢;¦4%³Äzà:ÆŽàxÌMû%Áøý#¾Š¿îÿçå\cßÀaOú׫™ ¼S¼g‹•ë[’">äM[¬|4”ÑšŽšabj†9vËVPœ›vúEìë÷Ïø*þºÿ×ý¿îÿuÿ?ªß³Y i-B³ÑêÒo謴°"±VI¸,òû½°ûÕŸ°’‚Ö"4îa`¢º{$c*ç†]~ûáwv(l0©ÒjP {xªA‹—ƒD+Hº&+#ì· ¦·tÅÆ_½ñ×µ µ%¶ã“sl—t©vnÚãDUÛ~ë{YÎ@Ñü ÿëÕtPØoç«hl³ÇÏž-.%<Œ¹Ân)¤#°’"a 4UÌôŽõð»(8sÓN¿ªñÓïç‚°à.D‡ŸªD˃ØïÆŃ8Wv;‚8…LÍ´“Å™XJåW‚»$)>»g‡sÓN¿ˆ}ýÎMÓFr–‚ÑÐxœ× ЃÂÈu$iÓÄ6 WÞ‚Ø£¦ ­íbÆ"¬·al›’6M«¤žûúˆ‚n„š%B‹÷¯­V+FqIÁ< cÊÞa)ͤ¡&½kf¸—c÷èr¦¹#”¼Zb_¿³¼•lbE—ÔÞ7À y¡š$ýÛÕ’ö]SvJ[ÁèÐ áIXdiââ€R㇦©™Œ—’c·LJáÜM öƒ}ýÎ:‘ >eõÈ‘æ ÖÑ÷ô‚¿g 'ê ºÖ3‘4Fûòs‡°”vôÈ‘ÆK_;A£Ë±gôÈÑÜ´Ó/b_¿s×uq¹ëº8¬MZ4pƒ¶×øÏ¶¤ØG´/¬Kië Úþ‹¶?{‘ŒæžAoRûú»®«_¯¦¢HÃdzkE^pž-)öQ#íà™–ÒS M=ʳ¹¨%¬96¤¸¢¹i"¹{þðû¹žÅêÉrp×LzBúBÈ\ ÅõìI;RÂ…¥4"AAä1ët1v Z[ÍM;ýêjB—~ëy©H‹Ú ‡fÆïI” 4>­KÒÖ¢×´û!;°”FžÓ©qvÐÀ6œ¢9v‹S¶æ¦~ûúÏ ™MâôHÍFKqF|3K/Ÿ—=Ó¾pzÜ¢è_]cëyYq`ì@ÇŽKö˜{ˆ3p·Ä¾~¾ê-_?^õ—ÄRxÝZlÅëÒûª§]Œ¸ÀJ/M'{·‡M;dÝ‚¦SsÓN¿ºº¾¤ß™ÊTQ8EŠHÍE’%nvWA¹0«2‹RÚ”Q,;nœ…¥trÃFÍF1°sá±!ýæ™ÜÉû–öµ%öõ;ëª.ëE9@ÍQ‚+©˜|t‹$¼ïN;x„…¥´3)…\N Ë Ç~qqnÚ鱯ߩ;H3†Ö1j=i@ Éê¼¹=’´_3í×wKÂRª¹a£¦ –$Wµt66$­à³¤~ûú©²j$®lqÄ…»Xvº<’ b‹£›M„ÍGŠgd‹£ýëmqtclHZ)Ôâ覧[ ;Òï±´·²¥ßÙäÒp €ÄÒ‹¿›|®ÙäUíi÷8T`)íÈ&—­ÿ„ž-®±gd“knÚ鱯ß?ã«(NGвc¤4£¨9¶q³ZGH…™Ý3½ ù:Žî£–RvŒ Í…8°Ö²ÇØ´zŒ’vz ì‡ßYiÌ"zuœ‘5+Ü*–ƒb”¶$éP×{ÚÁù",¥ñ𹆄CÄ2›c·ahî†î ô««î8ýÖ[äúfïÖ ’¦i+k[ÃÛÁöãUT”ô3¶”=Ù»ç K)Ó›¤ñ:%aQ§¤±!á¯17íò Ø¿ÿmb¶Tbûõ&ö—üEÍØ ?‰ý ÒQbûõ&ö?í#lÚûדØîûk=YÌÁ_ô¹¿žÄ~µs.¿>ÛG§A¶]eX¨™êÿ:Øãi  x$E m¦=A„¥”¤é œ¾Û½=Çn±ƒÔÜM½egKìëwW7º$ÕÁU¶§s^Û‚0(þaMIšo÷´w´—!–R‰Û=jžÎ¸ Tm%Æn'O ˜›vúõtä-9v !س’©òÖŠ\8³-¦¡I:=Ö•ö…‹bW\™$9RÁvlµÄ%–#I+‹ä¸R°4‹ éw&Û»g×lsBMS«{m¤ÔV¼ öóàM(;Þ’ÂRÊ'@š¢±sx\±Ê´!I{çºÓN¿ŠZ¤¤ßmYØõìζ°Wê8ÓM”µahHzÖJ»7ò ,¥,¡fá–—X´ÌÒØ3 -97íôkéî<ý΂>/9º¯ ÍõC«…™p½k—ì× e(i—WVÚ£Ác)xº¤Ù@"v£b‘cCÒé‘ñ•ºÒ/b_¿ÛÀ?|×åq DÅS% óò@iÝ#‹Ï»1c‹GIvÚQa×#°L1HpÕŒ’ØÈâ+WRÄ [ÚéWä¦ß?ã«ø‡»¿š-g¼õÒ¦˜hcÚí‰cÑøò^vðpz»FY—Å6…ƒ0>*¥½uª½´‰óÔtÚ¢7(ç¤Þ÷øš‡òMvþd÷߈@qY´%·ôž€7ø:”3>VÀîoW£ÂR*‘,EÍA^±™LR„ïVÚy5Jìë÷“fCŽÄ§¹äbX¹ðjJŠ´–ö)®3±§ánÜ…‰Å„¤c;ÇÉ€ÒT Wwú5E2ž~k ²TÝ­¶4¸UU-ÔU\Ük²óˆPÑ,ŒöVPÏ})gõ·ØÒd!*âXYåcϬÜåÜ´/Ux³j+ýÖ÷RD)3”þDÍÅ] øÅÙÖ©4•«ŒÜ¾‘xœ÷Œ÷&–Òɰ5wÀ’*›cCұ𮴑ãŒú‡ßú,ÞèÏÎdKG)j’³†/&­ã¾xú:IW;=˾=CEXJ57ÅÔø^\Øz‘œ…±!éb¡®´Ó/b_¿“gÖûg®è„#ÍmYñ*ŒqÐ馢çÉN8Íà²wpÊKie'jè6±Cn|ì‘p87ìò Ø¿3èkÇÈ9ãˆ+ÍÒ1•ôv¤Õ#õ]q=v´ó–ÒgËjרŽ#.Ç~úr‚î×Ðñ8ýÎïÅ».u[ ÍV_:ï%x”»aÿüb¾‘v§¾ ,¥}¤™âîø&nͱGävhî¡Ü^ûá·^ØÍÛu/¯¤Y`ÄñÖ³~©Z¢Ø^f8wÐŽž¶ÂJš †…f€GìªÝ±óˆqìŽÇÜ´Ó/b_¿õ®D¾ÑòvÎ_¯f£S.¼l"¼2í~’޶[”WkÂRZñÉ¥™ª„wì@¥;Ç~z˜rnÚé×Tkžô;Cu%„sD¨Ž H²9b‚3A!é}vOÚ‘V*,¥=‡¤Y`Dhºóu~ªV"ÁïQÄÍ0oú…™¿óya«àß¡æF˜³ƒÙÏŸ-½ô¼¬“väšKéd—Ej¶:%.¬EíÄØ"<ÛÃ.¿€ýð[ë˜7ý°îLº„—f&M:,cºøânAOHx“{{’°£#±’‚34Èr µÆîÉ@À¹a—_‘}™~çÞ’»=u* æF_tO©ØTn5[ Žœƒ”ݪ -› žREC:'bÕJcŸɘ[vzJìë÷8®Gó´®R·Ð ¤WÜb¢sõ~¬”ôz,%íè+,¥äýÒ4äpE+6RGøØ5©#87íÑæmõ?üÖÏjûêwDM¥9XîŽz‹Uôäé[’–—1¥±å§waCŠšˆÐ€ SØ RŽ=#jª¹i§_ t>¯ßi¬ ‹¨itMC30»¢æ$Eíî\öëÛ[a)=íd©)ØO»@0˱×G;Y¿ó§~ñ‹¦ßŠ©xw<ûõ5¾¥ñZr?¹¡ñ©ç¼%½ÂêJ{Cq?°’2>-ÍFg%`'H9ö B+ÍM»üöÃïŸH#p}!Õ?5[ç.nãn½ÙtäÜhû*;ºQ K)‰-¤a†CScÞÛsì$¶ÐܰË/`?üÖvò€È¯Fs5išÚçxÊxGëô9ƒ¤;»¹Ý{ +©&±5΃"l¿˜æØ´UõÛ!Øå°~?Uˆ(HÊ­T‘…ÁCr“¤-X)io`8îQêÊ MÃ].±Õ¯ã4vÍ6¿œ»"åâáÿÃïCtG¼_\ƒb¤º¸A$}PðË}‹+œh(¦Bú ¸ ú ³=ôA÷þzèƒnÞy“>èÞô‹Ø×ïÌëšd‰T™4¶õ@¼j`[Â]¸’~óPÀm cac–Ò NöÐÄÙŠ¶%Œu+é7WÔÑÒ¾u³Ö~ÿÛØø7!±ú»!±§’¦¥=Cbõ#$öTÒ0$¶>BbO¸íááÏØù‰­?ü~² iKóŽ£AÑš:Îá§Ë4…È8màr£½+û€»¶4vd€ò-T:>D9v¾‡5wG…ýÊMJ¿³Šîà:­êøE ZZ WÑ_MH<]ÒoîxnIûÑÏ¡µ”VÖ_U0ˆëØ¡ïé’~s“¾gÚé×ÔZúý#ø^Í‚èM-±t¹±ÚZÑ%œuaNÈ@IK—½eG1¤°”z$2KÃJ1bþÒØ5·wœ»ªO£ûEìëw&\ã1RƒwÓöîMvq? Pª$%xB<íÎ'¬¤ˆ´†fëjʰ -â8v‹*ÍÝ¢ý\™ýð;?‹­Ÿ½Ä#"M®0É™À)’#ZÚ=¹7°”¢#¦4–à°ÛŽºÕ09Bç¦~ûáw¾êy9ÉFYb¾x€/B!‡ ®QÒ[µîì,:–ÇŽ×)¬=õgklJZ˜ÉDÉZ…ýôûG<î^­‚ÃØÚqztÍA˜á ûªÅì’´Ò¯*sx^aCÊVlÒ€!W؉0Çž1+íôk! öúmŸåøõÙÿ<=êÛ‚y=‡¸o¬þïÿí×ÿôë?üë¿úÿãó_ÿúýÿe»¼öëýÿÿøû?üë?…ÿׯÿð÷ïÿe½à¾«Ïÿÿû÷ßÿËã[ÿÏ¿þçÿåWùõ¿þ«üúoÿUýÿªÞ‰á¿Óàk£yxïžK ñÿü׿—ÝvÚûùÊÏ_8sqÏ¿ üüE?©zü Êø /8Õo–â@¼Úÿñ˜øˆÏôâÇ0ýÅ÷, zå@|þÀc9ñï¤ÏmÙzûùÜßÏÝ&Ör}nÈïçþþ­ßç/(û_¬j±ÊøXßÏ}(ö!É'³ƒdK{S‚³¿+›(×A0 ¶`lšvùì‡ß?ã—ôÏv¿7/¸îÖ²[œÐxïÇÞ<§Ò^òÍ>””~û_{DÙÑ]EXISY¡ñv õ¾‘1vW@ÌM;ý"öõ›ŸÅЏ­éËYeh¼%¥½Ü-oIÙ­Ô¼Kòù,W¥¤Ýo©KiЬ24ÝwAÂv{Vcì®Ëš˜›vúEìë÷ÏøYU/ˆëß‹$S_BÓý?Í«Æûr¢ìn™&[¾zï;öîK©)õ%4N”Øbg«»(æsÃ.¿€ýð›_ÅEñ­U'óÐ/MóhÔEL±ùWÛ®—ãRÂò‰R`ÙQ&,,¥‡~iŠ_¿kZgŒ ¹e§_ľ~ëÅqÄÝñY¤qö[ÎYÞc/·ï¥~Ï^󤽫ì¨î”v~jÐÆSXß/ÇØÁüsÃ.¿€ýð›Ÿåû+ûÞ#~£Ô-š ¿„3Æúï£ÐEêÐ÷/çûGÁçZžÞ/«g÷ ¡DS*(òˆ€;~sÇQ!àO}NYÝá_õU söŒ%IƒxЙàQF¬È2ݯ$¼g·÷|–Ý[Õ–RÆ’¤A8@X„ 4vÆ’47íô‹Ø×o="Ë׆îëþ׫A9ØE¢WÇ¿ Ž®”ðÕ_[†¨évqÚ„ i)%4¾övxý™Æv csnÚ鱯ßú^Øó÷Ä5«4ØØºO²æ8’ô3æ=IÅ#4z`%%ýÔîŵ k”646%}‹ì^ìvúì‡ß\†‹'ñzÛGÄ’¤YÞ¬½—Žâìê7Ë œ’ð/íÉÃa_hÎK,$Œ¿¦æØ}°Ó©Ÿ5ö jhÍ-;=%öõ[¯”åËv¶Œ çàÚx—îò·óœ’~ód/ Ú[ÁXIÑ264Î÷XÖbìxcnÚ鱯ßú5ðÿI†æâ›ÅÝÀ)øf‡‚˜bT?SL…n÷{‰ÀR:‘O, h·‰5ªÆcCÂ_cnÙ›Zc;öõûGìTþºÿ×ýÿ¿ºßI£µ§šF„ÆïìlA·W§=ü^ßž‘ KøñW¯ì×_ËÂRš*ÿçÜÖsîcì®Ì«˜›vúEìëw†DHZ*ViÐŒçD&¼½¯/½•läΔ°G†¾a%õ`%‘Íx„E£|47ìò Ø¿µYѾj²"Íñ°¨my,EÖÊ„¯o‡n—ô›/ùRÓŽs°’v䢄ƙ¤„µî]'Ɔ¤­šÍ MxêØO¿Ÿ-ù]FnAºó¿¬†m@õM…ŸY I[‹JÉŽZ^a!alýj Ø[ìDMìÜøwÀØb RÓNO‰}ýæ÷b½—®<v“¹1ˆTØ5¢mz÷P…·8¬KÔN»ï:K©Ä/’‹’”À¶ƒ ŒÝ’'‡sË¿„}ýÎߘQ¬­kÆÐ¿*¼8q-ofb¿ƒÕ%áßÎ3œÂ޳°!m]3†fùÑ\Øik_Œ=ciÔÜD ô˱Ÿ~ÿe¸àG[qñõhšÎC—™ÇÿñÌ;H;iÚ‘<#,%[í?Ÿ;ü|¢±G”tknÙ鱯߹³WDà_¯f{f‹!`wj90$IØ™1ü´v§ ,¥UEÒx m`‡WÅkìUEš›vúEìë·¾4·dO±¤ñlÃN‘Up‹ BIHø·þ.‘}¢²‡XJGi§¡Ùø‡*’ø-ÚØ3*>4·ìôkë’~ë³à\|#ˆšæ²í–nxÄÆO0Å烄Ž_N‡½yü€XIÄ . k¡cCÒÆ °Ë/`?üVàçx‰¼ºù¡{Šå¥‹v?:ÈŽp%a©¬ž×@ûökla%í¸”†ûb±ÑØ3R'57íô Ø¿óõhԳ˼¯WƒH1ö&Y¤˜ûHúÕørHûÂÂI,¥ªôÆÐx›ÑÀz¸0Æ.ê sÓN¿ˆ}ýÖëÙ#èÞ¥™NÙn{†ÎÛ—µsJ¿4ò(h·¼™XJ#èÞCã”í§sר#èÞ5·ìô”Ø×o­cT3+OèÔ8Ÿ”GÁèì·\è)V¦švÄ „¥´ò„N ¸Ñ…õ£yŒ=´‚ÇÜ´wò8öõ;#Zžætï¡9¸-ô¦ ýåí1\S’"Z»‡ý²& XIA÷pY ;ñïÀ±gþ;qî©§]ûá·~cÕ/ÞÛVD+4H‹Ú ^ý~óœ'Z•„ßs±‡¯ÂN5óˆ_ÍTã {u ë@1öŒ—¾æ¦~ûú­Kh_rŽ'|= ”!O_žNWïÖq)`ñ³„¬~” ŽB‹¯Š¢¶®†Cµ2G-qÓË9a¥7À½¾Ê}çoÙYyJúON¯`ù~ù Môí­Ë eˆ£5§T€OŠ8ÐIqÔ_ç¤Þ÷øšFï"èú¯Gó½Qkˆì.ÆÀɶu$éwn˜²c=$–ÆÖÑ5 ¥%¶yn“Ɔ¤£ÍM»<öÃï¼Öi˜}济kâHZAÉãªEW!É; OËÞ=V+,¥©.Ô4¼?‰mxrlHZ=¼ vúEì‡ßŠózm6w*Òx÷‘^=§Æþ³x“º$é¦uö´{®O`)UÕÁ‡¦`W¬uœ16$ü5æ–~ûú­ÏâÇŠšã¯WãÛn›Áj¾%÷„©&IÞÝ’vÏä,¥ UoÙë›ô»hYˆ¹i§_ľ~kåõÛW+KZy©aÊ“ï¬\ÆSž¦7\¤ãìžiß^ù",¥š{4jd˺¢}½vN»^ðQLߪÔ=b³>">7í^z(¬¤‘ÿÒÔtõ‰mêsì Û¹a—_À~øý3Þˆÿp÷Z}'W(iœ;ÇsÊ—ÐÛ¶l¡¹3$|ÛhB(; K©G4[šæia+8^9vh¶æ¦~ûúý3Ûï}€Ð¬ÕX ê"Óä€÷\Dß=SÂ"‚0šì üóÄBÂØZ :j™=WØŠÝ,dž¤ªÝ´ÓSb_¿ó¸^@wÕÔlÝU;“ÉÁ]t;Í &°“Å@þi)•”-Ϥ™8Ü;p¸çØã½«&×ËÜé°~ëñ‹à *‡¯WãœTö£žXz=ïÌ·Ÿ”°|úµ´ìÛ· ÂJŠÎ°¡ñV2U„Æ®A¨¤¹i§_À~øý3V«ø¾½<кáþóKÓŽb;å”uéÝx-+I»Ï¹Ò>pN,¥ÝU¤©M¶x"‡Æ.Aâ§¹i§_ľ~kµÂ§Ä åëÕ€ÿ½n;¸ïF(qFï…‹/BöëiÂRÊó4 Pl»æê±Êt;ý"öõ;³„üÈ_¯Æ_k´8´ù‘JBà<‡: ´’XJCÌ>¡ñc\`ýµc71ûÄÜ´Ó/b_¿õ½€Ðah…) šŠßÞä–”s/rSVæ10pîšNBP`Cê#oHX´ ÓØ-–ÍM;ýB3³¿óêÐèVËï…_Óüúî:Æ‹£.û†Nköï³gÚúK©å÷BMõrayµ=t‘Wßœ›vúEìë·NèÎsm?*C’æØÝ°3íÞù{!lÍ^ ~#©¡U¹ý"«—XJ;’¤ñîË8Ýsì™§ÎM;ý"öõ[ß Â7kë(šƒõ{`·ýub¹lER\Òž´ûmq`)}„Ø\³<YX߯Ø3êj47íô‹Ø×ïü^ì§Û‹ømBã½P=¹ÙJ—œÙÐÐC’¾{Pd÷<¸ÀR*â·‘¦ù-¡°Í;§jlHú^ÖN;üöõ[Ïþð;‡–½¾¤Á‚ù½öYuBÃbzž„¤çsÌ´#Ø),¥ìõ% [a±¼jì욢¹i§_ľ~ÿˆŠÅ<1$˜ÐCƒ”04C³o˜÷0÷HzIÙ퉥|è¡Aù˜°Íœ‹±›(ÌbnÚ鱯ßzÜ’œoãëÕxû ϲßÆÂº§$=À§§ý€›XJ5Óî¨a2'°Tè16$-ñë¤~ûú­G¤‹üóòNTš¡â6§ xYN4¯A¶e­·fÚ·Ç…¥ÔDNšŠ±U…oåHú͇µ”´Ó/b_¿3«n‚jòh¦Æ äÙ…½ùþžXI[krh˜<@¬ècì`+޹a—_À~øëXÅ–DƒÒ —í¢®¹lö×&Iϧ=Ͳ£û#°!õÌ+¥ÆûÖTbì$¼ÕÜH`‘_Žýô;·ùv—¹¦š˜…fieêØNûƒ2‘Œºu!ÛÙUv\ÍKiÆ ͰK`;V&ŽÝc#­¹»V½±ûúû±Å¢Éû1×xZ¥?­E‘Åï«IŠ­øMûV-ýj)EFPh62€­ R¬#íô‹Ø×5óV#ÍÖ¡¯WÓ±Ê" Rnh°‡¤[9og»UÍÜÀJjZõBSQvAlÁ*˱K\ÂknÚ鱯ßù®ì`¬;Þ•|ûù1¿éÉ#|ó8ç|ŽøÝ3Bž=B,¥¦yhxL'6Žð>ösįz³¶š~ûúýïRîïÿT4³àCû™é‰ïö/5›$­Ló¦O¤°0öïg]éhÀçxÓØtò|aô`–§L£ýÎPeGž£=¤i.d vqÇ)º#í ,¥šÕøÔ a±– 8clHqž¸i§_ľ~ëÙ÷HœçŒó{‘†Um·«Ø-zã¡+ ϧӇݷ¥T‚šì…¬ÃØ”JasË¿„}ýÖgqî÷:§ÚÎ…fiå* &÷{çëÔ•3òob+ûAݱ’fdÐI–a»V5;oû57íô Ø¿ó]Ù'Þ• ¡Ó‰w¥Ý•-ú°O@Ò»ÒöÞ²o´µ$–ÒP€;4^4؆ÔNŽÝòéâÜ´Ó/b_¿FÖöFÁÿu®ü¯Ôa…=Àu¶ºãEÂå–¯°6ÓŽúaÁޱõC©ì˜P…5ŠÞ56%pjIûE±c_¿óf‚íÄú› ¶,€A²bÇÏf-ILi¿juƬ_¶9ëZ´©AXØ’Ž=ôøÅÜ´Ó/b_¿“1É~qVì 85ÞzA›opÂùÆ|KÒÆÝž ÙÁ™%,¥µØÒL¯§v"ôͱgl#47ìò Ø¿“ˆkbÚ™D\® õNÉQHѶhe ¶zß ž´ã½',¥`«MC>±^Uc[}ÌM;ý"öõ;,Þu Gͯ4CgR¶*¸²ËeH±MiÇí;°!õ\º¨iX~ˆ­Xš8v†tšÛ5á>üÎWÊ@{˜Èé„fye°ó¤¢—Œ?ÍèXI¯”1Â~|·$,%Œ­WŠk˜q ìD œcCÒJasËNO#£8ý΂ÆÃÒ|=ûG]Ö <ß8»ï)I!Ü¥òïXIM ƒBS aö3rì!dÍ »üöÃïü, ‰ì¸š†›ClÛ®B:OôYèý‚÷óVRÕ=Fh|a¢`ÅØôYlnÚå°~ëõ8P¶Wµ&‡¦a—;½cÉäébyGHJ˜=íß<±”jÜ“KÃó°ß›ª1blHøkÌ-ûPaoøý#nYþºÿ×ý¿îÿuÿ¯ûÝÿëþ_÷ÿºÿ×ý¿îÿ§Ü'ðgAc3íYc€d˜º%á<Îî´³“.±Ù“7k *k z`+Âkþšt·ZMìëw¦%]ô÷Ôu¾4qixVã…â¹’D½+íhè(,¥dà–¦âR‚Øâé|»Dѽæ¦~ûú™®QÐ¥ó15È+,è#¹º‚É^xÐ3GiÔ²;ÇS`)ÕüäÔŒ½};ò 96$]δ‘vúEìëw^é±{aQ(œçaƒS  ^´»$ÍÇüùBB “XJC¡áÐ8Ñ]`§$Æn¢´ˆ¹i§_ľ~g,Ù =†òõj&rÚ¦Šîtš•{«ˆq³@r$–RDlBÓ‘OGlû ði‘Q©¹i§_ľ~?ñ$ïô–ñ$D]¼¬ÿz¼÷Uæž&)âI7íÍÿµˆ•Ô¢µ4Î ØâW]’€sÃ.¿€ýð[W­ž`W–EYÔ P/.ô‰HAGWù­ ìòtÌ´;cY`)%¿½4Õ/¶„­àŠæØÉo¯¹i§_ľ~ÿŒWÊ?Û}' lþ¥6ePsA<7«V@<ÂFHZKïL»“6–Rÿ…fƒ^ص@=ˆ±×JjBÌ-;ýÚ¢5¼ÏØZy+’Lj•·b=œ¬æÀZI ËZ…¤•·ö´p‡K©fÜŸš4ÖŸøâÂcCÒ¥½Í-;ý"öõû!ÜßN\u,Ôl¥ÞZ½ƒ\ö¿ €¤›+„ÆSް!­·Že ZißĤÞrìñÖ±øÜCi½î±¯ßáÕU5M¹> | \9Þˆeèâ¦(6?•£T˜GT»D¤wœ4XˆÅïScçïWsÓN¿ˆ}ýÖÑ£åu5‘Ô‡Æk’âÅ ,œ ·I h(ea¥°”Z¬ÓҘ؂†»dÃÎ »ü"Áïë÷ÏXº¾¿¥Î½¨.!©9¸¸t.{{·²â wIøêîàh÷b²ÀRÚú¡Yª*¸ç½+Ǧ¸˜›vúEìë·–.âZ¼rÙ©9Á©ÙqÈLÝ")®|NÚÑ–EXJ;{Q3õï4Q'XkŽ=£¼OsO•÷ÍØ¿ÄÏÊ^0 Þ¹O M ’O#’í8D\´^ÈÄ´ïWaaÿ¦¶ÀJÊÄ4i ²-€µ÷犱!ißfsËN¿€ýð;[jxÛŠ‘©ÅÔ°Ff{úogý̉†YY¯å_ÖRê±5ð"VÒÈÔbj˜mMlWê°fé'˹i§_Q”~gú:súɽÞŠV]¹Ä7UuÌdía_/{%v¨áIJÝ8¬Í–XÞ¨rìHûŒ¹i/ª«˜í¿sÿn߬mpvìß+Ò!ò¤¬rY(¤ôŠEJú´’v¯v ,¥¡:ºÐtï-¬ˆ;ë¦57íô‹Ø×o½RîŽÎî¡Á%ùöš?{ù5sñîã”E`Iv²û™UXI'¨b¤Ùêéy0·fŒ é7ßÍ67íòk«—húýp¦#ýœ)ß¡Y8Î]QÄ.”x²åÎX/'aDzlHOÊw ¬sÝË21Žed1wÇQ‘~9öÓÆöwÿþüg»ï¥àè+b£e™L@ÝH@쨌gIÑ;§ž´U`‘RÓ[94U{FÇ%§²$s(ú8E*1júEìëwòÁY_ùÞãIføOúÛIçlAq<$a \žW)»7Ø ,¥σ4^b«ÿæ5vGBsÓN¿ªè“Óïñ³ú§»ÿýö.ˆª¨AšéÕ¬Fs]Å@ØÅÒÝ!Åîs¦ýئ0°”Fä.JÓEoÀ]Û„øØME 1w½Ai‰}ýþ_…Wrc'¨áQéÆÖ¼-S‘!)`l»3ÚQ!)¬¤'¤©Ò[¤ãØ%;OpnÚ鱯ßY+cçÃq"á\šë-qÁªéuDÝ·9ýJÒ6Èk¥iï^1",¥‡™—š B`ÇÂB]ŻߓΥWiÂ/Ç~úµ˜ÝG5Í׫¹øe\¿‡™Þ ÒÓ¦‡$ªçËî]…•t" Zo ì`FsQf¤AcnÚå°~ÿˆGÄ# Ç£ŒM%XÔ .èzˆÑ"ü9…¤ý²Åge¿~#,¥ÅgÒ°E:±¨‰ÓØ-ª47íô‹Ø×o}4H©^þõj.R‹ÑN¥¡Q’]*MI˜oxŽìN}XJYt. ù‭8+rìšgIÎ-;ý"öõûgü¬–ÿž§µ ˆrÛ À{úÖ] xIy5ª¬^¶*„l*Cx`ˆ#YFÁ/Ê9i…7Ä=¾Ê}ïS‹³û~½Þ· ?Õæ}Û-’tº¿;íÛÏÏy—çRr Cc$SÐ{ÐQÖG¾I$Œ‰euŸ„{]ÖÇð=„m%ô@Hã,@~­hnpRñÊÑ%…4,øM»í¥K`%­da f‚³ŠØá—Ò{Ä¥µæ¦~ûúýôfXÞÈZ‰Òl,6ÅëÏÊÁBTQŒõtn^¿&{÷Äa)e‡`iÐùNØ…ˆc\¨87ìò Ø¿ÿàˆhªß ¯[ÐE½ð*†ÏU 9"â*‡,TŽ¥Ô¢~_^·W1kHRmî´+DYøýÐ ^'p7éQm:šµšƒ^PÒì¥ô›Ç¬ÕÒîå¥tbs,ÍVÌ‚§9blH ûÚܲÓ/b_¿ó³ØA˪ºJ|–>ŽÓ¦Ñx· :~'!§¤ÏbÇ:Ù»=ý¥Ô£[·4Í+±…­ zçØ5‰à97íô‹Ø×ï¼r>È#¸IŸÆ#3S^6’‹Œ1ƒQMHqå\Ó¾uA]FH+»BKãåºÂ®”FL³+4ç–žûú­gÿx9ùù6”æø_kZñ⯪)’~s`´²ƒ4šXI;B³Ò, ;ÁÄñgPZjnØå°~ç:vØŠîÆ:vpÎ3 9ì1³§$ywzÚ»H¨ØcfW­uŒÝJÙcæàp`σƮñ¼hnØåWS™ôûglR®Øm±ÑãN•ÆcǹÐÀ§!qwIº¡w–OÚQÅ%,$Œ¿¦-‰mèëÀ±[ö}àܲÓSb_¿óÊn=ûV¦Ð¿#5Þ?cdóÀ^¿lXq?K{óZt {wJ>v?ŸAË\óÈ9ôžŒaŸøš‰¥t’`wêg0[`-Ô*‚ãûûW²áÍIb*ŸËˆNXˆ…ƒP#¢Eâ&ÀÙåAѨð§>§¬ð†¸Ç×| ²Á¸ñt ú¨VD€/ú¨âˤ¤¯ž9€#~¥i¡™Ñ(en³çØ‘¶sh”\ûá·> èÚ,,;ítÚ-î[Äun1“Ûú)Â+í ––ÒÌ× 59µC%/Vb©äÛÇû>ïc*$<öf a%͈ÏJ3üZCXôˆÑØ=Ûjî.ö¾Ø¿Z3¯4ÝäPÓýîü~6BCáËh’à§rÊ~*hÏ€•äcë““Í{³[<íDcQ ÆÜ´Ó/`?üþ/ô‹Šçz㲓šVta© y¬"¦l 7ª­eG%¶°0¶Þ ®9ʬè¬?16$])¨Âþ¤§G¥é·Þ"Å)QË rjx0¶V<’¶FKl“„5ß+öÃî«L`!alýõå•öl_4Ç.Ù]†sËNO‰}ýþ?«¿_Å1_…U~$KýUÜŠšÎñžmQ<»€8ž]D ˧gJ„Ý‚–ÒŠM¾4žZØŽö{Ä>_sÓN¿ˆ}ýÖgñ¬E«—âIPš]p êuºV3µ‘ì’¿dM•Û'*¿ˆªÅRµ‰4Þ«YXc&/16$½2mnÙé)±¯ßz zï˧ÖYJšWO·¹õE'›®eßB‹jYØ5ìÎÙXJ=¨i~4¶¢k'Ç®ŠYÇÜ´Ó/b_¿3‹éûð½žOeÿ@:åqÙ‹2å=Q `#äõ²z“Oá ÌhuJ23ˆÃf˜£öL(œ]=òÌ›=vŒªý;»Öû÷óä®÷„¹)mjÖ_¶Ø‚2ï¥'¶ãrÿFO iœ’›XÛíש±)E«„]žûá·doØO;5W?ÅÓýG?ðÈYB$=’÷¤Ýû–ÒQkhÈYì"g9Ɔ¤˜Í-;ý"öõ;÷‰åb*𗿢úxWœï½š³Ó\;rPÒ>ñ®°Ûì#°’Nˆ¥ÙH‰v¢ñ9dž¤}¢Í-;ýöÃïL踆¯Êª¦æ€ húÓõ½¨WÞDMIJðöt´ƒ,XXJqmšå‰€ÂNôláØS×_17íô‹Ø×ïŸñF´¶qÏ%ë‡í$¬Õév&š¦;ŒèaêÇ€–v=–R‰Ã 5ý¢ñ)°ý Õ)Ɔ„¿ÆÜ²Ã/a_¿µòz®UÝL³^8u¼ ‡Ò~%éÐ:VÚ›ûC¬¤–ÕÍÔT̈-8´qì`Á‰¹a—_À~ø™%FWÞƒ'4ÎdcÙEèÎrcÙÖÝ© Ž'Ôϰ7ÏOVR°à„¦¢Ÿ ±ž9c×\´97íô«ªÏaú·¸ö/uüRâëÕ4x°ã\hï&IIû(;´Ê~a)Õx¨¤Á™Xö¶áØbÔÒN¿ˆ}ýÎø»=¬'ZIsý…g%'h6Î^X§IÒ+ì–°óG¬¤lh%göv½/¬5iè’°ÇY…vK ¿•Tã”+MAšµc­ãÎZ›Þ/>wØé°~ëÈ‚J‰½ÄCãÿ··J­j¨RkâÃðÚ´“öˆ-±”¢—¸4Þk?ýcCÒ'·¹e‡_¾~çͯZ~ªYj¶ øÕl,ÆddJÑþoà>‹ö 6™«ØìíH©Y ¢"–ôL{ª¢?æ¦~ûúý¼+—ÛòÙß GëE¿bß–ž_ìB)æ»iﺾî%¥‘¹‘Ôt¬«Ñ¤¤í»endPê´~u/ÒïÜyÑîŠú7i6ö=¸~[æ{Ù#)â+í[Åĵ¦»ÅÐ °µ;ÀÖÆ±ƒ‹5æÁæÖûúý~!ñpe‰Wÿ {¦Ï亹%½²wµ8Z'¥ö½ñ£Ùë„°1vͬÎ »üjºN¿sÓ°%ˆ\(jŽR ž‡‰ñê’¤ùZ{™jÕØZÁ+»¤¶ÄNä:q왹Pœ{ªk+ýðûù,Í¿²Ùò³4ÿ‚>’E:¾ÉÝ3z<Õ‚{FØÍ×XIÑj/4NDXÖºqìïaÍM;ýöÃïÌ4ӎ±Ðxñ—÷ ëž ØÐ‚˾õ…cÞ¢ë¤}ù AXJ=3 ©ñâ¯ÀzaXŒ]3ÓsÓN¿ˆ}ýVfz ìMCãO€EGÖt¶á«X»HÑdÐCp%íN1XJÑd04H™";š ÆÜ´Ó/b_¿FHì¯ûÿY’dzFѦ875]dŸU¿$ú˜M’"×ó¦Ûsb%µŒsSSE2±…¼%Ç.çæÜ°Ë/`?üÎ’ªŽú̪dÍ.žÅ†TSñ,âÌݧ$,ˆ ½±¯Þž×G,¥¼‘fá@ìÄ;`ªMqË’ª¶ÓN¿ˆ}ýÎͼm,d™)ÿ®QÄ÷†ÚèÚUm¾@ÒfÞ©H$È'±’j¶ ¦ Âì÷£Í’6ó­¥~ûá·6ó]¡,Š¥98¿ T\Q`8AÅ})2VI»‡pKiG X\5;ý#iìbÍM;ý"öõ;“›'ÛO{É#'û3“)ÅíãHÂï`‚å”ö>Ôˆ ®±ã‰òÜ9˘Ç.qøÕÜ´Ó/b_¿ŸöÈi[O{êymb¬¼ž×¶0‚-:óÙ ?Pvð KÉÇÖ°Ð盫K¶KŽ]³+}U×k^hîšØ× [ÉÎÞ7³ \3=·ð€õßÎiXfï’¤ó‚ÕåÈ>¼Â@XJ=rd¥Aëja›—ýhl—ârò¦~ûú­WŠG«Åù¸Knïm™1i^ð†l¿§„eß³*Ã>K –RQF¿4!Ä"ލ±3b©¹e‡_¾~+™ÈC­{ÅU ~&ö<Þök{Ɉ37 >×ôø ­ËÄQXñ ¤b¢åpøŽ8êeæ¤ÞLµù_3 Õ³›ŠŽë¡©zÙ=yEzÅòvã”ðÏåüß²oçÿVR‰»\jЇ‹…µ:ÃcCRF…Êпˆýð;¹ÁìÅ?‹Ž¸¡a†zÁÂ\öª†%Q"ZÙÁB+,¥G\jΧĎƒ•cCúÍuÓæ†F~ûéw’ÃÚâ{5¹z#R³|ÝAM’>™Î!iu<+íÈÃ6¤™,Ô0¤I¬ÓÆÇØI+¯¹A+/¿ûéwfmÛº‰îª_¯&lüæÙÜ€C4,¾½“}â_‹XJçƒòô}v.´áÆØâ“Ï´Ó/b_¿“KÏ/4j4£–¦éúˆXƒ—G’B¶N{Ì0^[í®±u¸ßìvÜ»¯J¸|›{߯]ÒN¿ˆ}ýÖg™Èè¢h M´q"çÀ'³âÎÐCÃÎÐDM,¥¹þÒ0|@l´xò±«(cnÚ鱯߹ëòß2½šŽ›Á®’±†]×®’Þ_ìËŸVa)µ—ZÁ5ÞQ;°7š»$µç¦~ûúý3v*vÕ1¼†¦i¦f¨w™S‘T ?ZH¿¹Ð±ˆìxk&–R|išRXíÓfŽ]³ïç®JkÚ#±¯ßyøµ,’¹µt…æ ÇùõŒ„ ŽüãLŒ”´3²„~Ùú”+iGI‡4 =ΉÅÆN Í »üöÃïÌ`Ù`Ùº-¥f#l¾½ê«3zür¼ÓŸÝZZ½;íVÀ=+)˜þBƒ­¿°Øúkì‘÷^œ›vú5uU~ë³ §(h5¢¦Ò°Š³xÁðÆe¤ùZK»Ç9K©fÔ”š‚(`ëE$cCÒýJÙi§_ľ~?A‰¶·äyé âŸ J ÌÀ. íHÒbÔgÚ·/¬ÂRz^xÔLu éH‚%Ç*̉¹i§_ľ~'§B ‚¸.¤ñKZÏàG½+¯‚#§#ÞA;w ÄRzîs¨©2Ö/xcì’]Ò87íô‹Ø×om}—]ëÕoLšö«í[r£"|SuI:I¬’v¿3 ,$Œ¿¦æˆ ΰu‹<ÎÆ®qC®¹i—§À~ø•4άTÕ)4M”–tÞÐè¢Ï¤ßZÁWÚ½ 4°”j¦ƒRƒÞ@ÄV\/plHº‰µ¹e§_ľ~ç6ßïï­íرÍwÍÁƧDw,°|Y²)$mùÚI;â_ÂRÚ±RH³ÔÇ˱›~Ž=c¥ÐÜS{÷k!êòú·?90-³×6òÂ:ëôÁ§Æ +ò©µÌƱƒívv+i½].ù›w,yç9öÃKT/Þ[ú5u…•~?Yø9uD»ŠÀ]ÞœŒŒ}IÒ ãèiï(Ó"¶ ïˆg¿£XtïÄ'ÏÓØ#ÙWŠÊ¸ÎM¿€ýðûglÁþá%vìÁ™z”x‹lpñð–sá½Ñ™Ý´%é·±gÚþ±ˆ¥”\fÒTš[pCÚ9ÉÀ°JÚéWzú;;é5ï5ôõj˜‚@äÔ&X„¼Ô›’v*vΕýøXXJ=3A¨i` "¶"·•c×Ì}åÜ´Ó/b_¿ÄSÑÛöÈ¿^÷4é~ÿï8Ø¿µ GHþÏÕ½u¢ìÝ›, +)˜–C3œúFØŽα»jšcnÚé°~+ìøÏîXC:Q°Ð½ô.#ùhC_³‹t˾g×ù*Âî\¥”cÒ w±g2Ž]óÌÆ¹e§_ľ~+2?Áb¶Õƒ94ÇC•ÇCîõ\ÄÚ—‡9!é²Ìjód?^*,¥y?Ô,ÄÚ‰NÁ¥±§2jcnÚ鱯ßù½Ø²_gô×’Æ™‰<× uГypW’¾3È>ýzVXJ3*¥i°Ý_6»GÅ£æ¦~ûúý#V+?þWň¿ âÄÞñé£]OÎ<~Øâ1Ò>ý°&,¤‘Çip„ vàxÁ±G?8·ìô”Ø×o½ÉêÿmïêzíJŠëûýçqF(¢?wï~e‘%±¥<  Æ(ƒæx`LÄßçt­µªú\&_Û€¸òýRUê®ýÝ]«j³gíºsrôN;üÖ±Þ(9V";åÅró¥+ªªs¬F×u3RÕ8vö¨£æ¦œvA÷Îîðf¯œÔ~ì$Æ9±ãPp?‘W‰Û”¶Ô}„Þé’:v¨+ãta˜.>ÿ» çn é-tw»ãX¬p|r6Iäþn}šÖ|©‹Ò±ärtø–.©ùäX'×%Ø$Ç®ž¢®¹)§]ÔÝíovbpwo¶qJ::E5•ߤ*JÛú¯'²ç ]RÅ“hÅɸŠÔÍ*UHU”Ž|!ïòmó»7·#Z ž3ÜŽÝz d•5œ ®Á,ÊÝŽgÈ ŽBº¢mŽœÓU‰jº :ÛÁ×|î¦*W³ ºwv?é°Î¢ dåT¬šœbAï•…ØÅØÉ¢tr{ y¤ uI娬«‚|ÍuoG³âq~¹)—]н³[¯á Ø^SrN¼xá¼½#™ükÅ#3¼¦@g)§”º¤FxMÉ9àù¤.ó‡9ö–_̹=¿¸æÐÝ펺ŒÄÚ¼¨ËH¬Ýã#‹¼'VêÙâÊë ™ÕëòŒí©ª&&l{‹er{d¥{¨ª‰ »õeLáN)ì:ôª»c¿›Q)-œJqPéŸ3 •þ+ÖžDi¿›Ï7¸Î¦öqÉÇÖ™NŽ(u.=¦Îç$JGžjÈiuw»c5<°ŠÓWÃÆi*÷:° H [. ´¾]áfÉ ¾ÎuIUYçœbÃH7ãµÇ±s¼97å´‹º»Ý¹i–…e®;':;¶ËÞÙ1_wvœ—½³ã¸ì‡ÆÖ]C¤Luvœ—½³cåËrÚ[žÆŽÃÔæWœCЀ÷|c]Ô%Zï._9ü¡+*6¿â4”P·*¿ Q:ò:CN»šêû66ÞÉ–Ëg ¸1rà_@C¡ƒiX3uRø„Yæ¸Ë‡õÁ–.©íSÈAé¹Nc§€ãÜ”Ó.êîv?‹]Š5 @–Á)69±™‚‚Ì’Ó^6 ”PºË•" ]QÉ×Î䌩zÚ‚Èç¬>6(=~9…vIw·;²×¾¸'åÜ8'#oÆ~¼òƒN¬Aç!J¡‚TC^H]R[gpnû¤³¹n;Ñš‡(ÖÜ’Ã.éîv?“Û }Ž,ÿ–s R¯Ý_5ñ¾ËS”ÞŽå¹Åh]—”£Ò‹Ó'N.tûT(r Ê#B9ä°Kº»ÝÏâR|6ÿëBsHôT»îœŽ”´’d¿– ‡ëÞÁ­ u—ò¢´_sm’Ú:¸%—ºÅRJ4¶QZ|1í·Ö° ºwv?KñÙüÏæ6ÿ³ùŸÍ¢ù‡uS[Й,×vÒh‡ÕS,ØÎå ^NÒ) [ª²2ƒ\nžb×%ÕcFN3 ¥‹(ŸÆöXÏÍ]ÚÝ;»µõLËM° ,;!= y¹rÆü0ß)Y7fÈ›¡UK—TsØ qªŽu&sœ1vqØ ÍM9íª:Ça÷Ò?,áuDÓkã Vsù|Âoü° °Z8-·^rT1H—T  rPÈ%]‡”´±s@hpnÊiuw»· ì° m«îvJÜvD¼–Ûxná}KU”ÜN9…ÜjQ\Tö2眖=IÝ<ä3YcgO!ÓÜ’ÓRêîv{ðyCr IÍœt(.ÈHX!*OVRXS7/“wP¨KjÜ §<Žº ¾Ûêe±rêrnÊiuw»u]k¾ÝïÞ0Œ¤üÃ+Zꩆ`ë…JkÌu6%*œtIÑ0Œš¤ÛTwjc·hƹ)§]]ÍÆÂîØ”6Ô¡Œê›Ò†Î'6¥–>[ÐÄ1 <–WCn}]—TŠúFpú¾WC„dÄØÝ!g4·ä°Kº»ÝÏâ“Â6kÖí;Ê=Œc=BØ”m¥¡¸[g¥“».¯ä¸¤KÊû‹8‡}c©kýC|ì¡AÎM9í¢înw Ì Í@™1NCžF³»@=–€ÙDé66lzʇù+¤KªxøNœŒ:$ê&3Kc'”}nÊiWV Sؽ•GUyr¯;§¡¥Ì°âxsï-üƉ¡.È3Ã`M­nŒª;Ž Ãdm„®ÕûØ[O+ÎM9í¢înwäL¯{ºXË¥ëÎ)(âÃP*îÛ†LuøáÛ',•‹Wº¤rdΓP³ ÝÛgሱAáט[rÚEÝÝîÈë±òi½îœ¸4Ôof”,ظ. ó5 i_[{|é’jêÓæH·\­ h …‹"Ÿ!Ï*¨å‘Ý›oim¥‡opÚW‘$Ênµ…ÅM”^ÃV·PÍSRè’r„\qºe§K·ŸŠ³”&Ê}ƒ#äLÑ¡în·‚ãV°o=+y]ÄAÑk·òþ…†š,ïIBÙáîòiU?Ò%5ñSÃWt]<ô»»ëHsSN»¨»ÛŸú…Z³gdÿÔçPhiaÜÜÖz˺ӂ†¤ÜT]>­„_º¢zäô‘ƒK Ý §Ç®Q‡Å¹)§]ÔÝíÖ–ÍÂN_µ…ÃʆrBÂa=äH!Á]~¬3+U§/YȰrfõ£ƒÚÆŸÚ´ÓÙË êmæÆSr@ROJ˜|ÝPéÐQÙS±Âë§(=%̯øæY:8uI-Ÿc«ëZÉšm”ž’žBN»¨»Û±þ ìÏ “Ñû¼¯‰›„ؘ«Q(õ·[Ó éŠ:wlÌÌRbcfÜ$%Æ>ÝÁª¹)—]Cba·ÞÄÃvÕnØëÆiÉÖ®Óš¯5[S®w'(‚,½Î8V2¥+ cã×䜀܀nµöW»z{,Í-9-5Ý{»ŸÅ"ÒINZxqð‘¾í¾`°;€××î;ÀÔ ò„\n¹‚®K*>ðâXÞ´t>à{ÄžsKN»¨»Û½Aóó×€Ž6ÎP¯„ ÊŠÔ‡u1Aii •”“_º¤ÿÀ‹c¯L×mè•À±[ì–9wS†VBw·;Ò.r—ëæºsªê­™»—ñÉfÞ^Ž´‹|†ÜR¤]—TQù™sÌ5äºi­`|ì$$Ÿ›rÚEÝÝî(îL|é*킜†ªù lƒ®ÚñåWå•rKÞt]RÕKYÄ)zi'lDZ±½ã ÏõA৤ÖGvG[‹oОj?޲ª‰üû Å4D¹ï …3PWTÝ¡=A‹[èfäqììК; ,9g×½³[ø$’S×Å9ÈN9,áÆÚ òiuØ…o±â]nx×%uêº8g`å Ýh@Ž:sKN»†joÃîgñ6xrä¹UÈòcÑ —q“õqÿ½Nª‘dÇ{öÛ­9¨#*&É1t×mð\qlˆúÜMþ·£¸îÝÏäRx»ãn¶<îÄ.;µõæÉQV¯æÊU›j¶b憛m˜{¸U:|^L¦;HÑ»GY=ç–œvQw·{;–¡ ¦ëΩ(Þ­j+ݰM<Š(ËH!?°ˆ¥.©ïRr²cÔ$ÕHùØÉ»¤jî$ü³‹º»ÝòÃG[†÷pçÁLä& 7ý ¸Ê'à ¨KjDWrP/(Ý(_ŽÝ£‡+禜vQw·[Ç‚†¹zR¥8Í;Ì"¸²1ñ%õÙB~W½)Éx-눻^fèfXDZ³'Ujî¬îµgÝÝn­ ‡•_uÛÈ\wNVjá*ÖêìºjˆÜ¤°2J¢ü4/›tEù¶Iœ69€îªº>6(­7×Ü’Ã.êÞÙ€·¹X« l‘SÐ9ÞÜž fÖ:Ã[M")Ìgk.7ß»ë’ÊÙ"ï_êÖ‰ XŒ J+í”BN»¨»Û½*#¡tF“‹WcBY=a”'ÊêK¥OJ-.φ!]QÑùWœøuê4çØ%ÌsnÊitïìŽ& Ÿ¼g%»:ÇvÊjÔmOm(’(›¯´¦ Üú¹.©u¨ä${ƒS·MÕ]­±Aáט›rÙÝ;»£˜">}F1EfÞ#Š)s"QL‘¦(<` ”W I—Ôð:qUÁ˜.Jq4v÷¥æîª°ÉÕuïìÞÜžGçæ†Ä{~Xb‹ 5¸¶æ ½¦<þ“kè‚ÂØú¾ä-þÝ>p×`lPî†L!§¥ »ŸÅ²åŸÝüažï·'D€sª0k±Øý‰¶:E½â{º›ÞuI•ÀL&ÇÚºn8¦TsSN»¨»Ûý<.Å?¹ù¦ÎÅ^u׃nÕ‡í’s1ψ¹-Q¯xß­ŒÉm.]QÅÚÄÁ«Tº -_9¶{N|nÈetï쎚áU0ÖrÀ•‘Ã.X—6v™¶H¥oÓZNS^ ñMº¢rÀ•‘ƒ!Ô­ì ‚±AíëiÉi»‹ìvGXÔ•Ù3:ÄA)m%Ña*ÞÅ7ª$X=¨æOÝuEåÈè ¨¨;¦7oJ¢ä-;JÈiWRª|Ø­ërú×íËØÕ‘œ!¨·eÖTÂêd¹“@éL¯ÅµäX\SWÔá»>qºLL“»Eë4Î ¹ì‚îÝ5«é¹îœ! íÊ\8 ®àŒ ”5vyG“!ê’:X‚œ.,"ÓmêPE(ùŒ47å´« Ÿ=ìX¬µ§lSªÄéIU"–A’…XÓ³¨W\½¬7äP꺠Z<â ‰uÚlö±AyТŠã–žÊ »4Ç.°U*^wNWNSÃ.3¡J´¢^ñMa·Ó¡fœ½„.©¦ps fú­Èfšý¥ýg›!§]ÔÝíŽ¢Û …«Å!h@w׎óÌ¢´ƒ3äô•.©W“³ß§ëæí“06¨W<«¶>Õ^i¡»Û{‘UÃÚ-yÝ9ì+–eX»"—‘+ç¥{°ÓNS¹å3º.)w:§Û–DºÞÌÏÆÞšùqnÈetïìVèÝZ®¬ÞE:äd¥b±DFnÁòN%o¡·4#‡¼¢Su«úV”ˆÝ®fóÓúQ7¯xÛ©±Iá×6·ä°Kºwvdz_Qæý›ÉÁ qýO³}_²yzHS²HÆÓ^fè’:ýL‹Ã 'tÛïGV[+ÿ¾`npÜ.4Áº³;Ö0«ü‚å8} c{CX&+A‘-|6QZÃÌrkh溤ÎðZ3gƒîrU~¹)—]н³;"&²y•˜‹¦Za졸«A‹UQŠ˜ŒrÜUÒ%u8*±8]àš±VQZ%ØÜË®. Á°[èYÖ N_[:I¢Åáê´–°ëe»Þ< ð|ÅJrà]I—”¯-“­ÈNºÉRv4vò”ÍM9í¢înwD K¾ ùÚ9ײyþ°Ïìq˜ß ”¢?†\Où‰˜ uIµ@Ô#ŸLéâ“©±‹¯}nÊiuw»ŸÅ–Űáý?å&ç°;  É   9+(}Âê¹9F\—T÷]q¶Mˆós»z‰®æ¦< Q~ÌGv?“KÑX¼­ž8l¦Ú `£ÕÃVæ ´ö 8aÇ¢bjé’*ÑV[,ºn‚U;9¦“榼 ¸°çGv‡w®"©Ho+qÐò-U$úU|ÃØ{©F§'ögªÚ±ø˜{$ùæˆÒxïØû¯"v¥Ä!Ê¿Ÿ)ä´+©œ8ìŽ^ëŲš;*y“œ™NÖ Áº;`¿‚˜ 0ŸÕ…¸}~ ëT‹ÒirªRŠL· ¤Q¯¸Î°¹Q¾.»ªR™Âî@iHéÚ “3«~Xôk5ïªöT.JÞóÕÇ@ò‰Ýìðæ×Icû¾L7>qlc7¿Ç47å´« ;ì~»m0³Š\®;'cXCÞZË ë„µŒ¥íìZêI@é’J޹A ]¤›OõºZcƒÂ¯1·ä°Kº»Ý[û$E¶\§"ÄZÞ­\¯'(öŽï–º¤Êޏ~ÀuÏO€é& §pìˆëÕÿGØEÝÝî(eê(KÍK™ŒC€.t†e Ù‰ª¸­ÄìÄc'9Pé’²±ñkrP&&]”iì(1ÓÜ”Ó.êîvop3xæ&9ìÁ›¬„¼³/!5j@Æ!„#yduI倌#'!ñ‹áŸ‰Ä/BjÌÈÜÄÜ’Ó.êîvoh@ð'¥r‘SJ×±k¨¨û8ù¬Q‚´JÉOíHÒªìRÜí̺ÉÖ²;‚禜vQw·{Ã_…ÉñàÉÀt/ö¢Ï«š€Ü%Ç×(!ï–~!]RGàÁ“Ó;iZ5ÍÊË÷À9YMÌñ…¥ÌZDwQú6­Ó Îúv1çŸ-ŒÚLS'²¡[OuXc×HFåÜÕÛ£.»ª·N »×±üçåëïÒÎõUo·‡þfÐ4Àøl~Ûï__þûòæá§oÿë_vyõöávJn§iÿÿöÕ›‡w¨?\~÷ð³— ½\öÿKï§¿¸=——¿»ÌõñJþÏÈÓî÷†&ô/¯—/¾ù_^^þþáç/ßËæOøûÝjö}Ûµ}ðIz—þ‡Ÿ¥U5p»ÞÛiúߟ¿øj?O?j÷'ý‘ýןªwéø©²†m;U¿úâßüæûï~óååöaüâÛ¯ßþéí—¿¾¼ü¥ÎÜÆ'ýÑ“þp¿zñ°|¢ë ãÿ‹¯þýÁèÿüð«__Òå·éòˇ|ùýC¶sño‡eM–‰Œƒ9”ëýöíˇU|zºTH-¦ß\L2ä2ðv‰¶‹\í*Åÿ½VGC‹éå¬X7uÖ½Æ}ç[ã@}Š+¦ô¾ª+í~½ZwÝÐþ»\™|;î¼]ÛÙgŬä C¾–ì¶]‡œä'¿: wxùž~yV9ÕÚÜ|Èõ±îÆýz},};¿ ·ó¿jSãÑ"rKQއ‹ä'¿>†^x|ÈõYÉ ÷Þû_ëä6>öú<þûØ[Õº“dt4£^ÿ$=áv5ÉŠÎw×nOÓ^á­Úã‡NÈGÝ” éÓy"ë’릂|µ¸o§ËI†œm$'¹ß”~ÕO‹þß]µœïOèUæ~ûJ[Šë:u¯¾û¿7ú¡S÷„™¶áÿe›uE†N«ï¸L¿ýæí^ÿö›ïÞ<åæu+²Í¼ÿ_V¬Ô¤…¼ZÁi®œuŒ‰kšO~WnöDJtÅóøöëë¾}ý?o¾¾¾þÿl›r¶yÙÿÛApÌ• ÒmsòÿýAìÃŒzY¾Qû_,Ûý±xÝîVûï·{~t»_,Ãdy•ÊTÈDœjOJ]UDœZŽ]Qj8>ëârë"]R¿&ç4u‹AiìâFš›rY Ý;»·ý×ûžödý1Þë´ãVe SJz|Ú‹ŸrÚ‘z°ŸöÌTž©¦=+'“§Ô~Ú%/j´tE9PœcK ×EÆNž±¦¹=EÉì‚îÝO?í«£’Õo¿Çi¯ç:¯Ç*Y‰ç4NûcñNûz?üÌ9VaÇC_È«5N ©í´»¼ ùº¢º÷ÏÝõ¤‹îz»z“pÍ ¹ì‚îÝûiÿ€WÜ®7PE_ʱ®ù_{>öÃô®9W-ðn·ÿ†“.dù’Þcãúq¬P:ž endstream endobj 189 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 193 0 obj << /Length 268 /Filter /FlateDecode >> stream xÚÕRMO„0½÷WÌMHìÐN¿èÕ(Fo&ÜŒvAØD "‰ß.Ã&{ñhšôÍtÞ¼™NF@ ™XQ†[€©st’@yB’Ž=ûdh•5zaìÌ%´å­ÙSOp?²—p¶ß4ùNô®dYa> /ExtGState << /GS1 197 0 R /GS2 198 0 R /GS257 199 0 R /GS258 200 0 R >>/ColorSpace << /sRGB 201 0 R >>>> /Length 2240 /Filter /FlateDecode >> stream xœíKo7Çïý)x´¦ù~\e$ d±‰ì! %NìŒì`¿þ²Xd“£éÑÃ’ò?LÏT³Šõc±šÍTh-Þ-Þ‹?–o¿ìG(©œ5Ó×§_Ŀćååõw¯ÏÄåõ¢ËI%æãõeo~u¾Ñ|þêt6Šÿ-ßÿ(”øyÑâMù¼_tu÷ÍrÜõ"ÎV@ke´"Fiµ0ÙI“„uY}€¨d6FÌGB¼Í~oï‚’ÞŽ!¨CàεqÒeqµX“¤Ò]Þ-ç]!E©õ¤ÀòP0…¨|­ M ViÃPhò¤ÌiR`™ögÕ³•zÒfqö^&5³<ë$™€YžRqë&–'`geˆ0ËCÁ© ÍÕ&“B04<§WMr&HÏZeꪷ7qVð%þn(°8)ådP«Bg_R5 g…œ)sV'…—¯ÏâWÊ[S/„q¬—Öës½ÝÊiõþ•%D(Í~ÙU.)DÐR—Y÷täxñïKÒ³tQ´6'uè6ü»öWõX6R«n£¥Yû«¿«ûâ6f`›‰ïr91ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ ñ“SÝêmu©Áí—K³“S­_nnmðRY±¢ókj‰tS0ÚI›Ya®”UÕ›¡£µRV‰÷‹sÒ /]ä>wKRµù†ÈÊ»}ÛÝò›8[4ÅiFS ZÞX›9‹„OQËK%æBhe4SjôužµJT“Ì ÐJœGvh]zõ½Ukl·kš ýDínWÓ ÷ºæH÷ÙZ™†ífVNlàøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àÿeñZ#Ô|™¨èçªû¶ÁÔ— R‰MW±¦¾æ°«”>eÚ¨Âñ66èrL)¬uB…> G]äNw‹6Qº ™ÕwûÖ[•BM!Z™ê8š=Ë_²TÈ{Šý”-íϺôv–ü²Ã)[|•eÚg©òjÇÂÈ–v‚g½Ùq>´^G¶4Ÿ­•išÝÄÚ’øÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøUü— ±/«•Â\ußNUßJ…ø”±N†0TŒŠÒÛÃ*œdsñ¨‹uéB›µTHÛ,íðÔåÖínÑÑÉl䦿»a¿U-Ô{L¦• µYþ‚åBF ìȘ~¢Î¼QVzÓrÂ(7*Í.«ªÕf¦ ÎûÕŽ…5cú‰:óÝ®æDïu͘2M³›X9á|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøü‡Ö4_ôŸü>Š«îÛ©Õ´SÆiª1XU9n¼ž$¶×“PåjÿÊ_kRixêrëv·c¤;”›þî†ýfÍAë19©ëXZ,WÐýPÅ€ñ†ê9¬62SEE—cº*´S-!Äžx0|ghø^«çZ 3üt¹õ²˜e:›öî†õÖà›†‰Qª:xî¡ÉÇŸ3ÛêBLU]ŽIjÝϧÖÁÏâÁàUÍ6Ÿå\vcðI—¼Xýt¹Öê(íØ´w7¬7ϦpgS([M®˜ßŠ?õ9»à‘&éËëï^Ÿ‰K²UFÌÇZ¹òµZ\¼Y*Î>TQ'éHYf/.®Ä³x¿|uQ]Üm©Kú•xWSs_SceÌÂhOIM¦ê–%’®–ôi]¹&lµ¼÷@Ù’Ö r‘eè–óŒô¥Ž'ãÕù‘5OSþï×YÑjT½}³X%s^×zkç´ý²ˆ·_2ÎÖ9òS®<ºÏÝé#ã*K¦£½ç8Öqqß´#(kCÙ”í÷‡uÏUòp#­æ›Š/™\&.Ñ2Bëv—¹ø•öv&óžzÈŽHcl«‚êc¼Ïæ‘…ºçÎyƒ˜v6š#-5ä)Óœ6y^Ë é>t¢X†òe¦H…²öè½X–eßøI£ìàéæX,·^£ØƒÅeÙZg;Å’åGŲ|)}ªX–u;º)R.ÑnyŽ¥2ÇIƒÇr«Î¼‹;?Ër~Š%ËŠ¥ u›všXš²Ù S¤lYÊü^,mÙå9Ú¦oß6c¹õü܃Å¥õÒÆ)–,?*–e çü©bYn¼ ï²­a˜bIOôzÒ0ž.›£±ÜzïÁâÎÆ²lâUžbÉòcb©éO6§º÷è²™ÊÓ½Gç Ýþ½GÕ?RXÒ›nï¾÷ì=Û·`µÎÆ’^d;ß{XÞz€ù¬ÝÄÖ#¤ %ÀtÛ³ôºÛƒ­ù“îoóê>ê`o2ÿ.Ó³èáÃÁɬ¡gŒÃ§‹“hG›÷;ONÅ£sÙS?ÁóÍŸåÿæc’µ endstream endobj 203 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 207 0 obj << /Length 262 /Filter /FlateDecode >> stream xÚePMOÃ0 ½çWø˜’æ£É í0!¸!õ K»JkZÖ"øù¸í E(ŠŸåg¿çDB¢Â(A2Fl\Æk¡•…¢!ïD8ãl:u¬Ò‰Zæ®…ä¾1°oÉ#ž…â‹&_‰îr’,ú)á­Õ—¿Ö.Æ@~„'ŠãJiK÷a—¦Žu¬7K/áü:ÔmìOu×Ï¥7EÃÀ0~2£iqfŠ6ë©›½äè,Á ï´%®˜ “e³ç–q‹†Ý®ýºáE€+ÐîÜÏÒÊ*ÄÐIñQ–ˆj¼£è$3½æŸÌHÿütrÐ~e®œÆ9à:M…Óz¶Fnsò ¥Be¯ endstream endobj 190 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-example-workflow-rep_dendro_1_plot.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 209 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 210 0 R/F3 211 0 R>> /ExtGState << >>/ColorSpace << /sRGB 212 0 R >>>> /Length 576 /Filter /FlateDecode >> stream xœ½UQoÓ0~ϯ¸Çö›ïìØÎ#«6¤J  ‘ö°M+-¬j‹X@ü}lÇqíM<$Ñ]>—»ï³C0‚ |¯>¸ë¬ûøæf‹J òûböÎeM ¿ªë[ð¹"˜»kS‘ÀÛªnP(° k ;è#©†-Àâø=¡¢ì5IdÓûækÐòЇ€eƒÊ$@ s@CHtôaˆ=òÎÛ8£e÷‡uË}uvÉn í:¤€Øß_õQäÉ £ÕÐî`â“Sh7ÕEØOZNìæ&†õõøõƵŽëi|}fƒ¦Ö¯ÏƉ¢âz__JBa‡õ©¾·ð) ɾ©DÛW 1YW‚@6UÑõäõv _¦î;LVûUw3Yþ\¯o¦Ó[hç±p4¼‘¾±`vÖj°fx\Áìÿns±Ø¸Æµ³¤7·w€æ!Þ,S ÂR¡Œþ>fa+‘›‚¥L%Û-…"ñë÷h^§È €l¯3ÛiÂe*A2’SÕ~ÞP$œÜ ´o2ˆ}ùpÿøí~ ìÄÞ~ê~tw"é|‚A©­=ÇGÿÓ7…|NN)P‰BÎ2• TÔT˜"Ad,ç,eê‘5J[ŠÄ®PïÆ¢P‘JLõ'$µÿœ¤H%È‹[‡…+ ]§¾C}½XÌîÆœf¬…úˆ²óìÛ£TÉ©&4²P­L%H6Í'$šûÝ‘©yqI$¹A(¢ÿ½>¼_ŒRDê°sK‚ƒ Õo©‚ßs endstream endobj 214 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 217 0 obj << /Length 512 /Filter /FlateDecode >> stream xÚ¥TQo›0~çWX<œ;ÖI[×T™&MSy˜”V-† QèBV-ÿ~¶)$<, œïû¾»û.) [†'ê;$Æ4BFxÂ(CAžžŸ•\ŠÐfý´G#n,×Ï!ùÔ:ßô5#gpDú1u–«Ph=ÊCÉHZäœF2&\$” AÒœl<áˆÞ‡&«]Õù—Òk 󌼼ºÎÕN5>Go_euW¿_vªëª¶ñÒÏË•Ð!M„°B@ÆiŒ8HP4"LxëÜ1o¯ß½ª8T^©)#1#Uú“ALåýk©Õ ²@šH&UŒ)ã^õ½-ÙUå­¬óî Jµ¿«Ê{ðô«(Yý²Í®ÀQ‹Z½ªúʵ®NB£c™mwæ­ÊrÃÓ+£2‚ôð“iq iö |è9Üï_¾^ÿ°„îI@œ„úDˆÏ3w®Ø˜•B<#@îÎOÕŽ“ÞkÕ”ûíØ½í½¹¼{Ñ?+noî®_»Uõ¸kÜcu{zd®6ÖÄ'æºä.ÜUe!»Ö¢:wtÚY¼Íõ¾ƒ·5Ôcâÿ· bÖà™U0¶:^´ ç»ÄÄ[VÁŒÄ06MFbâïöÉ¿¡Ë;F¡Ôß1)56¡ñø·—ÄMêüå> /ExtGState << /GS1 221 0 R /GS2 222 0 R /GS257 223 0 R /GS258 224 0 R >>/ColorSpace << /sRGB 225 0 R >>>> /Length 1449 /Filter /FlateDecode >> stream xœíKo7 €ïó+t´VD½uµ‘0Тíè!É!qêÄîÚnãýû¥^3œÝñcm×—òàÙåˆ"?q8’h'Ä¥ø{øõeþ„’JÕ‹5š||ÿCü.®‡7·¿гÛð¦ôz{Ö›V Í«£ŸóÝ þÞJ|@œàßåÅÝOÃÝ®q8#ƒ>H£„QVê(ŒKRë-D%ޥ׌x_ÿAœ?4%™† 6†Px•¸B1J]^«®Oª<)h›¤ƒI¡É“‚'#±Ðd¢µÔÄB“³Âü)TuðfÒ®"Fÿ)à*`¢!šLп'šL€Ñ¤²¸Ê“‚Å!š4)49+$%ClÏôªIV{étpÄà„±½‰DAGÌ?*4‘(¼9^iÄלTºdét-y¼‚åÖš3æi/DŒ2Nae+ƒ1åH風ƒ©ßÏP/A~έMË`[Ÿö½Ø+zUÖÒ¹Þ¤Ý^ùžõš¯"7†Ò‡ò ‡LÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLü¿$Îççî;çíüLeõc”*§›[T>¸¢ŸøÓ=¸QbÁUzbOo.x‘ „rbO‰ËÁ9 zôÒÄfs=€öÒÚ-¹©¯ç½×Ã7q8@>M:¤Ù ±ÄÝ^•· _âXa>Š*ÊiÒ¤IvôåQ~DÕr …œ¢—É­aJ«.Œ9Òo”Þû•LèVÇ4é>[k¥iýkÍmÆg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Ægüñw=°Ü|•òå«îÛ‚’êaßvK› u˜T ¡k³}8š„Á;¼zÐã¡ep*ŸÜÌ®­!—¨Ý”›þz£ÿÒ¹ånù ¥[¬r ;n5S ”𩨩ɹ“¯Ú-­œ40©Ô oß"½’jI`5Ž_[WJ÷6G]nV×CnðzKnúëþKãï15Ðû•è«\@Ÿ[iùð´Ž5æ±’‚ÅFåRÅÓµ§ˆÓs‘ÆúÈåRDˆÒY´Jœ^‰½»/N/‡·§ÅÅÃ=Áú|d¾tÕíª Ih09¹«Ú±gHÒV§;ú4øhbõùèÖžtNÄÜÓ÷žô‰ô~,ÿ¼üæÏk'o•Æ„NãŒG++—2Æ¥•”R&••§vRI™V&íq,¤Lê*Oí¤Ž2)«<µ“2ʤªrnß%_$\­l³•Îe›k fZµ¹5ÏŠ8Ӣͭ}VÙçIïZ!¿ù¼óœØ[ºýq»ÿQœžlfõ.sR}ª&Ü‘ `þfU¼É¿ 2ÕwòìæúËÅ‹›ë¥7ìI~‰³€S‰ønàÒ‹çõÍWPöÎÿúóêÃþ’÷ûyi¹´½±Q&\¾UÀåX„· !J¯ZÝøÿ0ÌÆÙ<_êyz0Ðw _›·Óµ «Ù¶!ÿÊ Š+a½Î‡õÈ~{g¤èüˆù¢R©foÊÖd9´eŽjw|Þô üÐj£ûVPç¿ð2ÎgÍ8Nÿy¯‘ñêÿ'06{©Ëtèè2@vŽ%N´ÈðJ±4u—2ÉVú4‹¥5mAé²Ë{Ý;c¹´ñìÁªÆïŒ¥I¹0ÿË*?+–P˜_)–€ÿ>Ð$RèÐÂ,–ÚK分.Q¸3–K›Ø¬jüÎXâ¦;Ë*/­ÓOši–vJgµ¼ñw86¿¹Â½èrrŸwãò>`s‰|5÷y_¬ž»Æ>ø7ü 3ðŠ… endstream endobj 227 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 230 0 obj << /Length 860 /Filter /FlateDecode >> stream xÚ¥VÛNÛ@}ç+¬¼Ô–°Ù‹×•Ú´A´ 9ª*ªL²v¶˜ud;¨ðõÝ››Sä%ÎÎî93'3Ç ¬ÜÖÙ0ߟÇG#?°b/P`3 bì…Ad$ô&Öxj]Ûăt\ °‡´+š6ŒçŽ‹#l×,çì`’r#»‘˾SNÍÚÔÎíøÛш€&`¹0òpjŽŽK‘hgâd}â xhÓFýºLYvhÂ2t>•ËP"+,èÅ$èÅÒä~¼NŽ @¬ ¶Üš(äF÷m&Ÿyݤ|B5`VVbMäb#š§¼eP˜Ø‹¡†Lв©UÀ= “¢‘4å¼l„Š%ï+ ›ß?¬­›Sv„¦,ËúÖ'å‚7}V—¢ž‡ÚqýPT+%)ÉÓfQ %]3[S ÌZiŸÍJþ ÆIâ¸QŒ°V  }o`Ç}i¿¼˜„að¼*ʆVõ ¼½RÙ=ðõ¼`54Ëäß ÷U*Zl £Zù ™o8‚Û¶/"^ä/ Cø) Õ‹´`ϺŸÕÐKtiµŒîoÐÒU¡vHpØ’*J‘èù”¶H={b\°H; ‰˜A…i%wˆúYZO:BÿÎ+Z×tªfZùW[“ðÉëæ´IXÞYSZÌgé)!Â>ÒâtÐNÙ@®¿àW3šN%œ&Rͱbrÿw°kx«AãáåEò¨D€ü„ƒˆúDݪܸApÐ×a×þ.„ú0ÞEàk‚mÍWë1’”çͬEIÂ÷Åß‘ §³ÁFO£W¿äd‰­ ™X%¨izÓÐ]#EKŠ÷ŽiÛý&§¥Åfp>ñ´xªY­'@‘‰o&Èø”=²©HG/å+ïÍ g2–ÈfÉ⮦©iUó·€Û©‡öyp'ÏÖ?êóÃ…ï³Î;Ê;Ç |û4{òã÷ðDÎoÛQÝ ¼z#‚Ä=+°Ƈñ¿¢¸Ýpu~ñöà Àƒ>y·ñÎ*\HDG‹ƒ}Ž¡*Ùÿz³| Ⱥ7î5ò!ï6ýúq9”ó CÔçɬ¬Ì[…§ôØ\"ºÚ·öw·¡îîy4B«)à öpˆÄc/j;"\;ñu|ði¿ endstream endobj 236 0 obj << /Length 1182 /Filter /FlateDecode >> stream xÚ­VKoÜ6¾ûWè(]Fõ<ºñ£. ÄènÛCS²ÄÝ%¬(®íõ¯ï ‡’×±ÜA/âpH~óú8Tèí¼Ð»> ÝøóæìÃU\x+Ò(õ6[ç!Ë…—&‹Dâmjïo¿ìºÞ”Fõ]ðÏæW8¸âœ‰[ÝÊÒ´׆ûvI¯åpõÎR­¶ÛWú”ôUèÌÒ5öÛ^·c°Š³(ö?¶Û«`Å}r+X%Qâ«n4eW¹Y¿¥qTÏN-oÖë`•‘ L‹gñLì+”÷ãÅÿƒ •KO*á³0¼U”°¼d+a‚ äIèÿpHÖ¡lÔ3s%raÁEŽfÁ*š®QzP5l¤•쨺`0ñxÌD fÀ"ÄÁ,uq¥h' ý‹Ò”p2Mý˧¡éSÏìùp•p²1c–sî0Gñ¦–] "ßàyµ=ªÜÚn–øCiŒ´9CåHJŒè.Iòi^޳åè”èX”œ‰<'÷A”û¥6 UÀºåØoe­zUnÅ’íØ{qe,ϧܰÈŵV­jJ­ w$GË®lŽ£rINâ÷ÝüЏ«ÆwÙ“ÝlÉ*…Úç'ö!Í3:Z–|Û“jÄY ŸôøODÄŠ8¢“™ãÉùµåŠ-_šýJHÕç¾Q–… ‡FUXw£ ʬp½!ÿ!ÄA÷moy„³ÃXîäxáÀSÝ=°•ÙÓ¹²®-g&Tªåtaþ“ìÅLö뙳Ÿ^Hß7ýÎèüm¬þs˜„Us!Š[Ýc ©AÉ¿Mø›Žü5{Êäé_Xv.ŸÊvhäOdÊì%©µÜb.+7e;ãòLæ'ÔÒôh/Ö8%YÖ$í'ÕŒ‹î§Vg¡gÒ¥Ž¡~ã±EÄ»`ß¾!%æá—?®?ÙÐAú£é5ÚÂUhvDSoyÍSà&`ñÔRœù]ÙÊ…<&‹R>m‡N¤ÕÝÁÈÉ˦fÁ*™¿±¹EýC¤~ÙÜ6º`Àž0žÅ¯c­J­•ÍS$Æ`ðc‰ š;œI®Hm"øt•ëi©måïw‡iI€s¦§Ùr*"x:â"9MÅ—qßkóå\ä1‹òbÚï‚' ð&SŒ",X–£,+tîPTäþ–ž?î¿<…Üg˜*áÿÀ#%iߣj’$¾,ÐÃ`R8 £úæ‚F›\‘†öRp¡Å 5LÜÉrŽùQz!C"ä,,²)âËÎhÛŸ!è(õoôb!O«éÜ«_[ ‘¸,ÝÃr×8‰–cŠÁ*öNp|8Òz§ª©˜É)¯EÂÒdæõ›6±àf‚s3µªÑ}­v’Q9yÎYš~õ§49†Ðz4ä˜H­ÆÓˆ`Ôe76¥‘KMr/Gǯ߱b~?_ZåZ.;­*l›ûÖõø¹kNÏë•·Z‚é{Ü#ëïë“ÿÐoâJHØÓ€IÕ›þØ®}zÉI#]ðVXÁ5¶ÍéUq¯×—ç$MÞFÐ‹ë ŸB²Å˜㡇ðUIBCîÜ«xºçrsö/èט endstream endobj 242 0 obj << /Length 240 /Filter /FlateDecode >> stream xÚ½NÄ0„û<Å–vÇëŸÍ¹=‰ ¨°h…r'‹œs:‡ž'„“®£Z­FóÍh$AÂ}%·»÷UÓYDá¬Uà€Z‹–v@¶J[ðïðʜмFT–=]bêã9Œ¼Ö­aýt*;—Ù”†Äµbó¢YR¿rÌüÍ?6±€FhCkŠ„Z•6>Ê/%{‰ù3Œñ;ÌqJCÄ|\rã¹Sì{^¢>6êm÷…ªÅñ*p«ÝqgXè‡9¦ãúàÖçyÈùÚä!¦Å|¯é”')Z§£²ÔÆY¡‹ô»ÝåÎW?—í]. endstream endobj 244 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ31Ñ35R0P0bc 3C…C®B.c3 ßÄI$çr9yré‡+›qé{E¹ô=}JŠJS¹ôœ€|…h ÊX.OÆìØÿ ~!"ìAD=¨cÿ€àŒ`¤ ñÿ?ÐlPvP\®ž\\P'è endstream endobj 245 0 obj << /Length 168 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bKS …C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ÿÿÿ?ÀÀ$€Éÿ²L>`q?€Hù ’ýˆd“Œÿ@$„ü&ë!d‚´ÇA"«©G2áÂdˆ-!¶ƒ\qÜ…H.ù‚a0‘\®ž\\\Lƒš endstream endobj 246 0 obj << /Length 179 /Filter /FlateDecode >> stream xÚ36Ó³4T0P0VÐ5T06U0¶TH1ä*ä2 (˜@e’s¹œ<¹ôÃŒ ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.Oæ òÿ0ÔÿÀðÿÿÆÿÿÿ0!û†þ ò8€˜Á¾‚븈ÿ‘õÀ̱?ÀÀ4— h‡û†:ö?Ìÿ˜ÿÿÿtà[>€ÝÄþ‡ËÕ“+ ßrDª endstream endobj 247 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚmŽ1‚@E?RL!G`. +¬šØH‚šHa¢•…±RK v8Gá”d×!R:Ékþäý=/BžpÄ£õŒõ‚¯!=HGNxÚo.wJRRGÖ©­Ä¤Ò¿žï©d¿âÔšORt¦tÍð 0@n ÇÚÒµ¶òZ¿ök·ñ+§ J´AO\ ‹e.d?:+°¦Ðaz²qw"–B…_c(/,]ã¹oÐé¹­¥¹„k@›”ô ÍUH endstream endobj 248 0 obj << /Length 89 /Filter /FlateDecode >> stream xÚ3´Ô³0Q0P0bC3…C®B.s ×ĉ'çr9yré‡+˜sé{¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þQ¸\=¹¹6VLÖ endstream endobj 249 0 obj << /Length 190 /Filter /FlateDecode >> stream xÚ1‚PDÇPlÃØ èç †X‘ &R˜hea¬ÔÒB£­p4ŽÂ()Œëw-hm^1“™Mìd6刧<¶œDÏùdéJqêÄ諨s¼P^’Ùqœ’Y9™L¹æûíq&“olɼ·¨,Þ@ 5I ˆô‰¼œî¿‡ èPÕA‹¬„MV#hü¶rèOÀë\š×ÿ‹áV1$kQè*-×:H§éHTÒ¡4ÐhYÒ–>Yñ]] endstream endobj 250 0 obj << /Length 133 /Filter /FlateDecode >> stream xÚ3²Ð36W0P0b#sc …C®B.#rAɹ\Nž\úá F\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O†Ø?üáÿðÇþßúþøûŸáï†ÿþ?`øŒþ3@Ñ?Š—«'W Ì“C¥ endstream endobj 251 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚMÍ; Â@à ir„Ìt³‰­"1‚)­,DÔÒBQ°r÷h{”!¥…dc¾æŸW¢£„"Š©¯)‰(ÓAããTˆ†]g¼Dµ¦8E5—U¹ ëåvD•/§¤Q´Ñm±,L¿Àg¶³ Eö)ðmž}À?Óɬ¨[¹† ½Ñ@€ÛP&ØÉ„ª/ÿg"vâk tìŒeÙ3²¶wžòÈÎJ\ánONØ endstream endobj 252 0 obj << /Length 133 /Filter /FlateDecode >> stream xÚ3²Ô³´T0P0TÐ5T0²P01WH1ä*ä22 (˜X@d’s¹œ<¹ôÌ̸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ŒˆÁÿÿÿÇÀÄê¥ÿch`üÇØÀðŸýÐR®ÿÏÀ`””ÀÀåêÉÈ|Q  endstream endobj 253 0 obj << /Length 127 /Filter /FlateDecode >> stream xÚ31Ò³T0P0SÐ5T06¡C®B.c4¶€È$çr9yré‡+pé{…¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ10þ¡/f†bö?ÿäÿÔ7Ôÿ©ÿÿÿýÿŸ@üñÿÿƒ˜ÿ00p¹zrrÁja‚ endstream endobj 257 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚM‰»@@DûùŠù®e­h=[H¨¢B© ü½x7¦8“œc×zÔtTÌп/ä 0CG·~—ú ‰…4Ô¤ †Ø’벤J© [E¯ƒÍx>Û_?îÈ-j\•]** endstream endobj 258 0 obj << /Length 281 /Filter /FlateDecode >> stream xÚuѽJÄ@à )Óì ;/pæ“Sç ¦ÎÊB¬ÔÒBQ¸BâÂv>‚Ïß$peŠ8;»çå¢n±»³ 3³Ù~vˆNœÄSLcLð.†GHºŽpšmb·0+ ¼Â4ðœøüôrálqŠ1„s¼Ž1ºbŽ‚VÞšÝë{MuPJ{µ oM”Â7´"Øâ5?ÐKŠûZØgcGý?ÒQýFö´vè¸>*jˆ¹Ìµh¹è]> stream xÚ]ѱNÃ0à‹Ù®ž¤f»–·Zªwn×BÆ{ÿG4êûèQ ù@ÅdNAÂÄBí¢Í^=•IÝ T‹d¬%sµ™÷˜Ú]KsýÄbr¦h6ó@Î^^43{2è±¹˜îƒzD!;‰(dý«­`ïÑ!´m¢X“Ú¯¡m㺠ZÆèB$B¤¹ŠÆRm7ó˜WúKPËÄ›–_ø †×Šæ endstream endobj 260 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚ]ÐÁJ„PÆñO\gã DsŸ « ×ZÄÓ¹jÕ"ZUË`Š‚Cúhó(>‚KÃØù®Žf‚þ¸ žû¿.;™ÏMbœÞÙ©qgæ%•wq™®.ùáùM–¹Øã2±7úVl~k>?¾^Å.ï®L*veS“> stream xÚµÎ?AAð•Wl2#˜ØdKÉó$¶P)D…RA¨9š£8‚òbìóÆóË|3ÍüÐz´8*ãqqïà!ælK,Ýêf!‚™ç+˜´ÀËùzS/§èÀ4¸qh·TQûƒÒy”~1}áÉ „3îÌMP u|˜žðf*¡e´ðz”7"êÈ…`–`_ÂâSt endstream endobj 262 0 obj << /Length 255 /Filter /FlateDecode >> stream xÚeбJÄ@à?¤Lqy1óš;ÉåÄÀy‚)­,ÄJ--í‚É£í£äR®\g& wÚ|°ó'ìü[”‡å1Ϲäƒ#^¼<áǽP±’¡ŒSòðLëšò[.V”_ʘòúŠß^ߟ(__Ÿ³œ7|·àù=ÕP¹…aHÂ(fîãTÆÈ AêÄ#{Ľš8=N¦Ý¯™Ø#Ã_+ÑíÚAïžtjÖ›£4HÃ`~AWÓQ‚~,¨‚·@Ekÿ¥flF[bÛ³î[ªúÏ µ~”ö“-´½(½ÛN[¶N£ÏA/ñ£¼†V—í­‹³è¢¦ú?Fj¤ endstream endobj 263 0 obj << /Length 212 /Filter /FlateDecode >> stream xÚMÎ?ŠÂ@ðoH1ðš\@È»€Nbj£àº°)´²+µ´P´ $`‘No°g‰7ñ)S„dgFA›ï/ê÷¢ˆ}q7`Âo:PhŠ>‡Ãgg³§iLjÉaDêG—IÅ¿|:žw¤¦ó/HÍx°¿¦xÆ@@6/ïcGÇÄP‰Âà”¨!×Rˆ^!ª'“ÌâTH3=™â,ÑšÅæ×R˜;÷â…g¹X²Kž%Hs$h%Æ¢uõg·+> stream xÚ]ο ‚PðOîœÅGð¼@]ÿ éb`955DS5¡öfö&>‚ã$»)5üÎð}œÃñü‘Ë6+X8!Cо¡ %j¡•P¦f•¢¶J`Rôò¢Ûþjµ×Ÿæ—­ùZzê FB”!Ì‚ž¥_©ºC4KhEoçM> endstream endobj 265 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚUαN„@àÙPLÃ#0/  ¼æHÎ3‘ÂD+ c¥–íH ± Ó7ðY0¾ˆ@IAXÿÝcCl¾bvæß?;9Î2Id#G©d¹¬Oå!åg^å&²Þ^îŸxW²¾‘UÎúcÖ奼¾¼=²Þ]IÊz/·©$w\î…ˆÔÌGï ~=ÑBç‰Oá \N nk¢m`ˆª`Â\MèðÕd³G :5"ìÀ€šÕ»>ƒfÆâ®g¢ä|w3±ãÇòÞŒT8Ú¦¢º¥ŠLH[e"4ûü 8 ¿Ð6IõÔŸ—|ͬÁkÞ endstream endobj 266 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚmÎ=‚@à!$¯á¼ èòS $Љ&ZY+µ´Ðh²…‘åfx“=%-l,¾f&™LCö9áQÀQÂÑ„)LLès›ý‰¦‰ ‡ ‰…‰IK¾^nGÓÕŒ9oöwTä ”€Ý×pŸ< ÑAZ-¤Ý@:ÒÔh½M¦,ÃÑ™òTYõ(ûÖPà zãõG÷ãߨ IaévíÁU.R8Uk®èÏÍ ZÓ¢ B endstream endobj 267 0 obj << /Length 236 /Filter /FlateDecode >> stream xÚEοJ1ðY¶L“2/ Ù¸{ºÀy‚[Z]!Vz¥…¢ ({ûh_$°¹"¬Î,»ÚüŠI曯^ŸSE º5Žê=:|ÆzÉÓŠÍôôð„›íŽê%Ú+ž£m¯éõåmvssAí–îU÷Øn @ð‰ÉëE2 ÊȨ èž1½JàAE8èƒA‡b„räÈßg|¯FÆí‰Ã„äÌ d¾]¥ 2÷ÑG€d˜÷Æ3úKê–‚ú'Îè‘'BÇ¥„žx`:!s\ÁIŸ²`~zNx /[¼Å_¨TdW endstream endobj 268 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚUϱJÄ@Ð7¤^“ò~@gãfa„ÅuSne!Vj)¬¢`•̧åS"þ@Ê-ÂÆûFaæ0Üa.wª³Óª’™,䤜NžJ~å¹Cˆøü÷æñ…W5Û;™;¶×ˆÙÖ7òþöñÌvu{)%۵ܗ2{àz-” DfJ £HŸGº„"|„Z¥ÑÖ¦ÁçÑԠÛ)ä€ò`ötfTvhÌ"Ã?|@‘×QZ×計VШó@0ã1ØE–Îã×¶-eý¶ƒÒƒ¯nOæ;`ëDŽhI|Uó†´éd" endstream endobj 269 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ…Í1 Â@ÐR,Lá^@ܹ€nŒ¦¢‚)­,ÄJ-m5âÅâMö)Sq79€3¯øÌ?ŠÃ<æ~ÈQÂq̇.ì6µŸý‰ÒŒô†£€ôžIgK¾]ïGÒéjÊ!éoCv”Í^a JH˸ìçø;%ü¢‡ŽB·‘Xœ[O”ë ÔŽgUð[¥kM•4FF~ŒúêÕxçÊÏ•€ÓìBTð hžÑš~; 9õ endstream endobj 270 0 obj << /Length 172 /Filter /FlateDecode >> stream xÚ}Ì1 Â@…á‹ÀæbæºÙ…è ‚#˜BÐÊB¬ÔRPQH!š£å(9‚eŠÝÙµ¾êð”(E!¨/I )ÒtxA©M )»eÂ8E±!©Q,LF‘.év½QÄ«I m%…;L¿ð>?9›:À^ÖÓj¬šµœŠµ7óœ’ùNÁ‚ÿ÷Ö=¨»Öj •‘Av†G ¹Êç)®ñ ®E‡ endstream endobj 271 0 obj << /Length 266 /Filter /FlateDecode >> stream xÚUÏAJÄ0à?dQÈÂ^`0¹€v:B[¡LaÁ.]¹WêR¨¢ÐU'GËQ2x€‹É¢t|MUÆÕG^Âÿ¿dùéyªæ*W'©Êçê,WO©xÙ‚†t,¦›Ç±ªEr§²…H®h,’úZ½¿}<‹dus¡R‘¬Õ==ˆz­˜Å€È!ò|¯e£2ŽL»Äñ²ä[+1“-ÿ2R•c;“–íë¶2l ›IÓTšõAp©ÝfÒvàî@tc[¥§Ö èÙÿư`æ)ôÏaTzÄCY?›ô£´‰/C ÷EåîPÚÌ5¡„Û&„së~´¡„o eŸôs*ÁP%Äe-nÅ7ã7x` endstream endobj 272 0 obj << /Length 225 /Filter /FlateDecode >> stream xÚUϱjÂPà?ÜáÂâ ˆ9/Pc0$Bj¡;u(ÚŽ…V2H¼à‹åQî#dtí¹É`]¾á¿çÿáÆÉ8ÉxÂ)?DÏxšògD¿GNxšõ/ß4/)|å8¢ðYb Ëo7»/ çëKºä7é¼S¹dÏâ蓺øù@7=æÊbTªEV´žÓŠUш?âI4›öà´õMÔÐâÚç;žØ@ê½A¯êmQSuj#Síêõ}7µ÷ÝÈ~Ô9ìÌÜ`^¹©ÀBË× è©¤ú’tUž endstream endobj 273 0 obj << /Length 190 /Filter /FlateDecode >> stream xÚ=ο ‚PðO„³ÜGð¼@]ÿAµ(˜AAM ÑT Em¢B/foâ#ÜÑA´«BÃßóÀ›;¼â™ËÇþ‚¯.=È÷tè°¿œ6—;Å)É#ûÉ­ŽI¦;~=ß7’ñ~Í.É„O.;gJ Àì+ˆ¯‚92´È =™ ¡¥Y5"¡ÙÕ$*GE1À_ßkÐMŒAÛŽÌfb)­n!ê ¢Êa—!"„ºt¨5¾}€6)è•GÏ endstream endobj 274 0 obj << /Length 238 /Filter /FlateDecode >> stream xÚ]Ï¿NÃ0ð/Êé!÷Òš?"R)èÄ€˜ZF¤‚@ê€j?šyó=D ç¤$¶ôî|§Ïjr¢ŸÊ=.ÏYMxzÁ«’ÞH•]õlºo-_iVSñȪ¤âNêTÔ÷üñþùBÅìᆥ:ç'z¦zÎÈLfÜU¸ò›/à2¸k`£­¸Ö&[ˆ~‡ÜÀõ6bòÓùÝ‘Tƒ~4óЃ{ÚÎh{“FRýD“öJÎÊÈ*+o£Ft:‡^˶ñCØÆf\8ØŒ&‡†Ñôи%F–Ó¶öŸt[Ó‚~JlÓ endstream endobj 275 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚUÍ1 Â0à_:ÿ`/PìMC”v(j3:9ˆ“: U:ˆÍÑz”¡£ƒˆIÄ!Ë7¼ï‰é8âQL#NN"¦#Ç ¡ÃˆDòkgÌ%²- l©cdrE·ëý„,_ω#+h§‡ö( ò¯¿ ß0¬R‚GéC:k3•d¦V™ª4PÖ`  {@û1¼ÿ€¡gy9x–Ρoi|KãZ”Cf1.$nð ñÿ> stream xÚ=ͱjÂ`à2î’7hî èŸäÇ6]ˆ fìÔ¡tÒŽ…*:H|±é(V;Qû¬›X¶’¤\FjÓÛeý%E)æM“TÌ‚k1åRvûO1Åjª±˜™¾Ç}H9S Ü Á¹B†4øÅ7Z4^ë7^󝿬üð;r<×ÿŽÌȇ0È)¤ Êèz§»!ËB–e,; eá£__ß=Fʼ”W¹|/Hd endstream endobj 277 0 obj << /Length 178 /Filter /FlateDecode >> stream xÚ]Ì1 Â@Ð )Óì„Ìt“MBÄ…Á-­,ÄJ-+³GËQr„”Bt ñóªÿá«|(¢œú1%Š2EûϨR.#Ê’ï²;baP®I¥(ç\£4 º^n”ÅrJ1Ê’61E[4%o!¨Aü™u4§x@ÕuŒ/øòØÓñYë¬qDówßûk;Ôp×pÒÐjh´WOü: ¬ðm 83¸Â7Ä¡B endstream endobj 278 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚUпJÄ@ð/l˜Â¼€¸óšÄäHŠƒƒóSge!Vj)DÑN.>Z:_ca;S„à·Q9m~ ³ó)³“âT3­ô8¯´,´¨ô>—')Œfº(¾îeÝHz­ÅBÒ Æ%m.õåùõAÒõöLsI7z“kv+ÍFá˜QÁ¸‹Ø–Ú"qõ Ißîé`{¿ƒ}w3ÁˆÕ ¢™á›fÀÆÿaBì™»=ÑÌð3ã ÓKˆ·žM;tŸÄ~®è±='sŸ.ìC˜Ë±ä |G ew´†UuÌ‚%s‘LáárÞÈ•|–ob3 endstream endobj 279 0 obj << /Length 211 /Filter /FlateDecode >> stream xÚ…Ž1jÃ@E¿P±0Eöš $+1˜Ø`bp°Š@R¹0®œ”ÛØ Î:šŽ¢#l¹…Èf Å<†?ïÈ<ͧ\ñ”k–9Ë3Õt" +–Ùýrø¡UCnË"ä6“kÞùr¾~“[}¼rMnÍ»š«=5kFÞç¬7Ê`€åhÛøÄß –#2o²YA¡;´§Ð `’°Hh¼ÎZ‘´"i‹¤Í ´É °!ó(£ðRF½ÛØ£µ±ÃÑDmå#þ½5ôI@%?‡ endstream endobj 283 0 obj << /Length 119 /Filter /FlateDecode >> stream xÚ31Ö3µT0P02Q02W06U05RH1ä*ä24PA#S¨Tr.—“'—~¸‚¡—¾PœKßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEŸÁ¾Ô¨o€B¬Â@ø €a—«'W $o&| endstream endobj 287 0 obj << /Length 104 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04W0#S#…C®B. ‚‘)T&9—ËÉ“K?\Á’Kß(Ì¥ïé«PRTšÊ¥ïà¬`È¥ï¢m¨`Ëåé¢`ÇP„ÿþ7Ô3`‡v(P†ËÕ“+ L5* endstream endobj 291 0 obj << /Length 233 /Filter /FlateDecode >> stream xÚ‘=nÂ@…ÇraiÁs°þ‰q:K`$\ %E”*PR$JZðÑ|ŽàÒ…̳Y¬¤¡øš}³«7ß>'“t*¡D¡<Å©$/’¥²‰ø‹ãLÜÂÏÏJ6k‰36K$lÊ•ü|ÿnÙÌ^ç±)ä=’ðƒËBˆœ#‘«ø5QPåD´W:·%ò#J c9Ðуr¦ç4àvh|Ð }*q¨ÿæl©äzÿ¿÷Ç=ÐÍö´½ýö¾×Ý÷´{[½¸#¸‚3¸ƒC¸„S¸íÃ5œÃ=þÀ9ò¢ä7¾áÄÚ endstream endobj 292 0 obj << /Length 224 /Filter /FlateDecode >> stream xÚ‘1‚@E—PLØ 芔$Љ&ZY+µ´Ðh+£pJ "θLŒ&4¯Ù¿³™ÿv<Fôq‚ƒ0ÂÑãœ!ŒéÔÇÀ—l‚izƒa zÁèl‰×Ëízºša:Åm€þ²+¥TM܉„ðJ¹…RNIPhSh50O"gèRÂÐE¯4¸•Á©;hÀhÐZƒzóø&/z( ÉŸÈ|ßû¿{´Ÿ=eoî }¸›ô”Þâ°v”wÎã]²SvËŽÙuÒ¹ç?à¿€ykxBÐ{ endstream endobj 293 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ36Ô34R0P°b#CS…C®B. m„@ $‘œËåäÉ¥äsé{€IO_…’¢ÒT.}§gC.}…hCƒX.OöòìÔÿùÿÖÿ±ÿ!ÿý—«'W áš( endstream endobj 294 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ33Ò32Q0P0bSKs…C®B.S3 ßÄI$çr9yré‡+˜šqé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]øÿ Æÿÿ€9ÿ?©úÿÿ€Ä~0ÿa``Êü«cRòÿØ:ìÿ€5ÚÿSõ`”üÿ†ÿÞÿØ)ö`Šñ˜R( Cþƒ^ ¤yÄPÀø:ô5>ŠËÕ“+ Šc endstream endobj 295 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚÝÒ= `šMÞâúN ­vlRk"ƒ‰NÆI4:—£Õ›p„º14}>´n]t|ü<„Éx˜Œ1—4Á4Â} 'àÖåô5±;B®@®¹rþ¬Õ/çëd¾œb ²ÀMŒÑTBˆ Ÿ¸õˆªŒ*7@w"#DI.Õ> stream xÚÑ1jÃ0€a ‚·øÒ jR'YbHS¨‡B;u(™ÚŽZڭؾI®â£ä=˜¼JïIq‰ÁT`ø$/ÿ“V‹«ëµIÍÂ~«ÌäkóšÁ,s»OÝÖýxy‡m É“YæÜÙSHÊ{óõùýÉöáÆdìÌsfÒ=”;#ìÒðkTÑNUç„ÝDö3’8L¤ð4£1è¤裵>+*bôùT)ôÑ?£dÐ C~yE}ˆŽºQÂKZq¾<Šš¥¬8ZµT°b+Ρ1ܼÏ×nÎ N”¿q÷Aªœ(ºF».äÀùgE¤žã…¸$ <†àAéÄñ‚óGÅ.!Ñ šÕP¼Ï/X-Å{Uü°­«£wÅî¿‚ÛáÆÁÊ’ endstream endobj 297 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚÅÒ½ Â0ð‡Â-}„Þ˜ìÇV¨ì èä Nêè èl­ÒGpìPz&±M„ˆÐÉ@á—„$åÓ$BgüK|Œ<p8äs9‡3d°-Æ!°%_V¬ðv½Ÿ€eë9ÀrÜèï¡È‘ä°øxë©Ô)Q©TóÅ”ïxÔô²©íe¥4ÈG¤ªzMÄa)[¼"ei=šAikÊëL¹ôM¥!çCÕhÕ×ø.TC×Ê#³¦igÖ^w†£o¶êªî´î¾J„-ã$äŠKH…­We¦N'Q<‹6ð¯?K endstream endobj 298 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚÒ½ Â0à„…[úæžÀ´[' µ‚ÄI'õÑ|£ƒìµÐ´Ö@ໄ\þ.ôû]Ô=ô0âÖƒa»:Ô›=Ä)È%!Èi> 2áéxÞŒçcô@&¸òÐ]Cš ú¶ŒuãŘPŒq‹Á"p3q%ŒÚÑ«áÒ§™ÎÐN°¢€¾ðß(WUyxû¦9ø³8¡ ëÑVÁ6q¯Ã1 D„=¸¢$Ø¡¨•D‰÷/À$…|®±ßd endstream endobj 299 0 obj << /Length 173 /Filter /FlateDecode >> stream xÚ37Ð31R0P0b3S3 …C®B.3rAɹ\Nž\úá f\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O…ÿÐ@€>À`ÿAJ3Bi†z(m¥å¡4?”f‡Ñ 43š+ÍøF3| @3€hf4;”æ‡Òõ`è+¢h˜z„~vö1’HƒiP¤~ ‚ærõä äœÏ endstream endobj 300 0 obj << /Length 300 /Filter /FlateDecode >> stream xÚÍÒ½N„@ðÝP\2 pó ÄX‘œg"…‰Væ*µ4Q£5÷&÷*< °åÆ™`¹øQ{ù±,ìÜÌ¿,OÓsL1Ç“ Ë3Ì/ð)ƒ7(r^L±ž<¾Àª†ä‹’k^†¤¾Á÷ÏgHV·—˜A²Æ‡ Ó Ôk4ü#gÌ«`Id ßKD-XûHT±ú…HžQìd[Ïë;'Ûøë¥n—ü1‰ªÞ“ÕÆi/jœ®óÇ{;_…ã÷ƒZŸÓöX\‹?b.®´ ê¿«QÙ_äËó%þ5Üt×õIÿ¥ôs&µüAÚÉciÇUÝ h’NËN SµÓ¤#þvPHDH‰&‡4MÎÒnL˜Ï•OÝ!“è|&%­Ig]‚«îà ê¤ùr endstream endobj 301 0 obj << /Length 104 /Filter /FlateDecode >> stream xÚ31Ô37R0P0aK3 …C®B.cS ßÄI$çr9yré‡+›ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÁlƒü†Q3è¸\=¹¹‹iƒ% endstream endobj 302 0 obj << /Length 286 /Filter /FlateDecode >> stream xÚ½’±NÄ0 †sb¨äå!~èU ë1U:‰H01 ›€‘sîÑú(}„Žª;¶RÐ!F:$_þØŽk{sqVã ×xZa½Áõ%>WðuÅâ k»yz…m åÖ”7,CÙÞâÇûç ”Û»+du‡ì³‡v‡Î¹‚:—>¢˜ö‚H%Ï0„èhâ}ÁGOÉäàNÄhI¢öl+÷­›Ñé"‡$§>ªx$O‰‘Aâ9Ñ3Hà:ƒ7¼¦ICc0C0˜Â” üdÿæ4rªGðËZƹ3h醥AŸ¡°:wß*¯½8,´;$Á¥qQRrº¤WEö¤½g‡Ž½{ !“Љ̳A:>6@ ÃøcòhÙ°Áu ÷ðž¤ö} endstream endobj 303 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚ37Ó35V0PasC3 …C®B.3s ßÄI$çr9yré‡+˜™sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒ„ñÆøcüo€100ÈUòƒŒÿ@ õ  ûPˆ3øúÑ v,ŒÔf [Í=èn†ûæ/¸O¡~0”ñÆ85 †)šˆcp¹zrrÚõÏ\ endstream endobj 304 0 obj << /Length 305 /Filter /FlateDecode >> stream xÚm‘½JÄP…OØ"p›¼€yÍf‰‘aa]Á‚Vb¥–Šv É£åQò)#\î83w‰.x›Ìï9“zu¶ªhI5–t^S½¦—Ò½»j-Á%]2Ïon۸⪵+n$ìŠæ–>?¾^]±½»¢Ò;z,iùäš<àH9àØ0w{‰1‰àÛcÁ]Ω<² h=òQŠ=6 zh¾,ÝŒ$üûýd˜ˆà1bŠðÐ׆«ا¨#X«êéÉA}Éëă¼ÞiMËÖ©¥S¬Ñ-d§ÚpíAÜiÈÌ$ r¢ñÉ0cúðGÖÝ‘»Ò"Øyäž*\ެŠå'¨ªÍ5 ‰Ðš?ŸÛ)¦ÔœhVVQ¥»nܽû÷ó× endstream endobj 305 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚ}ϽNÃ0ð«J¡l¬ü¹³;Ta?ùìûpÛœ7k©äBÎjiÑÃkÍïÜVb»¹Ì7/;Þô¥­8Üj˜C'Ÿ_o6÷×RsØÊS-Õ3÷[¡&Òå±0’Æ`Q·Ð0‘|T*õM *pŠÓŒ_¬°·ÃÅ2ô $ŠL‡o1ÔJc4|îÐåÝœŽä~82ý;á eSz™ñéºÒ)<Æ8`¯ÍŠN9y{ƒÑ2Êhà›žøål¡— endstream endobj 306 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚÅ‘; Â@†7¤¦É2ÐM4ñÑ(øSZYˆ•ZZ(Ú ñhà̶Ü"8ÎÆP+q›æ±óÿ3Íz­ ‡ ¬ú¶±ÙÁµ;MÐÃV‘Ym¡œc€sd4ÁÃþ¸ÙŸÐ9Ä…Þ¢!Š8üˆ¾Â~Âúƒè̸¥Œ+‘fÜ’^Æ áÜke˜ÄÙ"eš,®”æŸˆÕ tŽÞGd?ÀË„bú›$UÊ5â“ÒŠflì$*lóÞÍMgnó ´C¦JÙæhVÊ·3Ë®FÌàiÔp endstream endobj 307 0 obj << /Length 214 /Filter /FlateDecode >> stream xÚ­1 Â@E'l˜&GÈ\@7‘E±1#˜BÐÊB¬ÔÒBQ°’£í‘R¦gEì…áv>ÿ¯™'SŠÈÐ &3!3¦cŒ4#£Nq›ÃÓõ–ÌõRdÔùŠn×û uºžSŒ:£]LÑóŒ’> stream xÚÅÐ1 Â0à”…·äyдÒ*N­`A'qRGEçx¯ä ¼‚7бCéó=q(8‰òÁ ÿŸv«ÙŠ1Ä&]lwqÁ†Øy,ÖÐËÁN1‰Áy 6án»_íûÍpa8‡•‚&:2)Ñ™¡BztòŸÊU™«ÇUN­ËÇ+æIZÔà^Ü>¡àj©‹$qÍ©ÂÆIMîMRÚ'*ùmseÿ c¨ÒL@… ÜI 9Làwn¶i endstream endobj 309 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚu=nÂ@…gåb¥i|Ï’eÅÒYâGŠ‹H¡¢@T’Djûh>а¥ äÉÛX ÉŸVï½yšyñÏÞËD¦òä%¼J˜ÉÁó™C€8‘0Ï/*v[ ÝdvÕ»\/_Gv‹¥xv+Ù¡hÏÕJˆÊžˆ2Õ†(Wí ¨F¢ºO†¶öFF›l@²Ä&¿%`Ý}b —ÝÈzdüeL,¢>2½¿Ýÿ°~dgygL[41Ƕ¦³Š» ÚÖhKy“êJ BaûsµQø óºâ îDŠ endstream endobj 310 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ36Ñ32V0Pacs…C®B.cK ßÄI$çr9yré‡+[ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ700ðÿÀÀPÿÿãÿÿ?˜ÿ÷ÿaàÿÇÿAþ<ø$ìADýÁÿ‡áÿ0ÁüH0 ¤ÿA6b#È4oˆúÿ@ÁåêÉÈèü®  endstream endobj 311 0 obj << /Length 281 /Filter /FlateDecode >> stream xÚ•‘=NÄ0…ÚÂ’!sH›´––E"Tˆ ()@Ðß`¯ä£ä)·ˆ<ÌØ‹Å$Å'ÏÏ{ÏIן5-5tA§ç-ukZwôÜÚ7Û5¤oßZO¯v3ØúžºÆÖ×R·õpCïŸ/¶ÞÜ^Rkë-=ˆÔ£¶ð„/ÀqZq€gÞ XŸxÂqdWŒjï£Ip‹nIU¨ì¤iÿÀ+ÂÿñW%KK"5²-CiÖKìŒ #;–A˜ 58©E,˜ æ½k΢SvàYlK³ S^`‰%*#ÃGÝÅ4dP€ãã”ɲ€1ê:¼^.ei³À¥üiþ‘C–¨žÌ%ý>+éÁ^ öÎ~ÝèÈñ endstream endobj 312 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ33Ò32Q0Pa3 ²TH1ä*ä25òÁ\Dr.—“'—~¸‚©)—¾P”KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓE¡þüÿOb†PŒF±ÿSöÿ@Ôÿÿ€ÔÁÿÿ©ãìÿ©ó ò ê>ÿ? uBýP?Øÿ©(ÔlÔ¡Dýÿÿ¿ùÿÿø(.WO®@.Jå×m endstream endobj 313 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ36Ô34R0P0b#Ks…C®B.#ßÄ1’s¹œ<¹ôÃŒL¸ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. 5 Œÿ˜ÿ7°ÿ?Düÿ #ˆ P¨¨’¨?Pÿ1ÿ?ÀH{ôp¹zrrÙðD endstream endobj 314 0 obj << /Length 220 /Filter /FlateDecode >> stream xÚÅϱnÂ0à  H·ärO€“¢´bB*‘©L ˆ‰22´*+ö£¥êÀc¾c"û¿… F,YŸÏ²ÿ³‹A/áŒû~oü:àÏœ¾¨uʰXoiT’YpÑ'3õ»dÊÿ|ï6dFcÎÉLx™s¶¢r‘­"?D+§c¥~DRãdZ¡ÞÛ+-ˆЭARÔ«.à·Z”£§T7œ™ÿrBŠ ‘³Ê°U. (]Ÿ«],ᮣD> 4À¶À§ù®±Hsz/iNW^`ص endstream endobj 315 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ36Ô34R0P0bc3K…C®B.#S ÌI$çr9yré‡+™ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ê0üÿ‰™˜qàÿÿÿ7 c.WO®@.„S—œ endstream endobj 316 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚíÑ? ÂP ðˆC!Ë;Bs_ëZA,T;:9ˆ“::( n>'Go qèQz„ŽJcªƒ¸îß—dûÚZ£E5eÚuj¶héâ}O²SÆò°Xc¡ž’ï¡Êu4¢Ýv¿BŽ{ä¢îÓÌ%gŽQŸàh¬@åÌ&àŽlJ2§æDxbΪ…çÔÎUdÂK¬ ÛØ9TùŠ»`Pá+XÜUò.<¼˜ÉS*ñ“©0y1Æß ÍŸoò³–^Š_ˆƒ'øøïü# endstream endobj 317 0 obj << /Length 162 /Filter /FlateDecode >> stream xÚ33Ò32Q0Pa3 eªbÈUÈej 䃹 ‰ä\.'O.ýpSS.} (—¾§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹C}û?†ÿÿìÿ7€¨ÿÿ©Æÿÿ©öö€Tƒüæÿóøÿ10þŸ¡ö@¨ ìÿÔê6êÀP¢þÿÿßüÿÿ?|—«'W ã[« endstream endobj 318 0 obj << /Length 213 /Filter /FlateDecode >> stream xÚ¥1 ÂP †#B–¡¹€¾[¥S¡Vð ‚N⤎ŠÎõh=JбC1&¶ÕE\|>øóó’?ádäùäј†>…c &tðñŒA$¢GÁ´éìO˜X4 "4 ‘ÑØ%]/·#šd5#MJ[ùh‡6%·y=æ\0`..³ªYå°€óßAK<ý@\À@Q‚#6·§-WQwˆu©;Sðwð ÷?ñkB·KƒnÏú•¾ÍÐ&jÑ×´…„–ìùû1³´Áa®>7k.ˆs‹k|]Åf endstream endobj 319 0 obj << /Length 227 /Filter /FlateDecode >> stream xڵѱjAàY,„i|çtïôN´Œ‚Wbe!V&eŠˆÖç£-ø>B|„-¯Xÿ•D„ÄT±X>ØÙeçŸíuÚLéJ+HÞ—,—×”?8»‰ô²¯ÒêGÛ¹äÛ)öÙϲYoߨŽ^ž$e;–E*É’‹±P鑪SݽêT+ðé†(5OTÓ@u%ƒBMwF=p§±ŒºoHý-euŸaø~ÏÿììÒnlÞ]£Tȇ`1æ)†6AâÆ¯bXiú DAãŸü O žñ¥ÜÆ endstream endobj 320 0 obj << /Length 161 /Filter /FlateDecode >> stream xÚ31Õ37U0P0bcS…C®B.cK ßÄI$çr9yré‡+[ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êêþÿoüÿàÿÿæÿþÿïÿÿHôÿùÿ¾ü?æÿûäÿ1þß"~À‰`‚ÿãÿì?€ã ÁÀ€L 7ñÿ?Ðbl—«'W n endstream endobj 321 0 obj << /Length 223 /Filter /FlateDecode >> stream xÚE1NÄ@ E?šb%79Âø0;Úì"ª‘–E"Tˆ (·AKÜq­%GH™"б´4o4ßßþv]_ä+^sÍç™k{wüšé6[í{¹T^Ž´o(=òfKéÖdJÍ~|½QÚß_s¦tà§ÌëgjŒ8êU•ʇ R:EZ Ê·cªV¢ÿG@­‚V‡•ŠjçU'Øø„3r¸Ø¹Ó–½µ—£å:ªÓ ¾Fg ñ¾©u·Ð1Ìv¥Mª#†bj¿2;Ý4ô@¿* endstream endobj 322 0 obj << /Length 173 /Filter /FlateDecode >> stream xÚ31Ö35S0P0RÐ5T0¶P03VH1ä*ä26 (˜™@d’s¹œ<¹ôÃŒM¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. Œ°ÌXv8Á'äá„=ˆ¨ÿ3ˆàÿÿÿÃ,X  wˆ'€þüÿùC=„`?À`ÿƒ¿Aþ<Ø7@ïÿÿ ¡ÿ? ærõä ä ,t endstream endobj 323 0 obj << /Length 166 /Filter /FlateDecode >> stream xÚÕÊ+Â@ài*6Ó#0€í6ÝÚ&¥$¬ … (ŠD@@/G[Ç5ê°8¤Ã‚¨Á£¾ü"e9¥”ÓÐP!Zj îÑZ)%Ÿe³ÃÊ¡^’µ¨§R£v3:N[ÔÕ|LuM+Cé]MàD Ì!æßÄ a9PIÒcУd€/-x>ƒo£;wàê*”Ì!aVBÌÝð7õœ8\à ¦ä¤d endstream endobj 324 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚ}Í=jÃ` `-¾A¬䳋M)˜òõPH§ !SÚ±CC ÉÑ|”Á£'ꫯ¡¸’oþ4J$ëüQ²LÞSþâ<ÜØh‡õ'+v É3v/ز«^e»ùþ`7žO$e7•e*ÉŠ«©¨*…ÚÝ#ÐÑ3‘Q€Æs;Ðþ*ÑØ— ø‰/‚Ô@iàh#2ê+1@îð„[|áiöÆ¡ÙyÚÖ(ÛÆsöÄç“G=‘Ö· ·G¨Ô#¸ô¡î–ʳŠßøà•pH endstream endobj 325 0 obj << /Length 276 /Filter /FlateDecode >> stream xÚÐÍJÃ@ð 9æ’70û&‘ÒXµ‚9zò žl… …¬oè‹ì­×=¦3þwÛR<,û›Øù¸ÌÎg¹ÊÔN1S“‰ZæüÆÅqæB—xyåyÅé£*¦œÞâ•ÓêN}¼®8ß_«œÓ…zÂ7Ï\-”HŸˆèDìHC¥!Ú—%ZCÆ«%‚\Ä:Pm)î(0#µ”tB%ÔSØ@•=ER¥P¤GêéK(†b'$´GWP$d¥9óÒG…òmêæj9h m @¶Mi×^»£Hv:±vP{*ì½jÔÿ1ƒÄËuŒEü!7£è±blEèDna^ÔŸ(ôûö¯n ¾©ø™¶… endstream endobj 326 0 obj << /Length 234 /Filter /FlateDecode >> stream xÚ}±NÃ0†ÿ(C¤[ú¾'¨”±4R[$2 ÁÄ€˜€‘¡lU›GKß$/à Çù¼0Õ²õéì»Oþ››euÅ%ÇÓ\s]ó[E;jj­ËXƇ×Zw䟸©Éßé-ùîž?÷_ïä×®Èoù¹âò…º-‹ü¢•p ÐÀiB1íŒE¸ mQ,GE!ýA‘Ë0)29÷Nò3Dœ¤hœIƒ¤AÒ iþ¡1µ„„Éæô7ºVÎpHšÉ4Y0Ml¾3ÃEˆg¡°²P1€jDßEæK ÛŽé(kЉ endstream endobj 327 0 obj << /Length 267 /Filter /FlateDecode >> stream xÚ}ϽJÄ@àRn“7pî h~˜(Âb`]Á‚Vb¥–ŠB !y´ø&û)Sdw<óƒd„>¸ÃÌ™SŸ¥äRÊq™Ku&ZËsÁo\iLs9Õáèé•× g÷Riή1笹‘÷ÏÎÖ·—Rp¶‘‡BòGn6bŒ¡ØÌÿ™-Ñ‘eFGZ0ý‚Ucc^ÏpGí))€¡$ ·ô)ˆY†€È=ò ÜÆ¯ã—¥[Ç4Yêitìj·uGj†¿ wAlhA´_Bóí“gô6U¹ÊT÷¶2uƒ­Œ¶2H¾–òø’ƒo÷í^î_Ë„>áë>ƈ¯¾ã ø‹ endstream endobj 328 0 obj << /Length 211 /Filter /FlateDecode >> stream xÚÅ‘±‚@ †kLºðôôÀŽ$ˆ‰ &:9'utÐè Æ£ðŒ „Ú£ º¸š\¾Üý½4×ï¢xîäSH³€¢Å]¼c¸”Ч8ÖÊù†iŽæ@áÍFb4ù–ž×Mº[Q€&££4:až@ÒÀ„Yè2×0KT4^ÀÕ´—¢]N/ÇrÚ¡”ŠÊµ¬]¹œÔže£´“vd൅e÷›lÙÿ‹¿ßö5ÑÀÏyÕ€ÚP3jɱÞJY²Q“£U5¬¶æôpãß³ÛÀ endstream endobj 329 0 obj << /Length 126 /Filter /FlateDecode >> stream xÚ35Ó30T0P°b 3S…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ ¹ô]¢ÆÄryº(000````ò ¢H0ÿö@âÿ,Äáÿ0%#Œzÿÿl—«'W ØšŸ endstream endobj 330 0 obj << /Length 266 /Filter /FlateDecode >> stream xÚmбNÃ0à‹Åöï³Ïãú¢|ïGý¿ýÓÀ/¼Òq¯CýyÜófâîίFî®0ËÝtíß^ߟ¹ÛÜlýÀÝÎߣÌO;O$™ˆ9Á 1!˜rðHõâ°Ðdš…Úˆõ4›f¢&˜ç‚p–B•l9{„ôŸÈÃÕ6©8ù,Ö´Â/õvîK¤qb´ûÒ·í¢+tÍÙŠ%+ ¿N»C7¶É"­EB´8Ñè¤V‹êP Í#R¨I*š‡h~ jÁ:¹Rᕤè[I®ÍÆlÍ`Φü˜þÊ—ßò'‰Ä& endstream endobj 331 0 obj << /Length 258 /Filter /FlateDecode >> stream xÚ…±N…` …{Ã@Òåú $÷g%¹^Ltr0NzGÎðh< ÀÈ@¨=…ãâò íééicu]”RH”«Rb)U”·’?ø­XHU­×w>5œ?É1r~geΛ{ùúü¾p~z¸‘’ó³<›Ñ 7g!Ò‘ˆRUc¦ÚµŠ’R;Q2Q½P:X Ja2m0{´þ£ëûtÆ”yíl[ÀJ8ƒ XÏ í¥-ÖAvH¸xÎiO›zÚM¹Í÷YýSgâ¢ÄV6ë•Óo†¬GÐbìÔùÇÉÆï2ޏ´ÀºC’lÄLñUú‡[ÏŸù]~(ß6üÈ?údµ£ endstream endobj 332 0 obj << /Length 216 /Filter /FlateDecode >> stream xڭбjÂPà„ ³ärž 7ÁDpI *˜¡ÐNJ'utPÚ-4Ù|-7_ÃÍÕ­…ôæÿmzàÞs/üœ{ÓñCk¤#»Ò‘ŽS]Ų•dbû¨k»‹åFŠRÌ‹&1 {*¦|Ô÷ÝÇZLñ4ÕXÌL_mÌ›”3ulåŽó‡š´Ø]â ðI@B’¨I Ü/àßsÁ„ÌÌÈ'©È¸à€ßsABN–‘jÀ¸à€AOB¾/#ù&-ª¹Çï¿ü'5£o#óRžåŒÔ‘ endstream endobj 333 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚ¥Ð1NÅ0 `?uˆä¥Gx¾¤‘^:éñè€bF¬4G Ç GÈØ¡j°]&`£ª>EIcÿµï;Gy:räõžî>áÎófG}¿žÜ=â~@{M;öœ·Ñôòüú€vyJín¸Ð-2ЀÉL]_~ÔEÕI-jV£¸€8«Yåz&Á? …}—Bæ£Öæs훃$–SéÂhjääMM|wSSYNñ-ðµŸN¿m£²8±®NZôTÜÔ2fé5J÷ü’äD 2ЏMÐrà[μ©Ñ‚΂̿˜51ÿ=ž x…_‚²¶d endstream endobj 334 0 obj << /Length 264 /Filter /FlateDecode >> stream xÚ}пJÄ@ð9®LsoàÎ è&p›6pž` A+ ±RK EëÝGÛGÉ#¤Œîs&åüƒ~Ålvfö õIYI)AŽ+ •ÔAî+~âuÐb)u½?¹{äMËþZÖý¹–Ù·òòüúÀ~sy*û­Üh£[n·B´@""‡^­H1Ñj$—¨éÉeŠÅLЯÓ; tËY½Ñ;su ÓVÈfLæ5*}:˜ñ›…ý;8ÝCD§á­×ëxÏ:H:n2Áæfìfu«Y›ÛÿrÐVÿµùißL=Ý’½züÊ! å´äŽmNû@¢½Hö´ h––ö”‡ø¬å+þy×- endstream endobj 335 0 obj << /Length 265 /Filter /FlateDecode >> stream xÚ?JÅ@Æ'¤X˜foàÎ4 ¼Mx>Á‚Vb¥–ŠvBr´%GH¹Exã7I@E !ü 3Ë|b}VVRJ”ÓJb%u”ÇŠ_x1,¥®×ÍÃ3ï[.ne¹¸Ä˜‹öJÞ^ߟ¸Ø_ŸKÅÅAîpèžÛƒu9=‚AµÇ@u$Ò±™(ÓÞ'Ê•ÜLîhŸŸí7ÌXQcìWv @Ú8®Ô/Nÿ`ú“™¦î3¶1Ì&“šÜBX=Ñc¸¢Ë­fQò:¨Åƒ.rÿ$Âc³1ŒÞÞaÉØ˜VÿÖä@¿r&¸Âã0: ƒôS®ìYùZÛ™Z>´mJÎêç‹–oø3çÕã endstream endobj 339 0 obj << /Length 192 /Filter /FlateDecode >> stream xÚ…Ž1‚PD‡PlÃØ èÄŠ1‘ÂD+ c¥–m…£q@IAˆû;“WÍÎÎL0›† vÙ xólÎaÌgnäû¢ºEãét¥4'µgß'µT¾áÇýy!•n—ì‘Êøà±{¤> stream xÚ…O; ÂP±lãÜ è{IüÄ* L!he!Vj)¨h-GÉ,-$q̃´ÂT;ß…ÃñL­NuihuéÉ—›V'Ç/2OÅì4Ĭx“®õqžÅÌ7 õÅ$º÷Õ$Mô |€ ¨,G\ WÂ{¡ûFÇ9úé^Ù€"J[|š¼ ¬µÐîrè’YÁ"Ö±4nT?…”pGrjݬc_e*[ù«ËM* endstream endobj 341 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0U0Q0¶T01SH1ä*ä26Š(˜%’s¹œ<¹ôÃŒ¹ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. L@ÌÀß$äAD=ˆø$˜ÿÄÿ€Ä?€Ä ‹³ÃÅíáâÿáâ?Å@âP¢&VVÌŒ.ó.ó.S—áG—;ì&.WO®@.n=Þ endstream endobj 342 0 obj << /Length 114 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04WÐ5W01T0µPH1ä*ä22Š(˜™B¥’s¹œ<¹ôÃŒŒ¹ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. õÿÿüÿÿ†þüa`üè?’›îçrõä ä—5ez endstream endobj 343 0 obj << /Length 116 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0VÐ5W02W0µPH1ä*ä22 (˜™Bd’s¹œ<¹ôÃŒŒ¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. õÿÿüÿÿ‚êÿÿc`¨ü¨æ`°›ÿp¹zrrléI endstream endobj 344 0 obj << /Length 104 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0UеP0¶TÐ5RH1ä*ä26 (˜A$’s¹œ<¹ôÃŒ¹ô≠ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êÿÿÿÏÄÿа—«'W *› endstream endobj 345 0 obj << /Length 136 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04UÐ54R0² R ¹ ¹ M€Â FÆ0¹ä\.'O.ýpC.} —¾§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹ƒüûõ?€ðÚÿ‘ÿÃÿ‡áÆŒ?˜?°PààP—«'W ŸÒ,5 endstream endobj 346 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04F †† )†\…\@Ú$l‘IÎåròäÒ pé{€IO_…’¢ÒT.}§g ßE!¨'–ËÓEAžÁ¾¡þÀÿ0XÀ¾AžËÕ“+ ‰;“ endstream endobj 347 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04F Æf )†\…\††@¾ˆ –IÎåròäÒW04äÒ÷ sé{ú*”•¦ré;8+E]¢zb¹<]äìêüƒõìäðì:¸\=¹¹{-= endstream endobj 348 0 obj << /Length 103 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0W04S06W02TH1ä*ä2 (˜B$’s¹œ<¹ôÃŒ,¹ô=L¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êÿÿÿðÿÿÿ0 âs¹zrrå$~ endstream endobj 349 0 obj << /Length 117 /Filter /FlateDecode >> stream xÚ31Ö3µT0P°T02W06U05RH1ä*ä22 ()°Lr.—“'—~8P€KßLzú*”•¦ré;8+ré»(D*Äryº(Ø0È1Ôá†úl¸ž;¬c°ÇŠí Èl ärõä äÇ\+ß endstream endobj 350 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚÏ1NÃ@й°4¹¬—QY AÂTˆ (‘A‹ÃÍrÁå 3AzšWÌJÿ_¤ãæ”kN|y¹9á‡H/”–v¬¹Iû—û'Zun8-)\Ø™BwÉo¯ïVWg)¬ù6r}GÝšÅ3J•~ ZýôªýT™Mè¥Øa.åˆÊ)¥œ- ™oö̤Å/½ó`t™œÝÿ˜þRôø27ÈäVÖ¯½ifðöƒíh·¾hãÛ`+-·Rû¡ÔÑÒìNç]Ódvg9 endstream endobj 351 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bCSC…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿÿþÿÿD|?€bØ0ÿ ÿAD}°ò€ÿÁ&> f0ñH0b!þO ¶ƒn%Ørv¸ƒÀî³?sóˆ?À>û æË `Ÿs¹zrríÇG endstream endobj 352 0 obj << /Length 145 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bCSC…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿÿÿÿâÿHìó"ˆ Á€ƒø$`@±ØCLÁmQDýÿ ÿ!Ä( ,ÆåêÉÈæxô endstream endobj 353 0 obj << /Length 227 /Filter /FlateDecode >> stream xÚÐ=NÃ@à±\¬4๬¥PY AÂT(PR$‚ÖÞŽkÍ ¸7eŠU†ÙI"QÒ|Åìß{;—Ý5袥ùŒº½´¸Á°ÐaC]8®<¿ár@ÿHaþVÇè‡;zß~¼¢_Þ_S‹~EO-5kVE*#TòÉPËŽaa¥'\¦BÙƒ°û‰«oè¹Ò\Qéõ4÷pf<á¢`2éß”²Oà$‡Ì˜gãßëíµúD> stream xÚ31Ö3µT0P0bc SC…C®B.crAɹ\Nž\úá Æ\ú@Q.}O_…’¢ÒT.}§g ßE!ÚPÁ –ËÓE¡þÿÿÿÿÿÿà >ÿ†Áޱ¹›ËÕ“+ H¨X~ endstream endobj 355 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚEÏ=nÂ@àE.,MÃvN€m M,ñ#ÅE¤P¥ˆR%)S€B‹9QPr„ø.]¬lÞÛÈ¢ØOš·ÒüLÒÑt¦±Žñ&c&ú•ÈFRf1K~|þÈ<—èMÓ™DÏH%Ê_ôw»û–hþºPÔK}O4þ|©…3EÓµ¦s|–Æ@F öÄAÖ¤ÃØÈHaÀž8pnÀ…\]Ï­GЈ-8¶j<ì\  8hP÷Ãýÿø­žHF¬é–=a…‹,oËÚ>“U.k¹9‰s endstream endobj 356 0 obj << /Length 123 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bCSC…C®B.cs ßÄI$çr9yré‡+›sé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿþÿÿ€L€Å˜ŒÁN|Œ?ˆ êÿÿÿÿã?*ûÀåêÉÈé f’ endstream endobj 357 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚUÏ-Â@à%ˆ&c¸Ì 迨¤”„ P‚$ޤu½Ö’[GEÓev›¶ æKÞ1Çî»hÑ8º&nL؃-;CF¹XïÀA_ í>¡ôpŠÇÃi º?!å—&+ŒRå"c¢(ɉ(§N+˜ÆµGÍSroˆ‰›‚W\¯Š‹"­àЬæüÏ ¦+éÕtI…–ðߣmÅ›h5|Ö ¸üˆ‹¢dXB]/†qsøº‰| endstream endobj 358 0 obj << /Length 170 /Filter /FlateDecode >> stream xÚÅ1 Â@ERÓx„Ìt³Ž)R-Än!he!VÆÒBÑÖä¨9‚¥EØq™Š†Wüßü7sžæe”ÓÄ”Ϩ¶xAæƘ‡æxÆÒ£Ù3šUŒÑø5Ý®÷šr³ ‹¦¢½¥ì€¾"h é`,ò‚T¤'ÀuID ˆ§x¸/„ˆ¶Hÿ ¡øÙ÷®î9 ƒ›Zª¯šëpéq‹o¡lª endstream endobj 359 0 obj << /Length 174 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bSC…C®B.cs ÌI$çr9yré‡+›sé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿÿ0üÿÿÿˆø"þ3Åþ70`øH؃þ@‚ýŒ`?€#^¬„ùŠ^°Q`Cƃ-YÉ ²œä fƒ€² Ô$êÿ700€ F"Àb\®ž\\æ„wN endstream endobj 360 0 obj << /Length 236 /Filter /FlateDecode >> stream xÚu1NÄ@ E½Ú"’›a|˜„$ÕHË"‘ * D”H»$*â£å\!GØ2HQÌw€‰æÉãÿmÿ©«ãæT ©å¨”ºæDJÞsÕ ‰gõ­Ü?ñ¦åx#UÃñmŽí¥¼<¿>rÜ\IÉq+·¥wÜn…˜™åº2ûÐÌÌ4w„C0Mý€¤LúNÔéL”túAø ¨9ÁçÒ„Éa=tC¹6”8y€ÇF¢Ì›Ôa¥OÚ2éý/òaÁ<Ãô&ÄØùE>oùš¿åxv endstream endobj 361 0 obj << /Length 124 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b#SC…C®B.c˜ˆ ’HÎåròäÒW0¶äÒ÷Šré{ú*”•¦ré;8+ù. ц ±\ž. õÿÿÿÿÄÿÿ¡êêð@†H0 zÂþÿ(Qÿÿ—ËÕ“+ +òT¬ endstream endobj 362 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚEÎ1nÂ@б\ MÃ<'ˆm ÕJ„Hq”T)"* L‘(i½–RøZt)¹G L±Úá±EáçÝïÝñŸW‹¥2Ã3ŸÉ¢”}ÉŸ\YVØÖ>ì>xUsþ&Õ’óg¤œ×ùþú9p¾zyì×ò^J±åz-NS={èÅkg`ÕgÉ?EJ €E£AJ>.½€dÝœÀôt &Ú¤JI¡0rÏî熻ÇqžMÎþ û›û5¬·.M_Íf…[݆{ÂG¨èZµ>’¯‰±_õ?ÕüÊW®Kq{ endstream endobj 363 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚmÌ= Â@à Óx„¸ ‰‚Õ‚?` A+ ±RK E[“›™£ä)S,;Îh%Xìûfæùh<¥” }å:exÅ\³T¿:8^pV¢ÝQ>E»’m¹¦ûíqF;ÛÌ)C» }FéËEÜ$ s­´àXBט^H”ȃ©ÁÃ@ž?|be¨®ŸàzY©E—ƒâÿðTZ_Õq×-`öRÅ!a~…ˆƒ„®K<.KÜâj/\ endstream endobj 364 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚŽ= Â@…g°¦ñ™˜„Ä"•#¸… •…X©¥…¢­ÉÑr”aË€!ãN;±˜æï½GÓY‡®âg!ŸBºR¤³@[]/”òw%ä¯Ü”|³æûíq&?Ý,ØõïÝåLƹ©¿+ðx•ƒ“À—´€"Ò¡@±y‰Rx Œ-¶0ª±éþ~Ð*ž?¢uîmÖ½rç!0±ƒe¥æ] ÔEÓ`ç%ÐÒЖÞ*Åsz endstream endobj 365 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚŽ1 Â@E¿¤¦Ik—9›°° Än!he!Vji¡h›äh%G°L2ΦÐÖ…}ðgÙ?of§óÇœêÅlS>'t#k5Ñ?œ®”;2{¶–ÌZ§d܆÷ç…L¾]rB¦àCÂñ‘\Á¤"iJzŒDˆÆ=á[5/”ÈjLAOåQ~Ñý‰ß¡@«B_ÕZ¯h4èÊJ—â5¡Î«µ^RMuZ9ÚѲuEJ endstream endobj 366 0 obj << /Length 193 /Filter /FlateDecode >> stream xڕα‚@ à’.<} L— &Þ`¢“ƒqRG®â›á£øŒ—;[pqÓᾤ½´ý 5)+ÊHñ+•9ís<¡’^&¥|ìŽXLפ*LçÜÅÔ,èr¾0­—S⺡MNÙMC±€Ä  ÿ$z1Ú1Þwxï!"Ëûâ>ô<æôZ™iá&³N°?â>cíH ãRa¸ÊÉHŽ'c Ë:ÇÑ´m™¸O,Î ®ð —ºYK endstream endobj 367 0 obj << /Length 201 /Filter /FlateDecode >> stream xÚmޱŠÂPEï’âÁ4ù„ÌìKˆ¬® ›BÐÊB¬Ôr‹mM>í}ÊûËâì}VÌ™;ܹ“ú³™i©“Ô¥ÖS=Tò'uÃù9&aÿ+óNüFëFü·â»¥žO—£øùêK+ñ ÝVZî¤[(²€ÂÐÛ f#2³;܃J>ÂPD´Cˆv@Z }•ˆ„‹÷c½C  ¤7¸¾Ð'Ð* 4u‘ö.æ7ú¹mp Ìb2ræcÀòÝÉZþI÷_þ endstream endobj 368 0 obj << /Length 154 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0asSC…C®B.cßÄ1’s¹œ<¹ôÃŒ¹ô=€¢\úž¾ %E¥©\úNÎ @¾‹B´¡‚A,—§‹ÿû@âÿÆÿÿ˜AûŸz ñHð?°*;&põÿÿÿš4A€Åðk£aÿÿÿ[~ `1.WO®@.òÅ^£ endstream endobj 369 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚ}±JÄ@†ÿ#E`š}!óšÄä”k.pž` A+ ±RK E»#›ÎÇðUò(y„”[,g‚²ìǰóÿÿÌÖÕÉzßòq¹áºâꜟJz¥º`;볟Öã íZÊï¸.(¿ÒwÊÛk~ûx¦|wsÁ%å{¾/¹x vÏ’€4¸ˆlnfxYé•DdöItÁ§S¶n\Å#7@efd=º`’El6X4jB*²`„éá¾fÀ}E_éh0‡íb•ôj“1SLÍ€,xÝ>v*‹Å!*:MÃö–Æ¢ó½:²?-y‰%Û§F‚Í@—-ÝÒ7ãè‚> endstream endobj 370 0 obj << /Length 161 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcSC…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @¾‹B4Pe,—§‹Bý øÿ¬“Œ‘ò@dý ùóÿ? ùûÿ ùB~°o’äAdƒü ÉÀ$ÿÉ?Häz“õÿøÿÿÇÿÿIˆ8—«'W ƒzú endstream endobj 371 0 obj << /Length 132 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcKS#…C®B.cC ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ì ò ØþÃÄ@òx@ýÿ@ü€á?×C1;}pýÿÿþÿÿÿ†A|.WO®@.üØO) endstream endobj 372 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚÌ;‚@à%$Ópçò.¨H)L´²0Vji¡ÑV¸‰Wá(xŒ…[Æ_­Å~Éü³ó‡Á0ŠÑEŸ_ècäáÆƒ=’¹2Êb½ƒ4gA ΄Spò)§-8él„ôŒs˜ÃQ¹yÀ endstream endobj 373 0 obj << /Length 115 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b e¨bÈUÈel䃹 ‰ä\.'O.ýpc.} (—¾§¯BIQi*—¾S€³ï¢m¨`Ëåé¢PÿÿÃÿÿ‰zÁÀ<Œˆúÿÿÿ7ñÿ,ÆåêÉÈî{\W endstream endobj 374 0 obj << /Length 171 /Filter /FlateDecode >> stream xÚ½Š= Â@…·[˜&GÈ\@7!Q°1#¸… •…X©¥…¢õ^,7ðæ[n±ì8šÎȃ÷WÃÑ3ä‚r„Å9œAl&’ø]ö'¨-˜\À,¤c—x½ÜŽ`êÕ s0 nå¹Û =œî=Cê¿bq䙣Ò1 S¥e¬”ö‰K•vI'ì’ö‡mrÿ/)Tžòì8R`ßû¾‡¹…5¼ízfÊ endstream endobj 375 0 obj << /Length 155 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcc3…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.O…úòþÿ¨ÿ$þÿ$ÿÿÏÀPÿD2þÿ`ß$ȃÈù@’Hþ“Èô&ëÿ?:ñÿÿÿÿ7 “q.WO®@.‹£ll endstream endobj 376 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚ}Ž=‚@…‡XLÃvNàBL¬H·0ÑÊÂX©¥…F[Ù£íQ8¥…a†‚Îb^2ï}¹™KJ)*%³ K†w4÷Ò‹ó +‹ú@¦@½á)j»¥çãuE]íV”¡®é˜QzB[Ä_P¥ ¢:˜…ðá9o’.êAµ@9(¡dq%Ÿ»7@â'a¸ý/=ßµÓGÃ.^¬ÄTyhÆ ‰”pÁ A!\\[Üã>P: endstream endobj 377 0 obj << /Length 200 /Filter /FlateDecode >> stream xÚ¥= Â@…g°¦ñ™ èfI"¦üSZYˆ•ZZ(ښͣä[.(w“€–‚S|Åæ½7q4HRYs_8Ö ù éL‘WCNâvµ?Ñ$#µá(%µp:©lÉ×ËíHj²š²&5ã­æpGÙŒs” V,ÈS*7;(& A‰]ƒt,¾à -À•ÇýGTÎÀµ@Û8×=ÓF–>¼®á ¡¯†¾$Úñ¼Ë_È¥÷ªùF­Ñ<£5½Þ¯ì endstream endobj 378 0 obj << /Length 158 /Filter /FlateDecode >> stream xÚ­É1 Â@ПJø—ðŸÀÝu£Äj!Fp A+ ±RKAEëõh9J¼AÊÁqc!Ú[̃™Ií`4-ØԈËÞð™m»îjw쎜{Vk±«y\Yù…\/·«|9ê½e_Hx’+5ÐCôÑ8´äÂ#‚$ÒRC®¡¹šˆ\õ¡ì¸ÿBÿ"¨¿xo<ó¼âõõIw endstream endobj 379 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚMË1 Â@ЋÀ4!s7q5Æ@T0… •…X©¥EÁÊÍÑrr‹ñ,,Þ2³óÿÔŽg©D’€MÅ&rŽùÆv‚=ê×þpºr^°Ù‹°Yã—M±‘Çýya“o³YÊ!–èÈÅRÈùr¨êGB®ù7 }Kïÿ´D#"×eZS¨¡W¡ÿ!§ˆ("P÷B Ca÷£}­¢9ª6A«ª=> stream xÚ31Ö3µT0P0bc 3…C®B.cS ßÄI$çr9yré‡+›ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä€Àž¢þÿÿÿ @ü¿A€ÅH2…‚ù`€hàÀ ß €AþAý~ [@óÿ Œÿ€LxÀÀåêÉÈþ:B„ endstream endobj 381 0 obj << /Length 148 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcc3…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.O…úÌÿþÿ`ÿ…¬ÿÁ $0ð()DÚÉ? õþÜÆðêdƒ=˜”ÿH2ÿcÿÏÀåêÉÈÄ£d> endstream endobj 382 0 obj << /Length 174 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcc3…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.O…úÿ `Ôðÿ?ÃÙaCÄÙ00~ @2?ÀDv`²N2~¨+þߎ ¿#Èß``’ ?Ÿ‡“¿¿G#«¾g``¨?øA6 Hû†@Rž¡†ËÕ“+ Ém¢ endstream endobj 383 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ}Ž1 ÂP †S2Y<‚9¯Å*B¡Vð ‚N⤎Š®­Gó(ï¤Ï¤c‡|?!?É'ãéœSžèä3>gt#Í”»Õ§+•žÜ^wrëŽ~ÃûóB®Ü.9#Wñ!ãôH¾â"Æ…ôPŒ‚¢x+š—"B I À/ >Š¡€i`˜¦$fà_£…$hŠ¡¨†¢Šj(ª¡D{£{-ÐÊÓŽ~æêb° endstream endobj 384 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚ= Â@…_°L“#8ÐMLRØðL!he!Vji¡h'š£å({„”!qœ-–6ß²ó`ö}›ÄÃtÌ!'<ˆ8 9ñ1¢ Å© å»äp¦iNfËqJf)c2ùŠo×û‰Ìt=ãˆÌœw‡{ÊçŒÞ@в¶^m ´­…ו„û•W÷¨”x:ô däTLdOñ”€_Öû'¤X`–*ºw]!WÒ¢qµ½z¨‘º9KõUóïÐ"§ }}dà endstream endobj 385 0 obj << /Length 141 /Filter /FlateDecode >> stream xÚ31Ö3µT0Pac S#…C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]Øø XŠí¸ˆÿ7001;×ñ¾Äójä‘Ô®ÿÿÿÁÿÿÿ?À0ˆÏåêÉÈÅFJÜ endstream endobj 386 0 obj << /Length 222 /Filter /FlateDecode >> stream xÚe1N1Eÿ*…¥i|„Ì ð.›-V Ab $¨(U ¤A›Ý£ù(>BÊÑóÓ„,?kÆÿWíEw¥µ®¸kí.õµ‘i;¯O%/¶ï²$=iÛIºó®¤á^¿>¿ß$­n´‘´ÑçFë6Šx0ڄʬ ˜íÍŽX⌾T†~ÂèËϰœfGvÄlŽâgØ×ÎOÈ —˜À<|žðHTGÇ‚+î©¥µ§Ë‡D5ÿWôTŒL3ü*Ù¡¸=·‡2šÿÐþ‚½,·ƒ<Ê8hñ endstream endobj 387 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚEнNÄ0 ðÿé†J^òñ @ZÚHH•îC¢L ˆ @°Ò>ZåáÆ§úl·ÀŸDZãTåe}Í9W|Qp•s}ů}PYkP·å|òòN›–Ò#—5¥[ SjïøëóûÒæ~Ë¥?œ?S»c„€Nz¬DÈDF‘â˜Mˆ&4=:4§WâLì• «hLºVÆÚšÄQ—5Aýâ1;Í,òw×Ki üs°Ä™ãÇ…à Îdw;«Ò-¯—y"ŸÍ§\Û¼>¹ÿí[z 3áVc4 endstream endobj 388 0 obj << /Length 181 /Filter /FlateDecode >> stream xÚ•Ï=‚@à!$Ópæ.¿ bâ&ZY+µ´Ðh £pJŠëL±hë$ó%ó^5YºÌ Š(áÍʺÄxÇT²HN)Î7¬4ª¥ª §¨ô–ž×Uµ[QŒª¦cLÑ uMþÁÄ„B9ÓÌÆ›‹‘ñGÐ3aç(if ãMŽÅ( Œ/½#ì˜`Ëc„÷—V2öOZË¿Z;ý®5îñÜþtý endstream endobj 389 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚ¥Î= Â@à‹À4{„Ìt³&)!à˜BÐÊB¬ÔÒBÑÖ,x¯’£xË’qFEÐÖæƒÙ}o“¸v)¢„ZŽ’ˆRGk‡;ŒSʱóÚ¬¶ØÏÑÎ)NÑŽeŒ6ŸÐaÜ íOäÐiá(Zb>$Ã\CÈÌßÈÌüǹ.ì5ïªTʺ)ñ7¢ ½œùPÐ €ù\è)'…ߘ'å-,e›ù$9óÒ‘• i«ÌŒþ `¾AƒYÒ Öš G9Îð-²c— endstream endobj 390 0 obj << /Length 241 /Filter /FlateDecode >> stream xÚmŽ1NÄ0E”"Ò4¹ž @’T––E"Th+ ¤Ø´±æ£ø)S„ ãÍ“ü=3ÿuíEÅ5w|ÞpWsÉ/ ©í5ÔgûýóüF»ªGn{ªn5¦j¸ã÷ÓÇ+U»ûkn¨ÚóSÃõ†=6™Ì@! `dÕHpÑë³Îç³¢˜¢¢Œ°0g0º°¿p ã†\ÏF<'Ÿ"D´MÖbLz[‚Îë€õZj6]*7DEñã?°?(£j”A…LP5ãË GÕÔ¡˜µ(O•Y*GÒ@BRƒæ ›è þ5pI endstream endobj 391 0 obj << /Length 183 /Filter /FlateDecode >> stream xڕͽ Â0à+Â-¾Þ hÓ NB­`A'qRGEÁÉöÑú(}„ޤzW©Eqñ _Èå~3°#ò) ¾¦À';¤Æ#ËI~š×Ïö€¡Cµ"cQÍ8ÊÍé|ºìQ…‹ iT­5ùt]ãÁ‘ Ù'é`œ010%p1ßà ­‚içBÆt*R¦—€t 2;nB)¼û½¢¦•×4㪙_T+~Ѭý‹.œ:\âãM† endstream endobj 392 0 obj << /Length 213 /Filter /FlateDecode >> stream xÚ}O» Â@œ`q°M>!ûz‰I «€0… •…X©¥…¢­É§åSü„”Áõ²W؈p w»3s3Y:Ê'sÆÃ„³˜ó1ºPš»¡{¦~s8Ó´$»å4'»tc²åŠo×û‰ìt=ã„ìœw Ç{*ç Ó(¤Džˆ¼`D:„y#jAÔ BQ»SQ]9h@ø”¢9…׆mðÆ 3/"-PIÿoÓ™n•§ ÕªË×ÙñÍó?|ÉR3{¿¾‡6ÒnÚRûúæ}Z”´¡ëån endstream endobj 393 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚm1NÄ@ EmÉÍa|HB’b«‘–E"Tˆj¡¤`í&G›ŽkøéHÅü 4ÒÓØ£ñnêóv+¥4rVISJ{!O¿rÝ¢‰²þ~9¼ð®ãâ^ê–‹k´¹ènäíøþÌÅîöR*.öòPIùÈÝ^(Ÿ‰(`)3SÚ˜èç¹1›É+-:%ô8p'?, ó\üú‡%ᔀ^Ê‚úH½"È4Ÿ)ÂM¡ñ©úP¨9%7¹Hiè/üŠ!©¯ Gó«dLºâ!n&{„ÁÈë•|ÚÒöÍ J™MøÞc_u|Ç_ž!r· endstream endobj 178 0 obj << /Type /ObjStm /N 100 /First 855 /Length 2582 /Filter /FlateDecode >> stream xÚåZmÇ þ®_1ëÞ’óZb»N4M`hZÃ6ºµ­öNrõ¸ÿ¾GÚt—µÎ¶övf9ɇäì,Eg¬㜉&eCdHœ!o(¢• 3Z‘ 4Q¢äKèOÁ¢¥hBÖv2‘ô¯˜ì¬aü)dÖeeǘ  'ƒ?{í ˜l(GCNçÈ ³[žQFà f¶î1Š-„óYp>Äe2E:»>R^˜‡-d·Œ ‚0¤b¬9Ç ÖÀ`ÁÎz%Äu.Ї¨øEÆH †dgÕE†2½b½ò‚6TYÌŒ›ÆX°è’TiÂ:Š=n<¸sÀMÄ %#Þâ9F{§ ü×EAçDI³‘Ñ£$)¤(B;°Ï>‡ÿ:€΢áa‹5C¡Ž¶€=)±  c]'ÜD]5(%óŒAå´Ë:U2Öì| Fw ƒ*]Á$ Šƒ~]Ä™7Ú€º˜ù-¦iÖ ¥ÐØ?[·Ív±Z>o¶­ùÓó?#2 B#uF÷ìVWw>{½Ø^ãÉKóݺùøa1ߘwÛ»í£²¨«Ý¼]ëSWIEs­´ëÑñêT·³úÕî—mij'Íê¿77úŒgõÓfÓý×m¯m·‹y3«ÿ²œ¯®Ë÷%hVô¦þþÙ3¥¾Bo±ÊÛÑ4݈=Ã~|ýÅòÛåf1<~¾x÷®…¶T¯oVê›År·0êÿîVÛöº}=:W_­°þÍfQ¿_7¿¶u3ßmÛz¾XÏw7ï®ÛOõvq}ÕÖ7Í|½ZÖ¿¬[Ð`H3ŸÃõÕSl›ºZ®¶Wí»z¹ë9¬w}ÝôvË÷ÍzwsÝì¶õêýjÙþ§ž7Êoó±™·G¾œh:Vi÷~/ðûD ~?rÛ[Þ­1¹s®>‚‡ºúÏ?þòïv¾ç÷ýò³‚A–dúâ0ð÷ÀÀÿa` 5ÅhE—ÿ´ýîÕ‚cÚo­Dä>ºóá¼ùÑ  [d+_óÄt9BÕeØáRÞ>;Ȉ·±£5ã—ÆN¸;გSìÜËRβ|ütu}užïä¾2\è¦fjjºEûÀÔt/ˆtÿõ Ät "újAÄá–€8~m@£ÏZ¬t9Ø…*Z¹s£t´º¢Ó“ž¾Aq«Ø¼rš„W–#¼ªJ8O×õ1í^}!`SšÓ4b'¾ÊPà4bò•¾(˜D̉ª˜&ŠÁ+În"±“*OÕ3¢“Lj>!¾c‹>i#ކ”7-gÝð"W '®&îRW?ÝÕŽioV\„CĉÄiy±Ë© ÉM$öRñ™<ç‰m¨ržF+>Wñf±X0ž¨ ±ÙÒ4b޾Ò×±“ˆI_`Ù»}xì©G}w\=zå]y½xhøò>ò!íNÞ9é«Î ÚMWq‹ö7bçYb—*óDbÊ•cšHlQ”XžT—™í‚s¦:“¾:ó~?ïÍv½P;T–öÉÿ†û·{ª§ÅV†Ìc€±dÌ5²«Ê~[¢ïoàOÍÛ"î‹Åz³}ö¡Y#yÌê¿5‡Qœ¡’ºÚ~€oøC°êC¨Œ•VÙoÊ{ðnä\åy/ïïþa¨ìuûŸ Ñèïðn’öúuÔIΩ’h„*=ÈɽWÙœ/@*LNuƒJ„sWõ™dë&Y“¨ïɹnôLÉÚ¾‹,Õ é±’åQgÒND;°#RJ=£%9í,¯— —Ø;^É Ù”#‘ƒ Uv‡W$`û–ŽJ]KO­\î[ˆJÞö-=¡¾ {î[zN2m_>»@Ȉ?zõeÀ< ¡{3? !Ñ HȨ_ØãQ¶…l|¨J(.žÍ•=‡·ûfRµ9¼ºx…`W~h”Û£F. {XPÅz˜§Ú³ßSôl÷õ4ªÊzhY•¸xá•O.BQ@Où©yûÞ(uÅD7  =mz2Y±áë{"z¢Éé"Õãí9Šv–‹"Lél8A©^”Ù‚½èù¢ÜR ´ÃcÖ1û #×wÔÒÄw„*8tÔSÚÐP£Vèð§¶ð¤³+ËúÁõ`‡}ƒ‚0„e8„øDèÂq†<± zô‡°`õ({N¢ô-F˃KôãàÃ8¸Ä^V.½,¬\ò熹 ÔèmÔ#sĹK#äQ¤ÑFhNRn:M¹i”r¥ò“²“ÀA%Î%z`ýÙ¡™/)Qbù¤!þ>úJ'úÊ'úÚ¿!üúŠŸ«/:Õ—éËžõ/$3-Öï!.Îdñ(“Q¯0éö´½Âô ‚[ Žcƒ¯àêúÊÀÝ‘QT¥ápík.ªHáŽl…p2åj{êcîÉuÉ$ùJ¿•À<û¾Ii_¢z‹|<†@*/]æ¼Sú2¯Ó4·§r¹BÙß{¬IÍUúaH‘mß߯.ëß}+Ë §1-¤ó•~Ù™òAKª2:YM©ûûýuJ’D+¿£Dé~Ê)zÈa!Vç†tã°Ê.îAï‘x<ã‡<§ß¹øžÒc$?¤Ë€ô…T™ôŒTnú‘ïIÓQéòíÂøLò.©¿tœ õÂ÷gå¨ñÒÔ\êV½è`ÒÁlKºefijÜ%©b„.égÝùµ‚s—õôS¡î°»Ño®º·–°]Ea-Ý+NXŽ›×*ªãÏé¸yýü§“öéd+…Q ‘㨄ÈQ¥î$€ÅŽŠ ±†X¶be(;ĺ¡ÒÛo2ôýKʱqTvˆM£²CìPL(®ì¨¢Q"Ä£"D¨/&¬îÝܨ$ò£’D(ŒJ¡8*I„Ò¨$ïw„Çûáñ~Gx¼ß 5òPب•{Yô>£RFøs“‹Ë—쓨쓰Deyq6vwì“$ß._$Ÿ”/’ûòåÿÕ9· endstream endobj 398 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚ¥=‚@…‡PLÜ è²ÈŸ bâ&ZY+µ´Ðh«£xJ Îd)è-¾bß›yó6šÏâ¤3šf%gtÖxÃ0e5 $¬Ó ƒjOaŠjÍ:*³¡ÇýyAUl—¤Q•tÐÑ”àÔîÀg&Ì›ß}NÇr à5ƒÅr^± ÅaÛý2󆿶ã“Ê®ä`‘Õ׉iÿ`œ•»r_zHé&=¥¯| z)3”óWwøFHH— endstream endobj 399 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚu1‚@EÇPLÃLœ è‚ÁÊ1‘ÂD+ c¥–&j´ŽÆQ8%…gd•B-^6™ÿgþß‘;ðÆd“Oý€\¼€öžqðÇ~£ìŽƨÖ4 PÍyŒ*^Ðõr;  —SrPE´qÈÞbt ÇLR~3&0 £è> stream xÚUޱ Â0ES:Þ¢Ð÷¦µ±ÐI©Ì èä Nêè è&´ŸÖOé'8:knh †ä@Î}7D%“YÆg¬X¥Øç˜n”¤ÆE¬¦68])×$÷œ¤$ׯ’Ô~ÜŸ’ùvÉ1É‚1GGÒ ³æxos «ï*!‚¯¹…ø¦÷~‡ÑÖù²ŽZoŸ(kÌ ‡²B" PõÑðqã>´.îÛ¶ø{€°xcA+M;úç–=Ä endstream endobj 401 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚU޽ Â@ ÇO YúÍx­w8jotr'utPÜê£õQúŠ5I-Ôåù$±f2›cŒ-ZƒÖá)+GZŒv*Æñ™½Cã@¯Hí×x¿=Π³ÍÐ9îŒàsT/¥Ô¨"ŒkFÃ㇠ZFQ"¶Ã7!Ø\LÅ®{»kwÅ; #e´%ç(𮈻iõÓÇÜ›^/ªaTtY!ŸÉ)yçÉ@,=lá M>k endstream endobj 402 0 obj << /Length 148 /Filter /FlateDecode >> stream xÚ=É1 Â@EÑR~“-¼ èäg”`£#8… •…¤RK EÁJ³4—âRZ„ŒÓ(œêÞ‘Ž'̨–Íi•ª<¨œE‹3æö÷ö')˜-µ³ CŒ[ñz¹Å”ë9ULÅ2«ÅUD‹¸CÒ#õMx‘fÀx¢ñi‹çþß î€,œlä õ‡* endstream endobj 403 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04F– †† )†\…\@Ú$l‘IÎåròäÒ pé{€IO_…’¢ÒT.}§g ßE!¨'–ËÓEŸÁþ@ýúÿ!Äncàrõä 䄬e endstream endobj 404 0 obj << /Length 118 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0S04S01S06QH1ä*ä2 (Z@d’s¹œ<¹ôÃŒ-¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. òÿÿÿÿc$þ!°‘ ¨øÿÿ Àb\®ž\\ÏŠ>à endstream endobj 405 0 obj << /Length 102 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0"3#C…C®B.#¨‚)T&9—ËÉ“K?\ÁÈ’KßCÁ”KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓE¡þÿÿÿÿÿÿà >—«'W ²©$Ì endstream endobj 406 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04S02W01V05RH1ä*ä22Š(™B¥’s¹œ<¹ôÌ̸ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ò ü ö ò ö öêQqC=C=2Ãp\ÆàÀñ†   \®ž\\Õ8æ endstream endobj 407 0 obj << /Length 222 /Filter /FlateDecode >> stream xÚmбnƒ@ à1Dò’GˆŸ @ C§“ÒT*C¥dÊPeJ;vhÕ®GãQxF„kû²D‰d>á;Ýñãòñ¡zâœ×ú”WôM¥õ¹µörú¢MMÙË5e¯ºJYýÆ¿?Ÿ”mvϬý–ß ÎToHˆÈèNî [`ÑCZ,{µÃª3ïVÜZµwŒ¼ ³™LæR¿D·Ã%Ú»º{F:™ÉlZY<ÀߨFãåÉxmãžÝéhÒÁîW£ÿõÞÆ IÄÇÓxLz©iOÿ¸Çñ endstream endobj 408 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚ¥Ð=NÃ@à¹Xiš=‚çà˜ØB‘,… á * D)S€ µ÷&\Å7ÁGHéÂòð6.‚DIói5û3o¶X—k]꥞åZ¬µ¼Ð×\Þ¤ÈY\j¹šw^ö²©%{Ô"—ì–eÉê;ýxÿÜI¶¹¿VV·úÄ;ÏRoðƒÐN>`aö˜}x3 H‡”V½£mH¨ñâbŒ&oÃNúhà»h:€+T¨p²=Úüq::þϤ‹º>¾F›_²/C2ã1eÂyaÜ:ÄùÜèã#fœÃÉ`ÖÅèx–!7µ<È=c endstream endobj 409 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚuн‚0ðkšÜâ#xO `âD‚˜È`¢“ƒqRG®À£ñ(}FB½ЄĤý¥ÿ~¦øópE.-¸K =ºzøÀÀçìšh.wŒStŽøèlytG¯çû†N¼_ç„N¹gL‚\kÐZ—ÖÊZƒ™o¤’-ÀT c Úš[£âçìÛº8RõòfÉÂ_yOwyö_¾ªµ6ƒ|pd‚mAÔ&²Â:©­•QV&òƒ£Ò˜¬ÐöëíP€®$> stream xÚuÎÁ ‚@àÂ\z'HÅ Á òÔ©CtªŽŠºEúh>Šàуh³kˆeͰü³°;ÂûSrÈã#&ä»ttñ‚Bpvd”‡3†1Ú[í%OÑŽWt»ÞOh‡ë9qŽhç’³Ç8"h¸re¡)¡¯‘ƒQÀ¨5“ñŸVzV \¿4Ù ¤0°i:“·uç“ûÓl3%üRk-Le00½µÏöåøãæËJÍKÀEŒ|ñ}xB endstream endobj 411 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚ}Ê1‚@Ð!$Óp™èBBE‚˜Ha¢•…±RK ¶.Gã(’‚¸Î.ZHÄIæ%ÿψÙ$ŒÉ§)¯ˆ) èàEÄÙ×QgLsô¶$"ô–Ü¢—¯èv½ŸÐK×sâœÑ. yF •R 0ªýRG5X-ØXÍ NPƒSÏnil¡Ó•b“EOþÒ&¬4>ÀíØ=ŸÆöŸVgÓWªÊX³Ê(ßê9nðón endstream endobj 412 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚ]Ð=NÄ0่4MŽà¹8!U¤e‘H¢b·¤D±Â9Ú%Gpé²!±4_ñžfü³jO»K®ù‚O^swÆÛ†^©í%¬¹k—æù…Ö#™n{27“oùýícGf}wÅ ™ ?6\?Ѹa@Ï=ü*Å€2¥€*£ :À¢ ˆ(}!½Wj¡t™Y¨W=-ó0ð‹Í|3á?*¹|ÿ—Ÿ z†clÞbó¾´`Q$9R “Š2S ³Ž¨œù}Q:¡Hq/“þ3@×#ÝÓ7çp@ endstream endobj 413 0 obj << /Length 156 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b3SC…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O†úÿÿ0üÿÿÿcà?ÀÀÀ &pö`‚Q"êpÿ@Ä#˜øƒ`pì`â2Qì¿pOþaàrõä äIVR endstream endobj 414 0 obj << /Length 239 /Filter /FlateDecode >> stream xÚUϱNÃ@ à¿êPÉK!~’@Z©K"•"‘ &Ô ZÁ¹> stream xÚmÏAJÃ@à¿tx›9BÞ šFSŠ›j³tåB\U—.”ºjir½‰ä(s„én„¡ãË š…ÿ}ðÿ³šâ|2»à)ŸÉÍ$9?åôJÅ\z¨ÝÃú…–e÷\Ì)»–•²ê†7oïÏ”-o/YúŠrž>RµbÔµƒ·ðGx×+£$qP-Tô ªú8aÚ ý ¦Hñ«Ú”@\¨fñgm£{`Ü%íNGõP¸ iÛk,FÓû=pk0Žjluo-9¢Ôðþ¿m·Ë骢;ú[Ê| endstream endobj 416 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ}ν Â0à+„[ú½'°ÿ‚S¡V°ƒ “ƒ8©£ƒ¢sóh}”>BÇ¥ñ.EÁ†ËÇý$$q4MæäSÄ;žQÐ)À+Æ!×¾”28^0+ÐÛQ¢·â.zÅšî·Ç½l³ ®sÚä°È ´Ö Ä,¶5yoÔ“ÚfJN©Ñ­>¾ãÕTåHA¶±-£ÝIÓå?”ò±6*‘°<”+¼º1­ÁvL{°ùµÔ¢yõˡ˷øäjÒ endstream endobj 417 0 obj << /Length 244 /Filter /FlateDecode >> stream xÚmÐ1NÄ0Ð¥ˆ4¹8I±U¤e‘H¢Z()XA»ö 8W‰DAÉr„”)¢5c‡H€ÖÅ“5¶ü¿\Ö+.¸äÃU͵áCÏT•2,¸.ç“í­[Ò·\•¤/eLº½â—Ýë#éõõ9Ò¾3\ÜS»aXà½wÑ>:@æ~²^M€ê¹¤:ÌÚ_6‹ù¬;â~±qá…ÉLÇ ‚VrﻘëðÓJöX&{بäÈ#’‰Iz³c&ñ4ÃÍÿ~¸àg'ò¯.¿ýÑz¨w'©ÊÏÊ—¸ì EJsY#袥ú´}× endstream endobj 418 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚmÏ1JÄPàYR¦É |sÍÆ}!°®` A+ ±RK EÁÊ—£å^a2Å’ñŸ‰‹6É̼yÿ‹«£úT–å°’x"õ±ƒ‰pÂ,ÑÎ\@Ç_³Ùès/*g.ù ù)¨&éÖL“ÙøOPëãv˜Y´µ‡ùÏì`nî ÿ,ß{à·ùOÄ›Mx±[l)õz»i²ç&µ$©vªX?zÎÌòEË7ü }„t£ endstream endobj 419 0 obj << /Length 163 /Filter /FlateDecode >> stream xÚ31Ö3µT0PaS 2TH1ä*ä21PA $‘œËåäÉ¥®`bÀ¥ïåÒ÷ôU()*MåÒw pVò]¢  b¹<]ìÿÿÿÿ¯HüG#êìêÿ1Ô3Ôÿa¨c¨ÃFT0üc°a`øÃÀ€•`?pÌ`â‚L<ÀAðƒ‰8y0Ñ€LðÿÿdüÿL€Å¸\=¹¹7X^´ endstream endobj 420 0 obj << /Length 197 /Filter /FlateDecode >> stream xÚUÌ; Â@à?¤¦ñ™¸ ‰«` A+ ±RK E[7GËQr„”)–Œ³Øh1Ìë/òÉtÎ)—ZEÁyÉ—Œî”Ï´OCç-*2Îgd6:%Smùùx]É,vKÎȬø˜qz¢jÅH€HƒH¤C,â10êã\ÀÖq‡¤ŽEÏÿqRc,ŠS4EB€è¨µH<,l«)®o ÿËðe@ä¡ß®±ú¨)]¢ôšîúX¼í!í¸£uE{ú³/^q endstream endobj 421 0 obj << /Length 212 /Filter /FlateDecode >> stream xÚuϱJÄ@à_R¦ÙGÈ> stream xÚ•Ž1 ÂP †q(d°Gx9¯¥OA ZÁ‚N⤎Š®mÖ£x„ŽÒ˜Á!$!ù¿'3NØ*Φ|IéNYÐ>±Öç-KòÎùNÉ—[~>^WòËÝŠSòSNNT ȈD'Ò i!Š4y;ì‘·ÑGwp{c×ȃjCeè ß s»]Ø—ÊžZž†º.þ"US³“‚9©-­KÚÓ¦IÆ endstream endobj 423 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚeαJA àÿØb Í>Âä Ü]vÏÃjá<Á-­,ÄJ--mo|±é|y§¼bœ˜áÄC®ÈB†þdyÆ-Ÿj /;~ìè…ú•æ¶Ä2xx¦õDÍ-÷+j.µKÍtÅo¯ïOÔ¬¯ÏYó†ï:nïiÚ0Ùýêñs ü’#ŸV¾œH€ˆø…|ˆ¯Ä›œ¯Foý;sŠ+lqÎ…¤à÷Ƕ÷d,²6ª‚ɺY'=alp µ¾Œ+ù–‰Êè%ÐÅD7ôpë endstream endobj 424 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚmŽ= Â@…'X¦Ù#ìœÀMX£XüSZYˆ•ZZ(Úêm’#X¦Œo[±Øf–÷æùa5•B&x#/~,§’¯ì+ÌEÓÇñ³†ÝN|Ån…-»f-÷ÛãÌn¶™KÉn!ûRŠ7 !ÒH”ë›ÈꇨÖ+UÊ4jôdcÞ‘‰æM¦µ-å­@l_ Ϥô"j‰~Ð' f& Ê”Ö74˜.WHÁe °Ê4ù½’©A— où \s`¸ endstream endobj 425 0 obj << /Length 181 /Filter /FlateDecode >> stream xÚuα Â0à+ ·ôzO`RL'¡V0ƒ “ƒ8iGE7±}4¥Ð±C1Þ…:”ün83d3Òdäf”¥tJñ‚F“Žòq> stream xÚmαNÃ0à‹2XºÅà{H¬¦.X*E"L0"‚5)oÖG1o`‰Åƒ©¹saAõð ¾ÿt7;ž/¨%KGvAÝ)ÍNèÁâ v=ÿ¶4ïG÷O¸°YS×csÉÿØ WôöúþˆÍòúœ,6+ºµÔÞá°"à§<€ .L)'¨rfë¢Îù;‰î“õÚGpåŸaF¨Ù]1Píõ¢.š­ä;Á´a?2ÈyWL ǹGõ•9^ÖþÄjoÉó.G¥ò¤8Œ¸2T‰Já‘=ã"b<èXL’á-Ϋ(UM+®eÊýw1•ëÒEK[¼ðÙzA endstream endobj 427 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ}Î1 Â@ЋÀ4Á9IH,¬„Á-­,ÄJ--mÝMoð¦L2ÎL‚ö±vY~ Gc 0äG8 q bÉD9ìŽðׇàÏy ¾Yàå|=€Ÿ,§È9Å ¿Ü‚Iѱ…ËÊ_­êª½ÆâŸ^cÞÖfì“8y/âû>Éß_[;b¥–â Psõ®fm]vÒ¨íº”¾V½i».¥o­VÚ·¥¥Ü[e¤Ú2‡™¼ ¹t6 endstream endobj 428 0 obj << /Length 156 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcKS#…C®B.cC ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ì ò€øƒ=2>çgÀÿÿg`†àñzÑp=×aÁÿ€ø&fᘘ„?Àqýÿÿþÿÿÿ†A|.WO®@.ïûJÏ endstream endobj 429 0 obj << /Length 230 /Filter /FlateDecode >> stream xÚ}ͱJ1à9®X˜&yw×Ýl œ'¸…pVb¥–ŠvbÖ7[ñEâ(6W77V8±0/™É̤möf‡Rɾíö@fµÜÔ|Ïmcq…×w<︼¶áòÔ²\vgòøðtËå|y,/䲖ꊻ…PLdK?ÿ³“ìt4ýg1:üVuÈ&*Þ Ëw×#ïú¦ºÞ%è{"ßo¬×OÖpº‚($BòÁJ(D|p¤0hÚùÊðŽ®øšÍs^>Û¹3˜k¸•ý ÝðcÔ¤RýP5¿²¸y>éøœ·ZsY endstream endobj 430 0 obj << /Length 154 /Filter /FlateDecode >> stream xÚuɱ 1 €áŠƒÅG0O`¯\opÎì èä Nêè èjûh÷(÷ŽblÂ-ò…?ñå´šaUŸ—Óƒ+”>·$?Ž¨Ø–ì*_Á†5Þo3Øz³ÀÜ î šH1D¯>‘1Cf$t c¡U˜Ia.…È<5¾ÌGa ¼ûD"JLKLü“`` ?:•RŽ endstream endobj 431 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚuÊÁ ‚@`Ń0Áy‚Vq :f‡ N¢SuìPÔY£Ó7|;µÁâ4kuh¾ýçgd4ˆGôOÆ q¤ì^Í·=@’X¡” fÜ‚Èæx>]ö ’ÅC)®C 6¥èh¿[®¦Š —¨¡’}PíOmåwjØŠnì•ÖîØÎÖ¬¶ÕGe·¿rÛºµInùOsá•&yÅ?Í…_˜ä[ßæ*o©&+jIÓÓhò»‡iKx—‚» endstream endobj 432 0 obj << /Length 180 /Filter /FlateDecode >> stream xÚmÊ1 Â@Ð )ÓxçnBVÁJˆÜBÐÊB¬ÔÒBÑÖÍÑ"^doà–)BÆÙÕBÁbÿFåƒáSÌøTŽù÷œ@ùžúêÃî…¹F•œó R/ðr¾@Ë)òZâ†?· KŒ¨6•ˆéA–}’c‰Eî-Û ol¼}´Á:X}±“·"jþ³&x±ûoÂvÁV$öGCÖëˆ* š~‡™†¼êõf endstream endobj 433 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚmŽ1jÃ@E¿p!˜f°s‚¬ÄZ1®d¢"W.B*'e »öh{A¥ ¡É(&E óàÿaøíª-¼Ñ]{öü^Ò™|¥ºXär8}RÝ’;²¯È=©K®}æëåöA®~ÙqI®á×’‹7j$¹ô€•2©%32É« ]Ì„hzØdL²¦úsÇ×_Lÿä_ØÄY£t:wÌjh^Hù;„F´U.Úo%m¥Z”ö-è/LRz endstream endobj 434 0 obj << /Length 230 /Filter /FlateDecode >> stream xÚuνNÃ0ð«:Dº%à{â„:&Km‘È€bj@°’¾y?BFiŽ>@U¥JÖOöÝùîÜò¢¸‘L—²È¯Å9Y^É.çwv™î/·}ãUÉöI\Áö ¶å½|~|½²]=¬%g»‘ç\².7B>š@TÅ*ƒvPU‰<ÜÓL_Ã: ØÑ¼¡y;§3‹ýóÄd4œÑÅ0 ½ã1õ¤iÈï{±•‰˜O¦K[¨lû£5LQB}!ѿՑßgìŽlO­4 b ó¦ûçÛ’ùÜv› endstream endobj 435 0 obj << /Length 179 /Filter /FlateDecode >> stream xÚ}Í1 Â@Ð]R¦Éœ¸‰VBŒà‚Vb¥–ŠÖÉÑö(9BʈÁqvE‹y0ÿ3LªûÃÆ8àI3Ôî8BªyÝêŠírj…©5ã”™ãùtÙƒÊL@¸N0Þ€)PR+IÔFdêÆÞ’jIW¢ZÈE,×Î&´¬ *>¨„`…óîí¼íÛ°ù°þmôÔþ³÷´ú²$j¼üŒ¼åKÎaj` ¿†Uà endstream endobj 436 0 obj << /Length 206 /Filter /FlateDecode >> stream xÚU1jÃ@E¿q!˜foÍ ¼Rd\ l¬Â`W)Bª$eŠ„\v¶Gä)U8ÿM—b3ûàí¼™µK­tÁ™ßk³Ð×Z>¤iyWùÌâå]V½øGmZñ[¾Šïwúõy|¿Ú¯µ¿Ñ§Z«gé7Љ}'8³„Îl€"M !#ÊT ‰pˆp‘›P\‰©`‰~ÀԅƲꌀE¢Œw€KÕ¸r40À€0æïâ‚ß=æO%›òÐËAnªRZA endstream endobj 437 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚuϽ Â@ à”nYúæ ¼Ö«¢ µ‚7:9ˆ“::(ºÖ>šâ#tìP“C…îãòÑKm8¡˜ÆrÒ¥#:&xAk%5ÕÆáŒ™C³%kÑ,¥ŠÆ­èv½ŸÐdë9%hrÚ%ïÑåHD¥ÐëbæfþRú›¯A¡#´JÓAà©;=L•â—Vi„@ …&ª!`®”ÈnOY—õoò .nð îRð endstream endobj 438 0 obj << /Length 178 /Filter /FlateDecode >> stream xÚm̱ Â0àH†À-}„Þ˜–´ŠS¡V0ƒ “ƒ8©£ƒ¢«Í£Å7é#t¬P<“àRt¸ûïŽËÔ8Ÿa‚SW™B5Ác P¹Ë‰~q8C©AnQå —n R¯ðv½Ÿ@–ë9¦ +Ü¥˜ìAWX·œ µÂÑ ²0ã-‹‡FV°_j,{üáÍâ€aý€Ñ—ÂðÞÿé\wî¸v‘ðpzQÃèI6ð&‹]+ endstream endobj 439 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ=Ë=‚@à!$Óxæ.dÑ@ bâ&ZY+µ´Ðh‡Á£qް%gù+æËÌ›¼@.Wyò!É5Ý||¢4™gNó¸>0U(N$#;NQ¨=½_Ÿ;Šô°!EFgŸ¼ ªŒŠÖêš®³Ú~ë3§˜œ ⻂|¦ž°4Øš±4#\YüÀª¨]˜ˆgr¦1äõÄWOÕLÉ$ÓÇ­Â#þbVO˜ endstream endobj 440 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚEαnÂ@ PGNò’OÀ_ÐKH@b!¥`b@L´#ˆnˆ¤vý“Hý¶Þ0öe`¸'Ûwg»ÈßFJ)—SŒ)Óg†G,†’§šêÅþ€³ 톊!Ú…TÑVK:Ÿ¾¿ÐÎVÓ6£t‡Õœbö%71w%;Ã]Í®û:$δ &À´ƒ nKoW1ò]Ћp¿©uû²tÁF@ˆƒu¨°ÞFÿjü§ïM0ùÕ>ÉŸÔ)è” èÄN¼6ª²#0˾¢ jÜ×ñ£Â5>Ý[¦ endstream endobj 441 0 obj << /Length 224 /Filter /FlateDecode >> stream xÚMαŠÂ@à )„iòBæÎÍâ´‰ày` A«++µ¼âŽ®ˆè£åQò)·®;»Áló±ü3ìüj:™-(#IorNjNÓœNPå6Íh¦úÑñW%ŠOR9ŠÍQ”[úû½œQ¬vï$Q¬éKRvÀrM`ºØèÈ> stream xÚuÏ1nƒ@Ð(VšfÀ\À^Ù’¥PXJªQ*;eŠDv m²G tØ Æ.’æ­4#ý¿J—Ù†c^ó"áUÆÙŸú¦4—aÌY:mŽ_´­È¼qš“y–1™êÀçŸË'™íËŽ2%¿'PU2µ|„þ (ßÚ2w(Ú¦E-zD6¸BÛðFå”{ íDØIÚ3ê?¯”ûmgDíŒj #’× Arf#érµÑNN,t']´÷cÉá^Þal о¢Wúqái7 endstream endobj 443 0 obj << /Length 170 /Filter /FlateDecode >> stream xÚeÊ1Â0 PW"y€#Ô' MKU˜J‘È€CÅŒ X)GëQz„Ž U‚ƒ€ Ïòÿö8eSŠIÅ<Ò e ž1ÉÉ5ß—ý rKIŽrÉ5J½¢ëåvDY¬ç¤P–T)Šw¨K@ô1c5³ ™0|2 GÂÞAô¼w=ÿý œ§/t:ŸpZßÐi|‘óø©­m¬µí—˸иÁI Pt endstream endobj 444 0 obj << /Length 224 /Filter /FlateDecode >> stream xÚuϱnÂ0à‹2Xº%{â˜D,Q*5C%˜ªNÀÈ@Õ®uÍâGˆÔÅC”ë™vaˆ‡O§³ìûoQÏšGªhI† 5†N¯X¯¤YQ3ÿ»9^pÓ¢>P½Bý"mÔí+}~|QovOdPoéÍPõŽí–À2GpÌÃ=¾AΘ&ÈnÄ òè<ä?ÜCžþÆ Þuj„Ò«…W=AP!÷BzÙO²P½ÿSÜðBé%­í$”ë¤bpR«l°J–,³Laî ã´œ•øÜâ¼p. endstream endobj 448 0 obj << /Length 102 /Filter /FlateDecode >> stream xÚ32Ó35V0P0b#CCc…C®B.C˜ˆ ’HÎåròäÒò¹ô=À¤§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹ƒýƒúõþÿ€AÏþ—«'W !‘$‡ endstream endobj 449 0 obj << /Length 168 /Filter /FlateDecode >> stream xÚ31×37U0P0UÐ52T01V03RH1ä*ä26Š(XC¥’s¹œ<¹ôÌ͹ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. @ ",@Dˆ(€@Ä f€3˜h€ì`¤ŒDð9!'l°˜7§éƒqšŽ0x`LGŒÓt„Á8MÇä‚ËÕ“+ :Ì6Ù endstream endobj 450 0 obj << /Length 170 /Filter /FlateDecode >> stream xÚÕ1 A Eÿ²]¯8;êÀvë N!he!Vji¡h«{´9ŠG°´ãd±QÄÞ<~~ „¸~·p\p/•³ìJ^[ÚÑ L}¡­V[ª™9J2ãä’ >ì2ÕtÈ–LÍ ËÅ’BÍ@.ÀY®*åtÀßà“}4˜I“½¨™kÆ\Ðê7B <µÄ/z‰¢ñ…íž¿aúš×³?I£@3zóպà endstream endobj 451 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚÕѱ‚@ à’.<‚}#èF‚˜xƒ‰NÆI4:ãñ(÷72(µeqbÑÉK._þÞµ7\šŽgÓDv6¥tN§¯˜%’czp¼`a0ÚQ–`´’*FfM÷ÛãŒQ±YTKÚKËMI>×A»Šk‰üb¶2p:È[àvä ²; ¯zªUë^_mT™ÐŒœè} ä2H«¾öÜ/;è¯óÿEægÎòMCâÒàßλáR endstream endobj 452 0 obj << /Length 155 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bSCS …C®B. ßÄI$çr9yré‡+˜Xpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜ÿ?ÀÀPÿÿÿ Dòÿg’ö?dýf ùÿd„’ Ì „d`D"H'ÿƒ’<ÓŠüÿÿ=ÈÙè$—«'W b8Ë£ endstream endobj 453 0 obj << /Length 256 /Filter /FlateDecode >> stream xÚ}бNÃ0€á‹ó[ñòŽ«í#•Ú[wж¾£¯Ïï7´«ûkÊÑ®é)§ìë5€Ú‚,ÝÇH‡Y˜1Fu˜EÃ1˜Û$Ì`„Ú³$ª] ½ciÕÝiÇ’˜¶MÓ6Òj T§Ä%˜0Òú©`t‰è)ßšô »µýÚ£Éî§ûì0„R7¡ ŒÇ’A¢«Ó\—þt‚‡dèC@ëf;„wÛ€75>à/G°ž% endstream endobj 454 0 obj << /Length 263 /Filter /FlateDecode >> stream xÚ½‘=NÄ@ …¥ÉÍ!¾L"±ËnC¤e‘H¢J ´$GóQr„-·­ñŒ7qF}#[ãŸ÷–«Óõ9Õ´ “†–g´XÑsƒo¨¬Sxm™§WÜtî5áZúúxÿ|Á°¹½¤Öª±Û´ (E¸TV";§‘èYäepšÒ{ðJý¥9†~P(eÔRÂé™XföìdH-Ø ÌXq*óKÏíÄ8§ãþ/÷ü§~ÖbyœoƃÑöq?´}Ý`ôƒéáÁô©ÀôºÓïëØ0fW Ø';´¬jœô÷#˜©†úcŠÍªþyÄ< ^ux‡ß³ = endstream endobj 455 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚ37Ö32V0Pa3 Ss…C®B.3 ßÄI$çr9yré‡+˜™pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒ@˜þ¥ÿÃè õ?ØÿÓp,ÿBóÿ‡ÐÌ@@4#P2Íðÿ„®ÿ€JÛÿ@£ÿ@hytúú?iBöÿAu?œ†ú«þª¿aá¥aá ?öÿ¨á[ÿþ°ø@‰Ÿ?P\®ž\\2oÉ™ endstream endobj 456 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚ}б Â0à+Â-}½'0­Út µ‚ÄI‡‚¯ì˜¡Û¤…¦VÇÇår~>ÅS hR(Šéâ#^ô¦-Ç &ÙŽ"ŽlUÜ"“kºßgdÉfA!²”ö!”)isÞÀKT •¡oéY<py~# ³ˆ?@Iæz­S=©Z¿ˆ¿‹Ah1s–Ì!oâ9)ù–¹ÁÓʦ«:#Ç¥Ä-~·Ê endstream endobj 457 0 obj << /Length 262 /Filter /FlateDecode >> stream xڽѱNÃ0à«2Dº%à{p<¸-“¥R$2 ÁÄ€˜€‘súh~”> stream xÚ36Ó32T0P0aSs…C®B.crAɹ\Nž\úá Æ\ú@Q.}O_…’¢ÒT.}§gC.}…h 1±\ž. ÿÿÿÿƒŒê0 uŒî'.WO®@.•õy9 endstream endobj 459 0 obj << /Length 138 /Filter /FlateDecode >> stream xÚ35×31V0PaScSs…C®B.K ßÄI$çr9yré‡+˜Xré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þVŠ¡þÃ0¤ØRüPŠ %BÙ£Põê?˜b„PÌŠÿ˜ªÿÝÿ8(.WO®@.‹† endstream endobj 460 0 obj << /Length 249 /Filter /FlateDecode >> stream xÚµ‘1NÃ@EQ Mã#ì\Ì*Š •¥$\D‚*J(SAíÍGñ\º°2üñÈ "JË»Ïþ£ïÿÍã]>‘{™Êm”,—éƒ|DÞr!B~ôÊzó’Ó¥d‘ÓÈœ– ùþúùätöú$Pçòϊ˹‘vdW¢º3Vª-p¥uèÁµ›/ˆ «Æ—=›:Ô`Nzº¸wÏèʼn¬8røöØ,œÍVÃpÚž£¯Ý¥xèçóœðdnÿ¿&8둉ç°;æb9©•ßÞ³µ0ÔrEÓªõUXîЂyjóÖA‡^ªýŸó:œŸŸ'?—üÆ¿°ÛÈI endstream endobj 461 0 obj << /Length 317 /Filter /FlateDecode >> stream xÚµ’ÏJÃ@Æ'ô ì%/ î¼€¦©6éAX¨ÌAГñ¤=(z6>™ }‘‚/ðaé8³ÛÔéÑìæOæÛo·ÌË#âò‹ Ž'xŸ«'UŒ8:Äòx•º{TÓJe×XŒTvÎq•Uøòüú ²éå)æ*›áMŽÃ[UͨyR¢Zh‰FB ã™;$/€ör†«iÁeü.”˜ncŽkò“t{º^^8’ì¨#öa–3¾7³GÙØ ò/£xjÿ‹Ûævº¶é^ïoEÞ·v¼o¶Â6ÑjyÐ{óÆÉ„æn_Ì y²Ÿ`?ëôƒý5_ÜÃ^kéu⥠žòìà]<¯Ýp~-쉸oÉN©ö‘¿l7h×l6hD@Z„„+nL> stream xڥѽ Â0ð‡Â->Bï4bÛ­àØAÐÉAAëækù(>BG‡Ð3͇‚uP=¤òAYý‡Ú¯K]¹k̵ÚpÍ&ŽËœÛÈ…MšÊgd ŸÎoç°Úk|x–¯pÿ +‡Â@Zä/0ƒ´d73(Mº\5|¢³3¿WU =e0ƒ>¬ß endstream endobj 463 0 obj << /Length 263 /Filter /FlateDecode >> stream xÚeϱNÃ@ à?êÉyƒÆ/iJ"•¥‘J‘È€D'ÄŒ X{÷hy”^åc¡¯êŠ™D5‡=îþÙü:þé§“ÎÇ|ñ_.þ(Ø_’ IŸ˜4B±±ÌCjÑz8½–nZ:Ð7¡6 endstream endobj 464 0 obj << /Length 152 /Filter /FlateDecode >> stream xÚ33Ó31V0Pa3cS3…C®B.SK ßÄI$çr9yré‡+˜Zré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ìÿƒANúÃÿÌÿêi†úõ Zþ@ˆæ‡Ó5`šNW€ifœôýà˜fÄI3€i0™4?(pÓ\®ž\\wG³æ endstream endobj 465 0 obj << /Length 271 /Filter /FlateDecode >> stream xÚ}нNÃ0ÀqG"Ý’GȽ8‰DÃÔH¥Hd@‚‰uFlU›GË£¸o©‹‡¨ÇÝÅ|4RâülK§¿\•ç%æXâYUŽ>ð³Šy{9Þ<½Â¢û€³ ì ƒmnñãýóìâî °K|,0_A³D"êMLäþá¿1 /äΘ­¢c Œô/jEË802F¦x©åZ0WðýFf ÖÇàa2+x…3‘ ô .Hbìþ‰‚[¥TS'J &f N”@MüA­àÖy@»Qpâ: œèÜ7v#"Úõû†ö.€¶ÔBMíúŠGH'‘ SÄ~ }J× ÜÃ2ÿš` endstream endobj 466 0 obj << /Length 345 /Filter /FlateDecode >> stream xÚÑÁJÃ@à 9ö’7èî hšÒÒZÁ=yOêу¢ÐC1yŸÄCÄYðrkKÆ™ÝMEÛƒ·YþÙ?[Ï'j¬&ê(UÙ\Íæê."›Òp¬f ÷rû –¥H®T6ÉERž«ç§—{‘,/NT*’•ºNÕøF”+…ˆZ"(ÐüǶ…€Wëžœ;ËÁ÷ b#yí6ì sû"¶ßÇü¾ô£s¨Ý>‰Âæ·yGA¡¢Ú9ß¹±ŽÉ!yCacp^Wƒµµ$ä–ެÛéà ¥°¹·–ƒ;ë »êBú9>׺‰vݱ Õ°µî,û˜ü¡½)”7²?­c”䝯yD¿‘·Ö¾S¨míL?h:ƒ3E©öX÷ÞCÛà›7ÞÜÈWìΛÛ9à‚i÷-ÙÚ›CyÛvø,qZŠKñ ydõ• endstream endobj 467 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚuν Â0ð+„[ò¹'0­~€ÄIí›™Gé#tì =猪‹!ùAþ¹—úù€RÊÉG4Ó!Ã3vYªW}ØŸpR ßP>@¿}±¤ëåvD?YM)C?£mFé‹AhÀ0W–¹pµ•(Ô†Å&áRŽ_ïÕGW«¶RM©Êú1|šŠw5áFò—ú«ýö ]Ÿ÷æ·ñ¯¬5IW¦†º'C»§{p´Ü:ކ«ƒV†#Î \ã 8.y endstream endobj 468 0 obj << /Length 191 /Filter /FlateDecode >> stream xڵϱ Â0ÐH†Â-ýï L«–ºj3:9ˆ“::(:·ŸÖOÉ'dìP{^ŠCEœÄ<¸Ü%¹$“Q”`„c^ Ïc¸À4å¸ }âp†Ì€Úâ4µä]Pf…·ëý*[Ï1•ã.Æh&GA‚}1è”t@%’c55lË)É1•’¬(*ÉÚúzí¼Ãºgã û¶?øqÛÛ[®ë„­Da_½=@ÖMÐ é4ÕBÚ3²ò'`a`Otí„€ endstream endobj 469 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚ•Î; Â@à )ÓäBænbÄ*#¸… •…X©¥…¢­Ù£å(9BÊKÆY#X[Ìó‚?›M³ŒbJ]-(Ó9Á¦¹ô±kÝâtÅR£ÚSš£ZË•ÞÐãþ¼ *·KJPUtH(>¢®> stream xÚµ= Â@FR¦É2'p³$!vÁ-­,ÄJ--­o–£è ´‹dœ±ò¯æÁ·3ì<6{AŒ†\±Æ¸+ [ˆÎDi,7P3ŒP#¾eƸßÖ ²É5¨çƒ˜->E) ït´ÿD›ŽL®Ì”Z&U¼×!˧Òm,—J¯¿–yÿ"LŸXœÞI?ðåµ]ìÀ&^-Vìæ±gÇž·Zêø¿n$ù̴ɦ†¦p h¥Á endstream endobj 471 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚ]ν Â0àS:wÉ#ä>m©Ð± ì èä Nêè (¸¥à‹õQò3ã­ þ\È'›3ʇEÁ)çrFçï2:RÞߥ}ì¶×”¬$S2{ZÏù|ºì)/&œQRñ:ãtCuňCèà:DávG|‡iÊFy”­öÐV;¡tPo¼0ðáƒÌ7ÀæÙ÷âª{äKxÕNÄ. P¡5­ô €’’ÒÒ‚¦5-éQle€ endstream endobj 472 0 obj << /Length 155 /Filter /FlateDecode >> stream xÚ3²Ô3´P0P0a S …C®B.c ßÄI$çr9yré‡+›pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä?000þÿÃÀÀþÿ?÷£¾ÁþÁÿ†ÿÿŒÿ¡óFÁð¿FØ1 bˆÿ ÓÑbõÒøÿÿÁåêÉÈŽXo5 endstream endobj 473 0 obj << /Length 264 /Filter /FlateDecode >> stream xÚ…½NÄ0 Ç]1Dòropõ @ZµU™ˆt`b81#æô x¥lŒ¼B$€Ž7œbì´Bb"Š~±ì¿?â¶?é;ª¨¡ãº§¶§æ”j|ƶoE]·„îŸp3 ½¥¶A{)~´Ã½¾¼=¢Ý\ŸSvK»šª;¶rJ“€xþâP0ów4Éð{\í .c9ØNø]ÿ”"ÿßY¹pÒ&Zm­¬m¥1¬˜÷BÏ`­XëX Ï2ÝÌ1Ï2s–Pª)£Ö—àH˜²r”Á€—L¥5ø1ýÒýáU¥—Wôš[$ÜtUòÝ’ŒáYņ'¼ðr˜Ô endstream endobj 474 0 obj << /Length 157 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bS#S …C®B. ßÄI$çr9yré‡+˜Xpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ3Á$;˜d¦%YH2ÿÿ$ùÿÿ’ò@Aæÿ6Œÿ˜ÿW€É òÃÿÌÿ ‘ H$Ã’ÿÿÿ±ÿÿ“ärõä ä WžH endstream endobj 475 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ32Ó35V0Pa#SSK…C®B.#C ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ŒØÿ0ðÿ!ùÿ("”ªÁþ3Ô#!öÿ ÌÔFÿÿÿ€#.WO®@.Nq endstream endobj 476 0 obj << /Length 173 /Filter /FlateDecode >> stream xÚÍÎ1Â0 PwõÒ#Ô(i‚ í©‰ H01 &`dÁœJ\,Gér„I+: F,=þ°*G² ŒÒ ¥rBjLyI‰gTÝ9£i>dûVņTbfI×Ë툢ZÍH¢¨i+)Û¡© ë¸íEì¿ Yßëú¿Lì!æO`ý’@7Ú[§=·Û¾9nÙ…ÝØû4?ú×#nç×ø`9yÚ endstream endobj 477 0 obj << /Length 198 /Filter /FlateDecode >> stream xڵб Â0àJ†Â-}„Þ˜TZèV¨ì èä Nêè èj}´¾¯ÐGè˜!ỗƒ:Èw÷'„dfœ¢Á‰ßiŽYŽûNf¾6\ò`w„²½Æ4=÷]Ðõ/çët¹œbºÂM‚f u…~ÑCQýÓˆº¯*ÇSÕK¦cã;[È©›èXeÙ°c£–ÅF:Ô‹’!÷ö1HÞ¿B !ù›%ލõÔ‰=Ûˆ…ec'lô’ü_Ù‚ì§0«aOP‡Œ± endstream endobj 478 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ32Ó35V0Pa#3S …C®B.## ßÄI$çr9yré‡+qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ3üGBìÿ˜úÿÿq¹zrrÊWù endstream endobj 479 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚÝÍ= Â` àˆC!‹GhNà×"Ú ‚ ì èä Nêè (¸µÒÁkyo =Â7:”¾¦ÅÉÁ8„<ù! úín(žt4BMl}>pÐÓº.«ÁfÏ£˜ÍR‚›©vÙÄ39Ï;6£ùX|6‘¬|ñÖGB%%9µ "” 4Dªrr•{Ef‡V5 ÜR×’S^r_Ô,µÿ¬¥»IQiâNÉë[)%ö[ôyü/ Èû[<‰yÁo¨Rµ€ endstream endobj 480 0 obj << /Length 151 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bS#cs…C®B. ßÄI$çr9yré‡+˜Xpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ1Ô`øÿùÿ Éÿÿ”gþ$mÿ7°ÿ«’Ìÿ>0Éÿþ`þ‰l@"üÿÿýÿÿ˜$—«'W Žá‰ endstream endobj 481 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ31×37U0P0bScs…C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. Œÿ000ðÿÿ$ëÿÿ’ÿþ700ÿc°ÀÀþ‡Aþÿ2 \ i$Á €Êêäò?ˆl •Ä4b>Ä.dÛ!îp!îdræ~ùÿ€$Ø_\®ž\\-in« endstream endobj 482 0 obj << /Length 193 /Filter /FlateDecode >> stream xڭп‚0ðš$·ðÞ h[I;˜èä`œÔÑA£3>Â#02Î+šhÔM‡þ†ûúçK£`¨#Ô8Âc¤1ˆqgàaÌSQðˆ¶H-¨†1¨ÏAÙ9žO—=¨t1A*õA½›¡ ]‘O›Pö±’JA…äy)Iˆ¼r&õÓ~ó®ßþàÇmý—·’ªkÂ]Ÿ{77”Ôx­Ü¿f}N$¹nýCâù&L-,á‹ endstream endobj 483 0 obj << /Length 144 /Filter /FlateDecode >> stream xÚ3¶Ô36V0P0bcsJ1ä*ä26òÁ" ‰ä\.'O.ýpc.} (—¾§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹Ã?æ ÿÿñÿöÿDM}Ãÿ?þ`ÿ÷áÿæÿ@Ä8ÑPß$쀈` 4'þÿÿ‡Ap¹zrr8WÖ endstream endobj 484 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ%Œ= ÂP„7¤¶ñÙ˜„‡Æ.à˜BÐÊB¬ÔÒBQ°“£y”á•[„ŒûHñÁÎÌθb2+$˜Š+ä’ó]n: 2ç/*NârN7ærZmåùx]9]ì–bîJŽV9qµ*ý> stream xÚ36×34Q0P0bc#Sc…C®B.#K ßÄI$çr9yré‡+Yré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ø0°<¶‡âz þÁŒ@ÌÄòÿÿ?ø„™bTÂðÆÿ ÿ7~`øøƒýÿ@Ç400ÿcàrõä äÎpR endstream endobj 486 0 obj << /Length 149 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bS#cs…C®B. ßÄI$çr9yré‡+˜Xpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ30ØøÿŸÁþ?’ý?ãÿÌ@5J2"‘Ì0’ñ?;ˆlàÿÿ¨Ìèâúÿ€¤üÿÿA*þÿçrõä äðŒ endstream endobj 487 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚe̱ŠÂ@Ð7¤¼&`Þ8Éš …(¨ ›BX+ ±RK EÁBÐɧ䦜"8ÞqaZÜ÷=¸yÒÎ$‘/$ëI§+ë”wœå良þ±Úò¨`=—,gýƒ+ëb*‡ýqÃzô;–”õD©$K.&âœQÎ~8¢˜¼-x¥)؇%‰à Vd‰.hUAëmPþ[‡0ªÃ+|D0|D] ×zy‡ÊÝ^Öœ}÷b‡Uc\6úù?ù»à?#Zh endstream endobj 488 0 obj << /Length 236 /Filter /FlateDecode >> stream xÚuαJÄ@à9R,L³opÙ'p=…póSZYˆÕ¥…¢pE ûhû(û{]Ä#ãÌZ˜F˜ácfø«Ë³«Ú朻ªÍEmö%¾aµâ¹Q»WÜthMµB{Ë[´Ýùxÿ|A»¹¿6%Ú­y*MñŒÝÖ‰\Kÿ©&Ð#d!#P¬OIÇ*¿ —M «D // R2h‚``ÝRÌ“m\®ùÕ‹ãzð=@>6m8ˆ}F}:ä1Μ¢>²Šý ,EýÍfù¹œ‘]ˆîO Î sSq0€iî ›TxÓáþ¦‹j endstream endobj 489 0 obj << /Length 214 /Filter /FlateDecode >> stream xÚeͱjÃ@ `-~„ÓôìÆ&lpˆ‡B2e™ÚŒZš-?šó&†¾ÀA–Œé– î㤻_*³—‚2z•S¼ÑbI_9þ`QJi©ŸßØthwT”h×ÒEÛ}Ðßï鈶ټS޶¥}NÙ»–˜a÷lÌ}ì!â!xHĢ µK{Ñ0S%¦ÓYLæIŒÙ±„4¬^½vA:ÓCžõÿ5ûÏ2?¹j,TÓkØ„pÂgÙ àe3D^63ÔìŸÅU‡[¼}l* endstream endobj 490 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚeϱJÄ@€áYR¦ÉÜÎ è&^¢‡óSZYˆ•ZZ( Wœ$/%ñEò[nnœYäÚ|Å,ü3[åû%åt@{Å!•Ç4?¢ûŸ°¬dšS5ÿ}º{ÄeƒîšÊ ݹÌÑ5ôòüú€nyyJºÝ”ßb³"fo8ü7a êLìàŒ¸{؈kq€ÐàEoÄÚ›A ª I¿sLÅlL;q›‰é6‘­˜ð,ú)þˆŽ"pøkë'ëaÒö“šß “6ª«jùTº…vûMtÕ%ü¥yþÖpû®É7«±šc%^–Æ ð¬Á+üš~oì endstream endobj 491 0 obj << /Length 200 /Filter /FlateDecode >> stream xÚMÎ? Â0Çñ_ÉPxKŽÐwÓÚ‚bÁ?`A'qRGE¡ƒÐ-Gñ;ˆñ¥.ù@^ø’W EÁ)çáŒ9ñ)£+åa–†kx8^hV‘Ùq^YÉ”Lµæûíq&3ÛÌ9#³à}Æéª—Þ{÷G«¼-m,@{L¡?˜ y㉲§C¦|Ï uäj%@ª* éy RM§œT—rR)§~ØØI;Ýó¶Ri+&¶éPÚ¦¼•õþ¡eE[ú´åfN endstream endobj 492 0 obj << /Length 188 /Filter /FlateDecode >> stream xڵб Â0€á+Â-}„Þ hšP:j3:9ˆSutPt®à‹ù(}„ŽJc¼ quù†ËûO¥óTSLŠf’”"­è(ñ‚Iæ†1ií_ª3ÅŽ’ ÅÊQ˜5Ý®÷Šb³ ‰¢¤½¤ø€¦$,D¶¨m`ŸX˜ôP?¦䯰…¨a"GËä „ÝHíè¿°Žáüú’ñ[¹%=ãΡ‹i¸ˆÛ¸’{}9ßàs \Üâ#G— endstream endobj 493 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ31×37U0P0bCS…C®B.cc ßÄI$çr9yré‡+sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä€ÀDübvQ$þÿG%úAüȨÿÿÿÁåêÉÈB•\ endstream endobj 494 0 obj << /Length 231 /Filter /FlateDecode >> stream xÚmÏÏJÄ0ð¯,Ì%ÐZ%c‹ã7¢â!¿02I†ñ|ÜøÖÛz¿ü¾“éGÆ­…Vx|–í,ÍïGi®˜•f¾ö‡×ã“4Û› ßI³ó÷odÞy¸A# ÕŒJõ—&E½8]&”ÃRj ©Ð¤ šÙõKXÿ™"9ãØß°öC¯ú"‚ãƒùÊÞáN¤¶¶šàžç‚ +–o¨q‘Ô ™€ï@æF2ŠÌÏh.ÊpFmLF IÿA.g¹•OÕ¬—´ endstream endobj 495 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚ}±JÄ@†ÿbaš> stream xڕϱ Â@ à– Yú6O`[¼Ò¥T¨¼AÐÉAœÔÑAQèP°ÖGé#tt«—ªtò $áB¢ÓyšpÄ :áDó%¦;騿‘¤Ò8ߨ0XÇnl•B³åçãu¥°Ø­ØVK>Ú/'2%;ŽãµÇÀ%|ÃAtG*èA0‡¬`/ºPu°½Fô19€9¬a{ÑíDíªb#úØj3XÃä5S¯øS… imhO_o`{ endstream endobj 497 0 obj << /Length 229 /Filter /FlateDecode >> stream xڅϱNÃ@ `G"yh_éüp’([+•"5:T #Ö^í%pcó»He``ùÛ÷û\·wm# iä¶”º’¦–ç’߸jQD¹ùéœ^yݱßKղߢ̾{”÷Ïöë§{)ÙoäPÊâÈÝFnˆ(ºžŠèF Ñ©j…Àd|ÉŒL@Àä6ììmБÜT /åˆõ¤sg`À|¸®Œ¿8c†Â¨Ò’5 MñÃÙâ—”i\Qn+ ¥yrŠevœEs¬á‡Žwü Ô4„s endstream endobj 498 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚuÏ=NÄ0à¥Mã#x.N´ŽV[YZ‰HPQ * ¤Aíp³%G0¢ÀE”a²» ÍgûYš¿<]6\±ç“š½çÆóCMÏ´XiXqÓì~îŸhÝ’»áÅŠÜ…ÆäÚK~}y{$·¾:ãšÜ†ok®î¨Ý0`2™€R¤Ó—é†r@ìŠI…ÀærBÈG£b¶dÅþ2lRÌ“V;äxFïò!#äSòÕI§gìµk4I±Yòžñ€;ý!þGøaÜbóžÝ¸óài^aÐeb_È»î+:‚¶‡ÑÚ(4¢ó–®é–•™ endstream endobj 499 0 obj << /Length 200 /Filter /FlateDecode >> stream xÚϱ ‚`ðáÁ{2As‰3È!¨©!šª±¡(hˆôÑzÁñĺïŒt©¡~Ãÿ8îÎûa@ ¨ç‘R0¤‡Gô=9›Îö€qŠîŠ|ÝÇè¦s:Ÿ.{tãÅ„8MhÍ3L®±â“+ÿ"dL-V¢K±x{°pprm î%@%*­!š¥ÞiÉfúÈ£ú1ƒÖºÕh¬´fG«£Ý¨ZŸFéȶ> stream xÚEÐ;N1 `G)Fr“#Œ/³£Ñj«HË"1Tˆ ()@PgŽ–£ä)S„{Aló)Çù“iw¹›iC]Œ4M4Oô2â;n÷²¸¡yþÝy~ÃÂÃm÷8ÜÈ2Ë-}~|½âp¸»¢‡#=Ž´yÂåH`xpœv ú$¸ä"¸,t¹?“”¬¥JIÏRÜsTR/´°vÌ „ –å6£#`f€ÀÁ3G&û-Û]\\ò\´Eõ«åV>R®ô­tŠUÌ?p¦²"ÅFÏ ¶ø¿Ìò¢!ÚS‚S¯`% ^/x?}Ï“… endstream endobj 501 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚmÐ1NÃ@Ðo¹°4°s°­ØŠR­‚„ $¨(U ¤A½¾ WñMØ#¸ÜšapJ‘æ³Úù·]_®;®¹å‹†Û–»–Ÿz£ÕƆ5wÝádÿJÛžª^m¨º±1Uý-¼¾Pµ½»â†ª?6\?Q¿cä Ài‚&dš r¢˜†2!Œ.ÁG?pS8’ôÈ|9‡]ó'ø?‚XP‹T)æL%—ü[2Õ/±jNl¥›þ§”>9Û’¼5þ‰FX ü”éà¢=Ø … Œ–W¨UÊUG@—˜ºîéž~Uí–Ž endstream endobj 505 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ33Õ37W0P0WÐ56P0µT°4PH1ä*ä25Š(Áä’s¹œ<¹ôÃL ¹ô=@\úž¾ %E¥©\úNÎ @a…h ¶X.O08&€)fT "ÇŽBñ7 PCäQ(;ÊBÕ P?P¨7 P¨NAu{§ ºA›SPÝPÅ)¨nÀ*ã”A3ôrÊ Šh¨0$@(.WO®@.”ªYÍ endstream endobj 506 0 obj << /Length 223 /Filter /FlateDecode >> stream xÚíÓ±nÂ0`#†H·ärOP'€ [%R3T‚‰u‚ŽZµsx´ð&y„ŽTŠü÷¿ Á†XjÉÒw>ßÙ<?LFšê3k>Òm&ï’§Zbó&ÓRüJóø'®Š/ŸõóãëUüt1ÓL|¡ëLÓ) uUpµ)v ¾š -‘?@øË׌ö8õ€;n=pOkì£q11»EœcfØÕ˜À³1>†KZ³*t’¼³}–­w{¢»7¢á:Þïƒþy+Ø÷€}¬k(óR–ò éQtn endstream endobj 507 0 obj << /Length 180 /Filter /FlateDecode >> stream xÚ37Ö3°P0P0bs …C®B.33 ÌI$çr9yré‡+˜™qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]€àÿ?0ÿÿÿü Íø@ ~Ãþÿv0ãÿ à’HXÄàÿßaÈÿg€0ìáŒPFý$Xû8ãĬAÂøÄ1›ãG ?ØA‘A ƒËÕ“+ öÛpÄ endstream endobj 508 0 obj << /Length 327 /Filter /FlateDecode >> stream xÚ•Ó¿j„0Àq%C ‹`ž *½B]®W¨C¡:”NmÇ-ív¨–GÉ#dt—&æ—?RiDø¨ ~ýi]_\V´¤;½×WôzGß*òIê’šMš ¯dß‘â‰Ö%)îôYRt÷ôûëçû‡Z‘â@Ÿõm^Hw ‰YmVìaܶb«Nß4RbÕXM›Î”\u®N›n•ònbÁý |ä± –mˆœbçÞ©¶‹LEæ´]$â±±7æ!3äi»ÈlŒzçÚ.2Ob'Þzº>¸Ñƒtî!ò¸´—Æ9™7Ê ×˜CîÒ.Ík&) 7L³Èʬ ¦k–üÓùì“ËõÁóÇ Á͹!¾·!×Kk¹KÛøÌ!×#°€Ü¥m<æá“ÆÌþçÎFkó(­°¿4J@?û¯ÉmGÉ/ðc ¥ endstream endobj 509 0 obj << /Length 338 /Filter /FlateDecode >> stream xÚÍ“?N…@ÆgC±É6½€QãÚ¸Éó™Ha¢•…±RK vF8Þä%^€’‚0Îì ‘¼Z ø-;;3|óqvrX”ºÐ§ú ÔÆhs¤ŸJõªL¡ù6Ç~çñEm*•ßiS¨üŠ^«¼ºÖïoÏ*ßÜ\èRå[}O‰TµÕ@W‚€dªR‰ˆ;Ȉ,Q–ˆG¨9ÛCi ì7rXKËä0—Aà@$ˆs;’²º:ñ>GOÔ11PV¨GG’ª à{ ré(µëÜ‘  J}1*7S(»$;SheIÙLõ>âoúCø¨^¥f­i0Ó¤ÚÙIñ™Î§ÉÌô¬ð§ Cœ4ôqú¢ŽHºèG®¹‹nJÛè°¬‰®³œcÔC +{ç7ZÛÎÛ¶>»ƒ Úà¿¢‹*E!¼Õe¥nÕ/ÙÏíã endstream endobj 510 0 obj << /Length 258 /Filter /FlateDecode >> stream xÚÕÓ1nƒ0`£ ‘ÞÂx'¨¡b€ ‰¦R"5S†ªSÛ±C¢d†£õ(9BF†ˆcWæGµR¦Z}lÀþ_ÇYÂ1§æÈSÎù#¡=e¹éÇ}·¿ñþEeEzÇYNzm®’®6|<œ>I—/Oœ^ñ«™æª‹kªo?nÁ‚>ƒíCK¹(Iç¸ÖªoïÐv^سs`'rVr\wƒ Iã‚—ý˼ÏÞ‹‘/ÞÁÈí¤íýênp=g¹ÇÍ?ôÿ;³†¸ÎØ—¹=Å  13èr…Ù‹ “E7™ÛòŒ™ÇZ€1µÓŒk kmªgjÖ.=W´¥€Ms³ endstream endobj 511 0 obj << /Length 228 /Filter /FlateDecode >> stream xÚ•Ò= ð×t y G('«Æv3ñ#±ƒ‰NÆI4:—£õ(ÁÑIÓ¾ú¤H~…þi¿ÕE[ôLK;¶nc<`’˜ïgØìq˜¡\Š$A95½(³™8Ï;”ÃùHÄ(Çbe–Yc6º,wh*àúÀ´.9)"1RH HP+wh ¾yÅ›(¸/*±†øPè#qRDÒ¥LùSõÜ×õ¸c_ÿÿ½Ÿè擽®²éPèÒå[Ì+^« —& ÊIº ¬)J¢¢t*Jl)sŪJ¶SàN2\àîÀU\ endstream endobj 512 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ3±Ð31Q0P0bS #…C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ÿA ÉÀþÿÃ(9THü±ÉåêÉÈ’:Õ° endstream endobj 513 0 obj << /Length 157 /Filter /FlateDecode >> stream xÚ3·Ô30T0P0bs #…C®B.3K ßÄI$çr9yré‡+˜Yré{E¹ô=}JŠJS¹ôœ ¹ô]¢ÆÄryº(ü Ä0ø!Ô(c2~f0ÂH`0ãf°c0øáŒP†<Ãƨ‡1þCŒ0;ŒÁcÔCÌÀ¤ø Ãàrõä ä6n6 endstream endobj 514 0 obj << /Length 325 /Filter /FlateDecode >> stream xÚÍ“±NÄ0 @ÝPÉK?¡þh H×›*‡D$˜02€`¾û´~J?¡c†ª&±ãrœNldH^âØŽ{U.+,p‰'%®Î°:ÇçÞ ºð‡ú…%O¯°n ¿÷_óÜÜàÇûç äëÛK,!ßàC‰Å#44~d´32DCÄšˆZAOÔ3%ä,F•¢b= _&gŒåË2‡½·dõÀ‚FL¤dtæ½Èêˆ^c;È“ºh†MZE=°p¡8È}ÃÚ‰âèÝ´1ª˜M¸Ótøµž°=Š[’l¥ÔýiÂþÿâìéñq<”3Mu;Ëúo˜ê†Ïš0Ñï÷q¯fUËȱ„±çšà:ëØ „Æåq’ñÌ×Ä·€•ZwÑ»¾$D#ÌB·HÜIè!iÐýh²Dåß W ÜÁxkD— endstream endobj 515 0 obj << /Length 422 /Filter /FlateDecode >> stream xÚÍ”ÍJÄ0ÇSz(äRß ymë²n÷ba]Á=yOêу¢°±_¬Rß Þ"”ޓɇ]XéÕ¦¿mæ#“ù'Ëü`‘ËT.äþáL.g2ŸÉ»Œ?ò|Ž_S™¥Gvîö¯Jž\É|Γ3=Á“ò\>?½Üóduq"3ž¬åu&Ó^®%ÃG@ÍÌô h "AG ``Æ©Ar,=CÆ  ÈØŒú?Fmq¬zæÌ´‹ÉY€Ìš2fä`œÁb‡auDzvQˆ¡Ã~ŒåÅ@ƶˆ-pŒÂc=B[ žÄÊc»…fã¿[&ª$ø…häß:_gVÚ9] ÊWAîàú8©ßC†^{dA˜Çe‘QI#ÜX<¸0å° =v£;¿t–'±µXíÄÂß ÝÍ!¶ÐnÄà0ò7 6J9 |^ŒÖ0~ZòKþï‰õ endstream endobj 516 0 obj << /Length 290 /Filter /FlateDecode >> stream xÚµÓ±NÄ `H‡&ÿÒGèÿJk×NMÎ3±ƒ‰NÆIMÔèÜ{4¥ÀØá"R ÜßÈ%)ù ~ø¡Ùœo®°ÀK<+±©±¾À×>¡©Lcuåz^ÞaÛxĦqkšAtwøýõób{%ˆ>•X> stream xÚ}ѱJÄ@à?¤l“v_@“pÞ] !pž` A+ ±RK E;!÷hñMÎ7H¹à’qfwO ¦ù`vv23»œ•µ)ÍÒVf±0õÌÜWêIÍ%Xšú8œÜ=ªU«Šk3¯UqÎaU´æåùõA«ËSS©bmn*SÞªvm€| 82"‡7@бï, }8$´þtHIR2>JØÜJ =°MT;4[6ÿ±ùR׳éÄÄ~“û íD©Ï}~k£.:Âíì£6ʃH«¬Ï±¥DÎJ†wðkñ©8ÊÌ1ÁÛ‡=Iszÿ‚‰6üÑWÎBðJIľ7ìl¢:šÇa²hJ½Ý7ùCÞ¦ûßÍ8‘ÂýðˆþÝÆðâÞ5,φýkV›Ôqœ<ò Òöè÷Ã/™„µXY×dã|…ËvRJµêJ}áI± endstream endobj 518 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ³4Ô31W0P0b 3 C…C®B. rAɹ\Nž\úá \ú@Q.}O_…’¢ÒT.}§g ßE!ÚPÁ –ËÓEÁþ?ü!žu€¡þ?3õ‡Äb°ÿSÿÂâÿWÿÂbÿWÂbþWßa1þ«g€°Xu0V6V ŒeG,ëŒeÿÆ’'Åc1Œ²†%‹’œÍârõä äãCì< endstream endobj 519 0 obj << /Length 347 /Filter /FlateDecode >> stream xÚ•Ò±JÄ0Àñ YúÉ h¯w v¹Ày‚ÄIÝŽkÁÁ×êæx¯Ð7ðÆ ‡Ÿù¾/ׄë¡Hû#MHYO =ÖS}TèòDŸNôC!Ÿe9q‹c}:å/÷Or^ÉüF—™_¸e™W—úõåíQæó«3]È|¡oÝAw²Zhpà !j€Í- ´GÝ ¡ #gM°rÎÜ>²6n¦Þ3²xåf[ò22>GÞ–üÑ_Þt2À¾r º NɆݲñ•‘»aw{VdS"Ø9ræm÷¼"sØ22Çq˜ æDŽä,‹xc'²SoŒäDŽÌ¼1’³8,¶òÆ0NdoŒœõ¶> c¬Ïâ°Ø[o ³Á»DŒÜeaXì¤w ï]ðGoŸm𺷂uüzg|UNùj ¼»–¿yö l»îþ¶i[5ËóJ^Ë÷ûø· endstream endobj 520 0 obj << /Length 459 /Filter /FlateDecode >> stream xÚ­Ó±nÛ0Æq pá#/8ŠÀ“$)PÚ©CÑ©íØ¡E³ ²ß,z=GPħ£íZ™êáðáçNþëõÝõæÎݸ[wU»zýÆmnÝ·ZÿÔõº¾q›u~ïë}¿Ó«OðCµ^½׫Ý{÷û×Ów½ºÿðà@Ýgø¥/z÷è"¼‚ØÃEwø lì…€;ÀiŸ€åi24> stream xÚ•‘±JÄ@†'¤Ls°óšL® œ'˜BÐÊB¬> stream xÚµ±NÃ0†/ê`é?BîÀ‰dSº`©‰ HeꀘhÇ XI-Â#dÌ`å¸s‚ºtÅËgý÷Û¿î·×~Iyºª)x ö5¾£_‰XQ¸™&oG\7èväWèEF×<ÑçÇ×Ýz{O5º ½ÔT½b³!€ÿ€œÈ£‚™Oª±ª–!2J`@;€÷PŽPÈ<²;…‘GgÈ3E9c̈¹*lÊ0´9Útüø / Îà Ýìi†Õnʲm'¾©¿;)¤ø–),åˆbÈߘ^‹ìJq™©Ý‚§®£zµlÑð¡ÁgüÍF‹¾ endstream endobj 523 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚÕÒ½NÃ0ðT"ÝâGȽu¢~n–ú!‘ &ÄŒ ˜Ý7è+õQúíØ!ÊŸ³¯ñ‚ŠÄ„ˆdå—‹³ÿÊl4¬æ\ñ˜¯jžU<ñsMo4HQÇúæé• Ù{žNÈ^K™lsÃïŸ/d·K®É®ø¡æê‘šgáʱ‰wƒ_ s=Ìÿ‡$ p8E €.¢° (±s‡×…¢ÀŸÂ4Ž2ì¥*ȱÓ| ]¹Ñ6&âÜ´LèÎpßàÚ‹À_à‡ýøËÇIHGN!ÄXÊ>±] ³7ž#†Ýfæýß".ŒÎF«?«Ç^Q 3Ò™Ö Ýщb= endstream endobj 524 0 obj << /Length 244 /Filter /FlateDecode >> stream xÚ…¿J1‡gÙ"0M!óº·`D«Ày‚[ZYˆ•ZZ(Úºy´}”<•aÇ™¹ãôP1|ðå—?üâéáIO :¢ƒžâ1ÅH=>cT¹Pc;÷O¸°»¡Øcw!»á’^_Þ±[^‘ØÝÊ™;Và8ƒŒ‘?dm˜gPÇj·\R…q :“dÄ„*Á |…Vbn¶;ƒg³Eó çd˜ö1Öo( Ø÷aãhDBÿcü³!ýD[Áo˜¬1¿En¥ ¹±¦ä%iêÝînª6N:ó\ÒZÛ` æ]H›_ÙI<ð?yë­œ endstream endobj 525 0 obj << /Length 175 /Filter /FlateDecode >> stream xÚÕн Â0àá–>Bï L*)¸j3:9ˆ“vtPtnÍGé#8fœ—:èÒM‡|ä~àŽ3z> stream xÚ¥‘?JÅ@Æ'¤XØ&GÈ\@“HòBª…çL!he!¯RK EëÍÑÖ›ä¦L2Î쮂°áÇîüû¾É®9o[,±Æ³‹w565>UúU7¿–Øv1ôø¢÷½.î±étqÍïºèoðýíãYûÛK¬tqÀ‡ Ë£î¯|¢QÑÑ’“CD–F°³"RcB|&;¦Jª ÀÌÆeÂ%w¹pU¾ëö3Bú?OûþÄÂ|€ G(ú‚^±'€f ‰]âTH¿Ø¯ð“|X9éʶÌÜ/O8E.‘> stream xÚ37Ö3°P0P0bsC c…C®B.33 ßÄI$çr9yré‡+˜™qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ì0€Áÿÿ$0˜a †aÃÿeüÿßf0ÿÿÿÌà‡xûÿùõÀŒ:û`PÛãçã?Hÿÿß  e00°ÿ?€Ìø‡ÁøCãÇ(ÎøŒv q€—«'W lù2 endstream endobj 528 0 obj << /Length 138 /Filter /FlateDecode >> stream xÚ36Ó35Q0Pacc …C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ìþ``üÿ€ùÿ0fÿÿ+†ÉƒÔ‚ô€õ’ ä0üÿ‰˜aˆàÿÿÿ@Ç\®ž\\ÍÙ¥; endstream endobj 529 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚÕѱJÄ@à)ÓänžÀMˆD­ç ¦´²«ÓÒBÑzïÍôQ|„-#†wæ_ñ°ñZË·“eþþäà°ã†uõG|Üñ]KÔkÝh©›Í­Fr×ÜwäÎÓ[rã??½Ü“[]žrKnÍ7-7·4®¹¦B‘ý,³Å?¶ ûXø€¾á ú-ä,fXN°pùµMõùÞËV´¶¤µ%‡\{œ`rùô‰Ä_ |•­¹»7fçZlžP‰Íð \X°~r„þ[ƒ'-pG NZpZ¸£ÛYÌŠŽê4ú_ÒÙHWôn¬$ endstream endobj 530 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ36Ó35Q0Pac c…C®B.#K ßÄI$çr9yré‡+Yré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ì0üÿ‰™˜aãÄÿ„޹\=¹¹µ‰Ã endstream endobj 531 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚíÒ½jAð WÓÜ#Ü>·ÔŒ‚WZ¥©LÊ+³vrp!E¶›üçT°+‹ ó›Ý-ÆÙÇvïÞXÓÅqöÁt;æÍñ';ë±j-->x˜súŒÇéiNó©Y-×ïœgOÙ‘yÁÌ+ç#CYEI ºO$RáxŠ%4ˆDJʤnï«Ò 󢣨Ò×®U¶¤ Hª@Yûƒ$߸»Np·â§¤D@¥(€þ¿ØAx^ƒæ §¨å9ìÅE…ÿÇÍÛ„ÂÆip xœóœÿvÚiC endstream endobj 532 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚíѱ‚@ à& &]xúÞÜHLtr0Nêè ÑUy´{ጃ „zwÀ¡Í×6ÿÔd4”’™JBG´ñ„qlfiG{Ø1+P¬)ŽQÌÍE± Ëùz@‘-§¢Èi’Üb‘¤‚˜µ©ÒÁc®|æÚ!P÷Æái à±®!`{èø.ÿT¼ÊV6ß¡ýAÓõ_°yÍÀ4Õ8+p…o âøš endstream endobj 533 0 obj << /Length 231 /Filter /FlateDecode >> stream xÚµ‘±‚0†kHná¼Ђ±0’ &2˜èä`œÔÑA£3<šÂ#02Î^KL%!_sý{½þ¬æI‚!.qa¼@¥ðÁCT±Ý9ß +@P% 7º ²Øâóñº‚Ìv+Œ@æxŒ0> stream xÚÍ’¿NÃ@ Æ]u¨ä…G¨_.!MB§H¥•š ¦02€èœ<’GÈx•ªÛ¹F:¡.§Ÿ¾óùÏçË“«è†"Jèò:¡lN錞c|Ã,5¢<WO¯¸(Ñm(KÑ­EGWÞÑÇûîÝâþ–btKÚÆ=b¹$(“#ýÑÃ!@5@÷Šøo˜J ÿ§4ö{®aäÁ³ÅŒòßëŽfJ®`o}4¼‘.lO­%Þw£‹m_…mt§¢e4](z†`_ëTÀU‰øµ`  endstream endobj 535 0 obj << /Length 169 /Filter /FlateDecode >> stream xÚÕÏ;Â0 ÐtõÒ#Ô' ’VbªTŠD$˜02€`nÆQz„T d¨jœ20õXö“üYœé™žcŠš+ã4xRp“s?¶aq¼@iAîÐä W<i×x¿=Î ËÍÈ ÷ ÓØ Eá¢^¹˜6¡–­É±Câ‰:_øˆ:WóÑ«}ßÍO_ /h‰ Æmƒú ýIž™–¶ðj^¤ï endstream endobj 536 0 obj << /Length 259 /Filter /FlateDecode >> stream xÚ]Ð1NÃ@Ð¥°4¾;ÛŠBƒ¥$\ ‘ŠQ%Ú¬æ£ì\¦°v˜Y)¢yÒî·çÝT—ëk.¹æ‹Šë57 ¿UôIõJ/Kn®æäõƒ6O\¯¨¸×k*ºþþúy§bóxË[~®¸|¡nËXÊp8™ÎÙë…HDÑFä#ò°Ô々Ú~Àþ¨¨7ö'ÉQÈ”´^;LKZ+45qj@.dêtÜÇv“ù!¤¸Ç"iíÐÄÌôehÖ”ôÁjÛ]ˆÿdVçµ³½ÍSuž‡è ±ýõ?h©›ÓêgåcfKxýºëhG¿Á•¡Z endstream endobj 537 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚ35Ô34S0P0RÐ5T01Q07SH1ä*ä21 (˜›Cd’s¹œ<¹ôÃL ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.O†ÀOþÁN2bÌH$;É&åÁ¤=˜¬“ÿA$3˜äÿÿÿÿ?†ÿ8H¨úANò7PJÊÃç‚”ÿÇ`$ÿƒHþÿ ÀØ`ÿð(Èþßÿ ýß E` q¹zrr:é“p endstream endobj 538 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚíÑ1 Â@Ð  Óä™ èfÑlì1‚[ZYˆ•ZZ(ZÇÎkÙyÛt¦Ž»‰… а{üáÃÀ»°O!õ¨­(Võh¥p‹ZÛ0¤(j.Ë ¦匴F9²1J3¦ýî°F™N¤Pf4W.ÐdI àñ˜Kü#ZX€ƒøã+üÏÞ8ä¯È’ àö„wåÂ6î .n ŸÁÉÁNÃõ<sUÃv‹öÁ848Å”Ìðn endstream endobj 539 0 obj << /Length 252 /Filter /FlateDecode >> stream xڅбJÄ@€áYR¦É#d^@7¹Ül œ'˜BÐÊB¬ÔòŠí°¸×ÊÜ+äR¦gvE8°X>˜YØŸÍ/Η%”ÑYJyN«Œ^RÜa¾aB«¥ß> stream xÚ•Ñ1j„@Æñ7XÓx牚à6l6‹@R¥XR%)S$$¸æfB.2©ÒNi!¾¼7ãÊ.V?ø¡ƒòÇu~žf*U+u–©õ…ÊWê9“o²(èfªòKÿäéUn*™<¨¢É Ý–Iu«>Þ?_d²¹»R™L¶jG/z”ÕV!â­ÿCì´؃@µp` 'h–Îì'–Ä‘vÄ ¡3k"úótÅ{O<¾8‚ FØ ¦evb8Ñ83Mð‹mH Є̎iÃoì˜Â“z˜ÑÌ>úBa"0‡Ži5s?hbé8–TÔ0µcíÙÌÄô00c*ÓCïÙ»1í‚Ö ¸ˆi<¸8Î^°óŽ‹˜­gëvJpÏi\DäXî‘ו¼—!‚ý) endstream endobj 541 0 obj << /Length 270 /Filter /FlateDecode >> stream xÚ…±N…@E‡PLÃ'ì~ >ÄX‘<Ÿ‰&ZY+µ´Ðh+ü™| Ÿ€ÝK$\gfÑX)Éæ°{÷žúä ÚøÂʪýÑÆß—üÄu%ûB·úáî‘·-‡k_WÎeÊ¡½ð/ϯ¶—§¾ä°ó7¥/n¹ÝySÌÿ‘º…Èí‰壼£'7¬ìe†"Ê0Ò›0ÅDr„ì“92•ãD˜ÓIÙ-Ù¨l‘ÎèðÞ+s@!ËÊÙ˜Âb4ÐHëÜþfƒoöqŽ!þÿC»?ù„õI?b`6ÅÀ|ŒtC t} lL™D2r1uIU'‘TuIk*’ÖT%5P%5°­!Ä.ƒ>“ÏZ¾â/1¢¸¾ endstream endobj 542 0 obj << /Length 310 /Filter /FlateDecode >> stream xÚ…Ð1NÃ@б\XÚÆGð\œ8ÁM,… á * D” è"ÖT¹–o+ølé"ò0³³DQXOš]yþþòôx:ÁNð¨˜bYâÉÆæÙ”OG8›…£û'³¨M~ƒeaò ž›¼¾Ä×—·G“/®Îplò%ÞŽqtgê%Qmÿ3¢ "Vì–åÏŠ<³Ÿ³•èXú1f3j îÔ„MÅVl!e±y‹ ºo+ =̃ï¬Zy·Çê½ÃÎÈ[‘ÄcoFG\{SZ·êƛЦQ?ƒä‰`߈†µ™=mÿ»•;4ëMÛ?l½þœ};Y«íTj¶Ä­õj´Ó©Ú õIP×Z§ël§klku釾2#}UJ.´Ò†RÌym®Íaɽï endstream endobj 543 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚmÐ1jÃ@…á*ÓøÚx-"cUZpˆŠ@R¥©—)bì.X:šŽâ#¸T!vóÞRYHì ~†Y7ËzãV®Æ·¾ãûYé·Ö ÎvÃ_ºíÔ¿ººQÿˆ[õÝ“;N{õÛç{W©ß¹·Ê­ÞµÛ¹ðÄ[J–æ0Á)\$‡£éx " ³LãY$¤áß> LQ~à 3ó afˈLÀŒXF,@'˜› ”œ.Lè™ h¥”™Ö2­Î2#Ñæˆœ#‹Ìä‘‚rîm\É-õ¡Óýjh¦p endstream endobj 544 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚÍ’1 Â@EG,„i<‚sÝl±F«@T0… •…X©¥…¢ur4â,-‚ëw3)–.düfÉÿ3tƒ8–Hœô­ ­Ä#Ù[>±s#‰ÇUewä4c³çØÌ!³Ér9_lÒåD,›©l¬D[ΦBÔöá$þ‰»å½:À¨ë[þŽRI9Šùƒz%”î 7t„ø | t}º½€GIÀ³¦ã%EPþðú_üþ+µM_*|u°69X~o ©hFš˜æW§©ÙjÒš»nîDµ!<ËxÅo†s endstream endobj 545 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ33Õ37W0P04¦æ æ )†\…\&f  ,“œËåäÉ¥®`bÆ¥ïæÒ÷ôU()*MåÒw pV0äÒwQˆ6T0ˆåòtQ```c;0ùD0ƒI~0Y"ÙÿIæÿ ò?&ù¤æDå(I²ôÿÿà"¹\=¹¹VI¢” endstream endobj 546 0 obj << /Length 301 /Filter /FlateDecode >> stream xÚ}ÑMJÅ0à)Y²é’Ø–G_]x>Á.]¹WêÒ…¢ëôh=JŽe¥ãüˆ? Ú¯if¦“tߟ ChÞ¯6 §á±s/®ßÑ\¦¼ððì£knC¿sÍ%½uÍxÞ^ߟ\s¸>kŽá® í½Ào@£B,D¸'€DdZš"-š,-ÚB/6¨3"x‰š¢äç”™œ®—ÓÊ®k‰í ƒËpÞ7q|Ì$pãFúæš¿È »ùdíL™@ÚAvüZ´H¥ÙFÓ¬¦YM«5Þk|,ZdÖìI³eb4Ðj`Môä³g!@Tt¶«`[ÈBÍ».àA8ã²EþõËwÌ•b«ÔŠW¢’üÉü'îbt7î}tû” endstream endobj 547 0 obj << /Length 305 /Filter /FlateDecode >> stream xÚ‘½N„@LJlA² À¼€ÅgErž‰&ZY+µ´ÐhÍ=Ú> @IA烋 á·ì|ýgf.ëK xQá®Âz¯•ÿð!ðe‰õ•Y^Þý¡õÅ#†à‹[¾öE{‡_Ÿßo¾8Ü_cå‹#>UX>ûöˆ)Eà§£‰¿ŽˆN£ÈGG#›"ˆqhfHøÔ8¾ÏéäfEÊAEIÅÈ=¿ÿ„Å-ˆÎ’%$©#쵂H\ÀÕWèfä¹  Íhg™…™cgݺi†¹8iZþG«`©s+´¤É,25×ô\iÜ`2[Ì[¸¨ÈE3)Dä/ˆþbZÁ1.8Gƒ ƒ•I¬³éUuužR¯áÍ:îXÔ&¼oÝ´í]Ö¯"MºÎÝß´þÁÿéýëo endstream endobj 548 0 obj << /Length 225 /Filter /FlateDecode >> stream xڽнjÃ0ð ‚[ôº'ˆìPÛt±!têP2µ;´4›qüh~?‚G‚$ÎýÅC»õ@ú¡Bw—&ó,㈮+]pöÈo1}R2æ¢ñ8^¼~в$ÿÌIF~{Í’/wüýu|'¿Ü¯8&¿æ—˜£•kžnûLMÔÐ@;ÑÁž&žEõD-twñ>‡5 pU/jh:ØŠ¶,PW+D5À^Ôh ma#:ôYÀVpÔ=ìDÓŠºb~9¬a€g‰æ/ÌÿŸuøÿwiSÒ]]Óq endstream endobj 549 0 obj << /Length 285 /Filter /FlateDecode >> stream xڭѽJÄ@ðY l“Gȼ€&áH¢ ç ¦´²+µ´P´N-²°`“b¹u>r‡"X?²ÙLæ¿Ó6']‡¶x\c[awŠOµ}µÍšéñLß<¾ØMoË;lÖ¶¼¢e[ö×øþöñlËÍÍÖ¶Üâ}Õƒí·hF8ˆs0;àÛ¤Ž¡+*³¯Lʨ€•Yñ ‘ iþŸŒk›àäï!%Nó¹4tíaà(.JÚ‚bÒî> stream xÚ’=NÄ0…'ÚÂ’›!sHRd ‘–E"Tˆ ()@ Qa-GÙ#¤Lyxcó´‘•Oòóx~ž×ÍaÛrÅ Ô¼®¹=âûÚ>Ù¦ÁfÅíqRîí¦·å57-ϱmËþ‚_ž_l¹¹<åÚ–[¾©¹ºµý–‰ÈÒOdÀ%2…È ¸9SQväTòÔy2ÙSÁ Tà» 2NXFvY òŒø_ȹèíC!š‹"Þˆº%R­î/ºQ‘‰(Œ¶"!×V$ÞMÀ x#$“0"»W ­ ÎˆPrÂ(¨ì$Ó7´Ày?â Âîßèö"^Ò\æ%òˆI‘Éd¾«^EÀ€AíÈRɯiP7ë@tÊê4F¦¾Ã}œÒ·  CÔGƒÉžõöÊ~†\ö endstream endobj 551 0 obj << /Length 239 /Filter /FlateDecode >> stream xÚ­Ò±jÃ0`™[ü¾he…ÚÎTAš@=š)Cé”dÌÐnÁò£ùQü5˜8²þ@mp CoÐ'¸ÓJ“§,ã˜3~Tœ>óLñVÑ’Ô%cžMq³ÙÓ<'¹æ$%ùæÒ$ówþ>þìHÎ?^Y‘\ð§âø‹òGÂGT‚ ´%ð1Šîs °à< (G˜®Ï‹(ºnhÄÉõ<œA홀°OîÐÂS€ÆiüX+ÒÃé"¬]ö1¨Õö n\PrÀ䚇cDôÆÞ§ý+Á"ZlÎ`eºúý1´ÌiEWÂÁL endstream endobj 552 0 obj << /Length 339 /Filter /FlateDecode >> stream xÚU‘1NÄ0E'JÉMŽ`_²)²ÊÒ²H¤@‚ŠQ-” ¨£…›øéHayøcARäIñÿù?ûî¼ïÍÎtæ¬5ûÖôæ¹UoªëðqgúË|rzU‡A5¦ëTsƒÏªnÍÇûç‹jwW¦UÍÑ<¶f÷¤†£!*y"<–Þ3Dà‰ê@¼àȓơ©ŠD,#DQÄc!C<– S 1¹©úŸ`}½EØ fðŠQæjÙÀM5ÏA°˜øcÁ²¦Ç.%ó‚Í€€ %‚Æ ç œ9æd’QÿÅœrè™’t‘pI#xÙï$u_"E`—-5KˆfXÊz‘ qv, /&Áy¹6:)z…‹©veÒuFµA¹EøÅ”àVxXVˆ;Õ³]äß‘^KFƒùa9 ÔjcªG²ëÜY•ëAEJ˜¨ëAÝ«D© endstream endobj 553 0 obj << /Length 312 /Filter /FlateDecode >> stream xÚ’±JÄ@E_H10Íüy? ÙÙ(uSZY,Vji¡hý´|J>!eŠa®ïÍàÅsàN2sß½Y×'MÃ+®ù¸âuÅÍ)?VöÅÖµˆ+nÎÒÎóÝt¶¼ãº¶å•ȶì®ùíõýÉ–›› ®l¹å]Å«{Ûm™È`Oòô˜eÍ€@ªAÕ"dek¦v"ÂDÅLª8O92!~l@Ncï@ŠzÐÐ.1öaiÂŒßáÿðBÿÚ v?Qàƒàt>—p„ C 4‚s9¿ŸH]¶>Ÿ0BÁ/@ IL}~¦-&¾ÃÇ\²^+—™˜îèävq°€ÑÈpÚƒ Ä:ŠTNëµ&­ÐøXaž*ÌE——3ìµq}µˆNd”!ýÑ«ÌId/;{k?žnf endstream endobj 557 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚ1 Â@E°L¡70sÝì ’@°ˆÜBÐÊB„€ZZ( 9ZŽ’#XZ:IV›t«þ 3ïOÌØÄrÄ#²‰xjø¨éBºN%7nt8SjImYǤ–’“²+¾]ï'RézΚTÆ;ÍážlÆ@TðJô ø@ ðhxÁ«jze/¨ š]aöåÙáýÝ;¿íÇÎAdDÉ/ak+ÚÎ?i¶¥”T“‚RSÊ"§…¥ }G«@ endstream endobj 558 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚ1 Â@E¿¤L/ :ÐÍ®A"ˆEŒà‚Vb¥–‚Š‚…EŽ–£äÁÍ$±ÐNxÕÌgæý¡˜1‡qß„l">hº.§!Ǧ^íO”XRÖcR 7'e—|»Þ¤’ÕŒ5©”·šÃÙ”s Î@ t€h~//i¹ÝKxO`L®Ð“tIVãçßxÅ?üÞù¼¨>ö‡©(=C±uÚ•¿/ñ@ªÅRÓr•iniMoEËBs endstream endobj 559 0 obj << /Length 130 /Filter /FlateDecode >> stream xÚ-ɱ Â0…á gð 2œ'0¹-¥™k3:9ˆ TGAEçæÑòfÚ¢|Ûÿ—ÕÒ7ôlXUÔÀ:ð¢x@='eý;ý m„;P=ÜfÌpqË×ó}…kw+*\Ç£ÒŸ;Zä“Fy2d›åÏd“L*R!s™ÉB¬¹ËY°ŽØã ,P#Œ endstream endobj 560 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ-É1 Â@EÑ?^á ¦xЙ‰‰mŒà‚V"ÑRPÑ:³´Ù™&Nwo¾\ø’ž%红V\ó¦xA=y1žö:À¨n×w¸°ççý½ÃÕ‡ ®áYé/ ­tò‹½4è’M22ÉD³˜ÉT&2+•<å*ØñBÛ#´ endstream endobj 561 0 obj << /Length 94 /Filter /FlateDecode >> stream xÚ32Ö30W0PaCsK…C®B.K Ïȉ&çr9yré‡+Xré{€O_…’¢ÒT.}§gC.}…hCƒX.O†z†ÿ 0XÏ ÃÀåêÉÈ[\w endstream endobj 562 0 obj << /Length 94 /Filter /FlateDecode >> stream xÚMÉ=@PEáþ®â®À¼™x¨ý$^!¡Rˆ ¥‚°{ äTß±4J2:*5¡Å4嬨`ö¢£ÿÆ´"žfšû¹@ò¶ BJJ7"”¼ï몀Ði ‹ endstream endobj 563 0 obj << /Length 172 /Filter /FlateDecode >> stream xÚ31Ó34V0P0bSK…C®B.# ßÄI$çr9yré‡+˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]ø0Aý? Áøƒ½ýãù† ö@CÿùA2þ€’@5@’±D‚!™dþÀðPI¸ùÌCdþÃÀþƒ¡þÿƒÿÿ “\®ž\\^åˆÓ endstream endobj 564 0 obj << /Length 175 /Filter /FlateDecode >> stream xÚ3±Ð31Q0P0bScSK…C®B.SßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.Oþ êÿ³ÿg``üÁ~¿ùûÆÿüäØÿÉ?`°gàÿ¤êàÔ õN}`o`üÁÀþ¤›™ÚÔøFÑ¢¢˜ÿ0°ÿÿƒÿÿ? Q\®ž\\à  endstream endobj 565 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚåѱŠÂ@à?¤X˜f!ó·FHÄJð"˜BÐÊâ¸J--îÐÖ|1}_aaËÁu=ÎÒÎe¿Ùýg›Mû]îp,+íqÒçeL?”&Òwš¶¹X¬i˜“™sšË)™|›ßíŠÌpúÉ1™Œ¿$ùMyÆ€vˆ¤Š3|-{Pé½ÓeƒÓ!,¨„GpPghÁºFdPCWTíÓ-”k¦¡Cˆðj( ­g¸f"{¿!ªý—Â[ïÞ—ÿA£œftàùËC endstream endobj 566 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚmÐÁj1à é^=;OÐd-‘õ$¨…îAhO=”‚ÐöX¨ÒÞ„Í£í£ø{ô°˜N"¸Q6>fB&?™Nî'izàmf4Õô™ãáZûÒ||ã¢DõJÆ zâ.ªrM¿»¿/T‹ç%å¨Vô–“~ÇrEP@X×ìû8õ \²²IU{ó˜»ùÁ3ÌbÆYã¥1Ezôè$æ'i=SË©†LÂB„p6Pu Ž–8ç:R†£ ²Ž÷›[4ß9Þ²áéí…ÃŽ&ÎÈ&üZÚú'­ãXήÁÇ_ð%°m¼ endstream endobj 567 0 obj << /Length 260 /Filter /FlateDecode >> stream xڭѱJÄ@à? LaZ áæ4‰Üª[-œ'˜BÐÊB¬ÔRPÑÖÌ›ø*¾‰yË+Äuv²g!–Bà#“ÍÌî¿ÎïúnÙñÎ;ÇÎóMG4÷Zly¿›¾\ßÑ¢§æ‚çžš-SÓŸòÓãó-5‹³#Ö÷%_vÜ^Q¿d ˆRPDZT†¸R´öR ÊOÔµ þ@ù*˜(ÞAWEÁ],øR‚º˜IµRê5ú7P­Ñ&?”2oÆ(~#FLØàgÈü5=dF#ïzv¢L;mf–Ä&,—mXJ[°Ìa Þ#å }Rº:%e-vÁvS½•Ô=U:î霾šes– endstream endobj 568 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ33Ö31V0PaS Ss…C®B.S ßÄI$çr9yré‡+˜špé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÁõBýc``üßD@.ƒý0ÅÿL1ÿSŒÀÃ?UBÙ7@¨`JJ=SüPêŠýê (<ö¡9ÅñP¯@=ómrüC%h˜ACž  !@ y`> stream xÚuб Â0Ð  ·ô¼/0­ µ‚Dª£ƒ¢³ý4?Å/iLsqˆð’»INÍÆª œ&vª)©9 ¼¢‹åý¶O4¬4Ê©åÊFQê5Ýo3Êj³ ­ioK¨k2ýè D˜ÒÀ€§dFLƤ1’(­C8^Qˆ€„ÉÆDð¹ïɰ|pÃ1ÆÛ½Ó.þ"bøÿyÒ€Œ)™gëºk¸×¿àRã?UŸ’~ endstream endobj 570 0 obj << /Length 166 /Filter /FlateDecode >> stream xÚ35Ñ3R0P0bSCSs…C®B.s ßÄI$çr9yré‡+˜˜sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒÀd’ñƒü†ÿ Œ`’ᘬ“6`R‰äÁAòI68ÉØ€L2`%™‘Hv0)"ÿÿG'!âP5Ⱥ‰ A€J$ãÿ `G@%¹\=¹¹Mÿx× endstream endobj 571 0 obj << /Length 254 /Filter /FlateDecode >> stream xڭѱJÄ@à?l˜&yM"&`µpž` A+ ±:--­7`ákMgé+ä ¼òŠãÖÙÍ& XšæKf’Íì¿]{Üt\ó)p×p{Æ =SŠu¨ÄÎæ‰V=U·ÜvT]j™ªþŠ__Þ©Z]Ÿ³>¯ù®áúžú5ð(ü6S¬ßü`À쑊-Ì— oÕ¶¸áÖë¥d‡ˆ¾¯ I¾Sòý03a‘™LlB".€¿Ñ!1ÍúOx½&ÂpcÄJÂ&ÆHù‹¸£…¸Û…˜„rI)¥ÌÜ” _ò,v0Ÿšõù{lØtéT–‰é¢§úî”Û endstream endobj 572 0 obj << /Length 125 /Filter /FlateDecode >> stream xÚ33Ò3²P0P0bSKSs…C®B.SS ßÄI$çr9yré‡+˜šré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿÏøÿÿ?TŠñó bü78) À¤¯s‘)hèb y.WO®@.!»¥7 endstream endobj 573 0 obj << /Length 106 /Filter /FlateDecode >> stream xÚ3²Ô³´T0P0aKSs…C®B.#3 ßÄI$çr9yré‡+™qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿ†€ˆ¡¾aècWüÅåêÉÈ3v\‚ endstream endobj 574 0 obj << /Length 239 /Filter /FlateDecode >> stream xÚ­‘±‚0†Ï8˜ÜÂ#ô^@D'ÔDŒ“::htGáxWÚœmš~éÝßöú_LÂyÒxJsNgoô(ò»ÌéŠIŠîžÂÝ5‡ÑM7ô¸?/è&Ûñ~IŸ¼#¦K¶ Cµ¥ Ô¼*x1F%¨À)dBœÃè ñ‘Š…¬ªA«ÑŸ8çEÅjGîU…Ò(ßNk¼ûÈ4ª,— ~ÐjÔ…}Á<ÛC¿2[|Žþfa?­-ÈÖžÆ3ë ñ“­oŒ×œÈ¾}°]Ñ=ÂUŠ;ü”K‰É endstream endobj 575 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ35Ó35T0P0bS#Ss…C®B.K ßÄI$çr9yré‡+˜Xré{E¹ô=}JŠJS¹ôœ ¹ô]¢ÆÄryº(ü‚ ê„úÏÀÀø¿,ÊÀ ÿLñSÌ? Ô0Åø™adªT Y;ªÑPû ¶CÝuP7ÈÙÿÀÔˆ ƒ™….ĵ˜—«'W ŽK€¿ endstream endobj 576 0 obj << /Length 221 /Filter /FlateDecode >> stream xڕѽ Â0ð–‚ì#x/ i*Uœ ~€ÄIí£ù(}„ŽJãÙK Í"&…äHrÿt¢F*ÄÇ8 q¢0šâYÁ È€f4ãÊé óäžê ×´ 2Ùàãþ¼€œo¨@.ñ 08B²D­uåÐ uf,HW§‚ ô¥lüfëç¬(ºz¥eõ§Ö~ûüæÞ¦Øô§¹_Qš@™ñÍëõ6Ò+L®6ŸñeålóZ¹šÿ«›v,X¿ÕKéP~ï‡ÞEÔºe¯Ö©úN=â’¹«vð™<›Â endstream endobj 577 0 obj << /Length 256 /Filter /FlateDecode >> stream xÚUϱNÄ0 à¿Ê)K¡~h{=îÄB¤ãè€Ó ˆ @°!ZÞ̉èF%Psw ²|Jì8¶ç‹Ãª¦’æt0£ùŒŽŽé®r®^j°¤EµËÜ>¸U㊠ÕKWœkØÍ=?½Ü»buyJz_ÓuEåkÖ?€ÆŒ!òÎf°l#>Ù3ZÎ;@Î'€ç7Àîx ïÉ&Œ&È–Nm9ƒR0—!¡G/aEïFD+E$½ÑŒµ²MX‰¿„^É>a‡-úÆü‘Mˆÿèû=¦×:upÇ´–¤-µiÞ}õèGŒˆA§Š^{s¦ywÖ¸+÷=Ÿ†# endstream endobj 578 0 obj << /Length 150 /Filter /FlateDecode >> stream xÚ3µÔ³4W0P0bSsJ1ä*ä2ñÁ" Fr.—“'—~¸‚©1—¾P”KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEÁþ?<@£0ÿg`ÇÀøùA ˆbüP¢>€©T*L`¥€)‹`J+ŦF Åþ¿Hʃ‚ârõä äWÎr° endstream endobj 579 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚåÐ= Â@àÑÖBÈ\@7‰¬ÆJðL!he!Vj)¨h«9šGÉ,SˆëlÅ3X,ßòf˜âu¢VsÀmnFlzlº¼ é@ÆH¸¤˜¬w4HH/ØÒ‰I'S>Ï[ÒƒÙCÒ#^†¬(±µÊ>ñl \3X~ZPCAù©J'BEH?4€þ—ºôuâ7{©-'¿ROrï%ËxºVÝ™‹Ã·¹CÙ ï qBszØxaº endstream endobj 580 0 obj << /Length 240 /Filter /FlateDecode >> stream xÚmÐ1jÃ0Æñg1> stream xÚuÑ1KÄ0àW „ãºv8ÈûÚôÎb ç vtrá@ÿ…?'â)ΤC¹ø’£âMHøH^ÂK^Yì/Pá÷æX.°8ÄÛ\<ˆR¡ëÅÑvçæ^,k‘]b©DvJË"«ÏðéñùNdËócÌE¶Â«Õµ¨WhíÀ­í"kÿ·ä@öŒæ¤àmDâ$f~¤#; Hl ¿¥½8@£ÁŠwdFUšì¨%[pù¤^q(é`J7)¯Iˆ’›ÑMk¯T¢äRÙñRI JN%}¤½Ö<=“Dt2l¥IÜ©yÑÑ&ôFš:Uï; ôAš9ÉOŠ} ô5*¡¿­ºÿÄÿ‰°­ ÄœŒE'"'íEÑ<´¾¦®_g'µ¸ßÑÆ©Ñ endstream endobj 582 0 obj << /Length 204 /Filter /FlateDecode >> stream xÚmÌ; Â@à . ´Vf. ›´1àL!he!Vji¡(X›£å({„”Á8ë£—åø‡ùÝéÅQ—Úš’˜º}Úi<"ÏÈŃ÷f{ÀQ†jÅ{T3ŽQes:Ÿ.{T£Å˜4ª ­5EÌ&¡€º6äü¥…°%/_x÷/PAP02gøýÁ0Ò¦–yp&îî¬dBw›:Œ+0ðÁüâ}¨AT¾yóMÞ6Ó¢5lö–¢.Ë5²Ài†K|¤øT£ endstream endobj 583 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚ31Ó34V0P0RÐ5T01V0µPH1ä*ä21PASKˆLr.—“'—~¸‚‰—¾P˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEùÃT‚D0S$ê00|`ÇÀü¹A¾ù;ÿæ ì˜ÿå˜00þ* àÄ?8Q"êI&êPMÊøbÛ½`Ëßœq ä ã ò Ìê˜þÿ:]þ—«'W ÈckA endstream endobj 584 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚÎA ‚`à'?( ‘œ ”ýüºÌ A­ZD«jXÔ.Ì£yàÒ…Tcu€ßæ 7f: 5ÙðP³™° ø éL¦ %¿—ý‰â”ü MþBbòÓ%_/·#ùñjÆ’&¼•ÎŽÒ„¡ZÀ{ÈUe5ÈTÆ©¬Ö-Õ‡W¨6êÀj@-ÐÉÅóOù¯Ó‰;*`{ú^‰ž[bàTd7“ý w§”§ÍSZÓ»= endstream endobj 585 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚ31Ó34V0P0VÐ5T01Q0µPH1ä*ä21PASKˆLr.—“'—~¸‚‰—¾P˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEÿó‚ÁþT‚zó !ÿHÔ±÷`øÁøþó†ú쀶¤ „|P±=˜i«‡u âÉDª)öph‘<„ÚkrF=ÈAï?0þ`<ÿŸ¡†½ÿ?ƒü?þÿ ì@‡s¹zrroXhI endstream endobj 586 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚ]Î1 Â@Ð\˜B/ 8ÐM²(ÚЦ´²+µT´“èÑr”!åbI qáÁ23ü;èö9änÀ¶ÏvÈû€ÎdC)úlGUgw¤IBfÍ6$3—2™dÁ×Ëí@f²œr@&æm)‰Ú¸·2Ï©\^¡sϵ2¸Î÷¯HÅøQ‰RñþQÖOþø—Ö5ÉQÑJrµìhè M£íÂá„TårL¼@³„Vô½£@ endstream endobj 587 0 obj << /Length 141 /Filter /FlateDecode >> stream xÚ32Õ36W0P0bcSK…C®B.# ÌI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]ê˜ÿ70ð|À ßþ€ÁžÿCÿ`ÆÌ00ŠÿÿÿÇäè§3ÿa`¨ÿÿ޹\=¹¹¢&[ endstream endobj 588 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚ¿J1Æ¿00…ñ v^@³9ïäŠÃ…ó·´²+µT´[¸}´> stream xÚ31Ó34V0P0bS …C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. Ì€à?É&™iN‚ìaþ`ÿD~°’È700nà?ÀÀüDþ“ØÀÈä‡$Ù€‚ëÿÿƒÿÿ7 “\®ž\\y endstream endobj 590 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ32Ö30W0P0aCS3…C®B.C ßÄI$çr9yré‡+Zpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜ø0È@A@ 8~Àüá? ±q©ŽØ0üÿ‚¸\=¹¹(CE` endstream endobj 591 0 obj << /Length 150 /Filter /FlateDecode >> stream xÚ32Õ36W0PÐ5QÐ54W0´P05SH1ä*ä22 (˜Ãä’s¹œ<¹ôÃŒ ¹ô=€\úž¾ %E¥©\úNÎ @Q…h ®X.OÆ ìø   P?`üÁð†Ø€¸ôE6Œ?êügüðŸ‚üc?PÃ~À†Ÿÿó.WO®@.ÿ§Wõ endstream endobj 592 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚµÍ1 Â@Еir3'p.#˜BÐÊB¬ÔRPQ°ÍÑr±0EÈ:? êdÙ³3ó7èuÂ.{Œô¸òʧãH‰ÆrCqJzÆGz$¯¤Ó1öÇ5éx2`ŸtÂsŸ½¥ […RÊüâë?´LõºæÝ3Ø‚ærÁÊkm‚¨„;xÔÂ3êH†Kv¤Ø@%¯â.êýoÔ nn—**ŒÉù@Ô¦ôDr endstream endobj 593 0 obj << /Length 108 /Filter /FlateDecode >> stream xÚ32Ö30W0P0aCS …C®B.C ßÄI$çr9yré‡+Zpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜?0ü‡!þ ̃±ÿ`øÿÿq¹zrrÆ‚Q. endstream endobj 594 0 obj << /Length 177 /Filter /FlateDecode >> stream xÚ3³Ô3R0Pa3scs…C®B.3 ßÄI$çr9yré‡+˜™pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜?ð`Àðÿƒý†ú@úƒ=ãƒ:†ÿÈ77Ø3ðnà?Î ßÀüÿˆþÇÀDÿa`ÿÁÀNÿ``ÿ€þÀÀþ`Ð O€âÿÿƒÿÿ7ÿÿNs¹zrr#߈ endstream endobj 595 0 obj << /Length 147 /Filter /FlateDecode >> stream xÚ31Ó34V0P0bcs…C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. Ìø?00üÿ`ÿD~°’È70ðnà?ÀÀüDþ“ØÀÈä‡$Ù0½ñÿÿÁÿÿI.WO®@.‡e% endstream endobj 596 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚŽ1‚@E¿¡ ™†#0Ðeƒ6 &na¢•…±RK v9Gá”Tâd)H¬ÌN^fþîþù‘žÌ¦ð”Çš£€Ã9Ÿ5Ý(ŒE”qÑßœ®”R{cRk‘I™ ?îÏ ©l»dM*çƒæàH&g8^W‰S­œQƒdHàVðá•R¾ ò!J*¨- Ài~ nNû/†ooñkg»Íîõ$AéÖHåŠ> éáwlzZÚÑIKÚ endstream endobj 597 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚα Â@ àH†B¡y½ž­uj;:9ˆ“::(ºÚ>Z¥p"ØŠç]qÐQ |CB’?Šû2ä€Ü“1G!‡#ÞI:R°«aøm”d$V$f¶O"›óùtÙ“H–$R^K6”¥ŒÊ¯À¨\ƒ¹UW0÷Â/¼º%>Á«°T¨5*è´4hy~“ÿÌ÷ö²¥ý¦Ýß> stream xÚ36Ò35R0PacCcs…C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ØÈ3üPàÿÃÇþ?nÿÀÿœýó3 ~Äo˜0ÿah`þÁÀ€‚?P³Íüÿÿs¹zrrjÙF„ endstream endobj 599 0 obj << /Length 195 /Filter /FlateDecode >> stream xÚ=αJÄ@à¶X˜fßÀÌ x{›`TñSwÕ‡•Z * Wî£í£ÄÊ6`“"8Î%GŠ™ùÿfŠ|q~ÆK.ø4p¡ó‚½R^j¨çåÔ<> stream xÚ36Ò3²T0P0TÐ5T0²P05TH1ä*ä22 (˜Ad’s¹œ<¹ôÌ̸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž.  Ø W á Œ@Ì Äì@,ÿÿ?Ã(f„ÊQ „þ0‚pC sC3ƒ=;ÿ?°f.WO®@.uH– endstream endobj 601 0 obj << /Length 153 /Filter /FlateDecode >> stream xÚ31Ó34V0P0RÐ5T01Q06WH1ä*ä21 ([@d’s¹œ<¹ôÃL ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.Oæ ìþ`üJò`À‘p’ƒºBþ`°ÀÀðƒ¡üÆçÿì™Iùÿí@’ùÐ.WO®@.1c endstream endobj 602 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚU̱ ‚PÆñ#‘k[çêªWJ'Á rjjˆ ¨Æ†¢¶ˆûh>Š`›Ph—º—jù ÿ¾@ BŸ\ò©ïQà“ÒÎÃ#ŠHE—Äè³l˜dÈ—$"äS•‘g3:Ÿ.{äÉ|Lò”V¹kÌRj×_œ œÒ.Á.X ,g0i)à <¡¥©¡pƒ¶&†®A†=éjœ|c(v‘kØ]þb=ÀÐ(Ô¿áúO¨ÁI† |F£?ê endstream endobj 603 0 obj << /Length 233 /Filter /FlateDecode >> stream xÚUÎ=KÃPÅñs Xx³v(æùzËíËb ­`A' ÖQ|A7©‘|±€Ð~Lïx‡`¼7UÓN?8gù«áá°Ï!ñAÄjÀÝÏ"z$¥ìr·¿~nîh”¼d¥HžÚ™drÆÏO/·$GçcŽHNø*âðš’ WUPñ÷6¾Aß´4æðŠ5¹§q ‘þ" bxØ%âtÇq¿Á_ù®cùGˆÅ²h;²š÷L€ Ëtè5Â<þfúOk…2·|âµÁ+ñ–ZlECÝdÑ ±ï(°ç˜ÂÑIBô¥Y_™ endstream endobj 604 0 obj << /Length 210 /Filter /FlateDecode >> stream xÚMν Â@ ð)(¡«ƒÐ> stream xÚUÎÁjÂ@àYi® Î èn²Zõ$¨sÚSE¨GÁ½‰æÑöQ|„x ‰³²Iéå;üÃüü=ÝF¤(¢N8 ^DúÖ!þ qª¨¯ÝiµÅIŒò‹ôåœs”ñ‚ö¿‡ ÊÉÇ”B”3úI-1žQY¦ãâàAægà//7ˆœŽ4gËZŽvª*Ì 0‰Ã¿˜Š+ã]S‡¸CEÉ@QsüϰFÕì,IqSn/¼'¶’gCþbŸ^m‘mjg`ç1øã'>ÚŸKø endstream endobj 606 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚ%Î1 Â@„á‘@„‡$|'0‰+AA¢‚)­,D¨¥ ¢æQ<‚eŠ`œÅ_ìì·°&î# µÇL_M¬‡H.bìÚ£½ØŸ$I%ب‰$Xp• ]êíz?J¬¦Êu¦[>ÙI:ÓIU•uO§Ã)Fh~ðß!;£ó:còÌÛዬQÖ‘‚ôŸÿ)HÿåpIëH]R·YÀ#õH[¤mé(œ²âl2Oe-?uàC endstream endobj 607 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚµ1 Â@EH!L“#d. ›ÍºˆBŒ` A+ ±RK EÁBb޶GÉR¦R×l´6¯˜˜ÿþPtÌ+îǬƬ5$Ii;ŒXÜf¢$#±a¥I,ì˜D¶äëåv$‘¬f,I¤¼•í(K~ |[äj¿„W¢‚opGÏà ÀÄ!´—S‹¢E¦ /‹òèzù´ÌO¾6x+Ó¸YÛ~åÕÎÜuдñí…æ­éÂÕ`ú endstream endobj 608 0 obj << /Length 121 /Filter /FlateDecode >> stream xÚ31Ô35R0P0bc3SS…C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]0001;Ëñÿ ÿaX*6T°ý†úÿÿ?À0—«'W ¾NÚ endstream endobj 609 0 obj << /Length 228 /Filter /FlateDecode >> stream xÚmαJÄ@ÆñoÙ"0M^ป'p÷WóSZYˆ ¨¥ ¢`eòh>JáÊ+ŽŒóé5‚E~°;ÿY²¬šc­té_^iÓèC-/’³Ÿ+9¸’u'éZs–tî·’º }{}”´¾<ÕZÒFoj­n¥Û(Ê-€~‚Ù€8¶#J^ÎQì0CÜc…0áùîÈDÌ_úŸžÓÁïø:ßsöNüaçü™r$_΂[-> ³À,°ˆ, %‡s„'äƒlÏ"³ÈÌñ¥™aAZÒ›M°¿ÈY'Wò TŸc| endstream endobj 610 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚuÐ1NÄ0ЉRXšß`3', ZiY$R AE¨€ ´ØGóQr„”[¬0¼„‰"OÊŒóÇ“ãîÈ/¥•^—ÒŸ‰÷òØñ+÷ÅVüɾóðÌëÝ­ôžÝ%Êì†+yûxb·¾>—ŽÝFî:iïyØ™-­2È9QµµÕ EëPõE6‚f¤LÍôV»&‘ÆàðÌÔb&e6‚€§Ñf“õÕŽó‘òY (yâ/ifU ý°Å_ cBüÔ¨M>Õ‹ý‚¸Ÿ™°y¥ÿ€‚޵¸2_ |ÃßÇ›jh endstream endobj 611 0 obj << /Length 188 /Filter /FlateDecode >> stream xڕν Â@ ð+ At-(˜'ð®¶µkotr¡P?ÁQðÅ_ÄÇè èý‹­³ù‘äIàõÃ+FŠÃ!¯=Ú“™º,ñ‘o)Ñ$ìG$'¦KROùt8oH&³{$S^z¬V¤SBĢ⊠ØÀ©iƒèA«äf°1ë€h‚.p;»Áö`¯Z  \2ðoóŠß›ÿÂy™³54Ö4§òý`ö endstream endobj 612 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚ•Ï¿jAðïnaÜ ˆÎ ˜½s=b!j W¦J!‚`R ìnÍG¹G°´8ÜÌœEH:›_1;ödÏyŸSp¯ÏnÈyΟíÉ9)¦œ¿Ü_6[šd?Ø9²oR&[Ìùð}ü";YL9#;ãeÆéŠŠÇÀŒÇæÒºÂ„ÐpQ*Å+j .+xsº7á”xÄ•‘Íç–Üð‘\ƒ }µrÓþ† ”¿ø´•R þ/:tK­¬uéîNTc¨'Û¼‰Ä'ò¡jìiT”2ƒ®D¥×‚Þé+XÑ endstream endobj 613 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚm½JÄ@…OØ"p›¼ÁÎ}d³ƒÚXW0… •… j)¨hëäÑò(ó)S„ÏD…m>†{çüÜuuìVZj­G+­ÏÔ9}ªäMjÇa©îägóø"›VìÖNìÇbÛkýxÿ|»¹¹ÐJìVï+-¤Ý*Ðô@ P„sŽºø‚&¾³¾[ D>#E@ƒ¢Ç†r˜Iõ~2û> stream xڕα Â@ àHÁB}Ѽ€Þ]õ¤“…ª`A'uª(¸ÙGóQî|ƒšTZèàà‘û†?$w#3°i²ÔhdÈŽéhð‚CË!Çá·s8cœ ÚÐТZpŒ*YÒíz?¡ŠWS2¨f´5¤w˜ÌHŸP˜Qžç®ÎëY’ 4aÐ:B@à ¸Ç8 ‚—1¾ìn -¡SQ¼üRá-8­ð d“_Ñ®Ó+ÈJ¢_<ÿ!’¯tùâ<Á5~lúQ- endstream endobj 615 0 obj << /Length 265 /Filter /FlateDecode >> stream xÚMÁJÃ@Eo˜ÅÀ[8мÐ$A„ÒB­`B]¹WêÒ…¢ÐEÁù´ù” ;#Ç›*ÖÍyóî{wæÎquÔLµÔZ§ZŸjÓè}%OR7KmN~&w²l¥¸Öº‘₲í¥¾<¿>H±\Ÿi%ÅJo*-o¥])L OÄ[ À`;d1ëa¶°3X`LpÀM6{ä{xÖSÏœ˜°Hpžî|tO¥0£1l¹6Ì ùi4ÈþÓ,ìÀe3zŸÓáw™gRÒô¦SÅß@v伕+ùÿcå endstream endobj 616 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚuÏ1NÄ0бRDšÆ@ò\œlÖBT––E"Tˆ ¶¤AKr®â›ì!eŠ3³ ˆšgiÿ_×'aE5t¼¢æŒB ÇŸ± 2¬(œÎ_žpÓ¢¿¥& ¿”1úöŠ^_Þvè7×çT£ßÒ]MÕ=¶[‚b—….'0SÉ2*(ÙŒ`&p ÞÁõBì!Ît ç¼àÒð_èÝ_èR¥c§Ø™%Éž 6{6Cñ!I¬cˆ“Ä)A×ô?€Ö«ÌÁ“ôXZ1IÁØËN+éOVë”ùÀäqY‰-Þàú m9 endstream endobj 620 0 obj << /Length 95 /Filter /FlateDecode >> stream xÚ32×3°P0PaCKC…C®B. ‚†‰ä\.'O.ýp ŸKßLzú*”•¦ré;8+ré»(D*Äryº(È1Ô7Ô7ü? ¶—«'W Ë endstream endobj 621 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚÕѱ Â0à_:nÉ#xO`RÅêd@+ØAÐÉAœÔÑAÑÕöÑú(}„ŒŠñjÁ]ñÂñArán÷Æc6Ü—Œ<2|ˆèL±áæŒÚ‡ý‰¦)é džôBnI§K¾^nGÒÓÕŒ#Ò o#6;Jà‹N-(_)/Ú|bƒ¨ÞÃAU+‡ÐÁV]U"sb·hµ9²RÌð¦I+[9hJñmý+܇¿úÏ¿Øiö&cÊ|­¼/?¤yJkzo´º„ endstream endobj 622 0 obj << /Length 257 /Filter /FlateDecode >> stream xÚuбjÃ0à‚Ž€Ödò=A-pèHR¨‡B;u(…@›1–²9æGñ#dô`ìžd •|' óŸ–‹;}Oš¼–üåô™ã÷¶5\—˜½RQ`öÈ»˜•Oôó}Úc¶~Þ÷[zËI¿c¹%àªa,ÑD!¯Q$mª‹bÞG¡‡Çá2bW…h*—¾^õjL/.i éÕA˜€j’S]3}`ðqdØô;€ÊÇç¸<ƒÆz¼ì<ÊÃÄ uH> stream xÚÅ’±jÃ0†OxÜ¢Gн@k»g«!M¡ íÔ¡mÇ-íì@^Ì[^Ã[WŒÕÓI –õq’î¤ûÿUu¹¤‚–tqE+þ z+ñ«Šƒ…‹ÈÊë®ÌŸ¨ª0¿ã0æÍ=}ý¼c¾~¸¡ó =—T¼`³!ÐÀ–g°¶ƒžçÌÚA@jTê®,÷ ÙÈãÀ°8¨_=¸eãöµ½âC»¶®ŠîAMF‹^ò ¸|œ:I *©@=‡N` í¿À÷Ú ”åž»kÌÛ6„Öñ9&>0s‚!€žof ¾á&j‘‚—ɤ¤”bu”» g€ŒÏ«C0I¶µòF‚)ZëÍæ¥ûàmƒøê*­ü endstream endobj 624 0 obj << /Length 152 /Filter /FlateDecode >> stream xÚ33г4R0P0bSs3 …C®B.S˜ˆ ’HÎåròäÒW05âÒ÷Šré{ú*”•¦ré;8+ré»(D*Äryº(üÿÿÿ*ÅøÿÔ€P £ˆ2ÀC@¨ÂÔ,ãdŠB±£PüÊBÕƒ)Æÿ€ˆAþÃ0@£¸\=¹¹õR€£ endstream endobj 625 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚuϱJAà¹ba ï ¼yÝÙhº…Á+­RˆPK E;1 ¾Øt¾Æ½±»âp½‹ S|Å?;?¬ŸÏxžjösö3¾­éüTCÆÍÍ=-r+öSrg“kÎùéñùŽÜââ„krK¾ªyrMÍ’a{è„Õ®lBŠ-`a:`Ðu)xªu‹w­äG½W‹˜ÕùÇ2©&e˯œɦá¶ÏÚnh›‡Î ÙÍhüuð‡aǨ‡k}ÿ¡ Þ[ bÔªµoŸb»ý"E“z“†O¾€Nº¤oÉŒla endstream endobj 626 0 obj << /Length 110 /Filter /FlateDecode >> stream xÚ32×3°P0P0b#S3K…C®B.#C ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ŒþÃûæ? ŒC 1ÿcøÿÿq¹zrrp^Ú endstream endobj 627 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚ= Â@…GR¦É2ÐMtý©bSZYˆ•ZZ(Ú‰ÉÑr2EH|›((vÂðí̛ݷ«Ga_<éIÛ=Ý—½Ï'Ö]ˆžQêÎîÈAÄj-ºËj™U´Ëùz`,§â³ eã‹·å(¢8!"«Ê@'-À1¹à4r²Sjed=L A Ñ‹]l»ÓŒßÄñ V0ùee˜þǯÛ̬äsnãÄ…«òíž ²Áœ¬Ì”/óÍKÝ´í*ëßàYÄ+~PûZ> endstream endobj 628 0 obj << /Length 248 /Filter /FlateDecode >> stream xÚeпJÄ@ðo \`^›B¼yÝÍ] ç ¦´²á@-íÄÛG²´Ì£äR^w¢ùÃÙüŠ™]¾™9ŽŽâ„ Oùpj8>åxƽPS5œÌþZ÷O´LIßpœ¾puÒé%¿½¾?’^^qDzÅ·›;JW\×…ªË¡~ lr¯&V‰÷g¸î¾{„'À´N2¬;säÀ8GÖêÊvn=§·õЪÊQoåb]pл ~‹‹¯^¶ã8ëõí®Ø:úg00ìœ7~Êžî¿®JT¥Ä٠Ͼüœ4s”M^!ÒyJ×ô[ÍX' endstream endobj 632 0 obj << /Length 201 /Filter /FlateDecode >> stream xÚíÓ± Â@ Д Yú ÍØµu+Ô Þ èä Nêè èÜ~ZÁé'tìPŒ×»ÒA¤{ÁÀÁKB†À%šMsòiª^äSàtð†a¨ &o[§+&½=…!zë¶ŒžÜÐãþ¼ —l—¤ò”ùG”)Џ‚ù¥á2³FV ë  a×`i8˜–[vˆ‹YÞÁ Ö z\4¦ vúNj¼`ƒõ‚ü†[·_=7Ç%¸€˜¹QÆÅp%q‡Sd• endstream endobj 633 0 obj << /Length 398 /Filter /FlateDecode >> stream xÚÕ”½NÃ0Ç/òÉyÔø  m¥ K¥Hd@*bFHÝ’Gó£ä2vˆjîü•Eb&Cô‹íÜÿö×ËË«¥ÈÅR\”b‹"ÏÅkÁ?øªÄQú.íÜË;ßV<{«’gw4γê^|}~¿ñl»¿Ïvâ©ù3¯vèѾQ¢5@d°ÖºµÈ´ÖG`ÊÌ·ìdQö¸bB\‰"dºÁW› Æ'œ‰º1é)àP’l$bÝ.µ¯DƦ9†hbY´±p‚ôÖ>bP:Ä`VE•S˜`ªœØåt¡³€ÖÆèÜL©t„Ç9”3)ï|Šõ bvóØÔÿ GÖÿNs@9ƒÑdSLç±8:›pÜ ¥1¸ eÃPQJn„gCÊ‹Áû9„RÞ@(ðƒo!ƒÞD¾E¢¼œiM«aZÓj$MØŸÔ|›h×f•‰ÖÛöj¨cÕ[ÔèÒæBíï’¥KÁï^~ïñiÂéûü¶âü+8éj endstream endobj 634 0 obj << /Length 313 /Filter /FlateDecode >> stream xÚÅÔ±NÃ0Ы×ÎÒ×@êÊÁ0·Ì=ÌãS,,D¿ uÇê‡Í+u|mÇêŠï‹ÛOö³ëîDîOæE;Y—ðЊÙDê3i S%wÎû3cH˜€ ;›<$érò”¯Ùét ?F7êðºÂ{ü‡ñ,\ endstream endobj 635 0 obj << /Length 293 /Filter /FlateDecode >> stream xÚåÓ»JÄ@à¶8MÞÀœÐÌÀÞ„°ë ¦´²­VK E[7e°°ô $2EÈ8gfö‚A´³0ðÍ%sù'™ ¦Ç$iH‡Š&’””t£ðÇ#[ËeåÛVw8Ï1½¢ñÓ3®Ç4?§Ç‡§[Lç'dË ºV$—˜/%¸K˜ó DÀºý¿ásÐ¥0­GbŒÇڷ鲸f¼V Æ[÷ÖïöÑ1>8Q†«.ìÝ„y4¿šT1£bÔ<¢[σ¶‡. êÃ| Ø¡ø ü¼Âº¯;í‡ Úý \tõ~˜Ûœ9ù„“ÙAƧÇrà×:ösÂLn˜ÙÿÊrÕnÈà™7ÃІûÂbÓ„/ǵàiŽ—ø »ÆËH endstream endobj 636 0 obj << /Length 290 /Filter /FlateDecode >> stream xÚåѽJÄ@ðYR¦É˜yM̲pž` A+ ±º³´P´”äÞ,÷&ñ ´ËAȸ³›„ÃÃΰ¿Ý%“ͦ‡GÇ”RFûš¦štšÒRãN2»šÚ¹ö{‹{œå˜\Ó$Ãä\Ö1É/èéñù“Ùå)Ùùœn4¥·˜Ï ܵç0Cþ v þ-¸ôˆ¸ñ0ÜypiV‚ …p-P¯‚¸ØLð"(J€Ëv×W—ÀU+ov®Œ‡-ã“ßúcDâõg˜Uâ7({ð_`üú7'4»¨¿ ÁlÃ…éâm¶sކH/@×b€±'Û¸^U Þ¶b°æÊUŒVlÿA1J·1×vÏÞ€g9^á[9×^ endstream endobj 637 0 obj << /Length 267 /Filter /FlateDecode >> stream xÚ‘±J1†'lq0…ûÞ¼€f̰pžà‚Vb¥–Š‚]òhy”}„-¯86ÎL¢œ‡• Ù/Ìü;“üq«Ó5äè¤%×QwFO-¾¢kHfçræñ×Ú;r Ú+£®éýíãíúæ‚Z´ºo©yÀaCÕ 2–i¤´å¯™5º˜À€z„>‚¬%k<&rš¥,«¶`vŒìd+q3Ëß’1«^+ü ô\úoxE<@ØG*Ðqˆ ÷ù/|AüýoŒÙ¸=˜¨×,¨¢8U(`‡Ø´ fA-©‘pœûžçÚŸ¹Ú¤Pjí"ê{mœ¤ÔIš€‘ƒã倷øYRŽ endstream endobj 638 0 obj << /Length 279 /Filter /FlateDecode >> stream xÚåÑ=JÄ@ð )¯É2'p2°Dl ¬+˜BÐÊB¬\K E;qÒy­ˆ…å^aŽ2EÈ33ïŸÂEô„ßdȼ¯Ú»Ò¥Ou¤mYê­¥ªÂAßÃîöžÖ ™+]­Èœ…c2͹~z|¾#³¾8Ñ–ÌF_[]ÞP³ÑIÚ%ae,ò*˜¸=ëÿcÊ<üæ<¬6êF¹ç<ì â½Âö¢òÈÓ‰Y+æÈ _à ª^L½˜ubÞŠ¬qîð‹ï,÷?vïóMÜectJ§è¨ÄAq´O8Öç‡:ê®ÑG±ˆþò}-¢ÿ˜ ô¿È˜KHçÖ~Ÿc¹‹½DÇ='ùù0t[°gž7×ÒiC—ôÍâÞÏ endstream endobj 639 0 obj << /Length 252 /Filter /FlateDecode >> stream xÚíÒ±J1Ð;¤¼ÂùÁ|IÜeÑj`]Á)­,APKAEÁnæÓ"vÖù„”[ û|Ï]°\k±äÜ„[Ý÷vGÜXN n2rבî)M‚Z/W·4mÉŸËŸ1ùc‰É·'îñáé†üôôÐEò37.\P;s0 ]*îËÉðÔ\æT3&‚œ0þÆ3vr•ÑõŠ‚ºHM“¤å%Á.,äè^{ØaK uÝ`†m)4ï‚å¾`±B¥°ŠOÅÝŠË5䀳¶Š"mDVô‘øÇ_ÅÏ—ÊBŒ.¤fY/ë©ó/AG-Ñ!A B endstream endobj 640 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚíÑ¡Â0à[*–œÙ#pO@·@ ¨%0&H@! $¸ñh%Ø#L"Çu€…D´ùþ¶—KzzµÙ¢ê²™Í"\¢1’CÝÅtíõˆŒAÝ“SÔiŸÖ«Íu{СuBãˆÂ ¦ ²åà³U|0Û€ù‰Ø–ØB%/Q@Px¼·à_åQvØïʲ#€rˆO‚û ^‰Ëç7\©ëŸ‘†ýãgpÓ÷x'A~^ɼ™¹P²Ù/ÀnŠC|U¸ý endstream endobj 641 0 obj << /Length 249 /Filter /FlateDecode >> stream xÚ­‘±NÃ@ †}êÉK!~¸5Ç©©*ÁÔ1#æÜ£õQú3T9l× êÈÝIßɾü±‡Ûë5•TÓUEá†Âš^+üÀ:p°¤PŸ3/ï¸éÐï©è·Fßíèëóû ýæáŽ*ô-=UT>c×€Kxåiôi$Þ«Š@v”#W@Áø!ç'=rå4à8 E\)™æGCÎ †B1Š:‹6ŠÓ½bê¥:wZ¹KÿŠ??²"XÖi=Ì1w«½fùbpêYœ4?Í]óšeä[›ƒã©ÄßÙÄt~xßá#þ°´”ð endstream endobj 642 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚÝÏ? ÂP ð¯,d°«ƒÐœÀ×ÚVt*øì èä ‚ Ž‚ŠÎ¯GëQzÇNÆ÷:ˆƒx‡üÈ—@ i¿—Drj*ñ æCDJb“Cíb¢qNjÍILjn¦¤òß®÷#©ñr©)oÌ™-åS†¯†/ž–ÂX¥ˆSeF·Ô•+^¡+ˆkÛª»d%ôA¢è3ðv×X}Xþ´øÅ~äÈö"õ7i–ÓŠ^¤Ds. endstream endobj 643 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚíÒ¿Aðïr Éî$7/ÀÞÆeQIüI\!¡Rˆ ¥¡æÑîQ<‚ReÌž V÷Ûùv¶ù¶™Ö[mN8åšå¦e×॥-9§Ã„]úHkêfd¦ì™¡ŽÉd#Þï+2Ýq-™>Ï,'sÊúŒ0eQĈ"”ïüå²ÇÜŸÞÑñþñ3‚Ï?£(%V” œÊUè… Ð’“n(6áÁY4nú+|×<>èÈ­h‘\Ð ºEƒŒ&tj8­Ú endstream endobj 644 0 obj << /Length 357 /Filter /FlateDecode >> stream xÚÒÁJÃ0ð¯ôPÈay±æ´k‡Û ƒÂœ`‚ž<ˆ'õ(LQ˜§æÑò(}„{(ÿ4 HÙÁCø~|!!ÿ$åærµKQˆ‹\”Wb]ˆ×œ}°²@s)Ö+7óòÎö5ËEY°ìm–Õwâëóûeûûk‘³ì žr±|fõAcdeŒ"côMd:¢Ê *¢¦%â½s'˜kàŽõcTsk¿Žkç4XNŒÊ±w"]/µ¦‰QSœ…“;GϼË`Ôr ZÀ1üϽÁ¨GäÛÁ¬á­wÛxkI'˜ EÖGoUKX‘¶ndlÝzË4XÁm4ºR‰µòÆy·°ŽG§-·–Î3J‚5Ü%£¹^X“óœâàîùè¤ÛÁ3ï-EÁ=<,FÇý ž{#Rð›Ýèh°?bë·±îFÓhím_üŒÿܹןº²VÞ6ЧÖÒÙÆH¦f75{`¿ŸõÒi endstream endobj 662 0 obj << /Producer (pdfTeX-1.40.22) /Author()/Title()/Subject()/Creator(LaTeX with hyperref)/Keywords() /CreationDate (D:20231024165238-04'00') /ModDate (D:20231024165238-04'00') /Trapped /False /PTEX.Fullbanner (This is pdfTeX, Version 3.141592653-2.6-1.40.22 (TeX Live 2022/dev/Debian) kpathsea version 6.3.4/dev) >> endobj 397 0 obj << /Type /ObjStm /N 74 /First 684 /Length 3972 /Filter /FlateDecode >> stream xÚÕ[[o·~?¿b›ÞÃË /€ ‰ h.FÒ¢[I$R`ÉEúïû ¹$gÏ®Ž%ÛIP»gIÉápÈo>îÊgšÌä3Od,~ÔÙO6òdCv² x“sÙã!N.r@¹›¼‡ <ȰA±ñæÀ†¤AÆNlÑ3.r $§l§$ÒL2@iDcá˜06NŽ˜ÉftD8G3ˆb!O ag]<È œM˜Hש‚°óŒia2yò",³ãD8X?É0]€Ò2J "œd"œ t–_¨ Qo q`zXO­w2•¢‡—>‚øç(yR#–RØN&¥hžÄ¿æËÙt˜]K U$,td¤0ÒÂSæÃwäg˜þWÓ#W§[î6ï±w3ökÎôaÎæžÓX·l6í˜÷‘yO©­f/OŸŽÿüﯗÓño×/o^]]ÿx8>»úá‡Ë×—×//o§ï</u]àé>u]¬¸Y×ʼn7U]¯[áç7×w‡ã·o¾¿+IÉô‡ãW¿H›CøòâîõÕoÓwf6X5T÷þñü¢J}úé d¦'nz‚¾áR˜m}sy{óæµl°OŸNÇç¯o^~{y¹ãógŸOÇ¿ÿrñãå§Ó‹ Z?¿z}{÷ÙO¯1‡ãKÂáøï«Ww?Ý–¯ ©íá%Ö+9"+Íß–¨oé{£ð)Îíµ³•|(F¿ ?·íoÿþ„Ý+ÿƒ1>Ös ÂzDí'ˆŠ @!aú€‰X(WAW\ù1˜ŠÈ÷O§8ð1™ ²ZʵA×?å– ”&êÍ® LPP˜“‚œ’q Éð€B­…ÔwqÌ!õ]œ…®Ñ€(2•গ¸Bþ–„4’‘IÉ$¾_èÇškdí€5²nÀY?`, $#˼È6ƒ`‹AHŠ0 j 93P‰œ¨DÎ)T"ç*‘#…JäX¡¹ P‰\T¨$ôu ¹¬P‰¼Q¨DÞ*T"ï*‘÷ •È“B%ò¬P‰|P¨D>*T"?ðKzïºÀ"Ôc)8Rö‘šýSˆbAZÝ;cX¬Æ(×1ŠÛ2èÅÍýFñâЂQÌsÄ6cÚêݼåÏ…YVKœÅIßã¾n5ºYi†a¢Ÿá‡ÁÍ%f‰<—•åÃ\àç²rQfçåÔ_ÜaÓ:ŒªLi8§¹„Fø‚P«@nư<ûA˳¸LѶæ×±×|63-1ϨjU%.ûÕ /öq–H7ζuP*×Á–Çr«<È6ÐraÆâòŠ(È–‡+>” "Rà„Ü ¦Û!‚e#‹£§hZaCs ÆÓhhuQ®]˜Jh¡\Qøà»€—ÜÂB¬Ù˜:¡mØ©óì€Ô™ æˆ:™DL uÕC¬ái0(¸j¦ÁÔ(ó`j”ƒB±S£Ž–àHÔÑ’åÒ ¦ÆÒ Ö‰–@Z'Zih ¤ ¢uÑ‚haê©-Ì: ¢…:ƒhah Šu%(Ö˜*u N ß:|ëôIðM±'XQ±'è Ø”PìI68¯ñm°§²ÆJ|4Ú ö$h7Ø“ bOÐE±'è¢ØtìIÐ.yv‰4Ú%Öh—‚F»#£Îè ö¥¬±/ÅÖ(? yƒ„&T.HØž×H²æå|”&ôþá‘°ùî@ÂæÀ 7$ŒaÁ_ñæm$Þç¾n/+ÄîxWŽÆg¸D 5³ Uš©SsÙRÿÍŸ° Û¹PÑÚ¬õ<'¾wB˜E¼Vå,]“rÖâš .6 Y µ¦àÖ‚¹U@ A:D[lçTî¶)V«×QÖçz¯<þ&7Áå Æ?ÿ`ÈÃ4œü§1··â wÎæ„)Çv<˜üŒÔ¹$“:—dRç’Lê\’IK2©sIfu.ɬÎ%™Õ¹$€“8, ´ãÁÙ [çlòêhp6t:8šœMÄhέg“â8œMZËàxp6I(ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆ+ÎÆƒ³ÉÙžâlâ'V¡“>sdz왣ËïÂç|ÎLÉÿ.|.4_é(šÃ  ‹Û”3Ç 6Å1±³nyÃ6 :b”—ûÈu *iy–£†YÌwºŸÀ ú) …ó_6| ˆLZ…yg[„@¯²>q TØU–·T³ÄGe|Kc¥V½'ž=í½ªX©àÊvõìP+®dcÔ|?cלbÏ*¢ÅØQ^š8!Õ¦‹T©\­Ïõ^;~×”k»3î‹Ò£> Y®ßç•ác²hârxÌ»/WÇ”¸øÿŠõqç(òÙFg/˜î„E"!Vïô¸S&’/<Ò8ÈäÎ’ˆmäN™€a jF" ì ư`B‡1–ÏEìÀÎÐaŒåû?°3t“:ŒAãÐaL°³0ÁÎNÀ;;ìì,ÊÉ´‘;ýóâ¨NB9jTíÜ+IU£FÕ¨Qµó.½Üi—@lg]±t ÄvÎÉr ÞÆ%x;—àí`\‚·ƒq ÞÆ%x;—àí`\–8ë÷xœõ{<Îú=gý³~ÇY¿Çã¬ßãqÖïñ8ë÷xÁè÷xÁX…¾Á8…¾¡Ÿ¥ ú†~0.èzh'èLx$úz»E_£Ð×졯+à ߉öCïxáZ4À·EB |½‡©aN¡ŽFpÖ‰~Öëb |äK•ïÿxI­ ù¸Ô tò—ä7 4 ^ú¼þô% êW>RÕ¦ÁëÓ@úÀ4 êõà~aä5hm×Þs¸þ-üöæÍõÝHc¢îÊ®¥æ?®^aÒl]Ä“­ÑÉdkÀ _ú–_WQnr50zq¦_®¢ ×ß:°små®_6Ë'ºÛ:_¿¹ûùêZª•Å=-3"k»|¶[WniÑÚ^õêîçKùøµ"t´>võ—Iyþúò?åS_mÜ¥¶íµ]]jïË7–+òt®·©|uù›Cžm;ø2@£øät€-â•.ÍZÅÖÉÒeÚQ¸ÅØŸÈÛÙÚ¤^bî“¶†©Ûo«ÖÞפ›:§3–k¡á¢GXά<£ƒÅp~ÝaîS•ÏÍT aÍÍVóÜ' ›3 E­xÞqžÔ§"­g¢Õ,Í$Ú©Ù ŸÜ™šzÒΤ>1í6Skî(»-ã9[zmËfØ:uI»|£û»½ã‰½µÃ††náÎÔÔžw=ts·ÛL©¹«@·0¯-Ü,ShÛjµLÐ>Ϻ4÷iàõ4´Kó¼3$î6e³[³ ‰w¼–ºM)Ü?$¯=¨™©Ž¯i—ñµ·±ËøÜI_Ýð´6¼×~N;k”ºá}Ú­Y£×öݦžvÇWk®¦Œ´3’ï†÷ç6«ÕŒ«M¯ tÌ9ÿp}®ÜÉ^¯íçv¬0PôD×5µÿ»ÿWpšv›©5wPÀzWõ¤øÕ³Uwv‡QznRôÒØ‹Æns¦‘¬î­Ì®Ê~#uOÖõ„w!¤ú˳›—O¾½»x}÷Ñd뺚þò+¢¯ÙJ« ‡Œºq/õàhÉ dd-ÁÁ ©ÆjÇ/®~¹º;鲉½8U«äT¯.°FdÔˆ%#IFT´èt{ùòîêæú¯e(Õç{¦äùSÅZ§Jh£X/2 ‹8iTzrëîÅnq#†³ë,1ÝIc0ž·§*êî•ä½jb4ñ¤]1Ÿô3æ)²žš!ëÍ÷£ÛbL»-¡RïÓ·Xu-½ÕY—;™Ù^`;7ù\æ“wòÑíÉ£ÞŽ"H;q;ŠÍN«œJ ÉïtÒVµ\ iüN¬@³W£8”+ÃÓœRèC:­·;®µØ×ï÷ì¤g¶÷¢&ó~¡—šÁßWˆš!ÞW[D»7ÚÞ»•û+å 5Ò)ÿÑXÝòë—_Z~ùÜ6wÖ¸­§ðµŽ‹Vé1Z­Zzvy‹ óö4᳋»‹Ÿo~~cà wŠß„9CþË›W—ÇÝ^ºþõ¯—ןäN[wÿÉ·c endstream endobj 663 0 obj << /Type /XRef /Index [0 664] /Size 664 /W [1 3 1] /Root 661 0 R /Info 662 0 R /ID [ ] /Length 1863 /Filter /FlateDecode >> stream xÚÖyœOõÇñóý0c™1ƒ±YR¢i,ÃØÍ`,³ZFÆÌeT²\»,IYÊ^dO"k qÈ ™,QÕ½WÛ u[u»´Ü÷ëûÏów¾Ÿó;ç|—Ïç{NÁ_¸ ìZý¡Óñ¢öÄ1#ÖŽf (I¬±¶4# ’XIbmh–‚ÒÄ"ˆµ¦YÊ+G¬Í(ˆ&V—XKšå †X"±4c¡<±FÄ’iV€ŠÄ’ˆ5§•ˆ5#ÖŒfe¨B¬9±$šU¡±dbMiV‡xb-ˆ5¡YjkI¬1Íû ±VÄѬ uˆµ&–H³.ÜO¬=±GhÖƒˆ¥K ù Ô'–JìašAbˆ5¤éálØ‘gÍ߀;‡ˆùËüÃéU˜FŒ;›ï8# ;óôƒf6Â.Äè•ù c&îÄ|wýd³ a&1Fd~¡XÁ0‹˜ª_dV?Ì&Æl˜O2'Ì!æ§É'W ¤Bè :Cè Ý 2 ² r ;ô€žÐ r¡7< } úÃcPè‚ –¼·¾O'«Bø¬+à( Jψ0Á`(‚!.¨¼Ü×aý\1Õ7)±ETO8:÷ùGs‘¹þ¬ÏöR.ˆ;᛾ ú/! 'ô…å‚»#tYÍ3þdlë\É;¾éóÙ ¥úÒ  B_”AèË ªsåoé.‰/ûË|ŠÆ;Wc‚oú,f”¡Ï{²=ôÙ^Û¹:{ý_Ȧ°žs )¾éóÏ'5yúT&CŸÀ¤mèÓ6Á¹äh…Ï’&Î¥®ðM21ìË ùG²Üa[çÒÒüYŸ>,cÈú†¬t˜î\z’?›á\Æx &³›Èê ²;‹œ<Ñ==báºèù“èUì/#KB²$Ìu.w•NôÎîy\Ö·«ÈO3EáVÑ/ýJ禊AÅà¢hºò…x"J</†ˆ§‰aSÄðibÄ1ßr2$'Ã<çF^ó±|(€Bçþ¶ÝÇHÖd 87ê Ý`ô:1æ‚;_Œ[!ÆÓµ‰õÅÓýŤgÅägÄ”ßÄÔÝbZñìÃbúvñS2£†˜ÙIÌ#fo/¬s"à1÷1ïO1ÿXð/±ð¼XtG¼ÜP,æ.K²Ä+b)«°l˜Xþ±XYF¬¢ã«ç‰WóÅš=bm¤x½±XGw×_ö㥢B**,rnCØØQlÊ›»ˆ-¥áœØú¢xs x+èÕ¶9âmþ¼}²Øñ¼ØY$Þašvõ»Y¨0SìyLì¥Cïöû–‰ýƒÅŽn‡v‰÷ö‹Ãì‘«â(Ã:VS¼Ä>¸+Ž'˜¦“[ć;Å©S¢˜¼úè˜8ÍÜŸY"Î.ç8úx‡8¿@\àÚO¾Ÿþ,.2¬K}ÄezúÙ,¿xü{ZïèÛ7uâjOqí)q}¶øš;ßxM|CbÞL†ßÅ-¦ýö"ñíañ}þžÅû!AüØBü4ZüLý îœ¿^¿Ý/þÇ3îröÞ8ñûJñÇâϳ⯯uë†0•†•È%9ŠxZDjb­ÔQZµ`eÔI+«É±¨3"Z;’•»-bþ#b¿ª‰ŠJ)‹›$*ó#÷_þ³"ÒYee¬U)Uµ´V­»¨®¢³x¥ŠÕК[MîW«„¨-ê u«Ã/¢^Šx@½·úJG{h€h ½Äªâ-¡—xD©l‰ô¹‘¶k¬A[Î6]*’¾Íþ!šoÉt¨…–ÑZ2ÔVZkÍ Ú mµX;­¥µ'–¢u³TM»u ã•ÖI•liªZëRAt­ZdK¯+2”í–9RdmÙ_ŠœÿŠý䔆2PÖYOºÛk–ÈÕÂ[ï¢ÌSrY¾v8+Ða…JëWOô?((åmÍÁJt+RYÙãüïIF>ôW1¬>WŒP!ÚH¥*³Ñ£Ä–l¬ÒÌÆq4žnL`l‹IJj›\NL!#¦2˜gT«6í¤˜®mÄžÛ&f43™µYëÅì©âæeGsUG6_{¬-`Új7³—æù9ˆÿãlqEX¢­Ï^IK¸(–1/˵ÁÛ mA¶V19«ŠWIå5$Èk*[û£X§}ÍÖÇ€¶Û }Í6:±‰k7k§±-CÅV’õM&{[;ñ6é¸]Û«íàÄΗÄ;ª-ÛÅ8vó¿P;íQåÙ^½·ì]½ãm_±_Ûµà‘U¦vHÛ¡½ÇÔ&ŽÐƒ#¬åÑ{âËø¾v3û@»€g'V‹“¤ü‡zÉÙ)F^ÌØNWgøóY–ì\±ŸºòP*:;OAœ×ÎeŠÅ§LößIù‹dñ%òôòXñÙRm%¨ Uœ}®×„}Aªüó’¸BÚ~ÉÑ¿ÓÅWŒ÷*ÕxɹNm}MnÜ ‘¾¹éïW ªC<ܵÀ:ûoeÿq쿆ýç¯ÿÞõ¸þ‹ÖÂvƒtÈpvKoN»w%ø?ñ¢3 endstream endobj startxref 195549 %%EOF cummeRbund/inst/doc/cummeRbund-manual.R0000644000175200017520000005202214516027267021131 0ustar00biocbuildbiocbuild### R code from vignette source 'cummeRbund-manual.Rnw' ################################################### ### code chunk number 1: init ################################################### options(width=65) ################################################### ### code chunk number 2: loadLib ################################################### library(cummeRbund) ################################################### ### code chunk number 3: read ################################################### myDir<-system.file("extdata", package="cummeRbund") #You can leave blank if cwd or replace with your own directory path. gtfFile<-system.file("extdata/chr1_snippet.gtf",package="cummeRbund") #path to .gtf file used in cuffdiff analysis. cuff <- readCufflinks(dir=myDir,gtfFile=gtfFile,genome="hg19",rebuild=T) ################################################### ### code chunk number 4: read2 (eval = FALSE) ################################################### ## cuff<-readCufflinks() ################################################### ### code chunk number 5: read3 ################################################### cuff ################################################### ### code chunk number 6: add_features ################################################### #annot<-read.table("gene_annotation.tab",sep="\t",header=T,na.string="-") #addFeatures(cuff,annot,level="genes") ################################################### ### code chunk number 7: global_dispersion ################################################### disp<-dispersionPlot(genes(cuff)) disp ################################################### ### code chunk number 8: global_dispersion_plot ################################################### print(disp) ################################################### ### code chunk number 9: SCV_visualization ################################################### genes.scv<-fpkmSCVPlot(genes(cuff)) isoforms.scv<-fpkmSCVPlot(isoforms(cuff)) ################################################### ### code chunk number 10: global_plots_1 ################################################### dens<-csDensity(genes(cuff)) dens densRep<-csDensity(genes(cuff),replicates=T) densRep ################################################### ### code chunk number 11: global_plots_dens ################################################### dens<-csDensity(genes(cuff)) dens densRep<-csDensity(genes(cuff),replicates=T) densRep print(dens) ################################################### ### code chunk number 12: global_plots_dens_rep ################################################### print(densRep) ################################################### ### code chunk number 13: global_plots_2 ################################################### b<-csBoxplot(genes(cuff)) b brep<-csBoxplot(genes(cuff),replicates=T) brep ################################################### ### code chunk number 14: global_plots_box ################################################### b<-csBoxplot(genes(cuff)) b brep<-csBoxplot(genes(cuff),replicates=T) brep print(b) ################################################### ### code chunk number 15: global_plots_box_rep ################################################### print(brep) ################################################### ### code chunk number 16: global_plots_3.1 ################################################### s<-csScatterMatrix(genes(cuff)) ################################################### ### code chunk number 17: global_plots_scatter_1 ################################################### s<-csScatterMatrix(genes(cuff)) print(s) ################################################### ### code chunk number 18: global_plots_3.2 ################################################### s<-csScatter(genes(cuff),"hESC","Fibroblasts",smooth=T) s ################################################### ### code chunk number 19: global_plots_scatter_2 ################################################### s<-csScatter(genes(cuff),"hESC","Fibroblasts",smooth=T) s print(s) ################################################### ### code chunk number 20: global_plots_6 ################################################### dend<-csDendro(genes(cuff)) dend.rep<-csDendro(genes(cuff),replicates=T) ################################################### ### code chunk number 21: global_plots_dendro ################################################### dend<-csDendro(genes(cuff)) dend.rep<-csDendro(genes(cuff),replicates=T) plot(dend) ################################################### ### code chunk number 22: global_plots_dendro_rep ################################################### plot(dend.rep) ################################################### ### code chunk number 23: global_plots_4 ################################################### m<-MAplot(genes(cuff),"hESC","Fibroblasts") m mCount<-MAplot(genes(cuff),"hESC","Fibroblasts",useCount=T) mCount ################################################### ### code chunk number 24: global_plots_MA ################################################### m<-MAplot(genes(cuff),"hESC","Fibroblasts") m mCount<-MAplot(genes(cuff),"hESC","Fibroblasts",useCount=T) mCount print(m) ################################################### ### code chunk number 25: global_plots_MA_count ################################################### print(mCount) ################################################### ### code chunk number 26: global_plots_5_1 ################################################### v<-csVolcanoMatrix(genes(cuff)) v ################################################### ### code chunk number 27: global_plots_volcano_1 ################################################### v<-csVolcanoMatrix(genes(cuff)) v print(v) ################################################### ### code chunk number 28: global_plots_5_2 ################################################### v<-csVolcano(genes(cuff),"hESC","Fibroblasts") v ################################################### ### code chunk number 29: global_plots_volcano_2 ################################################### v<-csVolcano(genes(cuff),"hESC","Fibroblasts") v print(v) ################################################### ### code chunk number 30: data_access_0 ################################################### runInfo(cuff) replicates(cuff) ################################################### ### code chunk number 31: data_access_1 ################################################### gene.features<-annotation(genes(cuff)) head(gene.features) gene.fpkm<-fpkm(genes(cuff)) head(gene.fpkm) gene.repFpkm<-repFpkm(genes(cuff)) head(gene.repFpkm) gene.counts<-count(genes(cuff)) head(gene.counts) isoform.fpkm<-fpkm(isoforms(cuff)) head(isoform.fpkm) gene.diff<-diffData(genes(cuff)) head(gene.diff) ################################################### ### code chunk number 32: data_access_2 ################################################### sample.names<-samples(genes(cuff)) head(sample.names) gene.featurenames<-featureNames(genes(cuff)) head(gene.featurenames) ################################################### ### code chunk number 33: data_access_3 ################################################### gene.matrix<-fpkmMatrix(genes(cuff)) head(gene.matrix) ################################################### ### code chunk number 34: data_access_4 ################################################### gene.rep.matrix<-repFpkmMatrix(genes(cuff)) head(gene.rep.matrix) ################################################### ### code chunk number 35: data_access_5 ################################################### gene.count.matrix<-countMatrix(genes(cuff)) head(gene.count.matrix) ################################################### ### code chunk number 36: create_geneset_1 ################################################### data(sampleData) myGeneIds<-sampleIDs myGeneIds myGenes<-getGenes(cuff,myGeneIds) myGenes ################################################### ### code chunk number 37: create_geneset_2 ################################################### #FPKM values for genes in gene set head(fpkm(myGenes)) #Isoform-level FPKMs for gene set head(fpkm(isoforms(myGenes))) #Replicate FPKMs for TSS groups within gene set head(repFpkm(TSS(myGenes))) ################################################### ### code chunk number 38: create_geneset_3 ################################################### myGeneset.pluri<-getGenes(cuff,myGeneIds,sampleIdList=c("hESC","iPS")) myGeneset.pluri ################################################### ### code chunk number 39: geneset_plots_1 ################################################### h<-csHeatmap(myGenes,cluster='both') h h.rep<-csHeatmap(myGenes,cluster='both',replicates=T) h.rep ################################################### ### code chunk number 40: geneset_plots_heatmap ################################################### h<-csHeatmap(myGenes,cluster='both') h h.rep<-csHeatmap(myGenes,cluster='both',replicates=T) h.rep print(h) ################################################### ### code chunk number 41: geneset_plots_heatmap_rep ################################################### print(h.rep) ################################################### ### code chunk number 42: geneset_plots_1.5 ################################################### b<-expressionBarplot(myGenes) b ################################################### ### code chunk number 43: geneset_plots_barplot ################################################### b<-expressionBarplot(myGenes) b print(b) ################################################### ### code chunk number 44: geneset_plots_2 ################################################### s<-csScatter(myGenes,"Fibroblasts","hESC",smooth=T) s ################################################### ### code chunk number 45: geneset_plots_scatter ################################################### s<-csScatter(myGenes,"Fibroblasts","hESC",smooth=T) s print(s) ################################################### ### code chunk number 46: geneset_plots_3 ################################################### v<-csVolcano(myGenes,"Fibroblasts","hESC") v ################################################### ### code chunk number 47: geneset_plots_volcano ################################################### v<-csVolcano(myGenes,"Fibroblasts","hESC") v print(v) ################################################### ### code chunk number 48: geneset_plots_4 ################################################### ih<-csHeatmap(isoforms(myGenes),cluster='both',labRow=F) ih th<-csHeatmap(TSS(myGenes),cluster='both',labRow=F) th ################################################### ### code chunk number 49: geneset_plots_isoform_heatmap ################################################### ih<-csHeatmap(isoforms(myGenes),cluster='both',labRow=F) ih th<-csHeatmap(TSS(myGenes),cluster='both',labRow=F) th print(ih) ################################################### ### code chunk number 50: geneset_plots_TSS_heatmap ################################################### print(th) ################################################### ### code chunk number 51: geneset_plots_5 ################################################### den<-csDendro(myGenes) ################################################### ### code chunk number 52: geneset_plots_dendro ################################################### den<-csDendro(myGenes) plot(den) ################################################### ### code chunk number 53: gene_level_1 ################################################### myGeneId<-"PINK1" myGene<-getGene(cuff,myGeneId) myGene head(fpkm(myGene)) head(fpkm(isoforms(myGene))) ################################################### ### code chunk number 54: gene_plots_1 ################################################### gl<-expressionPlot(myGene) gl gl.rep<-expressionPlot(myGene,replicates=TRUE) gl.rep gl.iso.rep<-expressionPlot(isoforms(myGene),replicates=T) gl.iso.rep gl.cds.rep<-expressionPlot(CDS(myGene),replicates=T) gl.cds.rep ################################################### ### code chunk number 55: gene_plots_line ################################################### gl<-expressionPlot(myGene) gl gl.rep<-expressionPlot(myGene,replicates=TRUE) gl.rep gl.iso.rep<-expressionPlot(isoforms(myGene),replicates=T) gl.iso.rep gl.cds.rep<-expressionPlot(CDS(myGene),replicates=T) gl.cds.rep print(gl) ################################################### ### code chunk number 56: gene_plots_replicate_line ################################################### print(gl.rep) ################################################### ### code chunk number 57: gene_plots_iso_replicate_line ################################################### print(gl.iso.rep) ################################################### ### code chunk number 58: gene_plots_cds_replicate_line ################################################### print(gl.cds.rep) ################################################### ### code chunk number 59: gene_plots_2 ################################################### gb<-expressionBarplot(myGene) gb gb.rep<-expressionBarplot(myGene,replicates=T) gb.rep ################################################### ### code chunk number 60: gene_plots_bar ################################################### gb<-expressionBarplot(myGene) gb gb.rep<-expressionBarplot(myGene,replicates=T) gb.rep print(gb) ################################################### ### code chunk number 61: gene_plots_bar_rep ################################################### print(gb.rep) ################################################### ### code chunk number 62: gene_plots_3 ################################################### igb<-expressionBarplot(isoforms(myGene),replicates=T) igb ################################################### ### code chunk number 63: gene_plots_bar_isoforms ################################################### igb<-expressionBarplot(isoforms(myGene),replicates=T) igb print(igb) ################################################### ### code chunk number 64: gene_plots_4 ################################################### gp<-csPie(myGene,level="isoforms") gp ################################################### ### code chunk number 65: gene_plots_pie ################################################### gp<-csPie(myGene,level="isoforms") gp print(gp) ################################################### ### code chunk number 66: features_1 ################################################### head(features(myGene)) ################################################### ### code chunk number 67: features_2 ################################################### genetrack<-makeGeneRegionTrack(myGene) plotTracks(genetrack) ################################################### ### code chunk number 68: features_3 (eval = FALSE) ################################################### ## trackList<-list() ## myStart<-min(features(myGene)$start) ## myEnd<-max(features(myGene)$end) ## myChr<-unique(features(myGene)$seqnames) ## genome<-'hg19' ## ## ideoTrack <- IdeogramTrack(genome = genome, chromosome = myChr) ## trackList<-c(trackList,ideoTrack) ## ## axtrack<-GenomeAxisTrack() ## trackList<-c(trackList,axtrack) ## ## genetrack<-makeGeneRegionTrack(myGene) ## genetrack ## ## trackList<-c(trackList,genetrack) ## ## biomTrack<-BiomartGeneRegionTrack(genome=genome,chromosome=as.character(myChr), ## start=myStart,end=myEnd,name="ENSEMBL",showId=T) ## ## trackList<-c(trackList,biomTrack) ## ## conservation <- UcscTrack(genome = genome, chromosome = myChr, ## track = "Conservation", table = "phyloP100wayAll", ## from = myStart-2000, to = myEnd+2000, trackType = "DataTrack", ## start = "start", end = "end", data = "score", ## type = "hist", window = "auto", col.histogram = "darkblue", ## fill.histogram = "darkblue", ylim = c(-3.7, 4), ## name = "Conservation") ## ## trackList<-c(trackList,conservation) ## ## plotTracks(trackList,from=myStart-2000,to=myEnd+2000) ## ################################################### ### code chunk number 69: sig_mat_1 ################################################### mySigMat<-sigMatrix(cuff,level='genes',alpha=0.05) ################################################### ### code chunk number 70: sig_mat_plot_1 ################################################### mySigMat<-sigMatrix(cuff,level='genes',alpha=0.05) print(mySigMat) ################################################### ### code chunk number 71: get_sig_1 ################################################### mySigGeneIds<-getSig(cuff,alpha=0.05,level='genes') head(mySigGeneIds) length(mySigGeneIds) ################################################### ### code chunk number 72: get_sig_2 ################################################### hESC_vs_iPS.sigIsoformIds<-getSig(cuff,x='hESC',y='iPS',alpha=0.05,level='isoforms') head(hESC_vs_iPS.sigIsoformIds) length(hESC_vs_iPS.sigIsoformIds) ################################################### ### code chunk number 73: get_sig_3 ################################################### mySigGenes<-getGenes(cuff,mySigGeneIds) mySigGenes ################################################### ### code chunk number 74: get_sig_4 ################################################### mySigTable<-getSigTable(cuff,alpha=0.01,level='genes') head(mySigTable,20) ################################################### ### code chunk number 75: dist_heat_1 ################################################### myDistHeat<-csDistHeat(genes(cuff)) ################################################### ### code chunk number 76: dist_heat_plot_1 ################################################### myDistHeat<-csDistHeat(genes(cuff)) print(myDistHeat) ################################################### ### code chunk number 77: dist_heat_2 ################################################### myRepDistHeat<-csDistHeat(genes(cuff),replicates=T) ################################################### ### code chunk number 78: dist_heat_plot_2 ################################################### myRepDistHeat<-csDistHeat(genes(cuff),replicates=T) print(myRepDistHeat) ################################################### ### code chunk number 79: dim_reduction_1 ################################################### genes.PCA<-PCAplot(genes(cuff),"PC1","PC2") genes.MDS<-MDSplot(genes(cuff)) genes.PCA.rep<-PCAplot(genes(cuff),"PC1","PC2",replicates=T) genes.MDS.rep<-MDSplot(genes(cuff),replicates=T) ################################################### ### code chunk number 80: gene_PCA ################################################### genes.PCA<-PCAplot(genes(cuff),"PC1","PC2") genes.MDS<-MDSplot(genes(cuff)) genes.PCA.rep<-PCAplot(genes(cuff),"PC1","PC2",replicates=T) genes.MDS.rep<-MDSplot(genes(cuff),replicates=T) print(genes.PCA) ################################################### ### code chunk number 81: gene_MDS ################################################### print(genes.MDS) ################################################### ### code chunk number 82: gene_PCA_rep ################################################### print(genes.PCA.rep) ################################################### ### code chunk number 83: gene_MDS_rep ################################################### print(genes.MDS.rep) ################################################### ### code chunk number 84: geneset_cluster_1 ################################################### ic<-csCluster(myGenes,k=4) head(ic$cluster) icp<-csClusterPlot(ic) icp ################################################### ### code chunk number 85: geneset_plots_cluster ################################################### print(icp) ################################################### ### code chunk number 86: specificity_1 ################################################### myGenes.spec<-csSpecificity(myGenes) head(myGenes.spec) ################################################### ### code chunk number 87: similar_1 ################################################### mySimilar<-findSimilar(cuff,"PINK1",n=20) mySimilar.expression<-expressionPlot(mySimilar,logMode=T,showErrorbars=F) ################################################### ### code chunk number 88: similar_plots_1 ################################################### mySimilar<-findSimilar(cuff,"PINK1",n=20) mySimilar.expression<-expressionPlot(mySimilar,logMode=T,showErrorbars=F) print(mySimilar.expression) ################################################### ### code chunk number 89: similar_2 ################################################### myProfile<-c(500,0,400) mySimilar2<-findSimilar(cuff,myProfile,n=10) mySimilar2.expression<-expressionPlot(mySimilar2,logMode=T,showErrorbars=F) ################################################### ### code chunk number 90: similar_plots_2 ################################################### myProfile<-c(500,0,400) mySimilar2<-findSimilar(cuff,myProfile,n=10) mySimilar2.expression<-expressionPlot(mySimilar2,logMode=T,showErrorbars=F) print(mySimilar2.expression) ################################################### ### code chunk number 91: close_connection ################################################### end<-dbDisconnect(cuff@DB) ################################################### ### code chunk number 92: session ################################################### sessionInfo() cummeRbund/inst/doc/cummeRbund-manual.Rnw0000644000175200017520000015743314516004263021501 0ustar00biocbuildbiocbuild% % % %\VignetteIndexEntry{CummeRbund User Guide} %\VignetteKeywords{cummeRbund,visualization,NGS,sequencing,cufflinks,cuffdiff} %\VignettePackage{cummeRbund} % %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %\SweaveOpts{prefix.string=graphics/cummeRbund-manual} \documentclass[10pt]{article} \usepackage[margin=0.75in]{geometry} \usepackage{amsmath} \usepackage[authoryear,round]{natbib} \usepackage{hyperref} \usepackage{graphicx, subfig} \hypersetup{ colorlinks, citecolor=black, filecolor=black, linkcolor=red, urlcolor=black } \usepackage{theorem} \usepackage{float} \usepackage{ifthen} \usepackage[OT1]{fontenc} %%%%%% % Alter some LaTeX defaults for better treatment of figures: % See p.105 of "TeX Unbound" for suggested values. % See pp. 199-200 of Lamport's "LaTeX" book for details. % General parameters, for ALL pages: \renewcommand{\topfraction}{0.9} % max fraction of floats at top \renewcommand{\bottomfraction}{0.8} % max fraction of floats at bottom % Parameters for TEXT pages (not float pages): \setcounter{topnumber}{2} \setcounter{bottomnumber}{2} \setcounter{totalnumber}{4} % 2 may work better \setcounter{dbltopnumber}{2} % for 2-column pages \renewcommand{\dbltopfraction}{0.9} % fit big float above 2-col. text \renewcommand{\textfraction}{0.07} % allow minimal text w. figs % Parameters for FLOAT pages (not text pages): \renewcommand{\floatpagefraction}{0.7} % require fuller float pages % N.B.: floatpagefraction MUST be less than topfraction !! \renewcommand{\dblfloatpagefraction}{0.7} % require fuller float pages % remember to use [htp] or [htpb] for placement %%%%%%%%%%% \newcommand{\R}{{\textsf{R}}} \newcommand{\code}[1]{{\texttt{#1}}} \newcommand{\term}[1]{{\emph{#1}}} \newcommand{\Rpackage}[1]{\textsf{#1}} \newcommand{\Rfunction}[1]{\texttt{#1}} \newcommand{\Robject}[1]{\texttt{#1}} \newcommand{\Rclass}[1]{{\textit{#1}}} \newcommand{\Rmethod}[1]{{\textit{#1}}} \newcommand{\Rfunarg}[1]{{\textit{#1}}} \bibliographystyle{plainnat} \title{CummeRbund: Visualization and Exploration of Cufflinks High-throughput Sequencing Data} \author{Loyal A. Goff, Cole Trapnell, David Kelley} \date{May 7, 2014} \begin{document} <>= options(width=65) @ \maketitle \tableofcontents \clearpage \section{Requirements} NOTE: cummeRbund 2.0 was designed in conjunction with the release of cufflinks 2.0. While we attempted to preserve backwards-compatability, it is highly recommended that you update your cufflinks installation to version $\ge$2.0 to take full advantage of the improvements in modeling, reporting, and visualization that have been incorporated. \begin{itemize} \item Cufflinks $\ge$ v2.0.1 \item SQLite \item R $\ge$ v3.0 \item Packages: \begin{itemize} \item \Rpackage{RSQLite} \item \Rpackage{ggplot2 $\ge$ v0.9.3} \item \Rpackage{reshape2} \item \Rpackage{plyr} \item \Rpackage{fastcluster} \item \Rpackage{rtracklayer} \item \Rpackage{Gviz} \item \Rpackage{BiocGenerics $\ge$ 0.3.2} \item Recommended: \begin{itemize} \item \Rpackage{Hmisc} \end{itemize} \end{itemize} \end{itemize} \clearpage \section{Introduction} \Rpackage{cummeRbund} is a visualization package for Cufflinks high-throughput sequencing data. It is designed to help you navigate through the large amount of data produced from a Cuffdiff RNA-Seq differential expression analysis. The results of this analysis are typically a large number of inter-related files that are not terribly intuitive to navigate through. cummeRbund helps promote rapid analysis of RNA-Seq data by aggregating, indexing, and allowing you easily visualize and create publication-ready figures of your RNA-Seq data while maintaining appropriate relationships between connected data points. CummeRbund is a multifaceted suite for streamlined analysis and visualization of massively parallel RNA differential expression data sequencing data. CummeRbund begins by re-organizing output files of a cuffdiff analysis, and storing these data in a local SQLite database. CummeRbund indexes the data to speed up access to specific feature data (genes, isoforms, TSS, CDS, etc.), and preserves the various relationships between these features. Access to data elements is managed via the RSQLite package and data are presented in appropriately structured R classes with various convenience functions designed to streamline your workflow. This persistent database storage means that inter-connected expression values are rapidly accessible and quickly searchable in future analyses. CummeRbund defines two types of data classes, 'pointer' or reference classes describe SQL connections to the database without directly containing data, and 'data' classes that retrieve a subset of related data points such as associated features from a given gene or gene set. Each class type has methods for direct access to FPKM vales, differential expression information, statistical test results, raw and normalized fragment counts, individual replicate FPKM values, and additional annotation information for features. Output formats allow for browsing and analysis of data in standard R objects (data.frame, list, etc). CummeRbund was designed to provide analysis and visualization tools analogous to microarray data. In this regard, numerous plotting methods are provided for visualization of RNA-Seq data quality and global statistics, and simple routines for plotting expression levels for one or thousands of genes, their isoforms, TSS groups, or CDS groups. The base class, \Rclass{cuffSet} is a 'pointer' to cuffdiff data that are stored out-of-memory in a sqlite database. \clearpage \section{CummeRbund Classes} \subsection{CuffSet Class} A pointer class to control access to the sqlite tables holding the Cufflinks data. The primary slot is DB which contains the RSQLite connection object. This can be accessed using the \Rmethod{DB()} accessor. The additional slots (genes, isoforms, TSS, and CDS) are each instances of the \Rclass{CuffData} class and are pointers to sets of tables for each data subtype. They can be accessed with similar accessor wrappers. This is the default class created by \Rmethod{readCufflinks}. By default, \Rclass{CuffData} accessor methods applied to a \Rclass{CuffSet} class will operate on the 'genes' slot. The \Rmethod{runInfo()} method can be used to retrieve information about the actual cuffdiff run itself, including command-line arguments used to generate the results files. \subsection{CuffData Class} The \Rclass{CuffData} class is also a pointer class to the SQL backend, but each instance is specific for a data subtype (genes, isoforms, TSS, CDS). Again, there is an DB slot (accessible using \Rmethod{DB()}) that contains the RSQLite connection object. There are several accessor, setter, and plotting methods that allow for global analysis of all features within a \Rmethod{CuffData} class.Subsetting is currently being re-written, however, it is primarily done through the 'gene\_id' field. Available slots for the CuffData class are: \begin{itemize} \item DB: RSQLite connection object \item tables: A \Rclass{list} of tables in the SQLite DB that contain the cufflinks data. \item filters: A \Rclass{list} of filters for subsetting (not implemented yet). \item type: A \Rclass{character} field describing the data (ie. 'genes','isoforms','TSS','CDS','other') \item idField: The name of the identifying index field for this object (eg. 'gene\_id' for type='gene', or 'isoform\_id' for type='isoform') \end{itemize} Making the best use of either the CuffSet or CuffData classes will enable you to keep the entire dataset out of memory and significantly improve performance for large cufflinks datasets. \subsection{CuffDist Class} The \Rclass{CuffDist} class is an pointer class that contains the results of the various 'distribution tests' performed by cuffdiff. These include differential promoter usage, differential splicing, and differential CDS usage. These are independent tests from the differential analysis of gene-, isoform-, TSS-, and CDS-level features and therefore have their own container type to distinguish them as such. The 'promoters', 'relCDS', and 'splicing' slots of a \Rclass{CuffSet} class are all \Rclass{CuffDist} instances. Available slots for the CuffDist class are: \begin{itemize} \item DB: RSQLite connection object \item tables: A \Rclass{list} of tables in the SQLite DB that contain the distribution test data. \item type: A \Rclass{character} field describing the data (ie. 'promoters','relCDS','splicing') \item idField: The name of the identifying index field for this object (eg. 'TSS\_group\_id' for type='promoters', or 'CDS\_id' for type='relCDS', etc.) \end{itemize} \subsection{CuffFeatureSet Class} The \Rclass{CuffFeatureSet} class is a data-storage container that holds all available data for a pre-determined list of features. Slots for FPKM data, differential regulation data, and feature-level annotation are all available. Unlike the previous classes, this class contains no connection information to the SQL database, but rather contains several slots with \Rclass{data.frame} objects storing multiple-features worth of information. There are available accessors, and plotting methods that are designed to present multiple-features worth of information (eg. heatmaps, scatterplots, etc) Available slots for a \Rclass{CuffFeatureSet} object include: \begin{itemize} \item annotation: Holds all feature-level annotation information for all features in object. \item fpkm: A data frame of FPKM data across all conditions, for all features in object. \item repFpkm: A data frame of deconvolved FPKM values across individual replicates, for all features in object. \item diff: A data frame of differential expression/regulation data for all features in object. \item count: A data frame containing raw and normalized fragment counts, variance, dispersion, and uncertainty for all features in object. \item genome: A character string indicating which build of the genome the associated features are derived from. (e.g. `hg19',`mm9') \end{itemize} A specialized sub-class of \Rclass{CuffFeatureSet} is the \Rclass{CuffGeneSet} class. This subclass adds additional slots to contain all isoforms, TSS, and CDS information for a given set of gene\_ids. The \Rclass{CuffGeneSet} class is designed to aggregate all relevant information for a set of genes into one object for easy analysis and/or manipulation. The \Rclass{CuffGeneSet} object adds the following slots: \begin{itemize} \item ids: A 'character' list of all gene\_ids used in object. \item isoforms: A \Rclass{CuffFeatureSet} object for all isoforms of genes in object. \item TSS: A \Rclass{CuffFeatureSet} object for all TSS of genes in object. \item CDS: A \Rclass{CuffFeatureSet} object for all CDS of genes in object. \end{itemize} \subsection{CuffFeature Class} The \Rclass{CuffFeature} class is designed for single-feature-level data analysis and plotting. The methods available for this object are designed to analyze or visualize information about a specific feature. This is a 'data' object, as opposed to a 'pointer' object to the database backend. There is a validity requirement that a \Rclass{CuffFeature} object only point to data from a single feature. Available slots for a \Rclass{CuffFeature} object include: \begin{itemize} \item annotation: Holds feature-level annotation information for a given feature. \item fpkm: A data frame of FPKM data across all samples for a given feature. \item repFpkm: A data frame of deconvolved FPKM values across all replicates for a given feature. \item diff: A data frame of differential expression/regulation data for a given feature. \item count: A data frame containing raw and normalized fragment counts, variance, dispersion, and uncertainty for a given feature. \end{itemize} A specialized sub-class of \Rclass{CuffFeature} is the \Rclass{CuffGene} class. This subclass adds additional slots to contain all isoform, TSS, and CDS information for a given gene. The \Rclass{CuffGene} object adds the following slots: \begin{itemize} \item id: The common 'gene\_id' for all data in object \item isoforms: A \Rclass{CuffFeature} object for all isoforms of a given gene. \item TSS: A \Rclass{CuffFeature} object for all TSS of a given gene. \item CDS: A \Rclass{CuffFeature} object for all CDS of a given gene. \item features: A \Rclass{data.frame} object containing feature information for the transcript models describing the gene. \end{itemize} \clearpage \section{Reading cuffdiff output} \Rpackage{cummeRbund} was designed to process the multi-file output format for a 'cuffdiff' differential expression analysis. In this type of analysis, a user will use a reference .gtf file (either known annotation or a .gtf file created from a cufflinks assembly or merge of assemblies) and quantitate the expression values and differential regulation of the annotation(s) in the .gtf file across two or more SAM/BAM files. By design, cuffdiff produces a number of output files that contain test results for changes in expression at the level of transcripts, primary transcripts, and genes. It also tracks changes in the relative abundance of transcripts sharing a common transcription start site, and in the relative abundances of the primary transcripts of each gene. Tracking the former allows one to see changes in splicing, and the latter lets one see changes in relative promoter use within a gene. \\ Note:Early versions of Cuffdiff required that transcripts in the input GTF be annotated with certain attributes in order to look for changes in primary transcript expression, splicing, coding output, and promoter use. This is no longer the case with >=v1.1.1 of \Rpackage{cummeRbund}, however we still recommend the use of both the following attributes in your GTF file to enable all downstream features of \Rpackage{cummeRbund}. \\ These attributes are: \begin{itemize} \item tss\_id: The ID of this transcript's inferred start site. Determines which primary transcript this processed transcript is believed to come from. Cuffcompare appends this attribute to every transcript reported in the .combined.gtf file. \item p\_id The ID of the coding sequence this transcript contains. This attribute is attached by Cuffcompare to the .combined.gtf records only when it is run with a reference annotation that include CDS records. Further, differential CDS analysis is only performed when all isoforms of a gene have p\_id attributes, because neither Cufflinks nor Cuffcompare attempt to assign an open reading frame to transcripts. \end{itemize} cuffdiff calculates the FPKM of each transcript, primary transcript, and gene in each sample. Primary transcript and gene FPKMs are computed by summing the FPKMs of transcripts in each primary transcript group or gene group. The results are output in FPKM tracking files, the structure of which can be found in the cufflinks manual.\\ There are four FPKM tracking files: \begin{itemize} \item \emph{isoforms.fpkm\_tracking} Transcript FPKMs \item \emph{genes.fpkm\_tracking} Gene FPKMs. Tracks the summed FPKM of transcripts sharing each gene\_id \item \emph{cds.fpkm\_tracking} Coding sequence FPKMs. Tracks the summed FPKM of transcripts sharing each p\_id, independent of tss\_id \item \emph{tss\_groups.fpkm\_tracking} Primary transcript FPKMs. Tracks the summed FPKM of transcripts sharing each tss\_id \end{itemize} cuffdiff also performs differential expression tests between supplied conditions. This tab delimited file lists the results of differential expression testing between samples for spliced transcripts, primary transcripts, genes, and coding sequences. For detailed file structure see cufflinks manual. \\ Four .diff files are created: \begin{itemize} \item \emph{isoform\_exp.diff} Transcript differential FPKM. \item \emph{gene\_exp.diff} Gene differential FPKM. Tests difference sin the summed FPKM of transcripts sharing each gene\_id \item \emph{tss\_group\_exp.diff} Primary transcript differential FPKM. Tests differences in the summed FPKM of transcripts sharing each tss\_id \item \emph{cds\_exp.diff} Coding sequence differential FPKM. Tests differences in the summed FPKM of transcripts sharing each p\_id independent of tss\_id \end{itemize} In addition, cuffdiff also performs differential splicing, CDS usage, and promoter usage tests for each gene across conditions: \begin{itemize} \item \emph{splicing.diff} Differential splicing tests. \item \emph{CDS.diff} Differential coding output. \item \emph{promoters.diff} Differential promoter use. \end{itemize} All of these output files are related to each other through their various tracking\_ids, but parsing through individual files to query for important result information requires both a good deal of patience and a strong grasp of command-line text manipulation. Enter cummeRbund, an R solution to aggregate, organize, and help visualize this multi-layered dataset. \\ One of the principle benefits of using cummeRbund is that data are stored in a SQLite database. This allows for out-of-memory analysis of data, quick retrieval, and only a one-time cost to setup the tables. By default, cummeRbund assumes that all output files from cuffdiff are in the current working directory. To read these files, populate the 'cuffData.db' database backend, and return the \Rclass{CuffSet} pointer object, you can do the following. <>= library(cummeRbund) @ %%fileDir<-("../../extdata/") <>= myDir<-system.file("extdata", package="cummeRbund") #You can leave blank if cwd or replace with your own directory path. gtfFile<-system.file("extdata/chr1_snippet.gtf",package="cummeRbund") #path to .gtf file used in cuffdiff analysis. cuff <- readCufflinks(dir=myDir,gtfFile=gtfFile,genome="hg19",rebuild=T) @ <>= cuff<-readCufflinks() @ <>= cuff @ Again, by default $dir$ is assumed to be the current working directory and \code{cuff<-readCufflinks()} should work if all appropriate files are in the current working directory. We now also recommend that you use both the \Rfunarg{genome} and \Rfunarg{gtfFile} arguments to readCufflinks(). This will allow cummeRbund to archive the transcript structure information located in the .gtf file associated with your particular cuffdiff run, as well as associate these transcripts with an appropriate genome build (e.g. 'hg19', 'mm9', etc) so as to allow for transcript-level visualizations and future integration with other external resources. Should you need to rebuild the SQLite backend for any reason, you can add the option \Rfunarg{rebuild=T} to \Rmethod{readCufflinks}. Once the database is created, \Rmethod{readCufflinks} will default to using the SQL backend and should not need to rebuild this database. Each R session should begin with a call to \Rmethod{readCufflinks} so as to initialize the database connection and create an object with the appropriate RSQLite connection information. \subsection{Adding additional feature annotation} Gene- or feature-level annotation can be permanently added to the database tables for future querying. If you have a data.frame where the first column contains the 'tracking\_id' (eg. 'gene\_id' for genes, 'isoform\_id' for isoforms, etc). You can easily add feature level annotation using the \Rfunction{addFeatures()} function: <>= #annot<-read.table("gene_annotation.tab",sep="\t",header=T,na.string="-") #addFeatures(cuff,annot,level="genes") @ By default, features added to a \Rclass{CuffSet} object are assumed to be gene-level annotations, but the level can selected using the argument \Rfunarg{level}. Features added to a \Rclass{CuffData} object are assumed to be of the same type as the 'type' value for that given object (e.g. gene-level features for 'genes', isoform-level features for isoforms, etc.) \clearpage \section{Global statistics and Quality Control} Several plotting methods are available that allow for quality-control or global analysis of cufflinks data. A good place to begin is to evaluate the quality of the model fitting. Overdispersion is a common problem in RNA-Seq data. As of cufflinks $v2.0$ mean counts, variance, and dispersion are all emitted, allowing you to visualize the estimated overdispersion for each sample as a quality control measure. <>= disp<-dispersionPlot(genes(cuff)) disp @ \begin{figure}[htp] \begin{center} \subfloat[Count vs dispersion plot by condition for all genes.]{ <>= print(disp) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_dispersion_plot} } \end{center} \end{figure} Alternatively a call to \code{dispersionPlot(cuff)} directly will allow you to visualize the full model fit. The squared coefficient of variation is a normalized measure of cross-replicate variability that can be useful for evaluating the quality your RNA-seq data. Differences in $CV^2$ can result in lower numbers of differentially expressed genes due to a higher degree of variability between replicate fpkm estimates. <>= genes.scv<-fpkmSCVPlot(genes(cuff)) isoforms.scv<-fpkmSCVPlot(isoforms(cuff)) @ \begin{figure}[htp] \begin{center} \subfloat[The squared coefficient of variation allows visualization of cross-replicate variability between conditions and can be a useful metric in determining data quality at the gene level (left) or isoform level (right). Here we demonstrate the variability of each individual ENCODE project RNA-seq conditions.]{ \includegraphics[width=0.85\textwidth]{ENCODE_SCV} } \end{center} \end{figure} %FPKM distributions - Density To assess the distributions of FPKM scores across samples, you can use the \Rmethod{csDensity} plot (Figure 1). <>= dens<-csDensity(genes(cuff)) dens densRep<-csDensity(genes(cuff),replicates=T) densRep @ \begin{figure}[htp] \begin{center} \subfloat[Density plot of individual conditions.]{ <>= <> print(dens) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dens} } \qquad \subfloat[Density plot with replicates=TRUE exposes individual replicate FPKM distributions.]{ <>= print(densRep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dens_rep}} \end{center} \end{figure} %FPKM distributions - Boxplot Boxplots can be visualized using the \Rmethod{csBoxplot} method (Figure 2). <>= b<-csBoxplot(genes(cuff)) b brep<-csBoxplot(genes(cuff),replicates=T) brep @ \begin{figure}[htp] \begin{center} \subfloat[Box plot of FPKM distributions for individual conditions.]{ <>= <> print(b) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_box} } \qquad \subfloat[Box plot with replicates=TRUE exposes individual replicate FPKM distributions.]{ <>= print(brep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_box_rep}} \end{center} \end{figure} %Scatterplots A matrix of pairwise scatterplots can be drawn using the csScatterMatrix() method. <>= s<-csScatterMatrix(genes(cuff)) @ \begin{figure}[htp] \begin{center} \subfloat[Scatterplots can be useful to identify global changes and trends in gene expression between pairs of conditions.]{ <>= <> print(s) @ \includegraphics[width=0.65\textwidth]{cummeRbund-manual-global_plots_scatter_1}} \end{center} \end{figure} Individual Pairwise comparisons can be made by using \Rmethod{csScatter}. You must specify the sample names to use for the $x$ and $y$ axes: <>= s<-csScatter(genes(cuff),"hESC","Fibroblasts",smooth=T) s @ \begin{figure}[htp] \begin{center} \subfloat[Pairwise scatterplots can identify biases in gene expression between two particular conditions.]{ <>= <> print(s) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_scatter_2}} \end{center} \end{figure} %Dendrograms <>= dend<-csDendro(genes(cuff)) dend.rep<-csDendro(genes(cuff),replicates=T) @ \begin{figure}[htp] \begin{center} \subfloat[Dendrogram of JS distances between conditions.]{ <>= <> plot(dend) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dendro} } \qquad \subfloat[Dendrogram with replicates=TRUE can identify outlier replicates.]{ <>= plot(dend.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dendro_rep}} \end{center} \end{figure} %MA plots MvsA plots can be useful to determine any systematic bias that may be present between conditions. The CuffData method \Rmethod{MAplot()} can be used to examine these intensity vs fold-change plots. You must specify the sample names to use for the pairwise comparison with $x$ and $y$: <>= m<-MAplot(genes(cuff),"hESC","Fibroblasts") m mCount<-MAplot(genes(cuff),"hESC","Fibroblasts",useCount=T) mCount @ \begin{figure}[htp] \begin{center} \subfloat[MA plots can identify biases across ranges of intensity and fold-change.]{ <>= <> print(m) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_MA}} \qquad \subfloat[MA plot drawn on normalized count values instead of FPKM.]{ <>= print(mCount) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_MA_count}} \end{center} \end{figure} %Volcano plots Volcano plots are also available for the \Rclass{CuffData} objects. <>= v<-csVolcanoMatrix(genes(cuff)) v @ \begin{figure}[htp] \begin{center} \subfloat[Volcano plots explore the relationship between fold-change and significance.]{ <>= <> print(v) @ \includegraphics[width=0.65\textwidth]{cummeRbund-manual-global_plots_volcano_1}} \end{center} \end{figure} For individual pairwise comparisons, you must specify the comparisons by sample name. <>= v<-csVolcano(genes(cuff),"hESC","Fibroblasts") v @ \begin{figure}[htp] \begin{center} \subfloat[Volcano plots explore the relationship between fold-change and significance.]{ <>= <> print(v) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_volcano_2}} \end{center} \end{figure} \clearpage \section{Accessing Data} \subsection*{Cuffdiff run information} Run-level information such as run parameters, and sample information can be accessed from a \Rclass{CuffSet} object by using the \Rmethod{runInfo} and \Rmethod{replicates} methods: <>= runInfo(cuff) replicates(cuff) @ \subsection*{Features/Annotation} Feature-level information can be accessed directly from a \Rclass{CuffData} object using the \Rmethod{fpkm}, \Rmethod{repFpkm}, \Rmethod{count}, \Rmethod{diffData}, or \Rmethod{annotation} methods: <>= gene.features<-annotation(genes(cuff)) head(gene.features) gene.fpkm<-fpkm(genes(cuff)) head(gene.fpkm) gene.repFpkm<-repFpkm(genes(cuff)) head(gene.repFpkm) gene.counts<-count(genes(cuff)) head(gene.counts) isoform.fpkm<-fpkm(isoforms(cuff)) head(isoform.fpkm) gene.diff<-diffData(genes(cuff)) head(gene.diff) @ \subsection*{Condition and feature names} Vectors of sample names and feature names are available by using the \Rmethod{samples} and \Rmethod{featureNames} methods: <>= sample.names<-samples(genes(cuff)) head(sample.names) gene.featurenames<-featureNames(genes(cuff)) head(gene.featurenames) @ \subsection*{Convenience functions} To facilitate Bioconductor-like operations, an 'FPKM-matrix' can be returned easily using the \Rmethod{fpkmMatrix} method: <>= gene.matrix<-fpkmMatrix(genes(cuff)) head(gene.matrix) @ A matrix of replicate FPKM values can be retrieved by using \Rmethod{repFpkmMatrix} <>= gene.rep.matrix<-repFpkmMatrix(genes(cuff)) head(gene.rep.matrix) @ Similarly, a matrix of normalized counts can be generated by using \Rmethod{countMatrix} <>= gene.count.matrix<-countMatrix(genes(cuff)) head(gene.count.matrix) @ \subsection{Writing your own SQL accessors} Since the cuffData.db is a SQLite database backend, if you are familiar with SQL and/or RSQLite query construction, you can simply design your own SQL queries to access the data that you are after. \begin{figure}[h] \centering \includegraphics[angle=90, height=\textheight]{cuffData_schema.pdf} \end{figure} \clearpage \section{Creating Gene Sets} Gene Sets (stored in a \Rclass{CuffGeneSet} object) can be created using the \Rmethod{getGenes} method on a CuffSet object. You must first create a vector of 'gene\_id' or 'gene\_short\_name' values to identify the genes you wish to select: <>= data(sampleData) myGeneIds<-sampleIDs myGeneIds myGenes<-getGenes(cuff,myGeneIds) myGenes @ The same \Rmethod{fpkm}, \Rmethod{repFpkm}, \Rmethod{count}, \Rmethod{annotation}, \Rmethod{diffData}, \Rmethod{samples}, and \Rmethod{featureNames} methods are available for instances of the \Rmethod{CuffGeneSet} class, but additional accessor methods are available for the \Rmethod{promoters}, \Rmethod{relCDS}, and \Rmethod{splicing} slot data as well. <>= #FPKM values for genes in gene set head(fpkm(myGenes)) #Isoform-level FPKMs for gene set head(fpkm(isoforms(myGenes))) #Replicate FPKMs for TSS groups within gene set head(repFpkm(TSS(myGenes))) @ As of \Rpackage{cummeRbund} $v2.0$ \Rclass{CuffGeneSet} classes can be created from any type of identifier ('gene\_id','isoform\_id','TSS\_group\_id', or 'CDS\_id'). When you pass a list of identifiers that are not gene\_id to \Rmethod{getGenes()}, the function attempts to lookup the parent gene\_id for each feature and returns \emph{all} relevant information for the given genes and all of their sub-features (not just the sub-features passed to \Rmethod{getGenes()}). If you are interested in just retrieving information for a given set of features, please use the new \Rmethod{getFeatures()} method described later. More recent versions of cummeRbund allow for subsetting of conditions as well, by passing a vector of condition names to getGenes using the \Rfunarg{sampleIdList} argument. <>= myGeneset.pluri<-getGenes(cuff,myGeneIds,sampleIdList=c("hESC","iPS")) myGeneset.pluri @ \subsection{Geneset level plots} There are several plotting functions available for gene-set-level visualization: The \Rmethod{csHeatmap()} function is a plotting wrapper that takes as input either a CuffGeneSet or a CuffFeatureSet object (essentially a collection of genes and/or features) and produces a heatmap of FPKM expression values. The 'cluster' argument can be used to re-order either 'row', 'column', or 'both' dimensions of this matrix. By default, the Jensen-Shannon distance is used as the clustering metric, however, any function that produces a \Rclass{dist} object can be passed to the 'cluster' argument as well. <>= h<-csHeatmap(myGenes,cluster='both') h h.rep<-csHeatmap(myGenes,cluster='both',replicates=T) h.rep @ \begin{figure}[htp] \begin{center} \subfloat[Heatmaps provide a convenient way to visualize the expression of entire gene sets at once.]{ <>= <> print(h) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_heatmap}} \qquad \subfloat[Same heatmap, with replicates=T can help to visualize variance between replicates.]{ <>= print(h.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_heatmap_rep}} \end{center} \end{figure} If you prefer barplots over heatmaps for genesets (although this is not necessarily recommended for large gene sets). You can use the \Rmethod{expressionBarplot()} method on a \Rclass{CuffFeatureSet} or a \Rclass{CuffGeneSet} object. <>= b<-expressionBarplot(myGenes) b @ \begin{figure}[htp] \begin{center} \subfloat[A (somewhat crowded) barplot for all genes in a CuffGeneSet object.]{ <>= <> print(b) @ \includegraphics[width=0.9\textwidth]{cummeRbund-manual-geneset_plots_barplot}} \end{center} \end{figure} The \Rmethod{csScatter()} method can be used to produce scatter plot comparisons between any two conditions. <>= s<-csScatter(myGenes,"Fibroblasts","hESC",smooth=T) s @ \begin{figure}[htp] \begin{center} \subfloat[Scatterplot showing relationship between two conditions for genes in a CuffGeneSet.]{ <>= <> print(s) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_scatter}} \end{center} \end{figure} The volcano plot is a useful visualization to compare fold change between any two conditions and significance (-log P-values). <>= v<-csVolcano(myGenes,"Fibroblasts","hESC") v @ \begin{figure}[htp] \begin{center} \subfloat[Fold-change vs significance for genes in a CuffGeneSet object.]{ <>= <> print(v) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_volcano}} \end{center} \end{figure} Similar plots can be made for all sub-level features of a \Rclass{CuffGeneSet} class by specifying which slot you would like to plot (eg. \Rfunarg{isoforms(myGenes)},\Rfunarg{TSS(myGenes)},\Rfunarg{CDS(myGenes)}). <>= ih<-csHeatmap(isoforms(myGenes),cluster='both',labRow=F) ih th<-csHeatmap(TSS(myGenes),cluster='both',labRow=F) th @ \begin{figure}[htp] \begin{center} \subfloat[A heatmap of isoform-level FPKM values for all genes in a CuffGeneSet object.]{ <>= <> print(ih) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_isoform_heatmap}} \qquad \subfloat[A heatmap of TSS-level FPKM values for all genes in a CuffGeneSet object.]{ <>= print(th) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_TSS_heatmap}} \end{center} \end{figure} Dendrograms can provide insight into the relationships between conditions for various genesets (e.g. significant genes used to draw relationships between conditions). As of v1.1.3 the method \Rmethod{csDendro()} can be used to plot a dendrogram based on Jensen-Shannon distances between conditions for a given \Rclass{CuffFeatureSet} or \Rclass{CuffGeneSet}. <>= den<-csDendro(myGenes) @ \begin{figure}[htp] \begin{center} \subfloat[A dendrogram of the relationship between conditions based on the expression of genes in a CuffGeneSet.]{ <>= <> plot(den) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_dendro}} \end{center} \end{figure} \clearpage \section{Individual Genes} An individual CuffGene object can be created by using the \Rfunction{getGene()} function for a given 'gene\_id' or 'gene\_short\_name'. As of cummeRbund $\ge v2.0$ you can also use isoform\_id, tss\_group\_id, or cds\_id values to retrieve the corresponding parent gene object. <>= myGeneId<-"PINK1" myGene<-getGene(cuff,myGeneId) myGene head(fpkm(myGene)) head(fpkm(isoforms(myGene))) @ \subsection{Gene-level plots} <>= gl<-expressionPlot(myGene) gl gl.rep<-expressionPlot(myGene,replicates=TRUE) gl.rep gl.iso.rep<-expressionPlot(isoforms(myGene),replicates=T) gl.iso.rep gl.cds.rep<-expressionPlot(CDS(myGene),replicates=T) gl.cds.rep @ \begin{figure}[htp] \begin{center} \subfloat[Expression plot of a single gene.]{ <>= <> print(gl) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_line} } \qquad \subfloat[Expression plot of a single gene with replicate FPKMs exposed.]{ <>= print(gl.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_replicate_line}} \qquad \subfloat[Expression plot of all isoforms of a single gene with replicate FPKMs exposed.]{ <>= print(gl.iso.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_iso_replicate_line}} \qquad \subfloat[Expression plot of all CDS for a single gene with replicate FPKMs exposed.]{ <>= print(gl.cds.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_cds_replicate_line}} \end{center} \end{figure} <>= gb<-expressionBarplot(myGene) gb gb.rep<-expressionBarplot(myGene,replicates=T) gb.rep @ \begin{figure}[htp] \begin{center} \subfloat[Expression Barplot of a single gene.]{ <>= <> print(gb) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_bar} } \qquad \subfloat[Expression Barplot of a single gene with replicate FPKMs exposed.]{ <>= print(gb.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_bar_rep}} \end{center} \end{figure} <>= igb<-expressionBarplot(isoforms(myGene),replicates=T) igb @ \begin{figure}[htp] \begin{center} \subfloat[Expression Barplot of all isoforms single gene with replicates exposed.]{ <>= <> print(igb) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_bar_isoforms}} \end{center} \end{figure} <>= gp<-csPie(myGene,level="isoforms") gp @ \begin{figure}[htp] \begin{center} \subfloat[Pie charts showing relative proportion of individual isoforms for a single gene across conditions.]{ <>= <> print(gp) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_pie} } \end{center} \end{figure} \clearpage \subsubsection{Gene Feature plots} If you included both the genome build and gtfFile in your call to \Rmethod{readCufflinks()} then you will be able to access some of the transcript-structure level features that are now being integrated into cummeRbund. For now, these features are extended only to the single gene, \Rclass{CuffGene} objects. Feature data are loaded into the \'features\' table of the cuffData.db database. When a \Rclass{CuffGene} object is created using \Rmethod{getGene()}, all relative features are selected from this table and a \'features\' slot is added to the resulting object. <>= head(features(myGene)) @ The \Rpackage{Gviz} package can be used to display features in a 'track'-like format. In particular, the \Rclass{GeneRegionTrack} class creates a mechanism by which we can start to visualize transcript-level structures in their genomic context. \Rpackage{cummeRbund} implements the \Rmethod{makeGeneRegionTrack()} method to quickly create a \Rclass{GeneRegionTrack} from the gene features. <>= genetrack<-makeGeneRegionTrack(myGene) plotTracks(genetrack) @ We can then use some of the additional features from the \Rpackage{Gviz} package to add additional tracks from an external data source. \textit{Note: This feature is now deprecated owing to developmental constraints. It is still provided with cummeRbund, but is no longer supported.} <>= trackList<-list() myStart<-min(features(myGene)$start) myEnd<-max(features(myGene)$end) myChr<-unique(features(myGene)$seqnames) genome<-'hg19' ideoTrack <- IdeogramTrack(genome = genome, chromosome = myChr) trackList<-c(trackList,ideoTrack) axtrack<-GenomeAxisTrack() trackList<-c(trackList,axtrack) genetrack<-makeGeneRegionTrack(myGene) genetrack trackList<-c(trackList,genetrack) biomTrack<-BiomartGeneRegionTrack(genome=genome,chromosome=as.character(myChr), start=myStart,end=myEnd,name="ENSEMBL",showId=T) trackList<-c(trackList,biomTrack) conservation <- UcscTrack(genome = genome, chromosome = myChr, track = "Conservation", table = "phyloP100wayAll", from = myStart-2000, to = myEnd+2000, trackType = "DataTrack", start = "start", end = "end", data = "score", type = "hist", window = "auto", col.histogram = "darkblue", fill.histogram = "darkblue", ylim = c(-3.7, 4), name = "Conservation") trackList<-c(trackList,conservation) plotTracks(trackList,from=myStart-2000,to=myEnd+2000) @ \clearpage \section{Data Exploration} The cummeRbund package is more than just a visualization tool as well. We are working to implement several different means of data exploration from gene and condition clustering, finding features with similar expression profiles, as well as incorporating Gene Ontology analysis. \subsection{Overview of significant features} The \Rmethod{sigMatrix()} function can provide you with a ``quick--and--dirty'' view of the number of significant features of a particular type, and at a given alpha ($0.05$ by default). For example: <>= mySigMat<-sigMatrix(cuff,level='genes',alpha=0.05) @ \begin{figure}[htp] \begin{center} \subfloat[Significant features overview matrix. This plot describes the number of significant genes at a 5\%FDR for each pairwise interaction tested.]{ <>= <> print(mySigMat) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-sig_mat_plot_1}} \end{center} \end{figure} \subsection{Creating gene sets from significantly regulated genes} One of the primary roles of a differential expression analysis is to conduct significance tests on each feature (genes, isoforms, TSS, and CDS) for appropriate pairwise comparisons of conditions. The results of these tests (after multiple testing correction of course) can be used to determine which genes are differentially regulated. \Rpackage{cummeRbund} makes accessing the results of these significance tests simple via \Rmethod{getSig()}. This function takes a CuffSet object and will scan at various feature levels ('genes' by default) to produce a \Rclass{vector} of feature IDs. By default \Rmethod{getSig()} outputs a vector of tracking IDs corresponding to all \emph{genes} that reject the null hypothesis in any condition tested. The default feature type can be changed by adjusting the 'level' argument to \Rmethod{getSig()}. In addition, a alpha value can be provided on which to filter the resulting list (the default is $0.05$ to match the default of cuffdiff). <>= mySigGeneIds<-getSig(cuff,alpha=0.05,level='genes') head(mySigGeneIds) length(mySigGeneIds) @ By default \Rmethod{getSig()} outputs a vector of tracking IDs corresponding to all \emph{genes} that reject the null hypothesis in any condition tested. The default feature type can be changed by adjusting the 'level' argument to \Rmethod{getSig()}. In addition, a alpha value can be provided on which to filter the resulting list (the default is $0.05$ to match the default of cuffdiff). Significance results for specific pairwise comparisons can be retrieved as well by specifying the two conditions as 'x' and 'y'. In this case, p-values are adjusted to reduce the impact of multiple-testing correction when only one set of tests is being conducted. <>= hESC_vs_iPS.sigIsoformIds<-getSig(cuff,x='hESC',y='iPS',alpha=0.05,level='isoforms') head(hESC_vs_iPS.sigIsoformIds) length(hESC_vs_iPS.sigIsoformIds) @ The values returned for each level of this list can be used as an argument to getGenes, to create a \Rclass{CuffGeneSet} object of significantly regulated genes (or features). <>= mySigGenes<-getGenes(cuff,mySigGeneIds) mySigGenes @ Alternatively, you can use the \Rmethod{getSigTable()} method to return a full test-table of 'significant features' x 'pairwise tests' for all comparisons. Only features in which the null hypothesis can be rejected in at least one test are reported. <>= mySigTable<-getSigTable(cuff,alpha=0.01,level='genes') head(mySigTable,20) @ \subsection{Exploring the relationships between conditions} \subsubsection{Distance matrix} Similarities between conditions and/or replicates can provide useful insight into the relationship between various groupings of conditions and can aid in identifying outlier replicates that do not behave as expected. cummeRbund provides the \Rmethod{csDistHeat()} method to visualize the pairwise similarities between conditions: <>= myDistHeat<-csDistHeat(genes(cuff)) @ \begin{figure}[htp] \begin{center} \subfloat[JS distance heatmap between conditions across all gene features.]{ <>= <> print(myDistHeat) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-dist_heat_plot_1}} \end{center} \end{figure} Again with the \Rfunarg{replicates} argument, distances between individual replicates can be presented. <>= myRepDistHeat<-csDistHeat(genes(cuff),replicates=T) @ \begin{figure}[htp] \begin{center} \subfloat[JS distance heatmap between replicate samples across all gene features.]{ <>= <> print(myRepDistHeat) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-dist_heat_plot_2}} \end{center} \end{figure} This method can be used to explore similarities between conditions for all features, or just those features contained within a \Rclass{CuffGeneSet} class. Additionally, the \Rfunarg{samples.not.genes=F} argument will display distances between individual genes or features across conditions. \subsubsection{Dimensionality reduction} Dimensionality reduction is an informative approach for clustering and exploring the relationships between conditions. It can be useful for feature selection as well as identifying the sources of variability within your data. To this end, we have applied two different dimensionality reduction strategies in \Rpackage{cummeRbund}: principal component analysis (PCA) and multi-dimensional scaling (MDS). We provide the two wrapper methods, \Rmethod{PCAplot} and \Rmethod{MDSplot} <>= genes.PCA<-PCAplot(genes(cuff),"PC1","PC2") genes.MDS<-MDSplot(genes(cuff)) genes.PCA.rep<-PCAplot(genes(cuff),"PC1","PC2",replicates=T) genes.MDS.rep<-MDSplot(genes(cuff),replicates=T) @ \begin{figure}[htp] \begin{center} \subfloat[PCA plot for gene-level features]{ <>= <> print(genes.PCA) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_PCA} } \qquad \subfloat[MDS plot for gene-level features]{ <>= print(genes.MDS) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_MDS}} \qquad \subfloat[Individual replicate level PCA plot for gene-level features]{ <>= print(genes.PCA.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_PCA_rep}} \qquad \subfloat[Individual replicate level MDS plot for gene-level features]{ <>= print(genes.MDS.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_MDS_rep}} \end{center} \end{figure} CummeRbund also includes a convenience wrapper around the \Rpackage{NMFN} function \Rfunction{nnmf} for non-negative matrix factorization. You can use the \Rfunction{csNMF()} method for either CuffData and CuffFeatureSet objects. \clearpage \subsection{Partitioning} K-means clustering is a useful tool that can be helpful in identifying clusters of genes with similar expression profiles. In fact, these profiles are learned from the data during the clustering. \Rmethod{csCluster()} uses the \Rmethod{pam()} method from the \Rpackage{clustering} package to perform the partitioning around medoids. In this case however, the distance metric used by default is the Jensen-Shannon distance instead of the default Euclidean distance. Prior to performing this particular partitioning, the user must choose the number of clusters (K) into which the expression profiles should be divided. <>= ic<-csCluster(myGenes,k=4) head(ic$cluster) icp<-csClusterPlot(ic) icp @ As of v$1.1.1$ of \Rpackage{cummeRbund}, the output of csCluster is a modified \Rclass{pam} object. This replaces the default plotting behavior of the original csCluster plot to allow for further analysis of the clustering results. The original plotting behavior has been recapitulated in the \Rmethod{csClusterPlot()} method. \begin{figure}[htp] \begin{center} \subfloat[PAM clustering with JS distance for a CuffGeneSet.]{ <>= print(icp) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-geneset_plots_cluster} } \end{center} \end{figure} \clearpage \subsection{Specificity} In some cases, a researcher may be interested in identifying features that are 'condition-specific'. Or, more likely, producing an ordered list of genes based on their specificity for a given condition. We define a specificity score (S) as the following: \begin{equation} S_{g,i}=1-JSD(p_g,\hat{q_i}) \end{equation} Where $JSD$ is the Jensen-Shannon distance, $p_g$ is the expression profile of a given gene $g$ expressed as a density (probability) of $log_{10} FPKM+1$, and $\hat{q_i}$ is the unit vector of 'perfect expression' in a particular condition $i$. We have created a method, \Rmethod{csSpecificity()} that outputs a matrix (with identical shape to that produced by \Rmethod{fpkmMatrix()}) of specificity scores (S) across all conditions for all features in a \Rclass{CuffFeatureSet} or \Rclass{CuffGeneSet}. <>= myGenes.spec<-csSpecificity(myGenes) head(myGenes.spec) @ $S=1.0$ if the feature is expressed exclusively in that condition. The \Rmethod{findSimilar()} method outlined below is another method that can be used to identify genes based on specificity but has the added feature that you can determine similarity to a more complex $q$ expression profile. \clearpage \subsection{Finding similar genes} Another common question in large-scale gene expression analyses is 'How can I find genes with similar expression profiles to gene $x$?'. We have implemented a method, \Rmethod{findSimilar} to allow you to identify a fixed number of the most similar genes to a given gene of interest. For example, if you wanted to find the 20 genes most similar to "PINK1", you could do the following: <>= mySimilar<-findSimilar(cuff,"PINK1",n=20) mySimilar.expression<-expressionPlot(mySimilar,logMode=T,showErrorbars=F) @ \begin{figure}[htp] \begin{center} \subfloat[Top 20 most similar genes to 'PINK1'.]{ <>= <> print(mySimilar.expression) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-similar_plots_1}} \end{center} \end{figure} By default, findSimilar will return a CuffGeneSet of similar genes matching your criteria. Recently a few additional features have been added as well to enhance this type of exploration: \begin{itemize} \item If 'returnGeneSet' is set to FALSE, then findSimilar returns a data.frame of distance-ranked similar genes with distances. This is useful if you would like to see a rank-ordered list of similar genes. \item The 'distThresh' argument allows you to pass a value [between 0-1] to be used as a distance threshold instead of an arbitrary 'n' number of genes. setting distThresh=1.0 will return all genes ranked by their distance to your gene of interest. \end{itemize} You are also able to provide your own expression profile in lieu of a 'gene\_id'. The vector provided must match the order and length of \Rmethod{samples()}. <>= myProfile<-c(500,0,400) mySimilar2<-findSimilar(cuff,myProfile,n=10) mySimilar2.expression<-expressionPlot(mySimilar2,logMode=T,showErrorbars=F) @ \begin{figure}[htp] \begin{center} \subfloat[Top 10 genes most similar genes to a provided expression profile.]{ <>= <> print(mySimilar2.expression) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-similar_plots_2}} \end{center} \end{figure} \Rmethod{findSimilar()} also uses the Jensen-Shannon distance between the probability distributions of each gene across conditions to determine the similarity. We have found this to be a more robust way to determine distance between genes using the high dynamic range of FPKM data. Future versions may allow for other dissimilarity measures to be used instead. \clearpage \section{Miscellaneous} \begin{itemize} \item In appropriate plots, using the argument replicates=T will allow you to visualize replicate-level FPKM values either in lieu of or in addition to condition-level FPKMs. \item As of v1.1.3 we attempt to provide new visual cues in most plots that will indicate the quantification status for a particular feature in each given condition. We have enabled this feature by default for most plots to suggest a measure of reliability for each feature in a particular condition. In most cases, this feature can be disabled by setting 'showStatus=FALSE'. \item CummeRbund will now work with the hidden '--no-diff' argument for cuffdiff. This will quantify features against .bam files but not do differential testing. This is useful when you want to aggregate very large numbers of conditions, and cannot afford the time or space for the differential test results. (Not recommended unless you have a SPECIFIC need for this). \item All plotting functions return ggplot objects and the resulting objects can be manipulated/faceted/altered using standard ggplot2 methods. \item There are occasional DB connectivity issues that arise. Not entirely sure why yet. If necessary, just \Rfunction{readCufflinks} again and this should solve connectivity issues with a new RSQLite connection object. If connectivity continues to be a problem, try \Rfunction{cuff<-readCufflinks(rebuild=T)} \item I am still working on fully documenting each of the methods. There are a good number of arguments that exist, but might be hard to find without looking at the reference manual. \end{itemize} \clearpage \section{Known Issues} \begin{itemize} \item Large cuffdiff runs (e.g. $\ge$10 conditions) produce very large results files. These will take some time to parse and populate the cuffData.db sqlite database. While this is only a one time cost, the process can take a while. We are working on making the table writes and indexing significantly faster. \item Cuffdiff does not 'require' that gene\_ids, isoform\_ids, TSS\_group\_ids, or CDS\_ids be unique in your reference gtf file. In fact, duplicate IDs will be aggregated by cummeRbund in the indexing phase and will produce undesireable effects. Please ensure that all of your IDs are unique prior to running cuffdiff (see cuffmerge for help) to avoid this issue. \end{itemize} \clearpage \section{Session info} <>= end<-dbDisconnect(cuff@DB) @ <>= sessionInfo() @ \end{document} cummeRbund/inst/doc/cummeRbund-manual.pdf0000644000175200017520000577322214516027267021522 0ustar00biocbuildbiocbuild%PDF-1.5 %ÐÔÅØ 155 0 obj << /Length 1320 /Filter /FlateDecode >> stream xÚíZËrÛ6Ýû+¸¤fB/‚@w®»i’ickÚ…ÛMA2§©òáÄýú^ eêA?d{Ò–ñâ\œ{Eä,䜡=Û¦GßRäàÐ'8`ÎtîHé³P:\pKéLgÎ¥{R/—êüªÎfßO<†…ûkRÖQšüUIžM<Š©e3³óîë*Í‹;Wò¹ÙžÔ¿#&ÙŸåäéOŽ`¾ãìK, ÐÉâÚ«®‹¼^\¯êÊA˜™>³ÀÁ̧Œ7}öA>‡÷ðñ% ìxÃÐQìV 6È­šñ:ÂÀrŠ…cvÎÏ€:ÆéKN¸n Ù±ä¦<ñ$ Üs½¤PK5Á®iÕ4×JÀaRø$¤pÐî¥Ç%rA^zé “òu€¾!¼±Æ”1Ëm{v‡š¥“·t’M,ÙÏgˆØÈç³ãDd7/iŸÈ¤š˜$‰ü6'fÇ'ëñy:订ª.ÔpÈ P8’ø¼³1x{Á>ö¨£l\-Ÿo‘Á=DnXH¬©d}ÉZÍŒjã†åY¢Í™¼®´aòaüÆ:vB¼ÝÓ§­©ÿ¢‰ˆŠª‰C:žmºB,F«þÂx»xžhmýb ¬2±Yíui­2ßlRKÙHÃëàíbX>ÚöqËði’­‹Üe²LÒ¨0o”á‘Äg6í ^MÄH û))c•¦Q¦òz¸ÜÆ>Á1wö°AøåºÔÝÔ“!©|_–õ=…%FˆÔ~RD Ò….¦ç'Éæù0JÿßÄÍ\•0ê# Hœû‚°ö㥻¼›ýÅÓà endstream endobj 167 0 obj << /Length 799 /Filter /FlateDecode >> stream xÚµVMsÛ ½çWèˆ:$!)Çt’t:~¸žé¡éËØ¢Ö‡‹;ί/äD©«¦Éø¬vyoß. ä­=äÝœ!7^ÎÏί£ØÃ #J¼ùÊ‹#/!)DaâÍ—Þ7€ýc„ÀŒÿì„ä¯ýÕúßçïίIæe0£„šPäç6òÃÇùÕ…DQò®ò1¨ølÑÕKk"ÙÉ/Ÿ¤€µf‘‚%oźæÎGÔÖš7õ®Î•hj#TagªàÖGò’³Ö-šÕ€{«õ¦=€B?H2¾¢tΚ@Üœ)Å«­¨Æ¤iÃfqlÛJÞr¹3¼uX˜E`Ár³ÚØ\ä² ò¦Ú2Å¢Ê÷~‚×zW¤ÓR6J´f A!ÖE¹·6Éu¤yi(ƒ*˜²n{óéì¢ÛúÞvÉ”£°7(M'íêaâ=”–_k‡A«XYê³bömB²5lq鸸½Ôjp‹H|¤˜D™öí}úbú‘mœÖfµê4“~Æ–;?¦€Õæ«bkç`ªØ‡Î ª­l Ë]¿é)ncZçPÛ±j¬:¼õZ«N"ª•5’i¥º72ÓŽ„Ä`'ÚŽ•F¦;'±ZñÍŽs¸é@ÑCp^Ðy#mQ©«²„FžÃIÓÇl¬ΨVT[ˆëª[‚Ñ£‘´ýlöÍ}}ÿ,U¤a®©”.&¢éà´3'O1() _ÀùËç÷Bwë†õ>ÄìˆA“ÿS#„h’gˆ!M¢ôD?õ…½4ü8ºçÛ‹ÇtL ì‘4.—11gž CR³ãú? \D€c˜EÏY¯·e£È‘2„ú‰¡Gšr¼™)ÃáþØ!˜Áp’pL!Ž^ÀWßä³§–“§KƒŸƒµ-÷ò´ê¯X«ò²k?1T’å›’Ù—­6N x³w§E¸öÍÈoxÍ¥ÈõKpìnÕ G3ü”6>ìŒ`§{+IaD“öÖøÆîû߆‹©›+…”f#•^MI4º³ÞV¢Í')¥Dú')ˆôþ¹ßÀqêWó³ßä2}x endstream endobj 2 0 obj << /Type /ObjStm /N 100 /First 825 /Length 2143 /Filter /FlateDecode >> stream xÚµZÛrÛ8}×Wàqæa!4î¨JMU&YgR;S“S5ÇŽÂxU£HYIÎ$¿§i2Ì›´¡Dˆ$Ø}út£ÑAB 'Œ^"‘Â?¡•Æ_¡ +ŒÁí LÀ½(¬Ã}6º™ÖÂù$´^Y¡½ð1 DІ…Fƒ‡ŒˆA cEÂã¸@ ŠLD¸e!‘|œYVçY6Ú„ ½ò‘‡v¨¤ Õ uN8+(é(ä%‡j• 4¥f^ ­I \Ò½‡-Ã`ÙŒ,nØèZFþ! Eÿyý#ä…@³yÉ‘ˆ—"®{at„… ’I ã€?Án¯Ð‚4Ÿl†É0&™Èô±íIù`“Óá„UPMl®‚bR ¼€}‚#¬6Ž©ÂØ@p†5LÜa!@–µÃ.±!ÎN±Î¡œ`“ÆS‰] G9¦‰à*G äêNáb2-#„ûœ‡f‚]°± c˜Dx¥ÙEL;Ž+<ÁpoMíEÎPaµŠ;G„…áÎ ü³V‰@l2Ü´£1å&¡³5"8@ kEðž;Ã;Üb"$XUä[QÄÛMkÀŒ8‰üûÊ[`1À}„Љ ´‘óp‚'©È¦Dbna•ˆùI#l©ö©‡áR…‡q3YkfOžˆù¹˜¿Ø¼ÙˆùsñÝ®Zì—›µ¤ïÅ?̾{k‚Ç/¼UJ½æCŇÿòá†K>lóùßš{>ì¾ïU¢ÛJ^–×¢7|xŸu.òÝe¾»îWbÚJžeYKÔµ‰ïòÝuVüVY•Ÿ\ñ᪶-ª>SoÞe ]¤ |ȇó,p?ª{D£>Nãó,uŸÿ}‹Zs‚Úe–úÍÖÚãÔže~&ß”<¡ Üd NEÑ@°CCù*‡ø2Güõ}e‹¬‡þ‡kwý7¹m§Ãé O¶kp<Íʆ^uôz˜r¿Õý'?ÏùU³ÎR÷å“Ge£Žhx‘qmrúicÝõiÜ•§‹|­ ½HeÿÎÖ”¸ûÚ ¸M_f^õ[ë{|ºÈ‡ªL£=.~˜ŸCÉw…Òoóƒøh+ûZ†ñ¶Ýççî.ŸgBn1ßkë&K¼¡'{l;B·Çžå¤\µ€WƒsõØÐEl—ô]wö\åËŸó¿"Æ?•#a¬|ˆCåÃ!|ÎÿÞw„üKÃtÄcéøÇ¤Æ@áXwzN˜hNôGj*,þɇ/z¶§äÕ©‹‰_KÆ·e@Ty8üC+ñ.ó¨Z—sß!ç^•ùñ„9f7b–þöp=Fë®…þê?N@̪5½ì¸Îì¬J³ªÖôu}òxM]eépö°YCúO‹Èm9°¯ú ‘]~|™¬¿+=òw>­Z3Ï¢=\¦“Ôý’ÒU§¼ºhñ±4ÿ@å—cè!Þ0wƒu^O9³-#ꤗÊûP; ëWÀ¶ØåŽ{Ñ5¢©£j<Ï¡Seü]£ï#J:е³æP¾+]´,‡ÁöÿºwKª ì—2"åÈ[•Z•ݪŽàÿWYô·‹¿—eYws”MºÇ£]õð¦¥òàƒÚÛ›–¢ ^4SⵘŸ-÷—¬êÉ“ÙüÍ×O•˜¿ºº®fóg›õ¾Zïw‚œãž³ùëj·¹Ù.ª]½~T_ú¥z¿¼úqóE\(\¨“¾œAÄÏ òM¿§ëõ¢.ê%:VË«P·­oÚд±iÓmkTÓRÓê¦5MÛÈ3<ÓÈ3<ÓÈ3<Ûȳ<Ûȳ<Ûȳ<Ûȳ<Ûȳ<×Ès<×Ès·ò.gµ5³ùùÍ»}}þórý×lþãfû¾ÚÖªËùOó—ógTŸ0鋽¸pF*e…³Vj_/KF✓* ×S1¼N7) 1° ¤Šõ²ªDŒ ¢ÐÓ£PZÞ®Ók镎Hj“Q˜éPø “åÕf%-yv¿4†ÏQõ8¤½Ð7)’¥õàÃEœkac†Ü8==ï¥ã…lD§М4~É#¸ÇY鉕<‚­7Òª#H±ÓC±ZºÄŸ—üÂ,HÚ#¸ÉGŽ¥(Qô2ð·úÁÆÁ‘ó|(hçhøCP.¤1Bì#$4ƒèˆõ2Ž×(LªÛAB¦w‹ñZò>Ì8RA42x=ˆÂOTH§ÚXÉÓ¹ñ$C2cnñáÄ%Ï/hÎ &½˜† Ó‚¸ä¢ƒ‚•õ÷1ëz”ð„è©üa˜g}þЊ!¤4 ''DGÌ<Ñ ^¹ºÒÉJåô!qJB0ëF¡f]d0­ri4 bú§ß®e±Idñzšxö2ñt¯$¥áÊ(Mï 6PkŒñ£m”Zο銭D™j4Õ©M¤¶@ãH¦¯I4a*Õ¼©ÁËX“ƒáLGb¦Z(ü‰‡·k YOGmš¶plàPD˜«3¾f†JZåÄ3½§(¦/`ÛÈ»u­;"f¦/QÈ;y»±¥4oŸ^Ú䯡¸é¡ ÃÞÊŒõö ¶v‰Ÿ<Çñ[_à÷.ÌÆõ9êZ?òÞÕ,ÐL ¯{ÑÕ›n¤¯÷)ú¦årñfJ;Éò¢…´ðNŠpÎpÝHÅ€¹¿óûò®¯€—¥ˆjg}³Z]öö³"`êëãð¨ðÚSô;Û¬÷5¼3Ãûˆb³ ÄÛá\jNxó‘§»Þ¢¦›]ïS«O oþj»YœWàCÌ_=?ó7Õ—ýÃ5‡ËI>´–“¼;i9éžÅÞÇ^ѯƒ½+…í÷ÌÅ ‘)â| º(ª·ðÑýÿÛ endstream endobj 174 0 obj << /Length 2117 /Filter /FlateDecode >> stream xÚXI—㶾ϯÐm¨÷F²¸‰âÑv@$$!ÃE=Óþõùj¡Hu?_D PU¨½ ڭΫÝêïvúýáùÝw³|gÛ4Û'«çÓ*ÏVErØîÒbõ\¯þ%ëMïvÑÏÝ:£Á÷ë ¾õX ®ïÖ¿<ÿé»ùnUnË}²'úÝj“ÄÛC|òjl[ûé8vµà&åw¿Û²$ŒêÂz“íâÈÐ'‰^\Mã~5|Ÿ\MµNŠèó:ßGælx‚€QïeóãøoHîºÏA˜\Üù².¾Ï—ë8R°_FÛU®; Rm³]oöYý¬(Nékܹ³µ@‡^¹Úæ*W’§I·ÕFÕ½¶ež‹RY'èr6äMs0i¦BãϼÜE¦íÇŽø²ïO‚BbÊêJ^[xD#ÐÉ÷­’ €-‘ÖŽ~òéoßožìeÆÖÛŽäœin×qô,zõ6¶<3íLó\€™²²ˆž!6©¼Se÷¢,HÆf€éÒÃAÄÆw¸8…LLtçIßC 5!ÁëÕU¦i^õL>“Q°d1Ç–~¬»õ÷×8QÄú· Œ] ZfÕ+Rìb†;À»W¨½;NB(ÇÑ î…VŠMA m(Vgï. ¢ÞW_ÃjyZFl;§Ã&ÝçIA–pjÛsì³È›«S”…Õ°cu0;@ ¬ŽlKA1ç³· qþ"…Fµý6mpž®hšž¿rJí2®ßèdMpd¢$Éo9jeË “dÏšz²…G>A¯ã±—‘Ï€²ù6wxõ«à‘ÏΣ'¯WR™¾*“—ÝÍ´ÐêëÅ5z]kßC™d\Ǻ±”W˜úêÊ•G0õpqpÆ•5â8P¿r(XÊ‹=½©Ò‘ •Äf—\™¸×h¢ Ê3JÏe ì£É¿F¶èÈ%w2•U¦y‹V–'ªx„oMÛ¸Î>ˆ—ýìã7åTcé²­AÞKÀs&¤)ê®GˆX*)‡ž€ÖÀí·Eñ <±HµòÂRiIñ%9ЄÊ,»æÎLqÉž("{v]˜ðX{»éýÙtîWáÃìãÀeŸŽçRkÙÐȧº¯–ñ\¬(W’)WCï•}Iå;X«’ºnÁELjuÅÖÁþéŸqZ-6w*k%FG, röÎEÁ9<ÕhZK#)n‡*…«Í*‡ñ*禪à¥%î^páùŠ,‘UakžK5)’Xš¾ðPWOÖMvÜÇìQFÿAôМÂS&ìßZžçÒ¨ku‰¡ƒfÒ¸+— æÒh”ÕÜÃhDZ˜ìø9Ž$‡ß¬#8ÐÌÄê~ð~–¦õ ÍiÆ|ú³ 6Øòø/ÍV®ò½ñzY/»MÒ›"ÛÓŸ5BÁm’Vôô5²¼œÓÖßX_›~äºà.=Yê7Œ(¾$]k°›iñö€{rñv½=öÔA=,°ÔòjYŸ›þÈI’[frÖ“…ÙæJÑÔh¯¡Ç4 ¿“†j}9-u&ð]AÀ¾±R¹›{²]HÙNj,"<¬Ã\ßѧoƒrJÖyíê<0·Ó OÉŒ™¯´WdLÍËÓÿßòŸ/:hÿÊ óý¿.^þw؇xúNÞAOèNÿûo]šn‹2^þ[Lj|N³|ÿýkñ*L§®9…O@×8ÍHýqØô§MkÛÞë€äºÅåpû—F¦ge+Ï'hpû£s§°O ;eq¹Ý•©(‘Þ!ýôüî¿îÒ: endstream endobj 180 0 obj << /Length 3037 /Filter /FlateDecode >> stream xÚíZY“Û¸~ß_¡7QU—ÀËU~°×qŽÍV%žÉSœÚ¢$ŒÄ˜"žÌ¿O_à¡áLÆë\y°…£Ñh4Ý_7'XWÁê×ßòûîö»ï?˜h_›X­nïV‘Y%*õ¬n«?{z³ à ð~èÏgûq×W‡ÍVlj÷Ã&ôÊ&½¶…¦¥Öæ/·¿ûþC¤VaègQD ƒÕVi? Cáç‡ÈQEÀñS õí€a]àF̈‡ÊV™ŸÅ*aêë4eo7[%Þ~R¯.ª üt¶ÁÑÔÛ—9ð ‚®–¡šIšºä‰|¿·L” Ÿ,´+‹ÎÊ`¾+­žêòPTÇu‡HŠê³Pò.÷7[fÞ­ãxi 8Ù9od‡²îxu!«Þ¿ãþý©ØoTâ¸ëÏ‹ŠÔBŠ Í²"XŠ,ô>Þüñ÷,4t`Ue÷]‹©_ï6Û(òþ c(™@2Úis!Ú‘2…ëǸ׷|lhâ†|ÅáäzTù`D õþݧ à_¸p“*ò3£)ïS7ƒXnÿá@ùó’û¨0ymeÛWØÏ@ƒõ]Ýœ¡‹úÙê ôu¦æjº½¹j/'ëÍÀØÞß„<ÚXµùõ}âaPz—W{¼œ¬ïxxYaû:‰ÝÉØ¶ßƒ1,(Á_¥©ìL<‘È<²q‘§[Û]K'‹c œž+"•åý®Cs{ÀmÏú¬D¥?ޝ•x²`¾ìšlƒÍ`g´ìÝ݉[mq.ʼ™ÕÒ»oòËEx„^C„L! E"÷K¶Žƒ½Ëû²YDyØllÞ¹ýwt¬…{ÒYàgiâ”ßl"ô]ÚÜä)?¾³( ¥4÷îa&Ò«…ý€.õáDse>oÚ7ixýFp'ãQS¨ZxÖtg‡–'@“eÁ§7l¡öò%CÕÊO£pn¨è„ ¢c?ë j·[–¼C-÷×ä幺â¹/ã­é¹®y_2]qJ¯}éxÁð8š¾úmuW?ãQà1é8sôgÛjéÀбšÁXÉÂáBüØ\]J?X/ë/õÛ5…ý‚¶dy¤¨ÐÛäì\É¢™oÝwL0˜i¾ïú¼Ó$% ü_8÷²¾èZ[Þ¡{R ¸ï1ªöghe}>ƒWØ–Eåøº§rìÏw+”޼°í[œA™$óð莦Q$žD­5·+FVÚ€£Õ¦Ä Zÿ©¨ž€!E.ª«YTÏ>†Â:0É_ÖŸ0l&/ó«€-FSp@ UfSxe[óHÎ? È&+;¡çH shydÇ>õ3GèUŠHÚÛ¡) y]Žå(ƒD“¹D­xÞ=Ú†Ùó ù퉔찉œvÊ›Ã5ÌOb"Yw zÐñܸÇ8¹5I,!|“‹„>÷Þk œÃ£¸ø‹ ¯“’Á”]UˆÇ8,øà@ùÑ肞 ÚŒq¤³‘wwÊeçH’9Ëâ}¼ÁçЦÈ:bÄ$Ê¢¹¶2Å™p%ê&c‡%oLH˜†àÑ¢“ 7Xò€óÚø°{Aœë’Gy º€ö:~êЛ¸®–GøŒ´QYÖhK÷ÜåÀÇ²Þ [\zh YKxGÉS㈎}ceãsQ-aÊ¥˜,I_úÑ'LŸ ÓïðüÃAˆû¾i,ß]‰4Rä¤á5 ¤ÝÞ7è®"ÝÅ‘þž”Í~ÙiµèæÜtâ.˜3øÃšh„O¹©ûãÉ©Xn¢ÔÏÅaÍ]|¶< Š”þq®§·›0 ½/*€CFNT°*ºP¾&­G;sŽzð4H ¶ôwr3H̦š…-3h¦™Ÿ¤’›}RapµfvÔŸÙkÞtHH‚I²€ýÑò»ç¤Ù2k”&uq䫤aœúߤ]>¶9DA™väeÑ.!”0ñ•ÀÙ<ªÛa`h«w¸‚éáÑñýÐC²‰3¹ººý$ÑCJNôžSQøI~ƒŽ(#èNMÊ7¡ùEjØ_Yk;}¯DU݉>Ï—ÒžåÙ^‚¥ô;Ž#Ï©$Ø¥œÙü#žE¿gÔ¢?HµìO9}Àdã1ddSµÃÛçól»oŠÝ  ±ã²(ÑOa}FÐ ¸Ð„` ÿCì€X ëÚÅ»§_X5úó) 8iICôrKXÉÏÔRb Ê ÉA.·¸{S#x9Ø¿ss¢ål—“ßE†" ¢Àz@ O;c1ÍDßׯ„§8¥Òê…Ø5:Ü9/Y6è°+xÓ ™{ÓŸòÏ\èˆ%.`CÒ†¶ã®ØÔAÝá¯-ðF¯Nª[*æ#ŒÃ°O€JLq(y±¬8¢`ûS÷¿æßÏôäì…¹»º»k¤VÚZž’F?ÛsÝ<,¢€Jì¿-ŽcÓ|ªÁþÁ4Œù0µË)I"°‹£r-Æ£T 9Ê š{Tíd}a¾¡çù:¾¯,#>™o¤ú*=~¿ìVMà‡Ñ£|#æš…Š.c!͈³qŒ¡UQÂÞÑ"©Üo6¦hØákLÇY@#X;*ê^ø® 9¸¯^ªÈ l³q'WÂ×…P>yà©9Zt’¾:DZȈZ¼Ù$Á<’Xéð:ë ^Ax5Áªh}®^»”µáñ¾Í~š>±òŽKYìá± [ëã½3b·%ø_¦£=À%E˜ r3ž§¬Øråüáb• žM‘Ãq¸Õ9O‹¥àøˆÖ±‡7‰¿èô¶”˜Å.cãn„››¡ã"9œg[Jê!|ïœ6í»6íbÆu”Ùs‘ñ”Ë;NœÔ@P4"îj©p0±S´i R^e§ÚH1 ¦ÐáÊú¢= íÉž™$oy¤í¹N‰Á"‘:ίÉVªPD€,nÝØ’¢©0 kgkžphÜH…~—Æðê_X3ÑuI̸Š-Š.|© i_¥‹UÀ'KŒ±ÜÕ¢]‰6_˜þë2vŸè”é³ÎK“’Àáþ?'ù/ä$sïN,mÛÑôßœŸüïƒñ‰ß<†¸,Ùÿ³(Í.MÇÅBw˜Xx2EàñˆÀV >Ó÷åQÇ‚" vø83/c¹ÕŽG  ˆ*?›º¿8@;vÉüzß\ù`äÞ,…Ä5(Ù1ÓKˆœ¿ö¼AY×c= Žãü9ܧíöþ&ôÆšà ð aì ¡™AÂúò…E¯é7æg‘aòÏ*Ñ£aºM’D¾a¼ÅIËq#Nüë/~*‰)"òà.Úñ¶íŽå”+ñüU¨Å!v¸ ¿L;>”@À˜„tă.¸ ˜’‹ÌDIýKc· ÷{ÆO ô‡ÉÉQ ±Ú¬•Z¢£4ñ£ ›cƒ :¡³PyþðãO<„bàU‡OÀC nì±/‡-“%‚ˆ3Ë1Å@ôÙ«ªênXª$6ãD)Ìs´Æi¤¤oR‰÷§ª,>Ÿ{\V +A;_V/X¼¤pÎT ™° †â5ç5j©êa†cú#š}cÂNh¹®ÈGl Rv4ÉÞôéÇ›œ3Òå½gÕjàËÂæ}á ùiá \œbÌ{ó³]òå™fƒ+¼vGä§:A7¿aOK‡&_‚˜Ú9!Ìž9‰*…dê‡ôõuM #èê¯øÍ°â ÏQÝJ)L‚!@WÛ03š_Ý~÷VØ: endstream endobj 185 0 obj << /Length 1897 /Filter /FlateDecode >> stream xÚíYKÛ6¾çWøfˆ¹âKÜúÚ- ÈÞš¢•-®W­,¹’œ4ùõá²dk¬w7A^–49g¾ÎkÃÙfξ_ß¼¸ºVé,ei$¢ÙÍí,JXªô, e<»Ég¿o¿ÝüØ»ºÃ3v–øv÷×öÕb©” ¾Z,¥TAžuÎdpÛd[CÓú–Æë_~úù˜,[7uÛºyYÒd]WyÑuÕ¾t«:ؓܚ¬Û7Æ,*wÓj±ÔQð§YwìHŠ‘äKcÉaúɳ»^$28@X,y ,x`ˆyCn@À…H‚·ø§.aˆ“A’°«5¼÷B¡* ·E¾ÏÀOY¬³ÎL  ”4ÿ åÅ›PÊi¼Ô”ÁÐÓ‹VWxiÍ?;¢¹jÌf_fh+ÈM†`Èóæ£ ý@$¢ X×{ Á‚& ˜y0Â8°¶]VTÈU¡\Új2ÜyGG²*§UKQiƒ´¿¬,>Xû¢/o¶PZé™i‘í‡ g|M‘Ukc—Pín±Bƒß¶ÄÈP]¹}Ç@ìáLƒüÒ%Àâ{w7è –œ³T;#z­\bŸSÕ[ƒ*á1ªDÄi°Fî²&[w¦¡%+y×Õ†~ã[„§×ÿ~wWÐ)ú¹ÚeNS´k»;ü„¡t«ßp“¬mk‹õº€GíŽà±$£ÍMSXOÒÓYÅרyÂþoB¶aSèÿq·áéüåÛm::ni,–rŒ¥5Rx#ÎÀ¬Ð»ånc¿Â{—°´.3ë©BëôàƒWך`ç\0Á#ü7{|ç׋ÜàBƒ½‚˜8š×¦£Ó#¥E1Kbéî"Äîô&1Ä㋾7Õ=_Ö Ó\õ¯¥@¥nîü=VLÀt c–燙蓬ÃÂ3eÝy6kÏšIȸTN9Ñðið¤¬áõl­{apóúõKÚ WûÍ·¯i…”Þ'¹?¤¥aSPÄ©ègk:šX· ô`‘æ÷"'Ñ} XÉ«èÈF2!ë£KsÓ›ÊÚ¬Z”ãÍ<<<ÂHÆ1ãZN¹|’) ø-ÄÄBK«c8`àˆ(:À@òÃÄÊ#ÊßúÃÖ‡ÕŽ 2nÒ‡LŠ42‡Ïš¬}ï.xß­ÿ•_yšmV;¸f ìNìTÊÔ'£¼tä#|N˜•½Å‚—µ.‡‚dYÖ(í;ëÉÊší«s>—+›B^îsÁÌÆ Á|ºówN‹eÑvãÔ ÞX‰ã}ëó¨Óì¥Þ°îi/Ñ©>µd —:¾„ñHûÃSz=ÍtÜFŽ?Z´·ÀâÛ¢ÝÛÊ‚–Çq­,Óõ¾#‚Œ–ù#hD­iÏa†¡0ì“- öcFdsqNKƒ²S!I³ÛÙíl†Vc0˜Èx­T*±Ui0'†jë)èÀöÀ¨iι,›UÖº_«Ì†®¿¬Ò«Õ˜†¨ÆÆÆSº7q%VçE^ôel4æï}јA•f/Í:Ïö”WPLFÑ¥Ö.O\&ñîæº*cc È”HXšFU÷Pc¡˨îc>lrÎ:½yã —D ú©‡/?Öñ…X¨89ç‹j]îss6)Zм]úˆD"«ªº³OÉ¥?Ô¥OØFî%¶Å¸kïNyï<|‘cØÈ“»º±:RÃsÙÏÕ3l³í®4íq÷Ë%‰_@дÛ^ïö°ƒÏƒLôßìN¯>YüßúÕîUĽ­¨Dµ¢¬˜¸º_-}Ò–D÷5 4ÔÉâ‘òJÓáRkfÓyh ûi?ñe¥!§Çݧ(ä>!"á¨/xÐÕò° ³¢o;ÁŽ˜È_MKγXÑðÔÒ)ǽW=¾ì %7#…ƒªúêà¡Á«ðïÉßµ…‹OEŽó³qû©€}ÄÂT?¦K¿:ÈíþßµÝÖÎöç î{óûJ²C™(ÀžÕ{=]‡ã¢ìëSÛÓÁLî|ñU‹/ÝÚx"lNú—Â’¦LÇñ#LþIZO„ÊI?ãbc 9‹e,þ:ç^“oÓ[ >|vkáÀ$a(<¢ø ƒàÜ^ŸõÝçÈI~¡w ]“Uíº)v®7»u] S¶>‘ÅíU;I-$ûß©!R3.¶±(ÁàR‡¨}wóâ_ÏG“ endstream endobj 189 0 obj << /Length 2886 /Filter /FlateDecode >> stream xÚ½koÛÈñ{~…¾…N Éå3@ \’s)‚;ë-®$©,ɸþ÷×ò%Úuï‚~1wggggfç¹²·9n¼ÍÇWž|ßݾzsF?tU›ÛÃ& 7IºžJ6·ÅæŸN¸Ýù¾ç9¿ê¼(ëãv§âØÙ÷¿{J%þEHâ4}wé»í¿nÿöæ&ò6™›ÅAŒô¼Í.ðÝÔO™Ü¾?Ÿõ¯w}]0nMpcÏ Â ¶êÃ6H¼úaàº-µ.xÖ5ü½Ö^·‚×4|ç¼ §¯ºrL†•@…MB=4æœcäüy=—0I×ÂC|G]ã]™WL[ÿûbˆß)¡©…bWmÙºÛ]˜øÎ§ßìDVP®›EKÜÊåª(ûã…„Ó jüµô~‚i– Ãí[mxôPVÕ“-ü1ú€\ïê;!i5ÄãÈÓ%¨QÈÝ× òòPÛÓë¦Ë»²‘ycfG¬ÓÜwxw89˜æ<ÛCªNÊú¾%Íx¢“˜u’·­>#wÕ#à' ß³-›£è¿üR· ð/á[Ÿ×¸Þ• ‡l&«ÁÜ!‹»¾o# Yõº]Pa;`#HÅnô±¯¬~`ƒek8aT jšœŠ-¦PâþÌ—}0ÍÂhÐ,Œó½iÐäÍ‘œ¦a) ¾çÆúo?~óîçÏS:d—ÊsÞ=2” ŒKÓïAÃ=´½õ‡ ³¾—8E¿×ÂAÎò‹ž/-XiDë….¬´¹€÷ +6/ë5õtºEÄ$…·àå-Ol0›Oy}Ô²Bú„ïü‚3‡Î÷–ûÉœJǽºâ)ß_æt&¯Û½)/;žò—çÜ<>µ,–’9G4Ó•ˆR7¨ç“°Ÿ¬j›Êuwß^Kñ„(/“˜ç¡.Ðô¾# äisryœ¢4´cd—í)7Ýq||¸üæ|nêå†Ò‚Ú.7 ËN£Åøâ #æ€Ê5sésíÀÝÚUX Wq°VI4XЬÂÏŽºÖ ñHÎí6U)8uî%“)K³Ú)óªâ giׂDy­Ÿ…7„wË‹$9"]ªr_ÚË?Âu”ˆiLWN‹y×Y#6*Ý­Þ;³£,0¸bC…̬-ô®P‘͹éHXÀ£,àˆúvSÎV²B†Ë•›ù>óñ òö—Ü``VQì°át®–!t)Qâ¼Ÿ× °bô·¾4”ÏaýᤃÙݸ"4mœÅöñö†aw6Y"T¢,ÓI4^ØkC1…À rSÞõ¸×Î yåd ŒÓ¬±”­@Í=ƒ¹†P‹àƒKc´`¤2HÉ‹cdB3 =±Ÿú(Ó½„[[_#cL‰M‹Žï8Ã;Ƹ{Î-•ÄTË|@~_±±ªöq·/¹KùPöåd+…Âè¯ùŽùîÿøŒÈž¼¨ý0v!ôÙòîÙJ0ŠÝ4 ,*Å–Ì9±S’%‹­ 7Ö¸áè¶£úÁFcÓ¤’QŒ´ÁŽF2Qø²ù4V,²C»áÐØ€Àq@KÓ <åq¶f;ÊyDf›K Ùpa0Ô§0fÓ ) ÔùƒC H¼^H1ÖvPRv€âª7ZÜYÓ~ 7„âþ×¾+&™«¢`nOÚ†‰F˜gdÑÞ"¡í€žczœçzžšËÜ$ÍýøÞbËŒCY»¶ýZo·»8 ‘#,h”óéñ‚ñËÅ5Ï{MŒ•mÙ¥ „h’àh (ú4xÕ¹¬%Òâî‡SÉ.Ïȃ—ÏÏZr1í]t±šù¦"‹Øc³ÐF:¨o9ª¼L¶_0z͈XjÛqI†¥Kn4ãå— EpV(ppÈ&æ=%:r …0/4š;–ÆpäÍ$ eì|+"ºÀÕ‰ Ð‚KÜÑ%ÜçŒfÇ&€V“FÄj.`3pž“‘x€2OÌÆ 9j `Ï×ÅM0ZkÜßpГËîµÝE×ì- V&…-Ö‚1ô·‚NÕŽ{'`®[NZX¾ÃˆòÈãÅÕÒ¡ÍZ+%½q¶ªõ0£xiÈ`ÒÔX”<òäá¤k•|Íô² !äò‘¨ ݦ ÓYãˆË’ò‘T½¯úBX{ÿá·3˜¶ ¸Áâ­7Ø–þ´fGk혊B!…C×Ì3û!y$­¶¡2°`˜H»Q•ÝÛ ’¥p þ`ÁÄ£SŽœ µ8AGÈC¨ÄÌeÖ£±ÝÊÇì)§–V|Eä÷cÛL>S7RЉ=à„õvEgê3×6Í(l–¡Ù“q- ÄFžšáÝSÉÏzNbRˆK¢@/Sóp¾x/’Î2¯öØ+sù?t žsóåïÔ¢Ú~Å㢞,!GR›OꪵUiI<¹¤ËÓ’n›Ÿ/º±Ëqý ’µiá‘wNÜùÉ’‘D7äC/@‘ÈgI°6ø*:nßM;µŽÝBŽ–hŒqµÓNc”š7C8jÞ4ʇÐ11]Å%àÕ4ýEÈÞMì¯ÄBEÙtËv"}8Ù’+ÞÛ”ôE€É×+¶3mdžÀOn¡$öR£Ó™~EŽP•41I¼ˆ¾ÏÅ”ÇVm¶é¹(VC=ÖÙ€O½ÓÂÎü<ÔçÕJç3T=–•AR8ƼL><ã‰n@UùOå7§ÜÃåþüµ3ÛŸ‹ˆ•ëŠÏ÷X³{¥Wžô'ÖîžËȾ»Yÿלü4Ïhq/c8SnœøvßGm[bâ’l3B)¡ãG­·öú­Ya\Œ%®"› $0™¼3H£ŒáýYõ@‹+%ê‰ÿ€zö¨’âe JC(÷‡·ô÷³âEA¬ƒþ›“s¨üAk‰Šçï$-¯sðÁm¢1»‰¡\bû‹8€Acˆ5 F°„ÙSùNX]´N…“PžJVŸ;?Vý¶.~@¥ø´Úñ¤#iâÞ ýÉGŠ,…/C‚òU3Ìmnà—ØTÌAã%Ìú×Ályóçi#/Ìѳ…Ép œ½„ÍyÛAíÔu.Ws9>uÒ¦‚2mZEµ¼8­Ìð×ÊûŒ=}‹Å9>êÊ.‰àÝØðkAjûË:Ÿ‚gTåÔE‰u%•Ó~bŸ8€J—ß1ZÍÒ¹”¦Ä;nXªÊáPÛ£¬&õ1¿y"¼õ_p}&¶ ™<¯FCv𾨳x€É5ˆs@#häAvÒ‹ 4gOÎøÔ:)ƒ¢•e ®2–š(ºšÝúóÑ>4r´h%ëS9ÞÈCF¡¡™©le8¨‹ì=¾Z®eÞäÙÌË÷r²;XáX:ÌÒrˆ?=ÑÛª.þÉö+\¼eê:($‰«’ä¹»jO’œžï†S ­²?‘[(ƒ=Ë~ ×ó”‹?e<áá!HÀ|‰ËR&’MC× À–êÖ@z bó %ßàûÂAÐfùч|ƒÌ,Ô ÷3û~IÖþ¡Éãy§©yÁUÎ@ÁfÕúT}C™)<}Ráü{ ‚XÛéš¶Ó+m3;ÉØÌéL™O•Jü˜9«–Æ ó"µÿ‰Réy…G‰ëÇÑj@W>ÖH8b4žþòK¢uRòf­O6Y­#ˆ~‰ŒäW;:F´n)ñˆ~xŒ?Õº¨–.B$˜]Ĥ©ÅgF~u GN.©’EIÎJªµÌ/„?aŽ yœp1—Á² †‚FË‚ ðÖc\0ÿ¹¨òË Àû6?Ò¯‹’´…tÇŸ7, m Cþ=&˜uù} 6ùÇó'Sþ~¨,æ¹c„™ ¦· À:SùÇ–x†òËí«ÿj¶ji endstream endobj 193 0 obj << /Length 2797 /Filter /FlateDecode >> stream xÚ¥iÛ¸õ{~…1ý020R$JÔ±h d7›E‹ŠÍ PMQh$ÚV#K^I'¿¾ï¢fö‹E>’ï>hwÜù»^ùWßo^½~e»ÌËbï»8õ²Hï•z~˜ìÊÝ?œ*ð÷ÿ|øËtìõ{,ÎÐhs©«¢jŽ^Y}ôÃϽ~¯–Whí…Óöw´Ët¦Ù«Ôª¼Þ»aNhx6˜~è½+Vt»±öTªvn0¥ÿ¿{wÿ2Í‘ò²4þ5¢‹vï œènÇá2¿L¸ÔQú~éö:pÚs;˜®™…8öü ø5.#âÙØïÝÀ1ûÀ!vn¢½,‰v® ¼,HÕÛÏÆÊiø œð”'(Ë‚wÂÝQmzžäáAgê|0¥ ihò)<ÉÉhƒápêÚñx²S üó^Ç€³jGÁ?tŒâ¨å_UÙß!8s-1—¼ëYc×X+`¡AJ¹,‚ }}}®Ê‘$˜Å Þ2Í\ðçÑtO<<´ªóÌ%qÚnÈA Ê ÏtVæýˆ£zð œhàð9ª¶a@g~«Ž/‹GF7œxšóçÈFÙÒbɰÒXjIgpé%'­!Ÿ¦)Œ`hÊ*Í꺖„óc—÷— JÇ_Ë¥hÏg@âÖUƒ(Äügà,T—±&n¼½Eó=‹4 ;Šñ|F9|ÀkǦDÍ)$‹×?ð§oëQD¢Dâ¸é'9‚IÑ9ôîüj&4%Ne|áÉçªUV_÷l¸ˆñd%Ó¯xŒ™Ç3ÚÖX•[ç8|BÀ±`?â#§Ì‡¼7®%ôWL*Š€/X2.]ÕÕ¥–)+×4íkèׇF1`’Ð> ´x^õ/jGHØó`ÐmgìFùsÿÓÕ`æ“À ¨+ö•óp²Èóºn‘÷/2Gß`B€Ûܳ9·ä a JÈë§žðÀŒø/^„Z 3𜊽—W:3t•×p©laEâñ¦¶hñoŒ;TgÃÀ¢í‘‘À´2^t’]À"¸/Z¤No_i9èX.d»[,Šà ª'wÏÃÔ·JÀU ššÂ"çГDbÞRŒ«%°óiR XY¾PŸ ié¼òÇm÷‰ v”Öš;S ¨‡4„èîjø<à¸åmÉ…ÀÝF&¢2òô*rb³% ‘ièÜ2 ï@­^ùxË@kMì$¤ñǰ«ÃQmˆz»†·"ZÊo«œ¨T쥘m:§ïͰ‘ ÃØ Ã)›_8>V,5›úZp8H$ÿ! -O$ÉQR}.Ä”­”(–×Ck« !4Zf|‡$ÏUýܱ¦®»¼{úèkŒ293@+âsÅx8üÑE}GIãp€û©G<¿á¤.ˆ´›+ÍÃeIGª¦ÇŒ×`¢@È—j8}C—D‰çÇj!CÞÔçç Z÷†¡D¾Ï{Žà6wÊ4UßbÜÜÇŠ7=Üßo­g~ÌëPìmÅòÀ·l´M Ԃ“-S·.Ë„)¨kä¾+;„ôâ×–ðö˜WÍÚ$Ô(˜KžÐͦ$h–ºJ/öµ5ç²ê6® b/ˆ'“Çx«8FA|*ù‚¡eà#ùƒàÉ0tX° ,€‹%¢ÐItÝçv¥”ò|òÒÙnÑœÐÊžÙí5#òtšNíÆ©ërMÏ*®H °½ÐOÖº¡ð«0s]@Ój1‚@Ï1XÙ©$)*›¥Ù¥8°&ËIi„6R™ó7 °rQÓ¢r¿ð$¯û–Á!(š Æ=5¥mMáGQÂ:5Ÿ¥ïyhŒtà%ɤ}p²öl¶ãb$vÛ¬À%.7Jc¸–çq8¼¯êMœŠ‚ÅÙÁàXn”ç|ÎÅðåàâO–€™IG¶Ô€m_*Êœ0šŠž® ŸÞ¼ã¢ú¼g³¦Å“tyÓ]uxÞÝX@ª‘å©â†| &”p´â¿æ"»àþ%‚¼€I²¢2â›Áå(^1LjŠ#mõÞ1š•¡* ãÊ|] ¤1zD½[pã(6¾qº}Žû‚‚@îípN¿¦*Â|#ä­¼){Sƒ±†Ò¨BOE0j×xÝÌœÛÓ1Ènï0XFÎíù,c𔡠(@gPNø%úS.ô£eíÉSj¯h¹›p±Ä‡ºkèš7ØJŸ:^5Báa$#ØÈ¶N€æGºŽ$Áìm߈cUBÇcº†®«®”YP…©¡Š½—†ks…Çc<{ˆˆ-ØöÖ0™ŠtÏ…¶ ²››Nô†FRЏ\ߢµ`m·º¼xA¿%…¥ÀÆA0Ÿ áyœˆ5´É¡õ{z¢`òß> stream xÚ•XYoÜ6~÷¯Ð£ˆÝGp’:H‹´I¼P4}Ðj¹k!:6¢´öö×wR+ÙrâØ€Er†Ã9¾™!íZ{˵Þ^¸úûj}ñü*Œ,/AûÖzgE¡•ø©pƒÄZo­ìhåxžëÚo«v“W+'ˆc[õy_ª¾,Î;o¶<ø8äUÙ¯Ï>ñÂë¶ÁYßµÕêßõïϯüÌÊDû1žåZŽï‰ÔKù¨ky\ù©-;<'„Ñ¡jû¾lö<«eÓ®m¯äÄ(°‚?ÇUÛyYå›J2½¿É{ÍYU-ʾåé®íxð†ÑÉ)@WÜ„ºÑ0íµé$¨É«“*µ펿ÅðV®<»ù þ²«µÍû\¬œÄÏìK- XØm zýày"‹"öÃ¡Ê °ÀÏ"»G¶,¶7Ä-a÷¾lx u˜²H¶¿ò^òJ£¥L¬d êM{o4kB@aYñÌ Éõ ~ü눖ݶT‡Q•ŽL-[4{®SÎÓ¢­ë¶á¥C×B\jÍwÞòéÏKçZ~c&vØÔ%1»ä‘–²Ãƒ43o¾* «`«8I‚ÚzÔî„#^šAD(²Ô3 /$ø"‰SÃà.`;idèµÌÖ¿h™zŽu}-¸«+ó¦z‰³ ˜ÏÎîÀËZažUžuÙ÷rkvWà[{bßRê ï ÏlæGÀàâ±Tˆ‹ÿ´<Â$dv bl:i* 3€R*é\}¨dØ;DFË ‚ЖyÜ7LUy}ÀÅq®˜#çé ©¸0&%I¬xü©†N v;T¬û%%3%åוùyò¥ƒ¥móŠË7r÷²‘ ŰÛÁ×Cú.¤æD’ÇBzÿûÛúáãZžå»‘ð]ß =W$Q`õÅ· ÆðC“!‘Ì>½ðü]íYoÚ‹ðkHŽ‘éL„R-=‘%®GuCÎ ]WxaÀ ¡9[D!ÔgÀcàÚ=OŠ¿[LdÏÆÀfçÀ+26¸íÄcÒ¶ìG&ª®8`ˆÂ€|,f»—.ŽD"ÊhA(Â,Ói_õ²k Ù0Ø* Šœ1S0Öy¨f4LÓ8Ë„›Ä& 9þlŒg›øa˜Ãž ÎtƒóþN½Qⶬ4'Í59'Ð(Ùà;M6\¦dæÝ`¤Ôº#H=§ÌÅâCT³yM\“Œ$´dM'±h$Ä‚*¹„íqQJÎ&Qñ~nPstÈ€„ñFRΟ¦íjÒvËspß–Cë?Z߇ëv²Ú ºÛèÀ7·ŸŽëæ{´Ž#ŠG üÇnϰH¶žQ”ûÄp^ê Bi}7Íd¸åew[š,Tp4\˜Æ=˜4Z,=˜o5í^Ìy£ºfaïéT´T߃p %<ãµTÁ´Ù”†Z4zë,þ'‚ö´šù.¥Çr;Ð- ÃÀ¤8û n¶ð>=@3Rm£˜…Ý”‰»\püVšeÓ±\íµ‡ ⇠CœäºXEx=B‹jd"MLJ—‘0°ÿ¦r?ð¡5uwÕó̼¶Šr§á˜!i|WÁ• ¯©®ûú½G k>~éû¼Á!·æ3vóñHüñY}·` ܶ½‘Ÿ± BàöÎ9->œ£x¼^åwR½˜½@B$B/€‚ïŠ8Óÿ¥Jg<ðúú$’æO endstream endobj 199 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_dispersion_plot.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 216 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 217 0 R>> /ExtGState << >>/ColorSpace << /sRGB 218 0 R >>>> /Length 58167 /Filter /FlateDecode >> stream xœì½»ŽnË’êϧ¨'(òž9Ün $haMÀhQHЯF~—Ȭµûp,ú¨––±×žQ_füÿ?F^âš?þÍGþøÇÿùëßÿßùßGúL‰ÿiµ\ÿ÷¿þëÇüø¿þÕ?ý‡ýw¿ÿéW~™éãþï?ý¶øïÿáŸÿÃßÿ»Íÿû×úÏéã¿üÊÿæýß?þʘîßþúŸú×Çß…‚m}ÎöQóç“?ž÷¿ï¿çül«aú|Jù¸ÿ»5ü?À}ü·ÿ¯>{= ýápì1?ß¹¾~å–>ÇùßýƒÄy–ÏyÉEŸ?(s}–zþ@ôùƒºêþ¿øÑûzýÌþt_¢Zz>k†x¥ÏšBLêçô~#ä"ï?¨ís”ó$ï?øöëççó™×&}}àÒ?Ûº>0éë×÷÷»þ@ôþƒ1ö—g…H]ú<õs­“ºÕ-¯ÂçûyýÁ;ϬïÓÓþ[&ž¡¿åòÙ˜ùûÃýñ1Ÿý äY?ËþÁ£íÞ •—èŸùùXï܉ßò™gHëgêQñ§b¼ˆ¸üYVŒ ª9Á°6À}Óõ÷¯¿{ÿ¸½ßç_OÐåóy>Úüóý)>×ô;‰ïIÚó¹Šèþ~/Iýãí¿>W¦¼ÏÆÐxü7ÆÃ\’Qb.ýþÒø_JãœÞ‡g¼¯éÚoû×Íy¡÷9Le?IåŧúRï•MýÆ_·ÏòyßÏk`Ealþµ8s/²Æ–ñ™KŒMŠ͹-—^ÂÞzó³Œý¼Ïüèø$¢Û^GFþ¬íã}ÿFúå³eý{Ï3êg{,{_Êi ÿñðw¤ËgŸÆäÏñx<üǹ(£Ä\úýØç¥`Õ*õÙ¿Â×Åy—óônKܦޱòûÓ½+ª(ü¦ïÏ÷~9!_{C ,)ŽÍ¿g~>5°/µWHMŠ͹-—¦ÂÞzó³¼[È»wåçýðÅŒµWÿ§}®w”çùìÏÇÓßC‡‰=×çPÒ¹÷"ãD`Tý)ã³Àõ½÷yTøSÍI©´!îÖõÇ><ùÝÁÞ—vôýË}ÝœñY;¨÷WxÌʹîíM~àÜöò¶¿“ÀŠÂØþkpÞU&lý¬×Ø ~KÌ-¹ôöÖ›ŸeÍ}lÁÞˇnj‚]}}®ýwï÷ž@ø™ßá²/±ãL`Tý)iïê§ŽJ§Î)©´î›®Tÿ='? oÔX<̈ñþ¸ïõþw¿Ïçhû,±Ç%¡cÞ(0ÞCÉÊÆ™˜~ ÍŸ#®¾'. bÿ©ç¤TÚ÷MW©¿>{† ‹¿ûÉ{öØõýÒÞGoÎ=ë»êŠN½…ô]»‹q"8ªŽm`à‰îUãU\£’øÍÃàž“ «Ü7]µò-m¯ê¢|¡¨óÈÇ>€VT9O“8y?Mû‰±“Ÿ§˜[ré%ì­w¼ÆûÇÂñþëÐ}èÁÝtì¯f»Òšþ­×˜ÏÑ«ûžm„á¿›m¢ë¾l Söa@ãßé‡wî'Yb.ýôÁ±–¾®¯‹Ñöûî}ß2û^‰ßÝb Þ_ZHá­4NF• |WƽG‡£‚ sR*mˆ»u]«òž^b×£næàe¬iÁ5-ÖÄw÷i)¤0Ò'"–E3ò¶ê—¶N5ùóœ”Jân]Ãð±/²{Õ6|€1öÅý¼ _~è÷ˆõŽ»¿AºXî붤k¯éƉÀ¨ÞŸ7£í/θº`„ ˜“RiCÜ­k˜\÷w¯ºÍ&W0¬‹´ó¿¯|ƒÉu[JIüæs¶= dgb†5CŒ±g6®cÓ¨ ~SÌI©´î›®z['vã¼°¯C—ý‹¾oÚ»P?ð€mnÖ¿ñ%@Ï,û܋ѿ1þŽtÚ§b^}߆ãñßz«ß¹$£ÀÜúIãsZßGÀ¯C½¼£në~Ýw¶§ëßФèþ°eE†¾£c<ýM„cS÷Š¡ñªÍ2š ´tæÖ/ÌÚ°µÖ8VŠ“Ð¾ÈE…ƒc&deéÕŒ½ÎDõ±Ò l“Æe½Ø5_¯=æÌZzà¾é×Â9y•x|-œ¼y4lÆ»—\{Þ'y± &sö6¹Ã/ˆ jy… ΄»CØ} mš„ï0=¤R Ào Ç[:hpÍÝo)ØÛáïï—Ó~÷ÚKB¯Þf<´·g£zÝæ#ÍÀ%¹[0jŠà ÍI©´î›®ç|3vÝÖâ|NÙ§=œFìø.ì}…&Çvä8ŽVTì>ÁIX¬…-X¥ˆNDõÓ Ä™—·‚5[}ÏI©´!îÖõ8¬zª[F8¬ºnn|"߇ ÷4~ ïC-ÊOó{@yßon`Iqlïà,8r„Ý‘/)Æ&åaÏm¹4öÖ;l¶{Ízÿ¼„ß |]Û'OÇ~†ßüÉ&tèyVH Ý÷À™˜þÈf ¥žºÊˆQ»?¯çì: =ݸoºþÔ¯÷ßû.”"ÆÈ \­_-°>›·ïBÕ„ÞÇ‘C:¹ç'"bŒÌ€=Ý8Úá5*ˆß¼óµRiCÜ­«^ÝŒkÌÂEþëbÀ¿c®ß±Ìï9m_ŽH辯N’6\ª„Ñ|À7£*ð 88î=*û0'¥Ò†¸[×?Å·ÿóvªŸ§ñŽP`Ä8Ñ׎‰°»}HÚ×͈{ a‡M )ŽƉ(^1ÌÈ09—öùУ&A='¥Ò†¸[W+ÄÈì5V·-1ß¶ïE4a=¸Oíˆ}¿ùIçiÝÂ8U:‘R³qïÊý<•„ïpÙ kÜ7]c}©\žX_À˜¸ÖœA¶•æ€}S%¡EcÛ\%…ÓÌ8=t£ÁÇ%\ƒ…X£‚З‚9)•6Äݺ†9sïÎ;T§Úœ †/°^˜wÿÛ¿ÝcB_)<8”¶}k3NDCYßpYßP{LhyÄœ¾Cân]ãR²{=9ÐŒ¼ÿïýÔûrÜËþ¿÷Soc( ]Jv–¤÷oáD¤$ã}_G2n¿°Å£’Ð¥dÏ))µîÖ5žÖ±Á8 MŒµ÷ É6±`=Û·qþJWH;YâDŒCëþݹuÇ_M£žßTsR*m¼U]Ã!´·¶† ¯¯‹QqP*¸s7~-Fÿ¶ˆ-{ÝžIF,œˆˆ-3#ÃV%\ÚÖ(šl«òœ”Jân]µ·f^å²Ðf”=ß¾ð.±íyÕ§Wí÷³ÑdAi‡ [8Ùh3âR{ú˃òßºŽ—b™T!èVôøþwœCÚ†¡¯‹‘ìýîÄûBÐè¥ï&äô›5¤0!'"ÙºMŒÎM¸mtîC£ŠðV²BÚÍHÜ­ë¹o[O©ÛœþusÚÞ6õÐÿÖi”PP[·+ß:M(©¬(Œíû 87c3^j ÊfÈç9ré%ì­·Þ‚˃4­¯`ìÏ»ík¿I…ÉÛ?Lh±Ë5¤xD…#¡Qõf‚ô;â¶q¾v*BæÂg™aõ€û¦«ž¤ûÂ6€rÿ5ãAøã1Ò¦Û@ëÛ[¦eCò«¡A­càgÒóHlöcË€kXqëJMùÇÊ~ xïêZl('Ó><1Ú»Úïpø÷¼'#eÓßVFòœ ¨°¦’3ÜÌi¸IÛp•ôؤ86ç¶œz{ë}9xL®#o‚Iv(êsÁ«‡Úv^޾ñf< + c‡ƒ—f×Þ–öhÎË¡¹“_è%ì­·?ËÜÓîï5>‹8Ò‡FÖ.]‘/*¾éò÷ 0R`MÏbõ1Vºjìë³hnÉ¥—>Ë­wÄÊ"’yEȾÏNy¯P;´¨$¥àæB®™mr&c›’q&V„ì‹ÕV¸÷%XÝ£’еM‘Þ«‡6À}Óõ§Þl.ûOë´[É“!»U;¶%R°[µtÛ­z¹íV­Çk#»U·Ýª=·ÝêòdÈnÕžÛnUçôŽ[Za„ù‰vÛŒæ¤ñ6ƒkp¯A$®Ã¿¤ˆ§3ŽGµ]È}‡‹+ÅZ•„Žï¹„Têwëê+¬®„ú º«P0 "? õ!õ•A‘¡>]ĉ(^XÍ` LwŽDY1jrˆç¤´8È/ﺆ·gÚ]³ ¸`téT™X’ànÓ„Î@½…[›q"0ª¶,0*®^Â!Ù£Çüx΢O mˆ»u=Ç¥B—]Éq\§!Ð"Ás^j·•»4S^µk9r< Uosoá:žëÁfrK3å#æÎ>æB/ao½Ï'ãI“Æ ø÷F×gåÕv˜8×HK;/¾Ä‰XW4¡.Û5÷Þ]Zõ¨$|a~B*m¦’ÙŽ®qã,¼ð­î'ÔZHÑÛw¼…«J&tãÜˆG6NÄòÊnÆÜ¯€p;^.yTºqî9%•6ÄݺžsÒ+Áé#Å9is^­pÁUwï‚ÆæÚM*ÎI9äï‹]’XQÛ»78Ë×m{õØ-¢b=·åÒtÙÑ{ôv2fAdòÌNB ŽNqËðvõ0„vïö¤¨]ÇÍÈòßXQÙ©hÁIüäÄžâ4öWƒç¶\z {ë}Ý{W|ïÃßpqäÏ…‰µ¼¿ò¶±ŠòYf_²,‡Í7°¢š·êàT¸.Œ•;Xc›©bî㢞{ëYÉ–Ž5ƒv®Æ ëówgö ãø`€6¥“ ùtpN÷¨¾Æ2Õ˜1à JŒ B놂ÉYmˆ»u«õ~üö…iøj Æ£Uy‡Hhz†ozZ:w’Á ébqË‘^¾ú-ÇWí|à¶Õ£ŠÐZ¶_I¥ q·®ç­Ø!š3Ù*†ïøðŽç<3Ö¯VS~+Z:ò±7‰ÀŠŠÈsös^;Bì±Iù­Øs[N½Œ½õÓ¢ÍYÛ¶eøCõ>J$„n¯jÂV£Rœ-‘½m› Â-€Ð¨$~sµ‡Å™RiCÜ­ëu~U´Ë)MÑYl¢s3mÜ:7ÚÞLy#åÈ{œ}{PÛçWA׳±eò´Ë±IùüÚæ‘KSao½#(j2»'EM&zwX9v¬ãD²ä¶’72¨ïÔF2ö)6g£Ê ‚`Ë{1qïÓ²cé9* Y9_I)µ!î›®ñR?ÌVªÊ,†âÓ²õdz©Ÿ'¤ w}áD,»i͘{«.ÁR¦QIè¥^-¤Ò†¸[×8º»š#WŒ…ÈÈ çãûáG› }û9›ÁübáLÌH·cìwÆ8$xÔÈKñœ”Jà¾é;Úú~›¾.¾”§Ñ)„_ía<- _ JH'ýNĉè±yL{³èÀÌ^+F­qùiö‘­Ú49ÌŽ®‘º±~ï¯ãÛƒK¹Uø™|i+Ò†¯¹™±ÏÃØ=Þ jz! Îp°ãJr{„jÚ[Ý0ò æóôi# Ž¿§—üp)HŒ•|ÎRÁð$Ë l,„5õIœá‹ñdFÐÈgìn‹§ÃJùMeO`\ü-ç²÷ßûø;÷ý}Ÿ©ïI¶ZÉÎÛÄðßö-ºíÓ¾08Åi¼êEJsQFˆ¹ô QÔ¡ìUíëbÔr7hùÜuËú^F•‡¡‹U(¥IU8ÅáÊfäýÈ—Tþ £&Ç4xNJ¥ q·®Í«„­ÞÍ;èå{'Ù«Ã_½ûKÂo=ÍÁ–Ò ªz1ÄÆÒ+¡¡s”®YN–bé¨DoÆ­ðBÊstéq²gÐ2< Ë03¢Hùd½§·üÙî³ÀŠêç6,NãmJØJ˯ƮÇ2¬¹%—^ÂÞzŸÛ[税¸½uÞ‹­–ÛLÕµ[¸±ôt’y8x$w´öÖÔŠds&µ#¶!ÑÏc“òímÏm¹ôš¶y½cI*ÌUîC9Ù1Ú‹ËFi¦ü¸Ôr丳 T?—#qXtÃØê|âÒLyÅžfX) ¿©|>óaå€6c`/y˜s<¹Tâd+ÊŸ¢Ì#/ÌŠ4¨ˆNãR*,BtcìöÔ`X©¦Uö¨|ÎÙ&]yÌ@²Îâg†oœ„ÎÙk…”º 'bøÊcÏ Â!…Ì£6;–<'¥Ò†¸[W_yp4Û•š â4&Ì"¤|W?ªLSÚ6RqYŽgƒÀŠªq*7§8ÝØ ·ºÇe—æ–\z {ë}gÄí¾ž+%nøwbžÚþðïwÀ$6XÛ‘áf).õƉhö5›Q‘ #*ÌxÔ(bã9)•6ÄݺF|ãƒ^]ýE÷}ƒ(¥4Ç>X Ü–øoLR÷qR²¶OÆÂðßÍ—~ÑußÝ…×]ãßø5eÔ˜K¿°GÂH>b˶šD/ÉžÞ™ÑTLèYSHñx'"ê˜b¢Æ!™ß£F½ÏIiv$P[ßuý©_ø{Xypžuê6ids½W¶¥Õlí°|P@c¡9‹ÒЍÂøï)K¤'‚ÄzPj#òßø;LGZjs«(¥ñ›ìHtˆÆ";´Pvw4%T¥8*æe®GÂðßËA[¢‡^òŒŸê½¯q<þ[?£àÓcˆ¹ôû©î¾¿4þ¿¯qGªáÈv¨Š.û0×Ç^¹öf”?:Rùoh‚Úv’=ÛL/ ÿíDb^λr<þ‡¹$£Ä\úIã]ßxz¥^Þ‡öѵ}å£céá¿1Ò²$kú¦7ÿæxø;Ò°ÕÓpqæx-îæœK2ê4õ›=g¼ŸùTü¥ñ¿À›÷×sü×SñÏ„¸ ¿~Ç5§%Šƒ(é}ÏnŒÂý ¦(ßÑ?…;<NcM•o—Ƶí;º±)G’)[>Z9réEì7½OÜÚ6iרÊœHƒÜ¶À:X4·Qv`lë¹å(ÜXQQ"8•1 ÂÇ4ÌÇÿZsK.½ªã%ŽÞï’é#ï’éAšp!&Z‚Ýs7¡£~)!•389ò/ÄÀ!Üz¶áS£’ÀŸrNI¥ q·®'ڈΨÔ#ÚHŽ3D@d9Î`}/̈́ԯ9¤Ã;× "@Œ]Èw·e(„ȉñœSRj#Ü­ë)ŽËĹ<¢8®’üX¡@I~¬]MÀrÇ’¥¬ÞIœ‰é°3ÆvX×·©È£v[=gWA“Þû¦k…¨0÷™þëb íó0Á¥8ÞËL[¦Â:޼0sb1žFÔ´{!8òô «´oÝãGÐÔ`X) ¿©üSo–?oùÿyï…¶°FBaN/¬£€Gt ¤ýE&n%›ò¦RÖ‘?ûµ ¬¨voqtó¶ðñÖØ%Â…WhvÐm›íže_ÌbL7aWÍ*æÀe—Œ *ž½à––=Œ4t<€ž8Ëa •Š\¹Gás€h NR š¾}n=.U›¦|€híÈ«¨jñØþõب@¦Æ6!rj®sAPÕmBž~ôöÖ;êøì£’]¤ÍŒ‚ÚPð íÊ9…F·•ö%dˆñîK;Ε8Ù3àÄîÝ9êð¨$~s)¤Ò¸oºF°Éâ_Oq00J$0CxÇ#ðÁøÃ¾õ‰ bKuoœˆÌ2£*¼¸²/"þTsR*mˆ»u=«ÔS¼Ê|ÝF'ì´ :õ†Ó­eÊ«ÔÓ)þu­iâ4¾ùÂ6†PjìvB(5·äÒKØ[ïóY݆×gIÄ$®lÇ{øÔ?Ó”?KêG'w`EÕ{}'û³«pP}…ƒjîìϽ²?ËÑû§îw‹åöæpÕ3æþªò~µR?³ ¹Æö3,é@‹p"†Ýuf ªÔ¸†þµE÷ÍÙÔýÚwëꇇ)}}¸êep&oY¨ÄT:ÂKìê§ßQÎÌš‘U Œ5uú™Ã$McY{Åc·•®¹U›EzûMï†lãx¿Å™¼óô»“0§RMÅ0yc›°¢Æ)e)N§[ØÆÛ¯ÆnÇû­¹%ÖqåùƒÞ‘K´ãUk·×É D-M†¶VÄ3M6 ¡Es ÈØkþ2ÎD91à±4KZTá9)•6ÄݺJ}† ìaÚÄhÒiÁõ“oHøÖ5CÊR‰¨.Ùh ‡—÷ÿyÔìèGÏ™õI¡ pßt Z¥'^þb3–BY á*½Mµ›òOÝÊ‘3éРæ‰ág¸¨]ãIKa.µ›Ò­L3¬ßTÖÒ”áEÜ>rþf w!Ö~rftøºškigžq"Z1ÄÀÆýxµ\?-æ,úák Ü­k\ò÷vÏ®š_áøûdPA{? éENBìªß+iCõ#áDÄöiꇺ5ºyNJ¥ q·®zC•ÿ¸ˆ¶žÁÉ$ìw;­¸,ïm”„®Ò{"Im%Ä­0ºD' Ì*(4ÊVúÚò¨$tiÈ#¤R¸[×(|Ïj)z¨<ÿÀ;žP¨ž_8³ló[VöoMŒþ¥æEÙ"LUÙþ™õoíÜ£‰–ÀÜúE%ºÊÚz-¹]eL6Ö(jeÑ#a¿^5ê©\ÏE5Jó¨Úr ë²±Fe@6ÖØ£Îøm4§¤Ò&©±ÆÑõK,ÌsPH w€7Žœ}˜¼o<Ó”÷lý’ÉXQW›GqXÃX¥dkìjlÌ-¹ôöÖ;µÕQq.3PÈ‹½ ¶µ /5:¡Cí|úR{áLDY.3 Ї —QVT£fõœù4Mî›®?u­Ü­ËxöRX¦Htz”Úüล´æ'èÁb_ckNČީb /ªqèºåQ{tÑœ”J›¡cÚÑõx(2k㇑Yaí”íåM,››©ð —#Çå.°¢®ÞJâ—¨(ô9¨|ÆÎQˆÁsg'UA¯bÅÑ;ìý*)ª¾hfÀ°»TEvÝň„,eó ){® '¢º’‰E';øÔ£æ(s¥Lë mŠ*,]êÉfG=-Ô¾Y§¶úBý›5i·Ï<Ñq=‘¹”Âq½o£9¤~LáDÄËm}ÏÂÙ+]š ½Qy„TÚ%']{ð.i`§„9J«+pÌä®ís™¢ËÎêw¬!ÆŠºRòÄaZ°ƒ)w{œ”<Ím¹ôöÖ;Ž÷…§êÒ k#æÓyó¥ïK1u[º-g¡8cE%_:ÌÉ‹QaEOgì|ÜPîºT„©LC¿)­wEhweWÝÙͨjò·¾ŽƒãBÞ…ˆß²dÕ¢žªq"ŠyfàXi\RïÁ4L蔊9)•6ÄݺþÔýë/ÿEÊ|¶ êÕ!ƒ …NÜ]}Ò;Ú¿¹¤ŽÒÁZĉÈú5#©ªÖ`Ìi_uE}yÍ)©´Iªâut ‹û+ÌYô³½¦3ì¯ï¢7áca·Æ )-©„ñß+.H¶²î¨ÊÙ«Fä¿e%|ªeTƒ˜KÅSKg‡e'ªWŠ3ÃSàrÙÕqºš­S^®÷Þb9|9%űù×â0_ØÁÚÓ›ÿšs[.M…½õ—í¶ Äf|] xˆV¢•õ0–_ò¡ÕÒJCþ’òaµÑ$¯ÿ5VÔŠÂÛæÀdiìn…ÖblR~~÷Ü’[¯é'òèýSOG{ÛI¬{9\– \ ~§šì 0Lè.¾ßjI'û'bFg1†"ú€C!AÚ½=xή8AhCÜ­«ž†Ây­D)Ks*­ ¼y:j‘d¢ì8lߢ:÷ýÖXQ%–3s²#TM.Hޱӱ hnÉ¥Wöksô7õTCòe7õ¤›ºá¨5覮ðtÏdB·ô¹Ì@ÜÜ0ÐTº±ÄYê£0é¦nŧhþ«i%•†ÄÝêÞöÏŸÔ5åxlP78qØÆ7¡”ߦv_ÞÅ–HyËåÈé±ÖT›¾9•Ê…m,U®±Û¹éknÊ­±ßôþKzš´¤çv[ÒS¹-ééxneIWáXYÒóeW¿úº‹£.žaIÏù¶¤çã””%=_¶sao½Ã‹4y`èѯzò 4ÅÑnÓÙ¯ú1!/Âá)eµ5áDdW(4õš„c¹&šâ’¡9%•6Äݺž;Cã9|Æ¡ñì¯Yæ5‘u%™ÐA׋ °®,ª",Gf ð½q°çxÔ0yN0¬ pßt ÓbV9îeÓb.WÛÆ”®¶*¯wÚ6nƒS´mLõjÛ"ê›á¶À…O}þ¡mcJWÛFhã¶GןjËEOf6üîÂANe)ÏŸÍ“ÏTS¿µéÍtälcc,)Ží œå^üSc—y\fœÛriºOpôþ©g ¿4þKãÖn¸h&´_] ÄJ<Õ•±é9Ÿ Ù UU»b½œ'¢\nÈI“_-Knÿô˜Ýp–Jân]#ŒdïµE11ºúÚ'f?d$ìm„„ö•B!)*)'"zT˜}ݸ¢¬ñÜMàO5'¥Ò¦*ýèAî»!YînhâUß=kNÐûÓÐD»ï™¤h-œ‰áìD3ºÌwÀuö0j÷-Øs‚am€û¦ëO}ÜÑ©…9¹3Å霅ž`(õAÿ2g}>ÞQª2ùDÚ…±¢âÄ6¶3†Cc÷³ainÉ¥—°·ÞzxªO° T6MÎgõ :èiè {Ç·4R’ËbDYµa{ˆJñ^WjŒÚ®ÂjO ©´!îÖ5òS»ú¹U†Hu\¸Cà~Œ7®/zG){Ð '¢F« 1`’1.»Bï2¡×sR*mˆ»u€¤Á.¾nÎ(î1ŽÉh”ˆz£šð—C*Ç q"¢¼¢Ùw½Œ(£ç‰QS4Õœ”Jân]êéqW Gœ¿ÑXÍÞ³TÈBRêú·ü9¹Š~çIYý;E·,Ð ë1lžÉñNgMÎ%t æÖï§~LjªíXÐJ‰åœ‡-ühm̶´E F$/¯#Ç]3°¢Ö±m‹Ã aë`³ì¯Q1l°’K/ao½Ã%T™…:—]Bõ‰¬pŽ’1ædø= ݘwÅlI©¾p"0ª6ÌJ+ÇLÕģ&Ç£xNJ¥ q·®'Ÿ©+ÃÈ6?qг&´}@‡šÏ{2e[D_GΘtcEuw» Nc÷a+¼»:Þ.æ–\z {ëæ×x»Pêëb <Ôb˜ÿB´å¢§„̯{Q–”ɉÈh1#©¼ðÆM4YÓ¨3º¹iNI¥MR9ã£k˜,‘ [ÜÂÓ Dõï¶üæ ÜÍÊüu—ljÁ…þ‘4\; ªç‹8);‚&%xbà‡oM›tø+p·ºç½Þå4Z:7oq2oÏ}z Îþ•åd`© 9}hÆŠJç CNe a÷!鉱Iùу `ùfŽÚ\ÂÞzŸòI‹½>£¦vg¨P…￱<’2&z3å'wä#W{i@ƒš§,˜8ƒ ’Âv›Ÿ{3¥Ÿº 3¬ÔP«Ÿ£ò1é/=ö&ýźó£ß@ X†KLô³v>éÈû_ +ªÛœÆ® ÂVû4v=¹š[ré%ì­÷yº:Wæç<]à,a‘,³\̦=¦âP=Ž|ò`¼|šmÍc‡3ƒç5¶ÑȪ±›E1w³VI>kþAïã N¬zUêÄÉ¿ä¥åt÷z9äK+ŽëV`MECjsÚãY½aWŒM*~ó~äÔKØozŸße𛾠 ¾]*`„ÉŒv=†–îFèL›\Àh¤ƒµîFC!ì+°uø7Í”—>\zM0:zGÐÞŽ+îÃ-J̘*‰±ã‘;Ê”-IBûÂë(ŠƉÉ1])ŒCS ÚŸî9)•6Äݺ†©¼³ÒÂÌ6•wÖb˜(Ý2`´èÕ„®%û5”ç<ãD´ðUŠë¦qèwéQ‹½Lž kÜ7]Ï[ÑXݱŸ‰Æ Zqv±¤Î˜¯í-{Lù9‡“‡òíÀë5uÅE‰ǃ±í±k¢>¦Â]YŽ\z%¯tGï0û'UÛ ³?6p„ºïm57Á‹Ù?"ÀÔ8ËGa3¦n7.íÏÏ2!;ZJQ*mˆ»u=>#æ6_>£„tæ¡ÎîJÞaÂ>£R6oND¿}F›ÑN$JVzÔ(hé9)•6MiHG×Ó‘"âäëæL6ú.ø2êâ nrQÞ›Ò8òŽoÙXQߣY¸W”z°Û½Æ¾¢Y4wóq Õƒ½õŽ€è¥ŽÁËÑ‹e¿Ô^ñ$]…Ò¦)φº¢Ñv~–ƒ•îãpc'bø†iFÇ­W¸¦†÷ÏcBÏ'ælŠÒN5p·®—¯†þŒÔÂ/˜›O¡cnW.‚L*|5íÈÙ¼ÂXQÙ=nÍáÆeìK)Ó÷™¦Â{ò9õ2öÖûoÊC¯vŽK,ýð$àòÐòB%Sq\šGå¡åµPyèuByUzŽƒm<Ékìæƒþ]z½„½õ>µ ¦ó´üPû¢Éƒ+±>‹ïŠòÁ´¬#¶JZêAU/iW“%yzÍÔNcçS[sKM–Órô¾c$÷[Sâ. FßoÓíb¨42ì#j#ÓÛ-iãkKœˆæàA3ê~mC€”G ,ÏI©´!îÖõ§žùðhòçÌëÜø“.ø{èÖܯ !žídO¼x–#ô=°¢Ê 'GÁ†s•rÆN' TsK.½„½õ¾¢ùY¬ À£Æ ”γÐ},÷p¦ü°¶zä(°XQãT§Ó=,lc½`ÝN=aÍ-¹ôêv=½£aÀ61ö%pÄ*f³ƒ¡:¦ŠBͨӑ{-)Cô…eŽÍh 9aP3ª`õˆæÇœUUr  q·®ú) &kB¦Ì×Íakû‚ú™•ΈýB½ï£(|]-JCÞ·µ °¢Z$Úšƒ~çe.ŽÇ.áÓõÜ’K/ao½êK½M€ÑBâëbL%_à´…ÃÀD,zxž'¤læ"Üp„SˆVQÆ¡¦€G=)ª'¤Ú4›2¯vªª¸—܆cî×ÅèJ.¬ú :Ú6î°Ëh†t°åq"0*þt¸!É“7¬G-‘H¬9)•6E ÈGWó°!첚òb’QvÝí†ÔÝâAmÔÃO¶Ûmß^ )â|Œ¡Qå2k(q™—Ž*B—óÜC*õˆ»uý©»¢·wG·ãR•â÷ÏÅ€ÉHk¸]­“|TžRF '"GÚœiB—?û#jTz ÷œ’Jân]Ïù 1lÃñðÁ™.>¿cAšÂ’'®Ûí”yTçeË\ÞuÊ<š£°eaýö»Ù.s7¶¯öÖûoïóoîíÜ”V]2!-?µ#?w„öíŽpÌþ#<÷AåtGÈÇ<¬;‚n+¾#<Ðû £Qö$3*ìBõRS’©›â{Û/ç )R†ŒQž$FV)’Ì¥¢·5…ïYsR*mˆ»u=§¡‡ç›žã4ô0§ëÒÂÓUãUþɦüÓ?Ï‘OdVÔr,apÔ Ø:h¯æØ¤âBÔŽ\zM·¦8zGèÓÃ8Æ2úôÐ^WQxgۅƳ½½kÑæö¸ü×6Ñe3öKøgb†Z ¤%×QI^£v—Tòœ”Jà¾éª[Íëd²sØXÞ\aïbв™³¿§ à |‹&GI+¬‘‘ਲdÁŽ>ÄM¸£4* ý6cšaõØAèÖõÏ÷죫&kà„ÙEœÎ… .TÅaxô^IÑÞ‰ú!!‡ÅÜXS-Ì.æðXflYÅc—»7æ.®$½Š{‡½{7#»«LpX.c“,ƒEà2vIQ¶ZïÐrÖ×1VTÔ‡ NIKW5ŽÝ¯QsKn½ˆý¦÷ÙèM=¶‡ŠTQÝ{?ÉÌ*E‡ÞFH|«Â‘à¨Þhëcãu›fn)G%áí!‡Têwëz~ŠÄ’OkÆO‘ØÝóaÝ·g*x‰òƒ’Ëí`ÀcC¬©m Í‘ƒ¡Ä#™ÏØýDù>ñHç£W8ŽÞy]•ü6y]éáoj¹Õ˜G»r-¦Â ýyuk½*]£T Ëؼìr®Å”ýð¥™#µý¦´ö ú¿Êtž(ê0˜µX°ÜÑs$Bkû»—tÑ4Eœˆq'b â¨q(êàQ»m‘ž“RiCÜ­k\|FuÙS""\ôßäÄEìo„ž]zS÷AM86k†cá€c”œF­á)Ñœ”Jân]ÏÙu¨CÖ9»6¿PL~§Ñ¦©#ì4.û~äƒÙdŠª÷ÓS/cÔ` „ U}šòS×Ó‘K¯â‰£÷1ë%fÍ­ÚX¼BEær);+%SÞÒÒ"?Oã+h>QŠžû‡îð×t4ï°ÎòßІIÉ`—†ÿŽC4àÓöì¯Å'ã\”Qb.ý~êwüóªÈ øYÞ·WKèg_¼.ï;Ÿ Ë¢)NlÀÛ#ü@Âðß+–:Òc_ˆÙ^­GãñßúØ@;=Ö˜K¿ŸúTÌÆ¬ÔÇÝÝÅx/•ÊHà=ë½¹ÌÁRÙ–•9ªO)J€G‚£âOÅX{£nÛŒ‡G%a'd©Ô#îÖõäfgçr rÓ¤WáäÙ!÷;¥yH;ç„Ü8{fIqô4NDd ›1e§Ë4öÕäQIàO9§¤Ò†¸[×;`çÔ—+`1_ «dY[ Øç¿õD>Ã2X…„ῳB¢QÙZ è<¡€Ç™òJxô>Õ˜K¿±}xQÍ!¶` ÈÌN f{ÔάµO¸çìöª×U #‡Ù)ì}6ç*í±IÉܱ§&ÃJùMåX•±DAãºòŸ1jØL='¥Ò†¸[×0˜NZ<©,Fee«Ä×Í™#³›Š½ye)maE›‚“¬Jjì«d æÇjúMé°Á? Y]aƒ¶Ê¦]‹6EfЮeBïâ3BŠeÙ8Ýyf´}«4¾ñž³*Õÿ©»uš§¨<½™á"¾;"©âc/ö¨aï](a)3k„1½™1”9YiHݹ² ü©æti`•Hžã»®'ˆv»#J=ÕsÅi4f:äÙá*ÑèOÊOF~޼a97VT=EçÄa¡Scé'ôØù„­knÉ¥—°·ÞÇôžY쵄é=3ÊçÙ׊ʾÁ žÓíl±Šnz )k> '"GЦX…«X.5jµTsJ*mˆ»uÕ‹~¹º#ãÍ`!vÉ[,"Äy$~s«ÛÚu•2NDwèœã2}c„C‘%ED´q"¢¡A%ÂÁSàQ›ož“RiCÜ­ëIY,/äÆ…æ¨µBaG\ð±žOSáÑîGÞY˜5Ú2Ìê±í&Ùœ]¨Ö­j”.:E˜fú¸Z/¬r°·Þq®@ñ¬äÖHfdÕÒØ[Èöqã\±† š¸šƒJ'ð™œôhozxÔÏ˧Sü‹ÓJªœ‹Gå;ŽºQظ¡(ñˆÂÆ›F¡…\Ö…ü‡O”iœ¬zº@þ®WËgxD'5doa§ö]Rõñz˹$£ÀÜúEü]f¥iÕ 3ù©KkhûÒMèJžWHQÍ8ÉbÌGÕ^7n×%K•„w¼Rj#Ü­kduÆö<³Š:ë¢%´šl¬{ò ‰M[&~sÃî#¤.câLD†p~+ƒG Ï †µî›®W1W9ÐN¬Ë¤M;)܃ß ÅX¯¦}óÈ'‘ËŽ¿Ñ=¶ï…ƒ G=Øîä°™LyeåÈ¥×ð~ô>'ŠÉÔy΂3ÙO,³îíŠ6{ÉTœ5ב7´ü2VÔ8çXqºƒmTœÉ”O*æ›ÛÑKØ[ïãNžQ&íëæ4¹ìl@è_išŠu²ù°+Øa—o-v û—P™µyÆÎÇ«¹³Sg>Ø[ïH­í ªK‘Z»ô-?Ðq´ðš‰Ð=|?êd<Œª NGµï“/ÐSȔը$´èµÜÒéö©ßuý©×ãÒº“KJù}Ýv=ɰ^îºt;W2³„){~rvm4VTŽúæ„3®².ÝÊ16)þ5ç¶\z {ëýSË£<ð3l‹æ‰'ʼ´ªºYâ…¶²Úbš¦|dÉýÈávluuÑ+žHE=k lžŒ!áØyžÎMŽõtKã´>Ç´áB5!Ì(ŠÓqçÁMF–âìÌô˜ƒ¼ÃidPùÄm“³·z`÷gzh:ÉÒ’¦U"ð›Â~ŸFœ‰¿n΂ 9#‰w?Îà@AŠOëDj»å 9‡ÆŠš>8ÇãÀ"8'ÆîÑþÅsK.½„½õ>[‚ª_öÓÁVÕ1u´N\zU›/=¦¼%äyäÃù´}*;°<8‰Ï±çØSñæ#/®ÊÙÊôŽp€ÁuHµSÌ`ÙCÖ!gç剶"t¾AÑ0,œÂ™®šbFßÿg+&jÔ¨qé9)•6Äݺ†ú•‘ºqš1˜ô‘­}§Ü§ ©_›‹É‰Ä™qã£ï›£qM=ÕqâtpÌOH¥ q·®aø*43Ù€'FÃ5gðõë*&˜‡ ¾J éã&‡%Q£ÔàMGà×­QOÔ·æÌ*Dmˆ»uõKæW;r×éæ°#|FÛ¬²OÀ¬±ER|ñÐt+äðôVT‰Äs2nƲΩÇN§ä«æ–\z {ë·Ÿ]TêýõëbÀB»¸4<(º{™-IŒ–rMNÄpÇg3ð×”}à®lqûÁœ”Jân]ÃqSy#[7`T×2 Ý×Ê0!o l ”²Þr}%cb`6Ε\Ê0¡S`~B*mˆ»uý©á?ï0ºè«ËIùf`=[Óçû‚hÂÑLàY¤W˜Œ‡câL¬Ëaיޓã–>:¢·æ”TÚwëúS¿ð¿4þp@N†ê½}]Œ¹w9®È¨´cvY&|ÚÝÎqrö)½T#ƒÂÀ6€ÓmWÖ;.†n‘­¦‰›Kÿ¿)÷X$úûu1t"L(JVtZÌn6§ÉBóGõͤ·ƒ…¡ÃdÐx)ÍaˆÝcçë4ɹɱZI—–£´hõ\f9å¢ÄA—-$ò¼7F7JQ¾‘î-Ûò±¢Ê)%Nf¡,aÙ7ØcŸjž;EžK?Ø[ïðìxê5l3%¥¦‹/X³YƒY„6Éö„”n[áDŒÈ—eOCÙSÚ"_¢x—ž=´!îÖ5ÔïôÿŒeõÁ@o¶‡ÕQ¸?ˆ[!õÑqRô³4NÄ óýÅïçQãÇõœ”Jân]ÏÁ²é(x–à4,Q6­û`‰’iý>Xî!–7¼sÆŠª÷Áœâƒ%°ÙKŒïƒeyŽ\z,Þ'CkûvˆöI–'Óò‚6X{„Á€¾ULq>æ;[N׊±¢Òy‡Èé4 ÛiÖØ¤~ë[-äÒKØozÃngQH’ƒ3"+ë©¶Ð ¢Bžî¬àÕGò†p%cEuŸ•ƒÓhø¶:c«MS^ŸësäÒKØ[ïÏNöçæ;Ùza"0c¨É B6ö…•„®Ž³›±MfÕ8õºù‚juÆ¡¾ÝƒÎ8Ñ«—§üZh¶THâD”ØÈÄ`>Šp( íQS¤]g_¶TÚDË8£JýL´;T‹‘á@E·Ó ¨˜(MR›î%E‡UãD¤èPMÆD ©p“Õ!9ê¼kG>OH©p·®~PÝÍŽNC±ÉfIª;˜‘Û™ì¸Ï3¤âÅë!ÏôIkªDÍYsèn2–ý_=v:5g5·äÒ+»^íÑûª·4àÏyüR‹Þ*ýPnôV>þÐèí´~CÄáü¸½Õé±íyªô(­ì´v‹±¿5zÃÜÑè­«ÑÛÑ;"ö¹'P˜‘q­a‹ëçÂ¥QÄïs’”WáD„qAŒÓ§pï6?•ÄošЩ˜Rj#Ü­ëO½£ÕéD©M•É 2ž÷´»žÏ]³šòÞ»#…-g¹dc»Ëx>Þ×»Ë|®ç`‘0c§gÇÜ’K/ao½ã.$ßh˜dÊè?‹†yØßµÇ„OÊÈ'®ìª—iÿ/ìª'êê–$Žò2“+†?ÉC§¨Á¯‰%•J~SØ¿²êö7¨X:sfò/yjÞ¦§ŒàYQþ†·çÇrùˆ„%űoÒ`«taÇô¯]DU{nË¥©°·Þ^h+ÓkºøwÇT@j&|°Î!eŽ€p"¢õ€8¾W•]ŒQkœw5'¥Ò†¸[×Hílå­.>f rc18`n í¥}„”!ËÑ ­yT¬¶ª<› 0á¨$dÅiÙ iCÜ7]ÏYÕö»cé‚Ã6 )³âþ´óy4SáÄÏGÞxo®/Ö템泓w^Uþ͔ߟ>Ž\z {ë±!ª&Ó#6ä¡ã{ §'NT ¿‚]®“¾´Œ9$¥ë•8*Ê~÷>ì£zT:A®l†Õ[êàwtÕ“Ô±³²\Æ×Å@ªÅ,ÉbU§ M‰>=*y³¥š•8Q–ÃŒ"3öÃFLµÄ¨QÿßsR*mˆ»u= ûôÝààüº9*Ò1ÙY2¹Üd›¦~ë¾´Oþ’çäŠ:µl6Îd¹IbÛÀáTc“ŠãÈsäÒkº”åÑû¸™ 'b: Ø ”1Ýv-}ü¯ÿúñ?þǯõOÿá_ÿÝÇïúµ/Xåãþï?ýþ¿þOø_ÿMð¿ÿ‡_ù3í4ë¿ÿð÷ÿîô}Ýÿ÷¯ÿôŸ?ÒÇù•>þͯüñ¿2bÏþ­8+|ýÚ›œDþ÷_ÿ`ù.03¯?}ýEaóÍø Ñ×_ÔUÙ E!Ñ êGSdÛiå™0a²Š? yýÁþßõÿ@äýI»ñ$ï)öRß“?wFÒáùܤïÏ]TÖÛŸ›ôý¹ß§û¹þB4þb 9>É[©mOMçHÞ+£æO|,’×$<»2Ìó±÷ ÏÔßrù¨¼G†ó¼Êû¥²`«²0‚3ÜBUU§·G´?.9íÀì‘Ùm‘ò‘ƒ¬f°O÷ØþëGárã` ä±k$znÉ¥±ßôÖI Á{V@3ØÅ¢Á7Ëu.~»¸É6ØY,…9Æ8±šEM8µ¯Ð3K¡æ´”ÚwéúçPw™d—Œ4§¸…j¥ ­VræòñíìVÅãÈyY3VÔ‰Ü5‡Í+…MlX©±Iñ¯9·åÒKØ[o~4o)ì~Á“LpèzÛ•™j-šøÐY£ù”»Íuµ9» k*¼ÁÉÈ 0–n;Üp)æ¦ÜzûMï?Çcõ³Õ߸ýÖ*WœÁ¼X¶½´1\xŸ2Há×®Œr°Ù¾Õ¢´UlÅaÕcWÇ[ÇÜ’K/ao½õYvŽ}Fçûàƒ¤¥I½LS|Î+žlËi;6VTò)ßœ÷¨ùäÀn·J±Iù+éÈ©—±·ÞŽÇª úÌn…¡¼‡à4öâBlÆnÃQ™Õ»)|]FìÃXQÕ‰Á)ˆª76Ûs±³bnÉ¥—°·Þú)ŽÏvȽd{Êï]&™Â·ûóÈÙ¯ÏXQ'K՜ɮ„ÄNö”ÓØ3bw<·åÒkºÙâÑ[Ÿeç?è¶¢ÎÚÁaŽø6³ÜÃ)_n¤8ŠüY¾S7S`M5ÇV§Ò‡!,|æ1v¸ÔcnÉ¥±ßôöga_´ëé×Ía!ÊÅŽj±ò®‘²v¨f!9[µ kjFGsÔöAXµõØÝqý17åÖKÍn½}8á={» }8!g¢°óþ÷¥|²ÑðdùpRœO5Í)ß9¡=°¢86ÿZvAv ¾³Ç&Åà ç¶\šûMoN¢ú‚Ö®àt7{ÔÔŒµzR5Å›XŽi+* ô§²°†°…•54vñ"sK•!T”ãèíg¬{‰r@™3YžÖ̆ü“ý”®jÊÏô“Ž&µÀбR˜ƒT“À6–Èר‘¤sK.½„½õö:¶ø…";çëæ ˜Â¶ÜL~ øn””ÞÎw—QÝò“&°AU;¾ƒ“Y«DXÖçöØ9²m=wfƒJéìw½½Õ/œ ZÙ}Ýœábû”°&}x(ü*Š{ÃL-g —°¦º[ϧѫ'lÒfÅ·zÍM¹õjîý}ôö3†R´»Õ|—»ÜldðÀ.Oé̦¨ÝŸ”É 9½ÇÆŠj.œŽÛ^Œ]"‰ÍsK.½„½õÖg¬7qjE‹ƒšâ2Ö`2è¿S\i’‹ªLù?³¡"N¡h1Xë™Àm.‹qIðV¿TˆÉþÏdÜ­îŸâàõ—úÿ¿ª¿xoÉ÷òà°kåwd;°Á˜å2MyIWC°ÁCO)+*ET®8»ÜBlemcMÊËÄžÛrêeì­··qqöÅFµ(ƒÓÛ—p Ú)Ž×ZMy«Ý­-ïNOéPÕ)‹Á—+°ðrÅØÙ¢˜[ré%ì­÷9ÂWØå¸Ê'qlð¯œ2¹VËcÊGx… váQ=GXR§vfp½#Äî“RޱIù_Ê‘KSao½ý» Ë Å.tµ2gñS™aû ʒ阢â›~Ž|0x¹jYž›-΀[ÑØÎÒd»;-æ–\z {ëíß…ž}Ì¡Gòam†‡Éý)ÎÇÊä ¨a36¨c«0g ÜÂXXbì°UÄÜ’K¯Á«Î­·ð¼©äê:„Áih…±Kï3¼6¾ÎÝ~l€¼SY>í*VT”ª NÁŽm,*IÅØQ­*æ–\z {ë}ž±Êœírž±J³Kå3VX"¤ð«É”Ÿ±:I¢•|©4§(êØ²ȧ±IùÛƒZN½Œ½õöïòàêøò”àœÌ—>áÚYY`¡‘(öµÕòŠ“±¢R”v§<ߨ²˜‡Ê±KæznÉ¥—°ßô>W+uAW8bpp¥(§‹zg·”}-qAŸï|äË™ÀŠŠ„ùààJXV€ñØq‰¹%—^ÂÞzûÝï¾Ù»¨9èÊÓGáˆ1,%™òû)äÞcEÍȽ2gÐì",šºÄØ=bc=·äÒKØ[oÿ.ÃåŠUœÉ>{h³©‡ßô¦l3Gi3Ê3ªkª;¥8÷"a«û¼a*~óuäÒ«ùò}ô>VÔÌÐýt¬¨àd¶š‚ÿvQ•8¦lEÍõÈjA+*Ù?gN{\™=¾û_qlRþäÏ:rêeì­·ß}/‚ÛTçIqŠ2-p?Þ­zeÌØ÷òrb¤'ƒ-øþ KŠcÿöºÒÕ²j`ódì&ÇÎ'Ž\s[.M…½õö3ÆØò‚Œƒ¯›Ó¸ß1ä¢tÇÌ)5öJß 9BŒŽnm#žš¡NWÏÁâÎcGO¡˜[ré%ì­÷1Cvv€ž%Ìà°Wüеƒ¯ø¾6öÓgþa-É”Ó5ÖÔ©`dOÕÆêT­±OŸyϧî^ûMïóY ËU¨f]pX"t©gåõüaé‹zδþKþÐO ¬©5hÌa¡7b÷â6’ÇåÏ’ç‘K/b¿éí59»›\Wö¬9HÒÍ®Š^y:CŠ¡(Ÿe•“йR¦y°Q&ÝÆ1s?ysÒÁ¨16)`Uö\ߌ#}kGïcŠ`ál—½ãq€t“ñ¡ÐdPM…)"‡|"ÅXP+v"1h¢&Å{5.‰0EŒR!ânua¨Óx£¢¾Áa7»Å¦]•Ýì^0Q¾ñ¡*¬äl&f¬¨¨Àœê›*°¨|c—°©xnÉ¥—°·Þç-Ùß]oîÄO}ŸT9¶;Þa ¤ü–¬rõôÖT “µ9,½j,Ë­zìÓ)ØsK.½ˆý¦·Wb¤^mïyõJ,Ìý{nŠ÷æ#¼ „-JNà¡}BÎC¹±¦šÝ"Á©¼ ‹F•1vq²aÌ-¹ô"ö›ÞçfŒ@½Å¬‹Ã®„LÇæÊÚ/}˜òIi´#Ÿ &VÔò½ 8ž)aÙÚc“òjÒž#—^ÂÞzûä ƒ÷©Ð ,8<ºfô4ÞÑ®U‹Ô2å³È‡°¼£«ž±¢†o`Áá±×Xt=v kˆç–\z {ë}ExT<2 gh|ÅÌèùDaÌØ‘w”Æ8ò‚]GXSÝFáà„v•OÍHgìê]%æ¦ÜzûMïãÜÚšcÆ×ÍiŒžAÌãn Yx®Ú¯!)ß’r ùÂÐXS5ÜzæD1 Ì3]]gì|nÝš;ûÖ ½ˆý¦÷¹å/ÞÒݕܜ ÆDm„ó·ª)Ÿúžtä“IñŠêÑ•Ü4 leß]£–ˆç–\z {ë}Ö±íïØ¥Às¬c‹‘>‹¿åö޼kÉd]½NÊëØÎΗ|G—·ÀšJa§òº"ì¶;õ›”×1”•œz ûMï?‰á˜Å_[D7s:‹Ÿ3¥©un·ƒ5ÆûÙŽY¦Ör&N+ªF¢›9Ìð1V©A”˜[ré%ì­÷1aKXNÿ ÎC_ ,³Ûq¦øi$Ý¥ðŸ¥î¾ ‹Í]¶ÁXQ׃"Τ»‘Ø<ìªD1™q.ÚœÛré%ì­÷¹t=ô ·—®gÞ†E_vcG†§šò5*¥#g‡cPYËcû¯}ÙÚ¼}Ù½œ±Ë1™knÉ¥—°·Þg«ï4[;Ò:òúW¤‘nË#)oõ}ùtu`E¥€gç?ôÀî<°c“Š­¾9õ2öÖû,Ùù/jóœF‹yÃ3ͪš0ˆVSalMGiµªÆAÄœB3°>#êÅsK.½„½õö»ðJÓýî‹3}°Gk Öê8nœqÞÏ2Ž|à|d¬¨sz¸ Žê—{Š”Í™9¹ôöÖÛÏØ Å¬¹èOpàñÞOÅŒ“<ûÅ”Ít²ýád˜\qpŽC5§B§:óXÔª±K8À<·äÒKØ[ïsýü¦òŠë×à· ÿ^¼ýMg:ÔvÜ )_¿öb93ŒÕ#˜ÜœF3³°ÕffŒ]ãùõÜÕ~+èÕ„ÝÎØ†íñ‡«¿›jp=‹È›jbbþ~fêû#ss6å•w/¹–O7H+(Žíç<óôúÔÀN†jì9Oä ç¶\š {ë}¢îš²­"Îc{ýßÈðÙWoÔaVœûj¾–ÓŒ ¬©S…ßJ„í(ë±û©Â¯¹%·^Ä~Óûr?ò+—û‘ɨJRmt/ÂäD#ÑóIòÂ3ã¤l¸Ù5ƒ$Û<ÒÁv–\ÕØý-5·äÒK‰À·Þþ,*£—ÈœÂ?féªLKÎÃn 9 ¾(ñù€gÝXQ§‰¼9‰ñÄnkD±Iýö9£¹ôöÖû˜!ÕS\™)8hLLeŸYågz®#gS(cE…É$8™¶TaùpylP~"G=ré%ì­÷FQ~…QTX šÂ(h_( £€•§ûÔè8òÎr+Šª®‰ÆGˈ#nÚsK.½„½õ¾vw.WkœÝ‡Å‡þðɇg›7ÄäËú©X.w6K´×«›™¨fçKpÐL#°…&=¹é1·äÒKØ[ïË<Ü•§þu1‚9P‘u<͸ٔÍÃ}…|¢ú¡ "VÄh‹1ýÜôå$xŽK"ÌÃ5¤Tˆ¸[Ýód¹4P‹'KOGb.(ª5ÞuØåŒ”Ÿ¬2¼³°=еx²\@hl¢SQcŸäÏ-yŽ"Aózs—’Žâ-YNJ’¡s»öÞJ#èž” e9‹Ì kªÄ[bNv°‰qC;·DsSn½ˆý¦÷qlïXš†Þ±½xÏ<îNöZè\Ë&šbåG'[ÉQ¯/°¢Æq¹ˆÓ¹º ËšnûÔ|óÜ’K¯î•ñè}î¿jW±ž¸ÿª?Þ£ð_ÞQ«v¨¯Þu;ÏýÈ'ã±…ng±Ž«Z--V l^ìñ gÑ:O¤ñJ^Ý´b•?è}>K£®é|–Æ~“YÏ4ïãImc‡)–V|Âzo¬¨èœÌ÷IXsÄØ6sK.½„½õö3FƒYB)“¯›³h3ga‡ôxeŸÍ”ßÏ•œE#Œ5ëXœÁa‘Óc÷ã:ÖÜ݇§¹Œý®·Íö !ƒùÙgb¢Ì€ówm4æl7 )¾Í“5ù%ŸXrŒ5"=ÑœÎc‡°Øôcìæˆä˜[ré%ì­÷9ÃA<™·}qXNn»›™…²3‡Ÿä“ós\ÕpNKÎÔOaMͰ̙ÃrrƲԜÇ>¥è<7åÖ‹Øozÿ).]8ÜD-í¯›£È1y¯9†Â¼¢â(5Žf“ÀŠš®€œáE‡¶kìðhÄÜݧÎ÷w½ýº#m­½¥ˆ3t¶jÐyøy²)ŽžuäÊûVÔµ¥ˆ£mAØæ„´'›òñyÕ#—^ÂÞzŸCdÎ~Z¿nŽbXžmߨk¦¼áÉØyJÅØ rx¶ÌIÔ‡ØÅx½N¼„æ¶\z {ëíg †Ìoø8OœèL¾‹PÑKŽUo˜²—cû-Gm¼ÀŠŠn攇›)±ey3mÔŸÈºŽœz{ëýýÖqV¾`}º‹}f-¡¥Ø«eê>‚YÎ#–°¦"'#8,hb,‹˜xìæe1æV‘é¥b(·Þç¹X&$.ÃâT^h jNÍÆ-ªòÚÖÎe¸1 «Å<¬¨r.Ãâ0ÌÈX†yìt.Ú[ré%ì­·? ]룻ò^p¯·Ì™ÚESxÎÅ”/ßÛ\m9s½ŒÕ‘_œ±•×[×͘[ré%ì­··zVÀgÏI[½8h¬¸·ÔÅ­<ñL»–)>5ÃGÄ3ñ>°+j8r78q”Ã[yngìhÊsK.½„½õ>Ÿe¼G(s»#øÉÔyafSþ,sùd0aEõ"NÃŽalÅ‚à±AE$C=ré%ì­÷I§ÛïÐjöЇт™ïßbÛ²Â+)ÌWøþZÎw[XSÍúàTÜ!e´ Ç.'*CsSn½ˆý¦÷Ù_ðøåˆš2§Ð‚@gÎ~1i­ËÝ”÷—RÍÙû‡ö¦'*;j*8‰ÖbwˆÑбIyNëȇ_YMŽÞçÊ2Ta>Å•eбWxeélš¹ªbÊ{ÀLGÎH`cEEŸíàðînlv¯QLùÊÒû‘K¯â¾_Go?co®óî‹óøýݳo³6o};ž†”Ÿƒíü—¼0ZXS+Þ}sCMìŒCÜè¦üví¹gâ ×ôºqô¶ñˆù;ÊÅÁ…âб5˜Ñ.:𔊢çA¸äû±¦zä™ÃÞÆÒqå±£ysÌ-¹ôöÖûzÆØ³ æóŒ±nåéµÓá]ä`ï¦â+GŽŒÊÀŠª'{CË€#cÕóÜ’K¯OÜsÆö»¯M·¥lÒM ;´WW({6åw_[|åÛ.[y«‡ªG»µÖÁÊ!¾˜ÚÎ\[|KG¯('}ô>¹ˆÍŽÅ û&ï3cf:#Æ0åoy’/çŒ~¨q2C–³ z:XYò5vs¢zÌ-ysAOÐûäEîǯ>çZLNãb±ÅCcÂ7ÛË‹²Óº—#Gù¹À’âØükq˜?/¬šhlRvÓÖyäÒTØ[ïcz‘1¤­0½È`Ò™ÜÞi'lt fʦ—YŽ\AtŠ'$¤:aRÎ%õ©€ãh¦üDöiNèÕùÄÝzrW©&äΣWå]´ñfê õd*ÞÏuä´+êiÍ©n0Ùi«­õŒ]¢Œç–\z {ë}rp2ó\"/RœæÒ‰ôõï’ÚO^äãlÆÉ;HzkªF^¤9Åž/`3-c;Ÿ¼HÍ-¹ô*þAŽÞßö—§Ge1зS+üîâÕ½¸öI¹u'¢GM1ÐzȸJ‡-G­áöÒœ’Rá.]OÚÍŽÍì)šp™“YSz ’³3ãÝgáµ=‘sѳ+ùƒyŒuU §=Ȱ¶1üCc“â_snË©—±·Þç±Bèa˜^‚3¹øM*v^FçcÊ•;ƒiÕ©~”C…é%8ª;-,ÃØˆè™W?¼Š*ç8)Ž.!Â&n@;›æNÞ V=Ø[ïcz™4¬¦p/pÈ7Ú+§\Ïr;zîAê[È›OìrFì±mzщ}ÖƒíXõªÓ &[Tì )nf û´|0E@XQå8å‡SÔ X'xìæÏ-¹ôöÖûϱÕ/tßgq{&Ì)¬,ÒN®¶mLØ"å³z.G¾f¬¨èƒœäF˜™õOúбIùd¿ç¶\z {ë}«Ý£E)1PElÿ°ï ¸èÿ “DáÔ,dE;‘1Ed7SúYhƶq£$öõ;oŠ/Ø|ãv•š…õ§!C~ã½àë%­(·§±ÂRšÉ:;•ù¿nb»ÖŸ3%ÅúI;ý"öõ;¯Á.:·4³ û® kfEfMf}ˇl‘•Ý„…„±µrÍAö°ßOÿ¨16$…ÙO »<öÃï‡#¬{é÷-Ɇ"ý R»Òì t`n‡¤·Ö\iŸô–R”Œ…¡ra½+ÆŽ’±˜›vúEìëwÆ’ßÞ-bÉ‹Ô%xŸ[NÍpîJÏë8’ô¾^+í –R{IP\ãùv-z×ûØY‚­¹i§_ľ~çolãªt´øm°U’PË¢XtVÁ•Egµ¡Wk™õª‰¥t¢@Gšë`¿_*cÅØô›'ìò Ø¿ó”âÙÙWwÒ Û­³vïIÛq’°[OH:¥ØÏWö¥3‹c!alR\ƒJ bçÆr†±!é“ó\Âdæ ÷ú‡ß?ãU;˜„ãv54ÄÔ¼Ãýy&PãvÕ“L[Ú·8Ij]‹ÆÆ_oJ´‘X¿=±ãv5榽‹ó¸?üΟUÇW¯7j¾‹¹>­ŽñÕ[$ý¬ì5%»óҌˠÐ0ØÉ< Œ I?«6ÓNOOä(í[›ùŽMqé±™ïØÌWR¥#!ö’âzJÒËÛs¥»ºÜô’Ø­¬êòÜÉc[Ã.7[žrr좃IÌM{Wžõ]ø|4¼%Ì ÍAÿ¢æE=ýâ+Eª…S¶TÖ’öéåCÂRÊòiÐðTØ Â Žå š›vúEìëwNm «;=i@Àv§x]Y˜¾›$=û¦ý¨Oé)Íä銞s;PDZGòtpnÚƒ‚‡Ùéw3[cöàÕ’†e3¨ÄTI [ÏìKÓ=d"ûpÒ+a)õ¨Ü•m|„­ˆº4mT¹«¹i§_ľ~+C ­¤óy ‡¬ÃðpÉ©–Q˜Ï‹ºTÑ~P¡E¬¤x^Bƒ—·°àOÑØñ¼ÄÜ´Ó/b_¿Ÿ+ð#|½4†=޲ռ`káŒi=èM+ûÖ…y=)exTšê¿Aa‹ØÍK“Wà#íô‹Ø×ïÌÜs6«“MR©AñèFñh+A*s%áßîø£(; W…¥t²I*5Ñ/Ã{G¿ ÒoþBJM;ý"öõûG„¶m'fûPú}½2OJ¶}ÛA ŽV!ié)v´{°’fÖãQƒ"(aQö¤±û[‰xwØå×PMyú¯o,å_¯æ€ª§ƒJìàÜá=(é%ÑOÚ—ÏÊMigF75çb'/Ž=óñë"5++ý"öõû¡ÝÀŠøäL“Hƒ9ÓÔÌ™nM’^ǽ¤}¢6x(%­ñ dI·ì†^À1v}s¦IÒÁœé¶ûú½1ŠÀëÞ …à{ê÷¯³âg}ô:fÓÄŠ`퉥´rc@ÍÄ2Mì@Éǹ1àܰïh¨è¯‡×ï§Ž„ %ã© +*{P\¯S)ŒynIOiÇE‡°”znª¨‰:_Ç"«Uc×H6ÕÜ5ª£jb_¿õ½4¯­Þ”ôëÕt,~ÝkHí8DÎÙ%é7m熥ÝA…¥ÔT½š*²ÄƒîÓ$Rô±KðëjnÚ鱯ߙxhÛS<»_æû¥ÄtVûMÛɉ‡ýHÒiṵó§M,¥\)B³µQªl±!á{ÁܲÓS`?üþƒvceBhZœ‡vã¨÷áî’ô|²@`?´ÄÉÆÓM‰õû¡Ýp£ûƒ.i-iÂ/4’øð;“ŽíU€¤á¯Wsð+ÝJÊ,Hl·~Hñ¸a¯Î±.¬¤LQ–fâúˆX}5v¦(knÚ鱯߹ëØÊÄ‘…šîËýAÏ–1°©Z(I¾è½XÃŽî0Âui‹•‰šª&3[°¶sìènsÓN¿ª6dé÷s”ÄMÍÚy”Äý9+ê6Öš6%E¸§}ûâ/,¥š¤tÔ•tDœw±!i#KƮ鱯ߙ’ø½.^ÿ°_ּ̡»ýB§‡Šžá°¯rv;Yó¡Æ.— lØ;•ë>*Ýu ±•ð¦¨ä=|}.Vº%Y®'Íø[N¾å I(ù–×ÍCÐDÈ]pãûÇ*U7*¦è~íI\CSŒÚâ”sÒÚ˜:÷§¯I*mýhFVªI³Á¨»<;Àuv¼2“’~ç¶ÒËŽvÂRŠJµÐ ÚLXT¢iì¨T‹¹i§_ľ~?ý#°ÐÊ+ÍÍÝ »ºì% ‡íâo5Ú¨¯VÒÈT|jºÒéúÇœgì]‚4w­ ûKìþ‡ßú,ø—úþÆD;) È"Dš9ÔédVIð®¡EóP§Ï'–RË^9Ô ·°¼û2Π ÂÎÝÒ¯ªþ2éw–H4$9ë / b‡ö<¡Ìá‚wÃbBOséëLÈaÇý¡°”V䥭Œ°ˆ;jììùš›vúEìë÷Cv†]ZËJèÊŠcÞî¤üBQ=$­¼­½”`lEÝnJ5Š„¤!å°–“²blHZyþŒvútaé÷³³žé/ÊYj6V;Û]£ôÜï3¼«¥ØÙï´w4((Êm¨ScÇÎ$·vR–c¯¤œåÜ´ËS`?üþdß GuÞüI×àZ]´ë σӬRR@rÍ´{qw`)Í|^¨éøÍ‹+yÝóyáÜ´Ó/b_¿“5¤ õõP@’š¼Q;ˆ¶,Ï ’ÿ¦ºÓÞÐ)œXI>¶þÚ5 ´FÄV„ä9v²KÍM;ýöÃï\“;Ž§ÄšÜ¹•E§­†“7߬bŒ÷‹G ÂÞÁáUÄBںƎU'ƒXÛôÎ’ÖäVÂ.OÙÇ÷õû‡Üqm1$èJ[š­Ü²†ß¾ÿsóù>!H,ÌÖ!x2 ééAÍod‡Ó9öˆ+mÍ=”·6аŸ~gÌÞ~jãªRMšY|¾Š<k6‡_—9 )Âr3í]i 'I‰0¶þšéJÜ7Ɔ¤#Ù-i§§Ä¾~?UªÇëJËŒãÀšÆŽã#Œ–IÆYÃnñƒXI+é^¨:0NTòÀèc¶Í•vú5t`L¿óuãÝt³Ææâˆ­ÇÂÂIzã]$éuŸ´#y@XJI_!MÁ/Ø}ñkÆØ;é+8·ìô‹Ø×ïŸñ¸ÿuÿ?+K&){¯ òõh¬‡2âÓ½›ùˆ—.I4ÛÅÊî‰Ç…„±õל„|Œ}Œ„è€wî1·ìô”Ø×ïçâ:Zl|½šma ¿<Æ-C«qï I‘šrÒîw¯¥´"Æ*ÍD̈X\/hì1VÍM;ý"öõ[/Ï=n¸€øz5ŒlÇ#·Èœ‘Œl^,;‚2ÂJj*$MU¦€c±kì’:œ›vúÅë…×oíßÑcÍØOt©H ÈÚ7šÞöëb‘¤ó‚§À~ÐŒ—XIUY“¡)Z7½ÜõgŒcCÒ…¥Í-;ýöÃïOæ¯z²Ê–Pö’} Í«ÄΕͭÄÞE;™½ˆ•t¢ÖVš¢Y`+({96$E̼'üR5®ûEìë÷ÏXºšw•èÉðX[ó+›×Í7ýáÀn~ û¶Ó@`)%¶4àÀŒF;9°57íô‹Ø×ï$_ݸ~Ê¢fª§Rö°WSJß“ÑÓÞ¬¤‘™SÔt%npØÏ“c·¤ãÜMMãÝ/`?üÎ}âDð¾—Ø'NðÜô ÿ¶_ÃãJŠùvØu…¬¤ 4Cg¬ ¶’>sì æ¦~ûú,3T´J}¤f©·±ý‚­Ç 3Öº$x7<Qöéa)È“¦+'DZ]=—}ìžW*œ»ë*Ìýêº&K¿ó7VÑÎ1.|¨éñòÆ5>÷çæ$$ýƼkí 'ÒîSj¯w—|w'¬Y;ÛÀkîƒØ¿ÄÒ%抙þKÓDÔ]CfÄÙ2°•žö‹|b%å§alb¿vwÆØÍvŽ+‚ñÚûá÷s'J*Gׯ.›üÒ±¨Sï½%[ ,=îÈ“½ƒÓŽØ®Á:K3Á÷MìPË%– ì ¬*Mø5ÕÎi?cëX8ш«g7ä‰ôµHdꎅ#"êX8WÚ‘Hö´H[ÇBÓ<-ׯ§E∆‰:z³Ül‘ؽ-{Ž$lË÷õ!acrRÙ,ÚüÉô¤·&I;£qÓîoÉÀBÂØøkjò3€­àœæØ5“>9·ìô”Ø×ïäZöÊ×fAȯWÓÕµê‚Íyba-K£åìU²ãº_XJ-“©©è˜E,®×5v´йi§_UݶÒï¼eظŸUÔTD>Ë@>¢¢öc=’t˰WÚ72Oˆ¥”QSiùQQQSÍM;ý"öõ[¿1o7S›/_¯UÛãG•«âñ¸U}ÍSµ¿xlö ¬¤ …†=â‰eÿxޤ˜vùì‡ß™s3‘¶,&&j²Gw÷<²QÁ¶jxH¿ùtÍžöbAb!õ›|LÔO ¶sAÀØðט[vzJìëwæ¨mT¡5(®(ØÖrá|füöJûD øÒ½×[çt–—–Ø®»)> Ñê†sÓN¿†ÊŽÓïñª÷6 àM;ÙÈ}bŸÅäɦÃr+Å…¤]—åqÈŽ6òÄJz²¶©aE±¬ãØ5cßœvùÕÔH(ýÎGd`#Ñj<"›† /‹¥oDìÞkônlº ÕÒ.;^ÂR*Ž¡f g±V ·blHñˆÔ´Ã/a_¿ÄÏêïWñ_ÎWq'rXN”-RsÙãtaÿWtW0¶¤¸¤i¿¸"ÆþÍÍ5³uü>à(“çî’6¤£¤}*çÌ?üÖÁ¯ÑïO%ÍKõ~åÉÒØ[l ’ÎL;)ˆ¥Ô3õššŠC±Ueh>v¥ÌM;ý"öõ[¡:ðþ]ãëÕL/;Ø`,Á7ß±QúÍÊXeC¡°”züd¤i|ÖÙ;bìÿNšvùì‡ß?‚šÐ_KÃ÷È"…•¦"¬ƒÀôBÁfE¶4$Flã.ûò°”JЉR3/.ᵚÐcCÒþÝæ–~ ûúýdÖTß;êzZ\ØaX ùà¦ÎXHÚÅZ†‹ì? ,¥“×ÔlTMk»ØÌLJ¤H¹äÀ.¿€ýð;oLü‘ÚYqMgõzãqpž2­)Iw ä<9È«]5±”vV\Sµæû©SçØ3k>8wÔ±»_ľ~gïuÏÖ2Lw¥ñf˜¸³¯È¸M’Ö{¥±ÈÁÙ†9E¡ÿ«°eµ»gÙ-ç¦~ûú˰ý¡õk± »¦ëÖཊÒbûȤ.ËŽ´fa)µ D—¦êܱø€»d•=ç¦~Uݶ¤ßOïü¢DÖKÍ(bh8Wmä~2?Zd½gaÿ@ûÆÞ‚XH=R BÃJL`;+11vÍ-{W߈µÿðû¹ý¿ÐäëQ,ß-Ž}מývlÁ„ ›#ÏÝÊ«3Ž]à(d*†RášçA{[uŒ=H4'­ð†¸Ç×ÌFiȉ0 5‘âmÖšš{¶–a”Ž‚zÚÑ)KXJ%Ã(Ð|oü ñ.»Ì/ÁØ"º\ßü“Öûú?«Ñlñ³Ú¤ FÙíÕÓ@‘îZ’ô³"UÔ@I¯-MÂR*™®¼µ´y Ø¢*Ž I?«yÒÞµ¤Žñ‡ßy ¿Ð°+åŸ'a~î):.áW•¤èùºi;1Rjo?c×T$¦["œT%)Üäs—G­Ä¾~gB03y»Ú;R3£ÅeöÕê’æd¹tGU´ghÏh­w5¶þúpá=‰mØpsì§Ó;çnÚß“Ø×ï§D$%o².È` R|ˆ`.Y׆$ÝM•öZTC]vJ%ïW GM žIÝ!I½³Ò¿ˆýðûa[˜ô™» “­÷.êÆ.èg7Z¨ïàë䡇U¸x½#¥öR°-ý"öõû'Þ|_¼s|دWÓA‚rñ¾x÷V¼ÏF¾›Þw´7¼ •Ôâm$ ÜÖS;cìHýŒ¹‹º_ ¼~?Wa×7zïKsèVäûâU€Våô~™-í¨7–Òs¹µEÙ¸kbÁg–M Ñ*žž~-½þÒ´óÏvßK#«ß¼¬,ÛtM¬vÜ‘êlIz_ß‘öë ‹°”Z¦èSSÕ‡úâFh×»$Iç."‘r¿ˆ}ýΊMk{¾;×0žM4+‰þõvÝIo­½Ó~°1­­©±ã®lz×Z‰ÚùØ3wAœ›vúµÄ´–~?¤ÈßÜIû^P«eÿ(¢ð߸å¬8Éî¼mê©Í[Ro¬¤lY/ÍP‹&Çväßrì.ŠŠ˜vùì‡ßyªï¸SQÇ`iXÂ*nƒ;º\£0$êGMû@\šXJOÇ`jŠ0ï{‰±!)"í·É´Ó/b_¿ŸVËß’%w*í6*v*GîBªÈ*I¿ƒqÓ¾ÀÊO,¥“ ÑÔl$5kéÓ#Ɔ¤·»xñGúµÕî$ýÎÏR¹?ȶ"ó±­ˆ·ª:j+R›$}–VҾЪjkVŽÆÖg)Á²­HÃe?ÛŠÔ&IŸ¥Ì´Ó¯©¶"é÷áèmhúq²¤Žš+¦ÏNjvÒH½^2ÐÆ>Kdí3±”ž--5 —iÀV´•çØâgÕÒN¿ˆ}ýÎÚ§jÕ±£ö©ãÌ>qIBÿâô¶$éØÔGÚ·šÌÆÖÕ¢kŽ8SHÆäy³’®ùëM;=%öõ[K~q»gÙ&5(ßùþg°Ê—=qY¸ýä é7C~ölÈŽ xa)%y¿4ÍßmÂ6\/pì$ï×Ü´Ó/b_¿õYÀüµVtD’4FÕ ÍLb;ïxò𱫧½ùiwDDeV­#Ædö|IlÄO”yŸÞ>7ìò Ø¿õ½Dw졬µ£‚‰tŠƒÉŽŠ‡[%E 礫ha.#¥{BiÈÁ]#“dçØ5Öœ»¢ˆŸ~¡K؇ßIÂd‰Lõê{‘Æ’û˜YVdé€(i]Ix7gÉ~ýí&,¤šå¸ÒK[7nñ1vÍr\Î-;=%öõ[ß NzVÈÏBÍ.øü8û튤Âî%æ"ˆ[Ò>5Nõ®ñBéï§yã °|wH:Õû>ƒöãË«°”NrQ³ñÉ]K•‡žK¿ÞÊÄ1ÒN¿¶x¥ÒïÌ7( L»ÚóS³tMgOd[¨¨ÃÓÚžÑ êiÚqq*,¥‘­2©éøÎ‰mºÂó±[´¯ÓÜ´Ó/b_¿õ~qž–¨•©CÂöñŒ(r¢—-i%•ƒº·¨%'²¢m–RÆCÒàRØïÓÕÚ16¤ßôÄæ–~ûú­Ï‚WAñK·¯W³•Kf/´Ë³“©í‚ ékI—²{Ô"°”âŠ/4h—'lÇK‰c÷h»¢¹ûûÒöõ;÷É {ѲcŸÜÀ\ˆ’Wõ­JÒž©°?Íöb!VR4: î´„mbumU’~‘µ§~u]A§ßyÉ}pºÚ™opëÈÍÔFǶ§;URœzOÚIAH,$Œý†âëQöÐÁBÏ\†S%éÊ‚KÄéé)±¯ß?#¢WŠõ—îéB³qË¿ELâ\{…AŠ[‘v£z.•´¢;¦4%³Äzà:ÆŽàxÌMû%Áøý#¾Š¿îÿçå\cßÀaOú׫™ ¼S¼g‹•ë[’">äM[¬|4”ÑšŽšabj†9vËVPœ›vúEìë÷Ïø*þºÿ×ý¿îÿuÿ?ªß³Y i-B³ÑêÒo謴°"±VI¸,òû½°ûÕŸ°’‚Ö"4îa`¢º{$c*ç†]~ûáwv(l0©ÒjP {xªA‹—ƒD+Hº&+#ì· ¦·tÅÆ_½ñ×µ µ%¶ã“sl—t©vnÚãDUÛ~ë{YÎ@Ñü ÿëÕtPØoç«hl³ÇÏž-.%<Œ¹Ân)¤#°’"a 4UÌôŽõð»(8sÓN¿ªñÓïç‚°à.D‡ŸªD˃ØïÆŃ8Wv;‚8…LÍ´“Å™XJåW‚»$)>»g‡sÓN¿ˆ}ýÎMÓFr–‚ÑÐxœ× ЃÂÈu$iÓÄ6 WÞ‚Ø£¦ ­íbÆ"¬·al›’6M«¤žûúˆ‚n„š%B‹÷¯­V+FqIÁ< cÊÞa)ͤ¡&½kf¸—c÷èr¦¹#”¼Zb_¿³¼•lbE—ÔÞ7À y¡š$ýÛÕ’ö]SvJ[ÁèÐ áIXdiââ€R㇦©™Œ—’c·LJáÜM öƒ}ýÎ:‘ >eõÈ‘æ ÖÑ÷ô‚¿g 'ê ºÖ3‘4Fûòs‡°”vôÈ‘ÆK_;A£Ë±gôÈÑÜ´Ó/b_¿s×uq¹ëº8¬MZ4pƒ¶×øÏ¶¤ØG´/¬Kië Úþ‹¶?{‘ŒæžAoRûú»®«_¯¦¢HÃdzkE^pž-)öQ#íà™–ÒS M=ʳ¹¨%¬96¤¸¢¹i"¹{þðû¹žÅêÉrp×LzBúBÈ\ ÅõìI;RÂ…¥4"AAä1ët1v Z[ÍM;ýêjB—~ëy©H‹Ú ‡fÆïI” 4>­KÒÖ¢×´û!;°”FžÓ©qvÐÀ6œ¢9v‹S¶æ¦~ûúÏ ™MâôHÍFKqF|3K/Ÿ—=Ó¾pzÜ¢è_]cëyYq`ì@ÇŽKö˜{ˆ3p·Ä¾~¾ê-_?^õ—ÄRxÝZlÅëÒûª§]Œ¸ÀJ/M'{·‡M;dÝ‚¦SsÓN¿ºº¾¤ß™ÊTQ8EŠHÍE’%nvWA¹0«2‹RÚ”Q,;nœ…¥trÃFÍF1°sá±!ýæ™ÜÉû–öµ%öõ;ëª.ëE9@ÍQ‚+©˜|t‹$¼ïN;x„…¥´3)…\N Ë Ç~qqnÚ鱯ߩ;H3†Ö1j=i@ Éê¼¹=’´_3í×wKÂRª¹a£¦ –$Wµt66$­à³¤~ûú©²j$®lqÄ…»Xvº<’ b‹£›M„ÍGŠgd‹£ýëmqtclHZ)Ôâ覧[ ;Òï±´·²¥ßÙäÒp €ÄÒ‹¿›|®ÙäUíi÷8T`)íÈ&—­ÿ„ž-®±gd“knÚ鱯ß?ã«(NGвc¤4£¨9¶q³ZGH…™Ý3½ ù:Žî£–RvŒ Í…8°Ö²ÇØ´zŒ’vz ì‡ßYiÌ"zuœ‘5+Ü*–ƒb”¶$éP×{ÚÁù",¥ñ𹆄CÄ2›c·ahî†î ô««î8ýÖ[äúfïÖ ’¦i+k[ÃÛÁöãUT”ô3¶”=Ù»ç K)Ó›¤ñ:%aQ§¤±!á¯17íò Ø¿ÿmb¶Tbûõ&ö—üEÍØ ?‰ý ÒQbûõ&ö?í#lÚûדØîûk=YÌÁ_ô¹¿žÄ~µs.¿>ÛG§A¶]eX¨™êÿ:Øãi  x$E m¦=A„¥”¤é œ¾Û½=Çn±ƒÔÜM½egKìëwW7º$ÕÁU¶§s^Û‚0(þaMIšo÷´w´—!–R‰Û=jžÎ¸ Tm%Æn'O ˜›vúõtä-9v !س’©òÖŠ\8³-¦¡I:=Ö•ö…‹bW\™$9RÁvlµÄ%–#I+‹ä¸R°4‹ éw&Û»g×lsBMS«{m¤ÔV¼ öóàM(;Þ’ÂRÊ'@š¢±sx\±Ê´!I{çºÓN¿ŠZ¤¤ßmYØõìζ°Wê8ÓM”µahHzÖJ»7ò ,¥,¡fá–—X´ÌÒØ3 -97íôkéî<ý΂>/9º¯ ÍõC«…™p½k—ì× e(i—WVÚ£Ác)xº¤Ù@"v£b‘cCÒé‘ñ•ºÒ/b_¿ÛÀ?|×åq DÅS% óò@iÝ#‹Ï»1c‹GIvÚQa×#°L1HpÕŒ’ØÈâ+WRÄ [ÚéWä¦ß?ã«ø‡»¿š-g¼õÒ¦˜hcÚí‰cÑøò^vðpz»FY—Å6…ƒ0>*¥½uª½´‰óÔtÚ¢7(ç¤Þ÷øš‡òMvþd÷߈@qY´%·ôž€7ø:”3>VÀîoW£ÂR*‘,EÍA^±™LR„ïVÚy5Jìë÷“fCŽÄ§¹äbX¹ðjJŠ´–ö)®3±§ánÜ…‰Å„¤c;ÇÉ€ÒT Wwú5E2ž~k ²TÝ­¶4¸UU-ÔU\Ük²óˆPÑ,ŒöVPÏ})gõ·ØÒd!*âXYåcϬÜåÜ´/Ux³j+ýÖ÷RD)3”þDÍÅ] øÅÙÖ©4•«ŒÜ¾‘xœ÷Œ÷&–Òɰ5wÀ’*›cCұ𮴑ãŒú‡ßú,ÞèÏÎdKG)j’³†/&­ã¾xú:IW;=˾=CEXJ57ÅÔø^\Øz‘œ…±!éb¡®´Ó/b_¿“gÖûg®è„#ÍmYñ*ŒqÐ馢çÉN8Íà²wpÊKie'jè6±Cn|ì‘p87ìò Ø¿3èkÇÈ9ãˆ+ÍÒ1•ôv¤Õ#õ]q=v´ó–ÒgËjרŽ#.Ç~úr‚î×Ðñ8ýÎïÅ».u[ ÍV_:ï%x”»aÿüb¾‘v§¾ ,¥}¤™âîø&nͱGävhî¡Ü^ûá·^ØÍÛu/¯¤Y`ÄñÖ³~©Z¢Ø^f8wÐŽž¶ÂJš †…f€GìªÝ±óˆqìŽÇÜ´Ó/b_¿õ®D¾ÑòvÎ_¯f£S.¼l"¼2í~’޶[”WkÂRZñÉ¥™ª„wì@¥;Ç~z˜rnÚé×Tkžô;Cu%„sD¨Ž H²9b‚3A!é}vOÚ‘V*,¥=‡¤Y`Dhºóu~ªV"ÁïQÄÍ0oú…™¿óya«àß¡æF˜³ƒÙÏŸ-½ô¼¬“väšKéd—Ej¶:%.¬EíÄØ"<ÛÃ.¿€ýð[ë˜7ý°îLº„—f&M:,cºøânAOHx“{{’°£#±’‚34Èr µÆîÉ@À¹a—_‘}™~çÞ’»=u* æF_tO©ØTn5[ Žœƒ”ݪ -› žREC:'bÕJcŸɘ[vzJìë÷8®Gó´®R·Ð ¤WÜb¢sõ~¬”ôz,%íè+,¥äýÒ4äpE+6RGøØ5©#87íÑæmõ?üÖÏjûêwDM¥9XîŽz‹Uôäé[’–—1¥±å§waCŠšˆÐ€ SØ RŽ=#jª¹i§_ t>¯ßi¬ ‹¨itMC30»¢æ$Eíî\öëÛ[a)=íd©)ØO»@0˱×G;Y¿ó§~ñ‹¦ßŠ©xw<ûõ5¾¥ñZr?¹¡ñ©ç¼%½ÂêJ{Cq?°’2>-ÍFg%`'H9ö B+ÍM»üöÃïŸH#p}!Õ?5[ç.nãn½ÙtäÜhû*;ºQ K)‰-¤a†CScÞÛsì$¶ÐܰË/`?üÖvò€È¯Fs5išÚçxÊxGëô9ƒ¤;»¹Ý{ +©&±5΃"l¿˜æØ´UõÛ!Øå°~?Uˆ(HÊ­T‘…ÁCr“¤-X)io`8îQêÊ MÃ].±Õ¯ã4vÍ6¿œ»"åâáÿÃïCtG¼_\ƒb¤º¸A$}PðË}‹+œh(¦Bú ¸ ú ³=ôA÷þzèƒnÞy“>èÞô‹Ø×ïÌëšd‰T™4¶õ@¼j`[Â]¸’~óPÀm cac–Ò NöÐÄÙŠ¶%Œu+é7WÔÑÒ¾u³Ö~ÿÛØø7!±ú»!±§’¦¥=Cbõ#$öTÒ0$¶>BbO¸íááÏØù‰­?ü~² iKóŽ£AÑš:Îá§Ë4…È8màr£½+û€»¶4vd€ò-T:>D9v¾‡5wG…ýÊMJ¿³Šîà:­êøE ZZ WÑ_MH<]ÒoîxnIûÑÏ¡µ”VÖ_U0ˆëØ¡ïé’~s“¾gÚé×ÔZúý#ø^Í‚èM-±t¹±ÚZÑ%œuaNÈ@IK—½eG1¤°”z$2KÃJ1bþÒØ5·wœ»ªO£ûEìëw&\ã1RƒwÓöîMvq? Pª$%xB<íÎ'¬¤ˆ´†fëjʰ -â8v‹*ÍÝ¢ý\™ýð;?‹­Ÿ½Ä#"M®0É™À)’#ZÚ=¹7°”¢#¦4–à°ÛŽºÕ09Bç¦~ûáw¾êy9ÉFYb¾x€/B!‡ ®QÒ[µîì,:–ÇŽ×)¬=õgklJZ˜ÉDÉZ…ýôûG<î^­‚ÃØÚqztÍA˜á ûªÅì’´Ò¯*sx^aCÊVlÒ€!W؉0Çž1+íôk! öúmŸåøõÙÿ<=êÛ‚y=‡¸o¬þïÿí×ÿôë?üë¿úÿãó_ÿúýÿe»¼öëýÿÿøû?üë?…ÿׯÿð÷ïÿe½à¾«Ïÿÿû÷ßÿËã[ÿÏ¿þçÿåWùõ¿þ«üúoÿUýÿªÞ‰á¿Óàk£yxïžK ñÿü׿—ÝvÚûùÊÏ_8sqÏ¿ üüE?©zü Êø /8Õo–â@¼Úÿñ˜øˆÏôâÇ0ýÅ÷, zå@|þÀc9ñï¤ÏmÙzûùÜßÏÝ&Ör}nÈïçþþ­ßç/(û_¬j±ÊøXßÏ}(ö!É'³ƒdK{S‚³¿+›(×A0 ¶`lšvùì‡ß?ã—ôÏv¿7/¸îÖ²[œÐxïÇÞ<§Ò^òÍ>””~û_{DÙÑ]EXISY¡ñv õ¾‘1vW@ÌM;ý"öõ›ŸÅЏ­éËYeh¼%¥½Ü-oIÙ­Ô¼Kòù,W¥¤Ýo©KiЬ24ÝwAÂv{Vcì®Ëš˜›vúEìë÷ÏøYU/ˆëß‹$S_BÓý?Í«Æûr¢ìn™&[¾zï;öîK©)õ%4N”Øbg«»(æsÃ.¿€ýð›_ÅEñ­U'óÐ/MóhÔEL±ùWÛ®—ãRÂò‰R`ÙQ&,,¥‡~iŠ_¿kZgŒ ¹e§_ľ~ëÅqÄÝñY¤qö[ÎYÞc/·ï¥~Ï^󤽫ì¨î”v~jÐÆSXß/ÇØÁüsÃ.¿€ýð›Ÿåû+ûÞ#~£Ô-š ¿„3Æúï£ÐEêÐ÷/çûGÁçZžÞ/«g÷ ¡DS*(òˆ€;~sÇQ!àO}NYÝá_õU söŒ%IƒxЙàQF¬È2ݯ$¼g·÷|–Ý[Õ–RÆ’¤A8@X„ 4vÆ’47íô‹Ø×o="Ë׆îëþ׫A9ØE¢WÇ¿ Ž®”ðÕ_[†¨évqÚ„ i)%4¾övxý™Æv csnÚ鱯ßú^Øó÷Ä5«4ØØºO²æ8’ô3æ=IÅ#4z`%%ýÔîŵ k”646%}‹ì^ìvúì‡ß\†‹'ñzÛGÄ’¤YÞ¬½—Žâìê7Ë œ’ð/íÉÃa_hÎK,$Œ¿¦æØ}°Ó©Ÿ5ö jhÍ-;=%öõ[¯”åËv¶Œ çàÚx—îò·óœ’~ód/ Ú[ÁXIÑ264Î÷XÖbìxcnÚ鱯ßú5ðÿI†æâ›ÅÝÀ)øf‡‚˜bT?SL…n÷{‰ÀR:‘O, h·‰5ªÆcCÂ_cnÙ›Zc;öõûGìTþºÿ×ýÿ¿ºßI£µ§šF„ÆïìlA·W§=ü^ßž‘ KøñW¯ì×_ËÂRš*ÿçÜÖsîcì®Ì«˜›vúEìëw†DHZ*ViÐŒçD&¼½¯/½•läΔ°G†¾a%õ`%‘Íx„E£|47ìò Ø¿µYѾj²"Íñ°¨my,EÖÊ„¯o‡n—ô›/ùRÓŽs°’v䢄ƙ¤„µî]'Ɔ¤­šÍ MxêØO¿Ÿ-ù]FnAºó¿¬†m@õM…ŸY I[‹JÉŽZ^a!alýj Ø[ìDMìÜøwÀØb RÓNO‰}ýæ÷b½—®<v“¹1ˆTØ5¢mz÷P…·8¬KÔN»ï:K©Ä/’‹’”À¶ƒ ŒÝ’'‡sË¿„}ýÎߘQ¬­kÆÐ¿*¼8q-ofb¿ƒÕ%áßÎ3œÂ޳°!m]3†fùÑ\Øik_Œ=ciÔÜD ô˱Ÿ~ÿe¸àG[qñõhšÎC—™ÇÿñÌ;H;iÚ‘<#,%[í?Ÿ;ü|¢±G”tknÙ鱯߹³WDà_¯f{f‹!`wj90$IØ™1ü´v§ ,¥UEÒx m`‡WÅkìUEš›vúEìë·¾4·dO±¤ñlÃN‘Up‹ BIHø·þ.‘}¢²‡XJGi§¡Ùø‡*’ø-ÚØ3*>4·ìôkë’~ë³à\|#ˆšæ²í–nxÄÆO0Å烄Ž_N‡½yü€XIÄ . k¡cCÒÆ °Ë/`?üVàçx‰¼ºù¡{Šå¥‹v?:ÈŽp%a©¬ž×@ûökla%í¸”†ûb±ÑØ3R'57íô Ø¿óõhԳ˼¯WƒH1ö&Y¤˜ûHúÕørHûÂÂI,¥ªôÆÐx›ÑÀz¸0Æ.ê sÓN¿ˆ}ýÖëÙ#èÞ¥™NÙn{†ÎÛ—µsJ¿4ò(h·¼™XJ#èÞCã”í§sר#èÞ5·ìô”Ø×o­cT3+OèÔ8Ÿ”GÁèì·\è)V¦švÄ „¥´ò„N ¸Ñ…õ£yŒ=´‚ÇÜ´wò8öõ;#Zžætï¡9¸-ô¦ ýåí1\S’"Z»‡ý²& XIA÷pY ;ñïÀ±gþ;qî©§]ûá·~cÕ/ÞÛVD+4H‹Ú ^ý~óœ'Z•„ßs±‡¯ÂN5óˆ_ÍTã {u ë@1öŒ—¾æ¦~ûú­Kh_rŽ'|= ”!O_žNWïÖq)`ñ³„¬~” ŽB‹¯Š¢¶®†Cµ2G-qÓË9a¥7À½¾Ê}çoÙYyJúON¯`ù~ù Môí­Ë eˆ£5§T€OŠ8ÐIqÔ_ç¤Þ÷øšFï"èú¯Gó½Qkˆì.ÆÀɶu$éwn˜²c=$–ÆÖÑ5 ¥%¶yn“Ɔ¤£ÍM»<öÃï¼Öi˜}济kâHZAÉãªEW!É; OËÞ=V+,¥©.Ô4¼?‰mxrlHZ=¼ vúEì‡ßŠózm6w*Òx÷‘^=§Æþ³x“º$é¦uö´{®O`)UÕÁ‡¦`W¬uœ16$ü5æ–~ûú­ÏâÇŠšã¯WãÛn›Áj¾%÷„©&IÞÝ’vÏä,¥ UoÙë›ô»hYˆ¹i§_ľ~kåõÛW+KZy©aÊ“ï¬\ÆSž¦7\¤ãìžiß^ù",¥š{4jd˺¢}½vN»^ðQLߪÔ=b³>">7í^z(¬¤‘ÿÒÔtõ‰mêsì Û¹a—_À~øý3Þˆÿp÷Z}'W(iœ;ÇsÊ—ÐÛ¶l¡¹3$|ÛhB(; K©G4[šæia+8^9vh¶æ¦~ûúý3Ûï}€Ð¬ÕX ê"Óä€÷\Dß=SÂ"‚0šì üóÄBÂØZ :j™=WØŠÝ,dž¤ªÝ´ÓSb_¿ó¸^@wÕÔlÝU;“ÉÁ]t;Í &°“Å@þi)•”-Ϥ™8Ü;p¸çØã½«&×ËÜé°~ëñ‹à *‡¯WãœTö£žXz=ïÌ·Ÿ”°|úµ´ìÛ· ÂJŠÎ°¡ñV2U„Æ®A¨¤¹i§_À~øý3V«ø¾½<кáþóKÓŽb;å”uéÝx-+I»Ï¹Ò>pN,¥ÝU¤©M¶x"‡Æ.Aâ§¹i§_ľ~kµÂ§Ä åëÕ€ÿ½n;¸ïF(qFï…‹/BöëiÂRÊó4 Pl»æê±Êt;ý"öõ;³„üÈ_¯Æ_k´8´ù‘JBà<‡: ´’XJCÌ>¡ñc\`ýµc71ûÄÜ´Ó/b_¿õ½€Ðah…) šŠßÞä–”s/rSVæ10pîšNBP`Cê#oHX´ ÓØ-–ÍM;ýB3³¿óêÐèVËï…_Óüúî:Æ‹£.û†Nköï³gÚúK©å÷BMõrayµ=t‘Wßœ›vúEìë·NèÎsm?*C’æØÝ°3íÞù{!lÍ^ ~#©¡U¹ý"«—XJ;’¤ñîË8Ýsì™§ÎM;ý"öõ[ß Â7kë(šƒõ{`·ýub¹lER\Òž´ûmq`)}„Ø\³<YX߯Ø3êj47íô‹Ø×ïü^ì§Û‹ømBã½P=¹ÙJ—œÙÐÐC’¾{Pd÷<¸ÀR*â·‘¦ù-¡°Í;§jlHú^ÖN;üöõ[Ïþð;‡–½¾¤Á‚ù½öYuBÃbzž„¤çsÌ´#Ø),¥ìõ% [a±¼jì욢¹i§_ľ~ÿˆŠÅ<1$˜ÐCƒ”04C³o˜÷0÷HzIÙ퉥|è¡Aù˜°Íœ‹±›(ÌbnÚ鱯ßzÜ’œoãëÕxû ϲßÆÂº§$=À§§ý€›XJ5Óî¨a2'°Tè16$-ñë¤~ûú­G¤‹üóòNTš¡â6§ xYN4¯A¶e­·fÚ·Ç…¥ÔDNšŠ±U…oåHú͇µ”´Ó/b_¿3«n‚jòh¦Æ äÙ…½ùþžXI[krh˜<@¬ècì`+޹a—_À~øëXÅ–DƒÒ —í¢®¹lö×&Iϧ=Ͳ£û#°!õÌ+¥ÆûÖTbì$¼ÕÜH`‘_Žýô;·ùv—¹¦š˜…fieêØNûƒ2‘Œºu!ÛÙUv\ÍKiÆ ͰK`;V&ŽÝc#­¹»V½±ûúû±Å¢Éû1×xZ¥?­E‘Åï«IŠ­øMûV-ýj)EFPh62€­ R¬#íô‹Ø×5óV#ÍÖ¡¯WÓ±Ê" Rnh°‡¤[9og»UÍÜÀJjZõBSQvAlÁ*˱K\ÂknÚ鱯ßù®ì`¬;Þ•|ûù1¿éÉ#|ó8ç|ŽøÝ3Bž=B,¥¦yhxL'6Žð>ösįz³¶š~ûúýïRîïÿT4³àCû™é‰ïö/5›$­Ló¦O¤°0öïg]éhÀçxÓØtò|aô`–§L£ýÎPeGž£=¤i.d vqÇ)º#í ,¥šÕøÔ a±– 8clHqž¸i§_ľ~ëÙ÷HœçŒó{‘†Um·«Ø-zã¡+ ϧӇݷ¥T‚šì…¬ÃØ”JasË¿„}ýÖgqî÷:§ÚÎ…fiå* &÷{çëÔ•3òob+ûAݱ’fdÐI–a»V5;oû57íô Ø¿ó]Ù'Þ• ¡Ó‰w¥Ý•-ú°O@Ò»ÒöÞ²o´µ$–ÒP€;4^4؆ÔNŽÝòéâÜ´Ó/b_¿FÖöFÁÿu®ü¯Ôa…=Àu¶ºãEÂå–¯°6ÓŽúaÁޱõC©ì˜P…5ŠÞ56%pjIûE±c_¿óf‚íÄú› ¶,€A²bÇÏf-ILi¿juƬ_¶9ëZ´©AXØ’Ž=ôøÅÜ´Ó/b_¿“1É~qVì 85ÞzA›opÂùÆ|KÒÆÝž ÙÁ™%,¥µØÒL¯§v"ôͱgl#47ìò Ø¿“ˆkbÚ™D\® õNÉQHѶhe ¶zß ž´ã½',¥`«MC>±^Uc[}ÌM;ý"öõ;,Þu Gͯ4CgR¶*¸²ËeH±MiÇí;°!õ\º¨iX~ˆ­Xš8v†tšÛ5á>üÎWÊ@{˜Èé„fye°ó¤¢—Œ?ÍèXI¯”1Â~|·$,%Œ­WŠk˜q ìD œcCÒJasËNO#£8ý΂ÆÃÒ|=ûG]Ö <ß8»ï)I!Ü¥òïXIM ƒBS aö3rì!dÍ »üöÃïü, ‰ì¸š†›ClÛ®B:OôYèý‚÷óVRÕ=Fh|a¢`ÅØôYlnÚå°~ëõ8P¶Wµ&‡¦a—;½cÉäébyGHJ˜=íß<±”jÜ“KÃó°ß›ª1blHøkÌ-ûPaoøý#nYþºÿ×ý¿îÿuÿ¯ûÝÿëþ_÷ÿºÿ×ý¿îÿ§Ü'ðgAc3íYc€d˜º%á<Îî´³“.±Ù“7k *k z`+Âkþšt·ZMìëw¦%]ô÷Ôu¾4qixVã…â¹’D½+íhè(,¥dà–¦âR‚Øâé|»Dѽæ¦~ûú™®QÐ¥ó15È+,è#¹º‚É^xÐ3GiÔ²;ÇS`)ÕüäÔŒ½};ò 96$]δ‘vúEìëw^é±{aQ(œçaƒS  ^´»$ÍÇüùBB “XJC¡áÐ8Ñ]`§$Æn¢´ˆ¹i§_ľ~g,Ù =†òõj&rÚ¦Šîtš•{«ˆq³@r$–RDlBÓ‘OGlû ði‘Q©¹i§_ľ~?ñ$ïô–ñ$D]¼¬ÿz¼÷Uæž&)âI7íÍÿµˆ•Ô¢µ4Î ØâW]’€sÃ.¿€ýð[W­ž`W–EYÔ P/.ô‰HAGWù­ ìòtÌ´;cY`)%¿½4Õ/¶„­àŠæØÉo¯¹i§_ľ~ÿŒWÊ?Û}' lþ¥6ePsA<7«V@<ÂFHZKïL»“6–Rÿ…fƒ^ص@=ˆ±×JjBÌ-;ýÚ¢5¼ÏØZy+’Lj•·b=œ¬æÀZI ËZ…¤•·ö´p‡K©fÜŸš4ÖŸøâÂcCÒ¥½Í-;ý"öõû!ÜßN\u,Ôl¥ÞZ½ƒ\ö¿ €¤›+„ÆSް!­·Že ZißĤÞrìñÖ±øÜCi½î±¯ßáÕU5M¹> | \9Þˆeèâ¦(6?•£T˜GT»D¤wœ4XˆÅïScçïWsÓN¿ˆ}ýÖÑ£åu5‘Ô‡Æk’âÅ ,œ ·I h(ea¥°”Z¬ÓҘ؂†»dÃÎ »ü"Áïë÷ÏXº¾¿¥Î½¨.!©9¸¸t.{{·²â wIøêîàh÷b²ÀRÚú¡Yª*¸ç½+Ǧ¸˜›vúEìë·–.âZ¼rÙ©9Á©ÙqÈLÝ")®|NÚÑ–EXJ;{Q3õï4Q'XkŽ=£¼OsO•÷ÍØ¿ÄÏÊ^0 Þ¹O M ’O#’í8D\´^ÈÄ´ïWaaÿ¦¶ÀJÊÄ4i ²-€µ÷犱!ißfsËN¿€ýð;[jxÛŠ‘©ÅÔ°Ff{úogý̉†YY¯å_ÖRê±5ð"VÒÈÔbj˜mMlWê°fé'˹i§_Q”~gú:súɽÞŠV]¹Ä7UuÌdía_/{%v¨áIJÝ8¬Í–XÞ¨rìHûŒ¹i/ª«˜í¿sÿn߬mpvìß+Ò!ò¤¬rY(¤ôŠEJú´’v¯v ,¥¡:ºÐtï-¬ˆ;ë¦57íô‹Ø×o½RîŽÎî¡Á%ùöš?{ù5sñîã”E`Iv²û™UXI'¨b¤Ùêéy0·fŒ é7ßÍ67íòk«—húýp¦#ýœ)ß¡Y8Î]QÄ.”x²åÎX/'aDzlHOÊw ¬sÝË21Žed1wÇQ‘~9öÓÆöwÿþüg»ï¥àè+b£e™L@ÝH@쨌gIÑ;§ž´U`‘RÓ[94U{FÇ%§²$s(ú8E*1júEìëwòÁY_ùÞãIføOúÛIçlAq<$a \žW)»7Ø ,¥σ4^b«ÿæ5vGBsÓN¿ªè“Óïñ³ú§»ÿýö.ˆª¨AšéÕ¬Fs]Å@ØÅÒÝ!Åîs¦ýئ0°”Fä.JÓEoÀ]Û„øØME 1w½Ai‰}ýþ_…Wrc'¨áQéÆÖ¼-S‘!)`l»3ÚQ!)¬¤'¤©Ò[¤ãØ%;OpnÚ鱯ßY+cçÃq"á\šë-qÁªéuDÝ·9ýJÒ6Èk¥iï^1",¥‡™—š B`ÇÂB]ŻߓΥWiÂ/Ç~úµ˜ÝG5Í׫¹øe\¿‡™Þ ÒÓ¦‡$ªçËî]…•t" Zo ì`FsQf¤AcnÚå°~ÿˆGÄ# Ç£ŒM%XÔ .èzˆÑ"ü9…¤ý²Åge¿~#,¥ÅgÒ°E:±¨‰ÓØ-ª47íô‹Ø×o}4H©^þõj.R‹ÑN¥¡Q’]*MI˜oxŽìN}XJYt. ù‭8+rìšgIÎ-;ý"öõûgü¬–ÿž§µ ˆrÛ À{úÖ] xIy5ª¬^¶*„l*Cx`ˆ#YFÁ/Ê9i…7Ä=¾Ê}ïS‹³û~½Þ· ?Õæ}Û-’tº¿;íÛÏÏy—çRr Cc$SÐ{ÐQÖG¾I$Œ‰euŸ„{]ÖÇð=„m%ô@Hã,@~­hnpRñÊÑ%…4,øM»í¥K`%­da f‚³ŠØá—Ò{Ä¥µæ¦~ûúýôfXÞÈZ‰Òl,6ÅëÏÊÁBTQŒõtn^¿&{÷Äa)e‡`iÐùNØ…ˆc\¨87ìò Ø¿ÿàˆhªß ¯[ÐE½ð*†ÏU 9"â*‡,TŽ¥Ô¢~_^·W1kHRmî´+DYøýÐ ^'p7éQm:šµšƒ^PÒì¥ô›Ç¬ÕÒîå¥tbs,ÍVÌ‚§9blH ûÚܲÓ/b_¿ó³ØA˪ºJ|–>ŽÓ¦Ñx· :~'!§¤ÏbÇ:Ù»=ý¥Ô£[·4Í+±…­ zçØ5‰à97íô‹Ø×ï¼r>È#¸IŸÆ#3S^6’‹Œ1ƒQMHqå\Ó¾uA]FH+»BKãåºÂ®”FL³+4ç–žûú­gÿx9ùù6”æø_kZñ⯪)’~s`´²ƒ4šXI;B³Ò, ;ÁÄñgPZjnØå°~ç:vØŠîÆ:vpÎ3 9ì1³§$ywzÚ»H¨ØcfW­uŒÝJÙcæàp`σƮñ¼hnØåWS™ôûglR®Øm±ÑãN•ÆcǹÐÀ§!qwIº¡w–OÚQÅ%,$Œ¿¦-‰mèëÀ±[ö}àܲÓSb_¿óÊn=ûV¦Ð¿#5Þ?cdóÀ^¿lXq?K{óZt {wJ>v?ŸAË\óÈ9ôžŒaŸøš‰¥t’`wêg0[`-Ô*‚ãûûW²áÍIb*ŸËˆNXˆ…ƒP#¢Eâ&ÀÙåAѨð§>§¬ð†¸Ç×| ²Á¸ñt ú¨VD€/ú¨âˤ¤¯ž9€#~¥i¡™Ñ(en³çØ‘¶sh”\ûá·> èÚ,,;ítÚ-î[Äun1“Ûú)Â+í ––ÒÌ× 59µC%/Vb©äÛÇû>ïc*$<öf a%͈ÏJ3üZCXôˆÑØ=Ûjî.ö¾Ø¿Z3¯4ÝäPÓýîü~6BCáËh’à§rÊ~*hÏ€•äcë““Í{³[<íDcQ ÆÜ´Ó/`?üþ/ô‹Šçz㲓šVta© y¬"¦l 7ª­eG%¶°0¶Þ ®9ʬè¬?16$])¨Âþ¤§G¥é·Þ"Å)QË rjx0¶V<’¶FKl“„5ß+öÃî«L`!alýõå•öl_4Ç.Ù]†sËNO‰}ýþ?«¿_Å1_…U~$KýUÜŠšÎñžmQ<»€8ž]D ˧gJ„Ý‚–ÒŠM¾4žZØŽö{Ä>_sÓN¿ˆ}ýÖgñ¬E«—âIPš]p êuºV3µ‘ì’¿dM•Û'*¿ˆªÅRµ‰4Þ«YXc&/16$½2mnÙé)±¯ßz zï˧ÖYJšWO·¹õE'›®eßB‹jYØ5ìÎÙXJ=¨i~4¶¢k'Ç®ŠYÇÜ´Ó/b_¿3‹éûð½žOeÿ@:åqÙ‹2å=Q `#äõ²z“Oá ÌhuJ23ˆÃf˜£öL(œ]=òÌ›=vŒªý;»Öû÷óä®÷„¹)mjÖ_¶Ø‚2ï¥'¶ãrÿFO iœ’›XÛíש±)E«„]žûá·doØO;5W?ÅÓýG?ðÈYB$=’÷¤Ýû–ÒQkhÈYì"g9Ɔ¤˜Í-;ý"öõ;÷‰åb*𗿢úxWœï½š³Ó\;rPÒ>ñ®°Ûì#°’Nˆ¥ÙH‰v¢ñ9dž¤}¢Í-;ýöÃïL踆¯Êª¦æ€ húÓõ½¨WÞDMIJðöt´ƒ,XXJqmšå‰€ÂNôláØS×_17íô‹Ø×ïŸñF´¶qÏ%ë‡í$¬Õév&š¦;ŒèaêÇ€–v=–R‰Ã 5ý¢ñ)°ý Õ)Ɔ„¿ÆÜ²Ã/a_¿µòz®UÝL³^8u¼ ‡Ò~%éÐ:VÚ›ûC¬¤–ÕÍÔT̈-8´qì`Á‰¹a—_À~ø™%FWÞƒ'4ÎdcÙEèÎrcÙÖÝ© Ž'Ôϰ7ÏOVR°à„¦¢Ÿ ±ž9c×\´97íô«ªÏaú·¸ö/uüRâëÕ4x°ã\hï&IIû(;´Ê~a)Õx¨¤Á™Xö¶áØbÔÒN¿ˆ}ýÎø»=¬'ZIsý…g%'h6Î^X§IÒ+ì–°óG¬¤lh%göv½/¬5iè’°ÇY…vK ¿•Tã”+MAšµc­ãÎZ›Þ/>wØé°~ëÈ‚J‰½ÄCãÿ··J­j¨RkâÃðÚ´“öˆ-±”¢—¸4Þk?ýcCÒ'·¹e‡_¾~çͯZ~ªYj¶ øÕl,ÆddJÑþoà>‹ö 6™«ØìíH©Y ¢"–ôL{ª¢?æ¦~ûúý¼+—ÛòÙß GëE¿bß–ž_ìB)æ»iﺾî%¥‘¹‘Ôt¬«Ñ¤¤í»endPê´~u/ÒïÜyÑîŠú7i6ö=¸~[æ{Ù#)â+í[Åĵ¦»ÅÐ °µ;ÀÖÆ±ƒ‹5æÁæÖûúý~!ñpe‰Wÿ {¦Ï亹%½²wµ8Z'¥ö½ñ£Ùë„°1vͬÎ »üjºN¿sÓ°%ˆ\(jŽR ž‡‰ñê’¤ùZ{™jÕØZÁ+»¤¶ÄNä:q왹Pœ{ªk+ýðûù,Í¿²Ùò³4ÿ‚>’E:¾ÉÝ3z<Õ‚{FØÍ×XIÑj/4NDXÖºqìïaÍM;ýöÃïÌ4ӎ±Ðxñ—÷ ëž ØÐ‚˾õ…cÞ¢ë¤}ù AXJ=3 ©ñâ¯ÀzaXŒ]3ÓsÓN¿ˆ}ýVfz ìMCãO€EGÖt¶á«X»HÑdÐCp%íN1XJÑd04H™";š ÆÜ´Ó/b_¿FHì¯ûÿY’dzFѦ875]dŸU¿$ú˜M’"×ó¦Ûsb%µŒsSSE2±…¼%Ç.çæÜ°Ë/`?üÎ’ªŽú̪dÍ.žÅ†TSñ,âÌݧ$,ˆ ½±¯Þž×G,¥¼‘fá@ìÄ;`ªMqË’ª¶ÓN¿ˆ}ýÎͼm,d™)ÿ®QÄ÷†ÚèÚUm¾@ÒfÞ©H$È'±’j¶ ¦ Âì÷£Í’6ó­¥~ûá·6ó]¡,Š¥98¿ T\Q`8AÅ})2VI»‡pKiG X\5;ý#iìbÍM;ý"öõ;“›'ÛO{É#'û3“)ÅíãHÂï`‚å”ö>Ôˆ ®±ã‰òÜ9˘Ç.qøÕÜ´Ó/b_¿ŸöÈi[O{êymb¬¼ž×¶0‚-:óÙ ?Pvð KÉÇÖ°Ð盫K¶KŽ]³+}U×k^hîšØ× [ÉÎÞ7³ \3=·ð€õßÎiXfï’¤ó‚ÕåÈ>¼Â@XJ=rd¥Aëja›—ýhl—ârò¦~ûú­WŠG«Åù¸Knïm™1i^ð†l¿§„eß³*Ã>K –RQF¿4!Ä"ލ±3b©¹e‡_¾~+™ÈC­{ÅU ~&ö<Þök{Ɉ37 >×ôø ­ËÄQXñ ¤b¢åpøŽ8êeæ¤ÞLµù_3 Õ³›ŠŽë¡©zÙ=yEzÅòvã”ðÏåüß²oçÿVR‰»\jЇ‹…µ:ÃcCRF…Êпˆýð;¹ÁìÅ?‹Ž¸¡a†zÁÂ\öª†%Q"ZÙÁB+,¥G\jΧĎƒ•cCúÍuÓæ†F~ûéw’ÃÚâ{5¹z#R³|ÝAM’>™Î!iu<+íÈÃ6¤™,Ô0¤I¬ÓÆÇØI+¯¹A+/¿ûéwfmÛº‰îª_¯&lüæÙÜ€C4,¾½“}â_‹XJçƒòô}v.´áÆØâ“Ï´Ó/b_¿“KÏ/4j4£–¦éúˆXƒ—G’B¶N{Ì0^[í®±u¸ßìvÜ»¯J¸|›{߯]ÒN¿ˆ}ýÖg™Èè¢h M´q"çÀ'³âÎÐCÃÎÐDM,¥¹þÒ0|@l´xò±«(cnÚ鱯߹ëòß2½šŽ›Á®’±†]×®’Þ_ìËŸVa)µ—ZÁ5ÞQ;°7š»$µç¦~ûúý3v*vÕ1¼†¦i¦f¨w™S‘T ?ZH¿¹Ð±ˆìxk&–R|išRXíÓfŽ]³ïç®JkÚ#±¯ßyøµ,’¹µt…æ ÇùõŒ„ ŽüãLŒ”´3²„~Ùú”+iGI‡4 =ΉÅÆN Í »üöÃïÌ`Ù`Ùº-¥f#l¾½ê«3zür¼ÓŸÝZZ½;íVÀ=+)˜þBƒ­¿°Øúkì‘÷^œ›vú5uU~ë³ §(h5¢¦Ò°Š³xÁðÆe¤ùZK»Ç9K©fÔ”š‚(`ëE$cCÒýJÙi§_ľ~?A‰¶·äyé âŸ J ÌÀ. íHÒbÔgÚ·/¬ÂRz^xÔLu éH‚%Ç*̉¹i§_ľ~'§B ‚¸.¤ñKZÏàG½+¯‚#§#ÞA;w ÄRzîs¨©2Ö/xcì’]Ò87íô‹Ø×om}—]ëÕoLšö«í[r£"|SuI:I¬’v¿3 ,$Œ¿¦æˆ ΰu‹<ÎÆ®qC®¹i—§À~ø•4άTÕ)4M”–tÞÐè¢Ï¤ßZÁWÚ½ 4°”j¦ƒRƒÞ@ÄV\/plHº‰µ¹e§_ľ~ç6ßïï­íرÍwÍÁƧDw,°|Y²)$mùÚI;â_ÂRÚ±RH³ÔÇ˱›~Ž=c¥ÐÜS{÷k!êòú·?90-³×6òÂ:ëôÁ§Æ +ò©µÌƱƒívv+i½].ù›w,yç9öÃKT/Þ[ú5u…•~?Yø9uD»ŠÀ]ÞœŒŒ}IÒ ãèiï(Ó"¶ ïˆg¿£XtïÄ'ÏÓØ#ÙWŠÊ¸ÎM¿€ýðûglÁþá%vìÁ™z”x‹lpñð–sá½Ñ™Ý´%é·±gÚþ±ˆ¥”\fÒTš[pCÚ9ÉÀ°JÚéWzú;;é5ï5ôõj˜‚@äÔ&X„¼Ô›’v*vΕýøXXJ=3A¨i` "¶"·•c×Ì}åÜ´Ó/b_¿ÄSÑÛöÈ¿^÷4é~ÿï8Ø¿µ GHþÏÕ½u¢ìÝ›, +)˜–C3œúFØŽα»jšcnÚé°~+ìøÏîXC:Q°Ð½ô.#ùhC_³‹t˾g×ù*Âî\¥”cÒ w±g2Ž]óÌÆ¹e§_ľ~+2?Áb¶Õƒ94ÇC•ÇCîõ\ÄÚ—‡9!é²Ìjód?^*,¥y?Ô,ÄÚ‰NÁ¥±§2jcnÚ鱯ßù½Ø²_gô×’Æ™‰<× uГypW’¾3È>ýzVXJ3*¥i°Ý_6»GÅ£æ¦~ûúý#V+?þWň¿ âÄÞñé£]OÎ<~Øâ1Ò>ý°&,¤‘Çip„ vàxÁ±G?8·ìô”Ø×o½ÉêÿmïêzíJŠëûýçqF(¢?wï~e‘%±¥<  Æ(ƒæx`LÄßçt­µªú\&_Û€¸òýRUê®ýÝ]«j³gíºsrôN;üÖ±Þ(9V";åÅró¥+ªªs¬F×u3RÕ8vö¨£æ¦œvA÷Îîðf¯œÔ~ì$Æ9±ãPp?‘W‰Û”¶Ô}„Þé’:v¨+ãta˜.>ÿ» çn é-tw»ãX¬p|r6Iäþn}šÖ|©‹Ò±ärtø–.©ùäX'×%Ø$Ç®ž¢®¹)§]ÔÝíovbpwo¶qJ::E5•ߤ*JÛú¯'²ç ]RÅ“hÅɸŠÔÍ*UHU”Ž|!ïòmó»7·#Z ž3ÜŽÝz d•5œ ®Á,ÊÝŽgÈ ŽBº¢mŽœÓU‰jº :ÛÁ×|î¦*W³ ºwv?é°Î¢ dåT¬šœbAï•…ØÅØÉ¢tr{ y¤ uI娬«‚|ÍuoG³âq~¹)—]н³[¯á Ø^SrN¼xá¼½#™ükÅ#3¼¦@g)§”º¤FxMÉ9àù¤.ó‡9ö–_̹=¿¸æÐÝ펺ŒÄÚ¼¨ËH¬Ýã#‹¼'VêÙâÊë ™ÕëòŒí©ª&&l{‹er{d¥{¨ª‰ »õeLáN)ì:ôª»c¿›Q)-œJqPéŸ3 •þ+ÖžDi¿›Ï7¸Î¦öqÉÇÖ™NŽ(u.=¦Îç$JGžjÈiuw»c5<°ŠÓWÃÆi*÷:° H [. ´¾]áfÉ ¾ÎuIUYçœbÃH7ãµÇ±s¼97å´‹º»Ý¹i–…e®;':;¶ËÞÙ1_wvœ—½³ã¸ì‡ÆÖ]C¤Luvœ—½³cåËrÚ[žÆŽÃÔæWœCЀ÷|c]Ô%Zï._9ü¡+*6¿â4”P·*¿ Q:ò:CN»šêû66ÞÉ–Ëg ¸1rà_@C¡ƒiX3uRø„Yæ¸Ë‡õÁ–.©íSÈAé¹Nc§€ãÜ”Ó.êîv?‹]Š5 @–Á)69±™‚‚Ì’Ó^6 ”PºË•" ]QÉ×Î䌩zÚ‚Èç¬>6(=~9…vIw·;²×¾¸'åÜ8'#oÆ~¼òƒN¬Aç!J¡‚TC^H]R[gpnû¤³¹n;Ñš‡(ÖÜ’Ã.éîv?“Û }Ž,ÿ–s R¯Ý_5ñ¾ËS”ÞŽå¹Åh]—”£Ò‹Ó'N.tûT(r Ê#B9ä°Kº»ÝÏâR|6ÿëBsHôT»îœŽ”´’d¿– ‡ëÞÁ­ u—ò¢´_sm’Ú:¸%—ºÅRJ4¶QZ|1í·Ö° ºwv?KñÙüÏæ6ÿ³ùŸÍ¢ù‡uS[Й,×vÒh‡ÕS,ØÎå ^NÒ) [ª²2ƒ\nžb×%ÕcFN3 ¥‹(ŸÆöXÏÍ]ÚÝ;»µõLËM° ,;!= y¹rÆü0ß)Y7fÈ›¡UK—TsØ qªŽu&sœ1vqØ ÍM9íª:Ça÷Ò?,áuDÓkã Vsù|Âoü° °Z8-·^rT1H—T  rPÈ%]‡”´±s@hpnÊiuw»· ì° m«îvJÜvD¼–Ûxná}KU”ÜN9…ÜjQ\Tö2眖=IÝ<ä3YcgO!ÓÜ’ÓRêîv{ðyCr IÍœt(.ÈHX!*OVRXS7/“wP¨KjÜ §<Žº ¾Ûêe±rêrnÊiuw»u]k¾ÝïÞ0Œ¤üÃ+Zꩆ`ë…JkÌu6%*œtIÑ0Œš¤ÛTwjc·hƹ)§]]ÍÆÂîØ”6Ô¡Œê›Ò†Î'6¥–>[ÐÄ1 <–WCn}]—TŠúFpú¾WC„dÄØÝ!g4·ä°Kº»ÝÏâ“Â6kÖí;Ê=Œc=BØ”m¥¡¸[g¥“».¯ä¸¤KÊû‹8‡}c©kýC|ì¡AÎM9í¢înw Ì Í@™1NCžF³»@=–€ÙDé66lzʇù+¤KªxøNœŒ:$ê&3Kc'”}nÊiWV Sؽ•GUyr¯;§¡¥Ì°âxsï-üƉ¡.È3Ã`M­nŒª;Ž Ãdm„®ÕûØ[O+ÎM9í¢înwäL¯{ºXË¥ëÎ)(âÃP*îÛ†LuøáÛ',•‹Wº¤rdΓP³ ÝÛgሱAáט[rÚEÝÝîÈë±òi½îœ¸4Ôof”,ظ. ó5 i_[{|é’jêÓæH·\­ h …‹"Ÿ!Ï*¨å‘Ý›oim¥‡opÚW‘$Ênµ…ÅM”^ÃV·PÍSRè’r„\qºe§K·ŸŠ³”&Ê}ƒ#äLÑ¡în·‚ãV°o=+y]ÄAÑk·òþ…†š,ïIBÙáîòiU?Ò%5ñSÃWt]<ô»»ëHsSN»¨»ÛŸú…Z³gdÿÔçPhiaÜÜÖz˺ӂ†¤ÜT]>­„_º¢zäô‘ƒK Ý §Ç®Q‡Å¹)§]ÔÝíÖ–ÍÂN_µ…ÃʆrBÂa=äH!Á]~¬3+U§/YȰrfõ£ƒÚÆŸÚ´ÓÙË êmæÆSr@ROJ˜|ÝPéÐQÙS±Âë§(=%̯øæY:8uI-Ÿc«ëZÉšm”ž’žBN»¨»Û±þ ìÏ “Ñû¼¯‰›„ؘ«Q(õ·[Ó éŠ:wlÌÌRbcfÜ$%Æ>ÝÁª¹)—]Cba·ÞÄÃvÕnØëÆiÉÖ®Óš¯5[S®w'(‚,½Î8V2¥+ cã×䜀܀nµöW»z{,Í-9-5Ý{»ŸÅ"ÒINZxqð‘¾í¾`°;€××î;ÀÔ ò„\n¹‚®K*>ðâXÞ´t>à{ÄžsKN»¨»Û½Aóó×€Ž6ÎP¯„ ÊŠÔ‡u1Aii •”“_º¤ÿÀ‹c¯L×mè•À±[ì–9wS†VBw·;Ò.r—ëæºsªê­™»—ñÉfÞ^Ž´‹|†ÜR¤]—TQù™sÌ5äºi­`|ì$$Ÿ›rÚEÝÝî(îL|é*킜†ªù lƒ®ÚñåWå•rKÞt]RÕKYÄ)zi'lDZ±½ã ÏõA৤ÖGvG[‹oОj?޲ª‰üû Å4D¹ï …3PWTÝ¡=A‹[èfäqììК; ,9g×½³[ø$’S×Å9ÈN9,áÆÚ òiuØ…o±â]nx×%uêº8g`å Ýh@Ž:sKN»†joÃîgñ6xrä¹UÈòcÑ —q“õqÿ½Nª‘dÇ{öÛ­9¨#*&É1t×mð\qlˆúÜMþ·£¸îÝÏäRx»ãn¶<îÄ.;µõæÉQV¯æÊU›j¶b憛m˜{¸U:|^L¦;HÑ»GY=ç–œvQw·{;–¡ ¦ëΩ(Þ­j+ݰM<Š(ËH!?°ˆ¥.©ïRr²cÔ$ÕHùØÉ»¤jî$ü³‹º»ÝòÃG[†÷pçÁLä& 7ý ¸Ê'à ¨KjDWrP/(Ý(_ŽÝ£‡+禜vQw·[Ç‚†¹zR¥8Í;Ì"¸²1ñ%õÙB~W½)Éx-눻^fèfXDZ³'Ujî¬îµgÝÝn­ ‡•_uÛÈ\wNVjá*ÖêìºjˆÜ¤°2J¢ü4/›tEù¶Iœ69€îªº>6(­7×Ü’Ã.êÞÙ€·¹X« l‘SÐ9ÞÜž fÖ:Ã[M")Ìgk.7ß»ë’ÊÙ"ï_êÖ‰ XŒ J+í”BN»¨»Û½*#¡tF“‹WcBY=a”'ÊêK¥OJ-.φ!]QÑùWœøuê4çØ%ÌsnÊitïìŽ& Ÿ¼g%»:ÇvÊjÔmOm(’(›¯´¦ Üú¹.©u¨ä${ƒS·MÕ]­±Aáט›rÙÝ;»£˜">}F1EfÞ#Š)s"QL‘¦(<` ”W I—Ôð:qUÁ˜.Jq4v÷¥æîª°ÉÕuïìÞÜžGçæ†Ä{~Xb‹ 5¸¶æ ½¦<þ“kè‚ÂØú¾ä-þÝ>p×`lPî†L!§¥ »ŸÅ²åŸÝüažï·'D€sª0k±Øý‰¶:E½â{º›ÞuI•ÀL&ÇÚºn8¦TsSN»¨»Ûý<.Å?¹ù¦ÎÅ^u׃nÕ‡í’s1ψ¹-Q¯xß­ŒÉm.]QÅÚÄÁ«Tº -_9¶{N|nÈetï쎚áU0ÖrÀ•‘Ã.X—6v™¶H¥oÓZNS^ ñMº¢rÀ•‘ƒ!Ô­ì ‚±AíëiÉi»‹ìvGXÔ•Ù3:ÄA)m%Ña*ÞÅ7ª$X=¨æOÝuEåÈè ¨¨;¦7oJ¢ä-;JÈiWRª|Ø­ërú×íËØÕ‘œ!¨·eÖTÂêd¹“@éL¯ÅµäX\SWÔá»>qºLL“»Eë4Î ¹ì‚îÝ5«é¹îœ! íÊ\8 ®àŒ ”5vyG“!ê’:X‚œ.,"ÓmêPE(ùŒ47å´« Ÿ=ìX¬µ§lSªÄéIU"–A’…XÓ³¨W\½¬7äP꺠Z<â ‰uÚlö±AyТŠã–žÊ »4Ç.°U*^wNWNSÃ.3¡J´¢^ñMa·Ó¡fœ½„.©¦ps fú­Èfšý¥ýg›!§]ÔÝíŽ¢Û …«Å!h@w׎óÌ¢´ƒ3äô•.©W“³ß§ëæí“06¨W<«¶>Õ^i¡»Û{‘UÃÚ-yÝ9ì+–eX»"—‘+ç¥{°ÓNS¹å3º.)w:§Û–DºÞÌÏÆÞšùqnÈetïìVèÝZ®¬ÞE:äd¥b±DFnÁòN%o¡·4#‡¼¢Su«úV”ˆÝ®fóÓúQ7¯xÛ©±Iá×6·ä°Kºwvdz_Qæý›ÉÁ qýO³}_²yzHS²HÆÓ^fè’:ýL‹Ã 'tÛïGV[+ÿ¾`npÜ.4Áº³;Ö0«ü‚å8} c{CX&+A‘-|6QZÃÌrkh溤ÎðZ3gƒîrU~¹)—]н³;"&²y•˜‹¦Za졸«A‹UQŠ˜ŒrÜUÒ%u8*±8]àš±VQZ%ØÜË®. Á°[èYÖ N_[:I¢Åáê´–°ëe»Þ< ð|ÅJrà]I—”¯-“­ÈNºÉRv4vò”ÍM9í¢înwD K¾ ùÚ9ײyþ°Ïìq˜ß ”¢?†\Où‰˜ uIµ@Ô#ŸLéâ“©±‹¯}nÊiuw»ŸÅ–Űáý?å&ç°;  É   9+(}Âê¹9F\—T÷]q¶Mˆós»z‰®æ¦< Q~ÌGv?“KÑX¼­ž8l¦Ú `£ÕÃVæ ´ö 8aÇ¢bjé’*ÑV[,ºn‚U;9¦“榼 ¸°çGv‡w®"©Ho+qÐò-U$úU|ÃØ{©F§'ögªÚ±ø˜{$ùæˆÒxïØû¯"v¥Ä!Ê¿Ÿ)ä´+©œ8ìŽ^ëŲš;*y“œ™NÖ Áº;`¿‚˜ 0ŸÕ…¸}~ ëT‹ÒirªRŠL· ¤Q¯¸Î°¹Q¾.»ªR™Âî@iHéÚ “3«~Xôk5ïªöT.JÞóÕÇ@ò‰Ýìðæ×Icû¾L7>qlc7¿Ç47å´« ;ì~»m0³Š\®;'cXCÞZË ë„µŒ¥íìZêI@é’J޹A ]¤›OõºZcƒÂ¯1·ä°Kº»Ý[û$E¶\§"ÄZÞ­\¯'(öŽï–º¤Êޏ~ÀuÏO€é& §pìˆëÕÿGØEÝÝî(eê(KÍK™ŒC€.t†e Ù‰ª¸­ÄìÄc'9Pé’²±ñkrP&&]”iì(1ÓÜ”Ó.êîvop3xæ&9ìÁ›¬„¼³/!5j@Æ!„#yduI倌#'!ñ‹áŸ‰Ä/BjÌÈÜÄÜ’Ó.êîvoh@ð'¥r‘SJ×±k¨¨û8ù¬Q‚´JÉOíHÒªìRÜí̺ÉÖ²;‚禜vQw·{Ã_…ÉñàÉÀt/ö¢Ï«š€Ü%Ç×(!ï–~!]RGàÁ“Ó;iZ5ÍÊË÷À9YMÌñ…¥ÌZDwQú6­Ó Îúv1çŸ-ŒÚLS'²¡[OuXc×HFåÜÕÛ£.»ª·N »×±üçåëïÒÎõUo·‡þfÐ4Àøl~Ûï__þûòæá§oÿë_vyõöávJn§iÿÿöÕ›‡w¨?\~÷ð³— ½\öÿKï§¿¸=——¿»ÌõñJþÏÈÓî÷†&ô/¯—/¾ù_^^þþáç/ßËæOøûÝjö}Ûµ}ðIz—þ‡Ÿ¥U5p»ÞÛiúߟ¿øj?O?j÷'ý‘ýןªwéø©²†m;U¿úâßüæûï~óååöaüâÛ¯ßþéí—¿¾¼ü¥ÎÜÆ'ýÑ“þp¿zñ°|¢ë ãÿ‹¯þýÁèÿüð«__Òå·éòˇ|ùýC¶sño‡eM–‰Œƒ9”ëýöíˇU|zºTH-¦ß\L2ä2ðv‰¶‹\í*Åÿ½VGC‹éå¬X7uÖ½Æ}ç[ã@}Š+¦ô¾ª+í~½ZwÝÐþ»\™|;î¼]ÛÙgŬä C¾–ì¶]‡œä'¿: wxùž~yV9ÕÚÜ|Èõ±îÆýz},};¿ ·ó¿jSãÑ"rKQއ‹ä'¿>†^x|ÈõYÉ ÷Þû_ëä6>öú<þûØ[Õº“dt4£^ÿ$=áv5ÉŠÎw×nOÓ^á­Úã‡NÈGÝ” éÓy"ë’릂|µ¸o§ËI†œm$'¹ß”~ÕO‹þß]µœïOèUæ~ûJ[Šë:u¯¾û¿7ú¡S÷„™¶áÿe›uE†N«ï¸L¿ýæí^ÿö›ïÞ<åæu+²Í¼ÿ_V¬Ô¤…¼ZÁi®œuŒ‰kšO~WnöDJtÅóøöëë¾}ý?o¾¾¾þÿl›r¶yÙÿÛApÌ• ÒmsòÿýAìÃŒzY¾Qû_,Ûý±xÝîVûï·{~t»_,Ãdy•ÊTÈDœjOJ]UDœZŽ]Qj8>ëârë"]R¿&ç4u‹AiìâFš›rY Ý;»·ý×ûžödý1Þë´ãVe SJz|Ú‹ŸrÚ‘z°ŸöÌTž©¦=+'“§Ô~Ú%/j´tE9PœcK ×EÆNž±¦¹=EÉì‚îÝO?í«£’Õo¿Çi¯ç:¯Ç*Y‰ç4NûcñNûz?üÌ9VaÇC_È«5N ©í´»¼ ùº¢º÷ÏÝõ¤‹îz»z“pÍ ¹ì‚îÝûiÿ€WÜ®7PE_ʱ®ù_{>öÃô®9W-ðn·ÿ†“.dù’Þcãúq¬P:ž endstream endobj 220 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 223 0 obj << /Length 631 /Filter /FlateDecode >> stream xÚTKsÚ0¾ó+t´R$¿}è¡mH_Ӵ͸§¦c PÇX`‰Ðô×wåJ3…´ïÕ÷­N„“wþÂ)à—AJÁò² IÁ Ò¬&› ‹sQäcÀ‘8ºöiÞpña‘K=ùß½‹ú’ô¨æ›jrq•¦$geΩæ¤(X’C߬dITª%?‚[žò~DHÁƒj)Q0›m=È•F‡4*yËã¬Q²A±èÒs<ï´ ê! ©jì(izŒ©»N»Ôñ9ÊlëNý©­Òýi¹fÐÆÐA®;ÕÔVžôPõLuʆ1îÑ1 )(r4í\)}½ºë¾U®ƒïZ÷{Tuþ¬>É$d†P!„'Ž8Ø9ßvhZI;¨íªÇ³•V+Õ«~A툿Feã@®ëªZL³#Ù ,dïvòÎJßÌM§“së¡zð­žëaõdÖ KgSYH³ˆïåàÛìÆpW¹I2vpL1’"#ã5ã4yœçpS‹Ó4vã°D‡êïT  >½~ûårŠòz€WÉÆ¢åæú55rƒJsswzq¹¦ÕÃ~E,/b"bÎ`ª¸^I\¯ñ‰õŠÏ× +Ò‡’çÛ%DÎ`mEä6ðl¹¤KÙ›ÞÖ¶§ ‹Á)gÿq4†^eòÿ@“3 ¾â³@cšEg@g4ÊÄ(¼ƒ{4 P'í”]¢tXnóªºq¤|Ÿ¢Cþ^û¬4hñψ>²®šŽþ+œzõõÓg”Z/[Ͷϼ¥‹«¨$%+³(s©H˜2ŠŒ%©ïSž$ þ4ív) endstream endobj 200 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/ENCODE_SCV.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 228 0 R /BBox [0 0 1152 576] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 229 0 R/F3 230 0 R>> /ExtGState << /GS1 231 0 R /GS257 232 0 R /GS258 233 0 R >>/ColorSpace << /sRGB 234 0 R >>>> /Length 24201 /Filter /FlateDecode >> stream xœÍ}K³e·mõ¼Å~øšïÇT*Y.;J%iŤR)—#'år;N4Èßÿb-<}ÜêVlÉ·ÌsÏconraXãË/^âËï^þûÍ?œÿ½„×ôŸÚ›ûÏÿ|óòÏ/xóÓoÿñËÏ^~ó훸^ /þßoÃ?þöÉŸß~þwòj{ùß7ÿò¯/áåßßÄ—_¬ÿýîMÜ?÷Õ›ýŸŸ<ÿíÏüEî -ý5…—<_gz©±¼–õö_ÛøÈKýàç{î$¼Î!3rþ}ÿNÂÃèwÇX_G~y÷¦¶õ½6þý›·xCªíµ¦óŒÏòÜÿ±7`|ÞPsó¼cyC¬ñ5%Üà;ñ>yCŽéµL{†î ¥ç×Þì º7„õ[ãÅÿ+S^K>S£×Yª|·]¦ÏmÄÑ^ãp3¥c7©½Žæ&BÇç ¥õ×ZÝ/èXÞÐÃkv:r7‘r|ÕþŽ¡Ÿ§™_ã™H Ýj-¯ùL$†î ?ýòmªýå?¾•ÅÔóš«Òö¿©ï¥¨×”F}mrkÑ×µÖŒ¸>?ÖsIkm¬ÿŽ×\^R¯Mîo–×Ô^RZŸíkC™Kq¿,ã5“ë˺&ù²¸žrH/qÖ×®ãþ:ËšðñÚåëbÊ2±qä×¼¿/Í×>^b:ß1¯®Ô‹\ë—u—ëûÖ-ô°ÇkÞ×÷­‹ûó5¿–ºÆY&GÆS¾8®ÉÉû󭾦ù"/—ýù¾–i\ã.OAÆý5æ5n²ªÖx]XXß·æxî÷¯ ŸëûÖÏì×| ù¾õýò÷´æcÍb,S~FÆíu=¹Ì$÷ŸÖ|¬yŒkEƲÇãu=ªXÖ÷Éõ¥Td©Êmf¹ž”×c[ß·vßïÏí5¯ï[cÏW*é5­ïËØ¨©Œ×¸¾o½-îß_Ö÷­iLûûÚ†Œ˜ñ|Òš5Q1g\ÿš±æ3¯¯Í{ÜeƵJƒÜoZó± KÓØ¿?æÞ@ièâKëA/H‰©ë÷çeŵBÚã."®ÛÜÏ?Çüšäû²–±^_²æ3®ŸÉ{©žyX+gšFP”À,Ž(ÏÎ&yñþf<ƒµóöÇ#ZßPóy‚ ÌS:x û8ÏÙ7½ ]k¸Ñ«g,ðÌgq­áÆF¬½5Ô¯Ò¥¹PŸ¼®Ü5Ü {ÁÁžg¬û5ÜËÛbý»Ÿ*vÍÈaSÍ…9åì¹e÷6¤aKŠá)gÇ.œÑ ªzý\žg¿/ÞRêƒ9°-æÔÍF0 x ›°#­ñ¶Œ«”NÌB–{=`·Æ{ý —1ÜÜ€`*À`*›§9°•¯õ`,›!8°^›aG‚y8ì×e†îŒ€OsÆbÕ6Þ4& KqÆf-û01š±Z`¼1[oÓû±KU3aÚ6õËe,zrÆtýlõÆvmÊœ1^ÆjVg¬eGgÌKPãIc¿ns¯X’‚ù&YXÓ²×;ÉÄ2ÞqÈF-JjIFÖ×n´ YY?»ç‹df­×=_$;k7ëß• Ém†}?J–âZŽ{ûK­Ç·w˜–ÌžÌxغ¹½…ÀÒ*Ö=8Ü‚†½tþS\ˆ/߯ç¤ï‰/¤Ž¾e}wñL„+hzûd‚€V^ýÐÅA&öw› hnrœÔî&oÝŒœÜ^ÀÌ0ù }7tñá´¢–‹oíé™`çÃ_s[R.ŽšÀ¹x& Wàâ[‹g[B.ΨÊ\±x×e(SÅâ^ÏK7^rs¬=·¡‰›'ƒ qs-&vm¾…QÛrÛæœÊl¹y×f*ÁmîeÂfq›?Ue>‡õµÑƒÇbZÛ$\Öf¯ÃσìÁia¢2K€—0©æÀM˜Òpà·˜2'€ã£é™ XÏ#À…à+–Ü3Áµ[ԼȞ .pT&¸À³{&¨fë0A22AY¿ó˜ë½ÞÈ×X™#˜ x:ýØ4ÿ½^ÈïLpì™àš– –d‚b|ê1·²­À ·5^¶«Ïc«×Py›Zò Ú;¿Ìàl‡Ì®AŠã€.øÅz|MéÆfk6sQn²{Q>¸™ËÜ×j¼f ³c=˰ë5+'¢cZ,`OøÔnÏlk}öàbk”n¦¶Öܶàqº%å­aÑø‡÷ˆÇº¹{"œÏ÷#$fÙʉs«8˜×~ÜVMq0§£¦8(Œ7f¹Bg$d¬8©8˜—‘œsâûóÚg›¤åZ»óˆóÚŠsŠƒ™ë8˜×em”íé=â´fV_q0 N·ƒƒ-ˆ“yì:éi‘× ¦N’¢8(𡸥8˜QÖ¿+&áÑéà Àz”ŠƒiÙêpP,_w$&5P\à ÀY¨Ó²Ñá`jX£ÀÁÔ’’oà ÁÖÊÛö>¦ŠpPbiÓyÄò3Ýá ÄS²ÃÁ´öà&aÀA±²£L à ðÅIÅA ÈGbÓZÑq\1ÓÊy“Øzp0­õ¶× p0ÑNÓZ†{ÿSŠ òŠƒ)à¦â <¶cÀÁ‰«ŠƒI‚‘áà DŒÔ£T”e ­âàfEåà`ŠØnÀÁ$¸îœ–$ÓèP–YpP(©‘¦…ËŠ» †IÀ(4Lë1Í|àPÆúýЇ‰Nq/'ãâ Q¾?8L”ñt (×·yP1­ý»y`qß_=¸˜ÄÃe¾¶dLëÐ(ó¿÷°QžÏpX)¤8º÷Ç RN»‚'Ð_Ó´ïŸz5^=øŠ=ü€ÆçAƒ“Ä‚lÃzæS"|±žùŽm¨`„býóި߇Ç‚xurYãMÒ!é딞ÁK§FfmõÝ¡Y—¥ß»½Æj{a×Þéú€Ýïàä<мaÝöô¦‘°ßÁ;yxÉòé§s—ã ¯«;Î~˜žÎcŽ‹l–O¼36žà#ñ&À©$­ý¦ß¼ × <“ˆ•Ç»¸æàa|ÀËÅ#·µ%žFˆ·kvÇÆc×ë²öïÏS¿" ‚‡Å9͇W'ö"#"I{B|¥½ïíÑZ6oi¯d[9^/cµ°wDŽöPü¼áìe¡ý‡=-N%ìí2ó19{\±ži¯+#ò°çË^©ý†½_ÛDýðµÿ†úI›/ìt€ó«’~ñ ±ßÕùebÿ£:É›¯ŽÏ¤Yè$o¾“ÖzÛö|(M$˜A˜SÃ?ô+…ÚÊ÷Ãí\ÿÉÎi^ïÞ«T-"à"%tšë3§ù‘ŠÓÌLÉ~VÆ S¿~,Ãý/\?ŽwŸÅ)ç>2#»ä…ëíÝóÂÈy/Œ°Kä… ^“›ç²Ú>áüÕ=§ ’ÏQHñtÏyáHôë` ’ÌuÒ›ò®£7Ûnp-œí.x#<ÌgJd]]ëxá~¬n¯í]ðHÖiöû¤¶Ë?–ÈÆ1î³ ×ƒûpÙ©æüãT‘ùá>^û$ú}.ð—¬iÒ} œX¼lã:qDöau8SÒCŒ×§Ö¾.ø'—Õ]p0-ÿ_ypP2/Î?œRœŽ®ÅW\¦D¦aºà¥à f&€Ó)'*ޝeµí:q>ÒŸ/”i/ÇNn'gG„‡ÌrìŒð”î2%«ªó…ifvlíÔæx¡Øáíàdfvr-›Ë?ß2:;»ìš:¦°Ã8J;=¦>_Úñµ,õï°ó<š<` ¢Fž°ìêæMäËÚñ òŒ5Þ~yÈï`yʺíæ3%k¼×/yÎú¾\]ørm7ç4‹íÇiÞNÅt `-x8ïȪq8à¸IQ>à(¤JÓ²L#Gó<ì <,0:L#óz<„“fÁðeNŸ¥‘À™iäzG¶køž4òžl—FÞNŽ¥‘‡^¥‘"ýL#ɱ4r@ðÁá‹ÁÒÈõG 6êß™FŽ—Ó,Ó|YҺ連›sšwpñ &¤­™÷1ª‡/·${Q¬µ$|Ǽ3OŒumIüÁ¤?’ü¸:Ë'R;P½€| ×â—–'xNÌ7ÄKNžXó%ÌE$ EŠL¨XŽH|99œ‰ Ú–'È{Sä2ÿ¡†ùŠd4MEü“"æ7(Â)·b0`}˜ˆ'«16‘O†Ë Ô 2ÙÈ aÂ÷3H(`•8JPkúäñ7$LHv3Hh" ÅïôÁüæÎ a$X!H("—rÀQ’J’$Œk0H©ˆCPü('¢‘d‚-‚„q  Ū;9µÜvuü0™AB&3$$xX2&ªßeÉš€äÀq‚äç *8ÎðuÉ"/§žHÎY² â‚£È3´SÊ4h pœ('° a…œ“AB BD䃄.y,ãæåÔ³0™Œ !ųGypà8!® 8Šú%;p\ãâÔ¶‘ à8!™#8N• ŽŠN‚ã©uÉãð<®Îÿ“äÛNþXòb Kƒ4[òxªãÆä1µ%t´äqÕùµä1X&“DzŸŠËžtýLå¶Ü÷ɸ¹dµ‘9‚5Eó5ö¢ê…(ŸW¯˜_&‹’QKc&3’ùLg¬/&duÉc *3yœÌfò˜n8“Çñ&LN[ò8êõZò˜cì'ysû­O¹×XÅ!د=]b¹þ=ßÜïëþu?:ÉðB’FÕáI§Øx#Ž„W\âÈ܈wyÈ@‹dPnË%%è®É[Éa.²’M‰Ÿø¸ãH¬Š*Af%¤àð\œŒ• OˆH–'‚ø$Óâ’mjëHÆ'㨠ë"P¯Ç^m<öö,@8O{GòC{(Ë‹­’@´§ÉqÚÛ€¸$í±eç̾/£…ö>P> âœýýà WôIÇØ‘ßHXoä# xò•L¾>“™œß‘Ú7+*t¢Á—–s×=ŸªãòE—¯¸¿d¬AB ªÖ¡8‘ëH æUè6n§ù‘:§¹íRã…Rb:Ý™q)^%.´ƒ¤ó>•ô¸OIâû$ºå0O‘2Σ8©ÑÍsyà…™e}xN<…ÏQ’Ñ=ç„x3×Áz®É¯“8®üˆ¬ƒà“Ç–ìÆ:Þäש8™®Ì.1yÎu!Šá>ˆˆHrŸ¬±&o±"DMä…¢8òBUµ³O…‡Ÿ<—“ /kdŸ\Éã€û!/”}çE*ù&òB Öy§yÒ)ŽIrßçG& yˆƒÂ›ŠÃIÁ%'*Üêg'“³ÀáùÀ Ä÷Äqÿç™,¥:ÐN.»¢ÁíéÅÕvÔDLù åʸ¹HïNvz;'Á1o󰓃";ØÑñ Òbr”vX¾¿8;=˜`ò8«¸Á’ÇLæ2y\‰gò¢Y—<Ö07“ÇMŸ¯%x-“Ç<Éãñ<žà‰LÏ;yÌ‚+ò¨‰üyÖd™x˜ˆE¼ÓÂ*Ùãž BˆÙEp%¢ÙÓ,1L/UÈ”eRA?×TØO(H©À·² (ô'«TðO^?þ“eʨ˜ãŠ€‹t8¥˜lûäœæàp?9sdB*f¦cL4GFDÉéÉJŽñ*P¥ætJ9©ÐiÎi–çŸ\rYÖgsN³ˆV§Ç“Å:ñ†ââ‘Ud¯ÖþhN #ûGàÀ»ëÕeXäk4q ¼LúO—T² ¼•JÄàðx9eª¤^g–-ÏK¸‚¤‚?Á)-7ž92-ø™½=aEíMC…íQË™|‡ÂzÛ³Ü Ö‚½û0\¦9wìØKy¬Ã)UÅÞD'ÖÊ¥·°ÇbŸ‚ë²ÇΞËûƒs†äû§ ¢ç…=+´‚„¬àj¬%Í\™òæfÇiÎ= ‚îÓ—)˖ض”¹ð̧N³ñÂã4Ë^,GT˜zN¦Y®L[y!UIà…•@ä…ŒpÉÂú«H.\qÊt¹³ä’)ÓÏó`¯<‡Þ|N”òð9Ø>çõþá*ñ²ÞÅY'•N\G|ŠnÍŒL7Ö¡³âZÆìÁ:žå^ç¸Ï}0‘‰ã>¬´Ã>¨ìà>£r‰ûp(¨±O;‚ÜÇ=³ý€îóõˆ7O'4$ ˆk_ëß#ÕÀ±{‡¤ÒÁ)®…géýÇ Êñ‰s¥ÓIV,(ç'NVðG×mÄàp¶‡ˆÃäEÄé ¥q|ýgx^˜±¯i2’´¸F;’É#agr¼*„W¡o†Ú©íXB%í\‚B;(·œLPÐÐŽ&Ü?y!“kä…‘MMÀ #*SÈ #ƒëà…"êsŠk±£ú{à…’ sÁwy,Ýçwe«Ë4gV\“†x)®…h°ÓaLMqͲÊÓ¸+xNdD’ŠëŠï;Šëê”§[AÝ8nù¥¸F¦Ì×”µPq À>»‚srv£._vÕ”áô[q½–åðEö2Î Ž»×P;à¸eTWã®z9Í{ìœf'×ÏJÆÕ9™[¦ådÌ‘í_L†ÓÙ°2œ®àn2ôh0Êþ¬qWPcw»q×p.xC7J׸Ë] “ª§qWsŠëΉ²Æ]È8³qWu¾ò%9»T–n»Š \ŒÌä?wéYã®è¢"$‹®q—ó‘GCHÅw¥»q—:ÌhÜ5.»=UhÜ–pwé>6ŵ¯ÞŸá*F¦ü4î‚Ô»²+‚˜t³Oã.Çv&‚"§qWr>ñd¾Áw—ž˜,£ä/@%súvEW:·%fWß®¤¶É$‡À6“$f@)YD–Ô$Ðt[ß®‚€+¥×`˜ôºÁPz I¯m$™¿Oéu„›Òë„€-¥×å*Œ XÑVEd‹hËØô¶ÎJ¬a #K;)½f‹ØRVGÐÖJ6Ðe÷ÄÖhV¶zÙ¦êJ#‰,m}†jŠ\ 3 Oéu€Néu†£EéuS¬6é5$&½F)©I¯3Tn”^¶²R.ÔÑ:ˆÒë1ôyQzå¢Ñp…Ò먩4ʇ™Ž*˜xžE&çóYä}K‡óA5ÏÃJ"çK—ºP0Ö9ö;KãJ­·Z¢úyPRzu]›ôšJ¯¡V2é5Ö¹I¯Óݬu!]vYäÍÑ<çcU›I¯ãU‚,’ýxIü;J–YPQ:ΔLr¯GÓý:§e%܇,Q`i?Kªæ(½F"À¤×™ûÒkTQ9éµwˆe_ _e·öݼ¤×óje ûT1”^³µ¥×”~³E¤éVeÇ–c¬²c .VÙA½eUvlÆÊ*;Â?«ì€ Æù£”^Ï»Yk@–Ïµè ¾Eèw9 dÚµè ^­¨¤ô­˜\‹®à«ìpÃI¯}`xK›}•]@ Ð¤×PU¸]>‹<Ñ”ŠuPhtZtyÂ7QáÈ «!¡µèÊΞáœ]ª*CeWa>Dë¾2ÂëÖ¢k£[t¡Ò‰-ºcb‹.xYlÑ D‹.¦YÉ6¡ÄFÛÐßeÜ@IZtA Ä]pGnß7ïÞçMÖÒ{-ºvRƃ±'ª¬ÇÕ´º#¢JÙOG+‚£ ª.*jMøRUÕ›©ŽLU­jšd}!UM#/»­ÀÅp}&EÝ¢¾'UQ¿5M@ÑÕ4 Jâà-P œ¤T»ÄÁÕ,qpÑÖéTcÒr&;•µ|mð¾o‡ê˜8Ø¡–  Áž×#Ë¥EoU؈«ÀÁ†}Ml…¥kŠƒ a‰ƒ¿láJPX©q°"¡F¬(í'ÖÊ¢<ÅÁŠçE”¯ç“5±u¡â`E q°‚+Õ6ÀÁŠq°F–¤(²$‰8(-™¢ÃÁ®”ØÕáUÖ“8XÆÝR¨ DŠ8Xà› ž?q°P­,à—ÄÁRnß·ÀÒ÷-ù î’(_‚R¸ƒïËjvú¾ê$ú¾¢t HW‡‡2¾ª3Ô]ô}3ô}åó¾Ã_m\Z+À÷-(Z¥ï[âÝŠaµ!|ß’îjã‚@>}ß‚¨µäªlÕ°Ç"Rw¾ï„<ß6¡0GsÄY~LG½<ÔÓ4d÷éè»/E€ƒh¥Ù,ïeé6!,íÎpUYú]î‡%Ùö«t¼ÑñEi9ÀÁJÏJÛYšŽ¾³VºŽÍnfŸˆÁæàbMáêc-ãê~ ,Å×ͰH[ñÒ³ÄÍÍ”³ÃºÙØ$™›Q¢ê¾5@¢„›Y0ÃoöTïþ\r…—X'€Á$ 8·ì?Ñ `”¸%XQÚI0“.FN³•N=³I´Ë\nç8—«*Yl`ÉŒs»¤2¾$Ö¹³-èÓBcPؔƢDªÔ˜öÍ…±)Xo4F¥]ê&Çè¹Î.[,à¼S@§†Æ²"IcÚ¬YmCp€Æ¸µ«o’ô§ë¾ž´#0Lcß)‰†S4Õdê4 öƒSE©&®ÉÀ>œ2éåKÂ$ó$3R’äûs±õÉPBk ’¥ü ±.¨çתP Sbu·SõÜôá›hàÍä/ª•nçø‘úlñ>ÝÀœã ;NR˜n‰5z ðB!6R„À}®éì®>[úÂM—Uéú¸Ha¸%Ö‘}aA Œ2I!q˜ÏQ‚ZNE($¯:R($¯øºäÑYï®ëˆÙY®³®Ò;y¹ú N‡*„븣N“ë¼!@Í} ëØ;ÇìÛÈ}Ä:lî³Üá>\¤»yRXÛM ­¿öyEiq@HVs8Q#ö)p¤ÀhgÖ×h¿àô÷öαt7÷ë ‚cN×ÉÖ4˜àÑÜÍŒH†Q8†Áfÿ“Mo£¯?‘ªÏO4u5plWSëÈ6ä§ïÏ5( '8¢i§c¾›ûJ¨Ž8ÖÈÀÙ-ó˜é¡ÒcFSó˜Ù¼Ÿà8áq‘í#86Ö­Ñc¶&Öð˜ÑÄÀoY…ÊAÙd&Ë`íe‘IcÈ:x Èi´wâaó(áF¦¬yt“M–2°‘yÞ\QÖbZk;¯._²˜¢@êλ‹>•¼6^õ,SRL^–C–ãÎÛË>´)G"ùF‹¹0%o¹Þ† C&b²¢»ÑŽL2o9¢°Þ2RBæ-34ËF“(D3o™…‹ô–ñ|Ì[‹²F—^HÃ[† hÞrfjY yC÷qú¥÷8‘Q`hšD¢ÔRñ<Éqi«¥p0{YÛ¨‘Ù]d}*yøí¼ËþÞy˜Ãw¿ŠåÊL$ôád—TøTTô!Ôö[ÐS X”㓚ß ò¨8zËÞ2¢cê˜Q³Á”‰âDi÷Qr¥\]ó·7›¤”Ì[Fwp‹ú»ñBFÍŸE +RŒ*"GiQG¤\TrøJf#HÕôɉ'û¨hñɦu>QUŠ2êJÜfT–©ðµE3IDuéÝ3ê‹T¾‹ 'O½ÙU޾ ™ç–š|5vŒZÛ[æ9¦õ$ˆˆŠCgQsC\TýnØúpî'Oﲨ=pÕ¢ú[Կݧvˆô@å‚hØJžÂ†­íJ,ï±ïâe \Ù° ­a+¤'vî'jíÜOÔ›·Œ(º÷–#t6Pìk[:oY‰Òéâ5¿·Ì¾ðDb‡Ýõb”P’ÓÙŒ÷Ë[.è¦@o™FˆàØ`¤è-£K•Çæ¼åݵ$xp¬!áxEFJpìôî Ž…#4²<*€F¸!L#]P˜BpÌyŸx~™ßâp]v…';ô<8fhŸ ŽñÖÙ¨‘ÄàÔO#9(À4pD~ÒÀ1SŸpD~ÎÀ1Ò;8†Û[ÎèÝa$óeàH]Á±Þ:›ŒÖðŽlQHpŒ··œ!Ã0’:y¬)ÀÞ¹£!À‘Ý"8†p,®€q뚢G¬?G0—òš¾ëPb! ÁÏÓÀ‘]Žl)È”H°KÙ,á-CìR~¾€Ô¥cÇèC‰ì.nàXY€l)Ëê»FIa‹oq*$8òh‚c½º8G ;pœ>%q"»#ôˆŽSÁÙB‰ùf„Ó}(rB÷qëf ­?»YWD&Ñͺ_Ju0ª|РĆ]Úͺðv³öí»¬Pøt³öÊ$*ä¡[ŠP1[7ko fºQju襰Á©¦‚“H­U¹•Xåê…Îl;U\í,¡ñª”|i7köC7ëzµ§›0ŠÔV÷뤧ÙïnÖ8‡Úê Œ ¶@íDí®-é¼´s(F2m]EÇjïÚulÜøN]ÅlÔXCÓdktN4m`¸;ÐD<>Ó"âgÚC›6‘éjËÕ!Ç‚Ó>úcûv}‰×X§p§‘SB”ÚËòÞñ©js¨Ýìxÿ9~U 0ë}ëÓ–÷Jåüpü+µ—Ôž2"Mm*j·z%Ÿ¹ãgõØFÖ;Q“vê¡‚×XW¢¬ž iq«·êw„ÝoÖk!¢KÎѱ´z/ïKÇ8ñ8#8ÆèžeŽ1: šcÜ¡õ¥cŒ#ýMdéB Êä6§µ–úÉvjSytŒßç~Þ1Þµ(‡ûÁ79™’áÒÈPà p4é÷«¸Z:†úf4»sTöó4xì1ãÈh€¸´îvL¬Ãc€#"óçܘÎg€¤@SÍJ¼:¾Iš¶{îWÛíWt´ëúXWÇŽz¬«Ã±Aî$“K[XXKÁÓCYöÁUWGÇ™uuÖ™ uu<¶‰0X-@†ÎO@£&œ¶pó´÷}s8”ipuuÍãXB§5WW—]ó…íXzÇ8±åÔÕE׌f;Ž>`=L_)³½àp^¸Mtv€šp  —,ÀšÙÌÂN2ñ§*lM¸ç~‘vˆ^‡iuuá²û {ß©ËêàN€¹= £Ï”#îØZÎÄ7mb͘,@ŽÀÐëÕŒ&Úq¡ À›=°ÀϸÞà¿:ud¾\‚ ^r»„“JN{ëyÉõp®ooíšÃì„ÖÙ¡®‘]{ë«ckÀÉ;o]̰,väÿ}rlüË/ÞhEÞWëNw5üÞçrU žjÚ}eÿç›—·oþáå¿íŸ}­î÷ßùé·ÿøåg/¿9õ.ç_ñÃú³uu/_ÿöEçüqNïYÄ×ï^þßzño^¾þÝ›/¾Þ¿ò1µ–„~:}ê§¥<~-ýtùÔO—¶÷•~ºñÓœ'> ¢Ïß>™¢÷ŸIgòò»ó\¶*¹lFúO©€Ÿ¾Å_%‡ýÃówé0šýÃówÙ ìëÐ÷~ìþ–[CŒfoÝwMVHÉÕ¨ögíïÒøb÷ñÒ¿sh¯uUÈ¿shÿ ¬f=d3í:Á½&>a=i›‡óÙOXÉÊ›Ã𳟰ŽkÝ*íóÙ÷Vñÿ}秇Þã¤M¤õÈ*ùáß?½è?ñÙ¦~ö¿>á³C·Œ}ö?ž}vÜúÉ©~»0Eùd|þ|Ÿÿì4âÏþìïùÕÇ<ëê?y|LßëѸ_ø‰ûa=¬^tœIaùógWúâaˇõ'?¼§õ'g®ãÎÙçÐøÑô¡Åz¼eõ ü¿rË%ívWÒ5j9½hìMæ–}ûí÷œÆü¡­%\fíš3íÓ·¿~÷Çßóoøõ»ožØŠ»‘'È;öïžÿ„¡¿ŒŠ^ZŒÚ|ï¦ýÏî‹ê31÷‘ºËòÉ¿Ëtêì~àû~ûìš¿åc án% i}êÝKц†ÿÞq”e.ËÜJÂO›ËÇCŠÝ\>ÿ¾§sùì¨ã›Ë°›Ëœ¹Ôñ?—Ré—?q.ŸiúÁï{:—ÏŽËú¨¹,íg.1þñçROdþ´¹|v.οïé\>ë¢þqsÙv¸âÌ¥Žü¹,»ôû{ÍåÕ.ùƒß÷¡¹¼šë}Ü\ÖÝ—÷Ì¥Žü¹ÔÜý÷[—¾‹Ö¿ïƒëÒ÷eø¸¹Tµü™K¨çô¹”6CŸj{žUeðûžÎå³2ž›Ë¸kãÏ\êøGŸKéŸ>Õö<ÓëðûžÛñ'"¯šË¬Ù\büãÏ¥ ,>e.Ÿ«9>ø}Oæòy^àãærlÿåÌ¥Žý\þ#Eysç]›->ÂÏÿéW_|þgqî>ø‹e-‘®ÿßýüoöüàØm¥ö-~óÇ/ßóìþ¿Ø*ý×ÿüâí1§ewçÓ9ýâ—?ÀæÝßsúö«¯~€Œ;_)?øËÚ~€g(ù… «æË¯b}ü¿ÙwNEWêßþú»Bßñ¿—Ú›ýþ?þ³°ëŸ_þð€æ÷ßöÝÐŒßþÉóëùì½Ëoª™ü‰OºþÕó0ÁðóïwÃ8~¤ïúÿwoâ® äXâ¾xƒTúŠïkïÀ î-ý1¹·à÷–š·Bó¼/È[zÚ’½ÝwÖ†ÔÏÛ7cl…߀¡{C e£4ßÁ±{‹“ˆïDÏùW¦jŸeS…kÞe_Ý]3^ðw.½ðŠ¿s}Á½¥h¦õ¼/ì·”vbùï8ôwú æ¿ãнa¶y¢ùï8ôS³‹­Îäq|OT> ZÙUÑĬˬ‰ºƒkoz̘hvî¾µ¢ª´Jh=¨V «.«õ¦Z”¬¶‘T+€&ˆm=ß §7nÍM“ž¹³1M Fʺž@³O¯ÛÍ×%)«Ùýþ®j`Éé‰f"Ð+[á§„§Éb‰ýèz®ª@Ub/Qµ8…©—®:Qh`zͪÀÑνNÕ àôήêxѤèïõ Å èŸÕ{3­Àþ>U•mËn¥7µ[ÔÜgQ­ú»-ª©Zô%¡©N÷3bRhPmÀˆCµh1¤–·«nsÿ}­ %Ò[ 6òF=Ñìë%ªV ¡z£t-ÖÁ©jCÊ+Ñšc¾Nj´âB:ü«V`¯‡Ñ£jpêÔè]µ‰g¼gÕ ª§j®Põ9fÕ~lCµ3DÕ @ 0CW­úøL=±Ât‹SÕæ‘ ÍTT+€ù9¨VG]ÏÜT+y$}R­@`?þ¡š5œn:5£yÐÑlAû±A7[Ób1ÌÏ”c´¿Ûžï)ÕZ ·sýsdÕ Õ&LDk·­‘šk>pvEsT±@äñÊzÆG´ºã³Êx&@ÐÉÝùr}!íÆ&sR·$¥ZUÆã½{×XµÐAº ãä¾²dúu3ûlÓ9­`hïÞ áùïÝ;Ù‹3ôÄŠCm¤M¥føU­FQÉ@`g 9L5(Ö™MEÜÆ}Z¸ªÐô# • dHÈwsQ.&÷BãIÎøDC…4¿R2œÝýfc›\Ô鹩WÝqŒ8o«gž€¨÷ÝÙC óÒ+çEç­£çµê°tÞEž1Üs‘N¾Ý=·\|®|î#±º.ŒÁ‚!¬œ^ƒ\Zr"\pkoà¬Í5œné(±²G×E‡…?ÐÊûb øÛf ! vÕ@Y6ÝD¯*ìIi—Ï–h…=Q /’®zð`âKÀÅÄq@“‰ÊF‚M#î=‚U xÌN‰!ØU ETX´ ˜F l¬‚ãÈΩ눆×s6Ï$ØS4Nc z¬âŒE‚@“ÆD³™Çذ?‘ô—ˆÎX¥ã c–pú]†Æ0ãGKžÂCcšQBc›!*§1Ψt¥±.hJGc^PYIcϦq$àJ²À$‹Nm°%ÙhèóE2Ò£Î7ÉJ‡šdF¼~g=p§#€ ‰¾ä(±²2(¹R2Åf¥$[ s$c [’µ„#EÆDd”ãÔ *2J¦Q2îÓ|êAÆÝ¯dL&E·+L€Œr¶Z E°^ãAFéw7H¬ò2î¿;"ŸW‚¥-㽂€Œ2Îù ãþ»ó¦e¼ ãî·×2ÊX½eEÆÝÙ>d”±"—"£œÎ^7-u³dܬÒAF9o}:‚˜J”Œ2V§È¸ÿeÜ2ÊX½[EF+ƒWd”qpü75ûd”ñ¾_ £´BÜUŒ@FGǽè÷ïá £,xbŸE4¦ fl”.×:VpL<> è(-¿6Á9”¢ œ:¥()-.à*LJ¥ú™ÀIyáÊDM3‘RÂlÓ»ÔòÞ¡X¹qÁåîo6ZÊ h ®p¹OÓ /å-|`Ê 8†ZsŸãê½jyÍB3÷ Ѧ¼Ð/7›>–9Ⓡ3òKC £‹Ÿ ™Ç_ãÂB¥)Á¥Dšíæ"OäíG¶=áÅÂG‰)÷¨ûIŽƒïÀcH¬ãƒJ‰.1¥œ)•üÃ^‹—Žå°H¹6Ýä‚IìÛÁ%•,^‚E'ùZ–M\·9‘èºÎx²\÷¹h…÷E.©HìÆ}•5å¾Ë8v’û2£ñ=÷­8^~_çI†¤û¾ äD\(¨#n4$®4ô'î4þ$.t nÉñÏÉáZAÅq¯tvlU\,hùDܤ#H\-ˆrw ¢ÔÄåŠ 5â¶t+¯×+ºÃ÷+<Ú…ŠJ»AT¡]©dà°;Ò-ÝÛ%v  ÝªèÅG»&•‘Î#ñ^•´‹ÕÒ´›µ(“£]­hI»«ûáØåŠci·+*ôh×+ºÐîWoL^PÁqÉ¿’W4Tl‘wˆ]ô¼¤#bIÞ"mÿ¼¦£¥yO’±ySàWõx{¤Y x¬1Uz´óE^×FôˆºJ#Q?ô5z"]5W=jÑ ¿q"–Ç_`¼"¶‡ãO&Á;(ˆçtï3&‰¼…1ɈÃŒŽÄCpuÆÎÉâ‘XcõOlÜO´ƒ™ð‰wìxc’ð‘¸bºUrE òL²á@s®È†þ\±<\+šÝ&¹â3sÔÑÈ<±cò ÜQ ±\î¸Á±#”æŽm¨y䎦ÓÝŽo`ÞD„F!“ ØñD”y…úöA™žIÖI„b¡¿­"ÀJÄ«p3‰ˆ5ˆDÌŠÖ²DÔŠC‰¸Œ‘+j0‰ØÍ£ˆèçañ‰Á"Tt¥Å¨<ö ¥F6sU‹C„¤Eb.-VAlœ­ ¦”OÎÎ":Ö°˜ÂȪ³¨…MÎ`q%Oç™dIFÕdKPÀ¨—À“«`öy¤ƒƒ<È@ØÊÈEæ1ݤ™Ç  dc 0Á #9Ù. 4HŽŒµl< ÔTŠÂF¶R#ëc‰°6ëDJ—²±@%}‰'q‘I&´ƒ0&÷ºýïgRwCMˆš»Úe³›L’ˆ[dþ¨`·-²Á™„]²È$N³È$ü‹L"€k‘ÉÉ€rgå»ú×ÌfGÄ™ìZ)k‘É¢«Ö²Ùñ²Ã»KQ?¨)‘Køã“•ïjW™Í†´Èä¸ô9Ëf£Ç©e³3¬³Ù‘:f³Éƒ™œŒD&V¾ïue‘ÉTd6]š,›–}–ÍF‡ËfD>™œŒDfV¾™då»Ëf7Çw× çGž’dÙl,rF&zL32™Ð@‘É„Ss™Lˆ/02™Â•ž²ì¸e³q ‘e³x5³ÙèøaÙlúˈLFœVÇlvÄ)ÌfKW¯qPsoLçGìHl<¨¹[™–ƒš;2ëPÓN[c6[\W6;‚[6›ÍUO6{ÞIKy~ž¢¦¼£¬‰Ï QX‹* J{"ŵSºåå Œw~?¢ÄÃÆŒ"woó\ÔY£Ð‘}Ü¥N¦Ð(vb”QîL¯QðBwQr4,eMCb¯jQNÞË9&:S0xOñ‡…öÕ«FààôÀ`¬L³Ú }!«È¢åÀ&,'ؼå,ÐÃÄr8·Ñr°t–a¤Œ94#µÔ6ø·¥¶RÍLmOuËÙÝù–Óe±œ޾°œPÒ3µ].{瀺Cö•Km‡+µˆ-‡ôâ©Î²ðloKm£¿˜¥¶3ø:SÛ5SÛýò°Å²Œä,£™ÊÔvV„q©mï¯ìóa}ÎPÎ÷ÊÎrD€\j;xË_ ‹²Ô6#åLmÃr‘YSÚßÇÔ6 ˆÌD Òa.rÞó°¥épò̧£¹'SÛæ!+s’Twõ™€Ô>™Wç´œqºuˆ ©2;QšîïóKÈDÜö³‚F~¢äÛÃ.P®Wĉ€vE“JG$ã‘mrÉúzqEìHKöC¼abÄàŒ+Ò¦˜ é0®åœ=1dË,‹] \$Wd.„+‡©X›ÊCrEt rYì˜ÝŠ,è¸è²Ø7WÄ2®Èƒ¸#p¸‹e±ÑIβØPY;?d±3² ój;QeËb£û›e±ÑöÚ²ØlLÍ,6ž·Ëb+¢,¶rUrÅ€ÜÐÉbÏ ñp^!"T–ÅnÌj#‹]xÌbƒÛ›ò13wåc‚òÊGpãŠÈºWD(³LCÓ¢LQY¹<ËbwxìT>væf |lˆñRùXÁuòQ›ŒQùXÀuòQ# Gù¨1i*³©Ñ |L\‘:‘ÃqdÃáŠñV>îÔ¼ßï–g^Cw´Š¦}L>SÃqMû8Lë¨ÚÇÁ4´ìEÙÒ„>—lj62Qe[ì·H66- lmV:ÍÊæìU°½Ynz(›MEüÞ§~VòLázÜmŸ]$2 ª8™ÌiGZ ä´RHÀÉÌNªÀIiÖÛÁIg—Ó–Ïï+Nfgœ”¦bÙ)Äå÷£‹gŠà€“r†âŽâdŽTp+NæU œÌL 8)ãàbßYö‘SˆgœÌt€“rÀÛt8™Î}NÊXqTqRšªu‡“2F{ãänÒNʸºH¤Œ“ó©eœÚ'S‘ œtã“ûýΧÞã~pRÆéTœÜ¿ç"‘{ìr+g¬8¹?ï˜ãþþqpr_cž2î'e\]$2³ûpRŠ7¦SûÈx¯?àd6ÜQœÌGݳq2S6 œÌ¹ऌ}n,›ú=—ìpR4Õád’ãW|nn"fÃHä„]a$r¢0#‘'Ž39;csˆDÎsT´F"'b»‰œ&4F$r6¢"‘r@ë•æœZ"D"g#Ö"9Û­þÙ/ •òÜ_D"yb¸E"åJ½bzß‹÷©å…;1<;‘È9¨NG$Ò š‘ȉ(—E"'…JŒDš‚/Ôã—ëG*¤¿ö¥µÞ@½#è×…ÕAù8.½N†%psÒÀ´ùÛo‰ tL`îÌm•sŠInÝÄûúÚà“Ãâ¡ö({ä¬ãa÷Äs$±z¦#Rvïd'F2mÑIaNô˲Óƺí8á›ëº3¶…uß©âþ°ÔÜ7ƒì«-3ƒÚdÄü”³oeì+?Ð*ëd §=‘Ã%âM´-AcÛ°È£S“=ºéÒÔ¨ÆX=ÌþhtgA NôÔaÔ;;cvÒèǺ:•’  «›…9íÁÎð¤A”¯QYP);ƒœd«Oê8AÇú`e%[ÇTFé:¤‘¾ÞL.©´åÔF;t+Oýï«M–álÖjtjÊ*DéWœÌCÔlýö¿;Î %jö©W@ÔˆÛ5…wyÔìˆT5;ü)¢f§jv¬j¢¦Ì·«¶‘¿«jJÕ£Ó†Éõ§’q÷þw·ŠlEMmowPSžAv¨IâIÔìþ¸¢f‡†šþw‡\•þ7«2éwÇHÿ»ãÜ_úßë~‡CÍÜ#‹èÔÿn8i‡þwÃýÐÿnôoá7V»Àÿf?ýï ^Lÿ»"çKÿ{mEmøßµP ©þw…€—þ·(m\µM®ˆ·Ðÿ.8·–þwÁ9Èô¿K¿â”YÎ9pqÊÌ“Œèð*úߥ\ÚQ‰ÓkNþwAœ–þwA!ýoÑ–ºœv.à}ô¿×8;%P.PÂ5eÜjÊ8»œvf\¨)ãàü˜=öâ]y˜¢¦¼P¼³$/ šû=jÊM¯)Ï&»jÊ´tš2LroÔ”|ùM¦Ѝ)¡EMyöÉG+·,Ñ+rÍ7jf|EÔÌǰ5se‚¨¹Ûôû˜en”å5óªbf³í#íöP,/ ïï8_ò¶&¡^\º”ÓzM¹Îì%õÙN9ãñX$›ÂXoá¾ÔìYòB÷þwfêÒe´ vìt¦±¢Åx°`b§Û%%/d¿è¢¥Ù±,å;\ž{³gçgžFÃuqÌ)÷ÅçŸ1ö•½ûδ(Ø—ÕôÜ·ù,îk9<ÃÇÝ"òQÄ…85_EÜHñàJB)q'!]@\J(ž&n%°;âZjÄAŽ4®*ÄqÌ73â~ÄÕŒAÜóæŠ¹³ˆû\•dΈw×ECïüoÙñÑÕɆoÎÿÕüìJ!Û…Ý)þ<ìRañ7ìV…üŽv­‚}ÒîUÄíiEáéò{²Ïsvv•ÇâÒîVtò ]^ãæãæçuÓ®‹óÞR½;·ÐL·¯ ’WT(8É;*3îà%µxä-5£X¼¦&d˜Á{ÖßÕ?/ªÞfC'ò*¢y—c{^V×àm•ï¯Ëàä}%_ÅÜr8Èø“þ÷Õ*•Ÿ/roy‚ÁùßÛ{&Y‘Yá¯Ýº»£NÍ;îPâØŒLT7bÆZ»™dc&3Þò¥)ßãâžX3æ¨O´á b>ñ†3í¸"èäŠiT?bE5¨ü¹âZGû¬ÈÖ¯Œwæ¹C\Ñk¬™'¬ø¹wDàÜ1 àrG5ÖMcÇIõœk¯ +¦»ˆ™¬(QËõö¿eEFµ^íd7§)Gc’ÐÚ‘D3í2Þ‚(Õe¼7ÃñJf; EDiÇà39%°÷"jFï"îBDÕX‘s»ªeG$Ï$3˜,?£Êƒ!ƒFÐbdÜ/-Jf„‡ôÒ"e7Z,A|ç˸8y—Œ“g’‰uXÌtG´e<œÿ½Ç®|{/&™©Œz²N<0ûë…«„;³‡Q‡4™¹È8Æ×臈f}&G^€†'ºÉÉF¶@ƒ²•’ƒ(åDgT*[³-éDå3ßòx‘daË•ÊCPºÌ¯IúÖƒÅÑå …¹!aBâ˜;»½=ËûÖÊÔ µqÕtKeÏ‹nÈç¿wAäÕ!-êì9MùU{ᯘ¦¼±‰ÈéæìPœ¨ª·iì&ÁiTޱCZ¹uBƒºvHCeuB´Ø4åìfÁiì~Ð"ëêŸSS~ç¿·æÜñѨNÈ:¨A'Tá ™¦§•™¦¼ßÝ.¤ÐñÑ%©òÒЄ…:!ž¾fšrÈ…MSÞY«M9ô ¦)GüÅ:¤á¸Pê„2BOÔ ÉþòÝ..MùƒN(õ[Y¹xh¼4åä‘Ô”Ã72M9Nï2M9º‹˜¦§qQ'$º&—ÿÞ§³]šrÌ¿iʵušrŒMS]M÷Vn>hÊ}ÔRtMÁwH‹‰5ÞДóú¨)G”ÛtB§NhÜþ÷>Ô£¦(•Xx%+©*w§¬¬•uB¨_:šòLW™šrCìþÐ)mrΡ)‡†žšr¦¢¡)gÜšrÒhÊÙšr”æRS^‘U†¦¼]"½Ù¯ŒÂ‘˜SS®?t4åùRÆ»wâz¶Å)g¶BÏ+œ¦)¯}xèñRS>PCM9ªÈM!‰óvMAÉj*,óUã¸ÛŸ]íÒÀÿMSÛošr(¯LS>¯Èë>o×kÊû&Qaš/>¾«ƒ.…*Γ5M9B0¦)Gu™)`±JM!‹Dˆ)h‘\1M9ø³)pÙ^ ݬÏÃ)x½rMª»²‹¬‹åí^S^¡„r bUSaŒjS ·[¡Ìî+¦`fuÎÕyT@gµ¤¦Æ¹™NA=]Ÿ0i,Ñ}µ^@À4åȸviS=jhÊ'ØÔ”ß¶ø'Ûr>Ïpû4¬þpÇ”WDÿÓ”wh©)G'-Ó”\ÁÑ”wÏ%£|iÊQæ:£©€\UÊV=•qEhÒí‰Ñãeýa~xâU¬?ÄÑá®þÐÇlääÝ»›.c4äŠèb\1°J+%2¦)‡ÚÕêï˜Tä|ÛŽ‚÷cšrh)MSÎ~9¬?¤GÎúCp[ãŠìdFD@†ÝÝMSÞt¾LS^‘Ë¡¦¼@³CM9NØ6®˜Ð@’\ýr ç•áÞˆæ5ÿMSŽŽ'¦)G„À4åV¥ My†NM9ëù¨)¬ÒWÄósšrýûÑ”'ÏåÀ`§•ÜÌÌsÅ^ašòrÅœ·röîÄæúÿìå¯nº@8ÚáG3=™FFi˜ðÒ±NˆÒ²Æ@=JÏPf¥i… Î &?ÅÙ*&Oty!&O¤®“GþÄäyQZ7É[Qz7ذ ¥yV·Ò½Îï·il`Ëi—ˆq ©‚5Hãõ³Aùv¦Ÿ­C€»µ°“¡I€à̸F©9€ìE7²¨ ×>š¾ÑG…æ”Ît¥m- Š6ÙÖ¢ôK”%âêÌB´U ¢®µ®›odÂäEat&)ËLžCTưEgŠÒ(EkÒñÓ‹Ú$/½%´¸£(Ñù‡(ñz!âÑÜ”E(Šã*ÐN”\QD§HN¸N ·s”*Åx7H“â‚”öðÓK€”¸”QôF P€ü— €x%@¡]I¡Ù‹*V8%@l M P€£@ 8BΙ–"¯ìBÒ@qäœlF¬)’)_t3‘¦#@Nˆ- ­0 lñH€ßÁäLWÒ.ÏCRÚëgzêéq¦‡ÙV gz ­cÎô°Î\p¦E˜zÝŒNE6œéÑn²¼Ð|ŽT^¨Wöéõgz4¶×€3=šµûRgš ©Í™^œéa­ºàLŸ ƒ3=ú‚Ü-}‡ƒLy¡zÌ”úåL¶ñæ Åjtð‘»嗮ÕÀFmú³eéqaZA»ôjRqÜ\-œ Ü~­|”˜ Åïi^t %SMr 4x -ґǃj‰ùoðK^H>P¹_ðbòDí”o+™|J6‘Jprd¿”àähç;h N¶t7Jpx•àäÄ+JprºÅä2Aѧ¦S~è‡fižãOªËÙ <Þ½*ÅX·Ëퟅ·8gæÅ>V±C?>ü „Ǥé1ZmS(­®bî`µRx ›îA±+‹=Ê0(2ÀÃóö¿Ó鹇£§K*¦‡bÆrS—Ø®‹ëZdñÙ­ûÑ÷…°M×,Fƾñ °Ó拹#Z¦s_RTÅ}›pOÜ× M=¸ï¥£K\;®.±!þ—O|›NL.ãé'wU¸•Úå¦N)¤â^"N)Ó#næ@\q5ã(ânFt‡¸œË]:™qL%qÂ8â~†t•v!³4vCp/9»RØðv§ !6íRIWª{ã°·kÒ>×{ íåhKg"OíftØ”GÄÁÙ •Ö œÞ ÛAJyÑ.:Ã;c;i&BÙn탭5Û?³]5Û­vÖ^L¾‹£µ¸ ÊïÆ¯ûýÞÿîéJuù4(÷ÒêÝÀÜ{«E€Ì‹0ñKo—ïgƒr4c2ÿ»"±L19øêCƒò&éÅäe§.ÿ>”æ‡IBÜ`L2Ý©îñÐ>mmFpL¯Íظ[¾21נ܉6ós ïdÜ\[ ¹Þé™äàQ9稛éÚí'ìÄä2ãúw2ÉpÉ"eÅ5¿b3AlPކˆÆ$ÑÜZöw¬P¶ôG[kùφ‰çH€æwäÚAš©áŽ…Cb;å¶ã!†'"¶b”J[¥˜?®ˆ#å)žI²LϘd¼Ž•±—En&æ"’‘|û‹<è+¢JË#nnW«ÝÝ:Ûµ„Tñ7=¡ˆø™m€`2â;´9éõÑ¢d´›°#1ØÊ—i‚iÂb™X-±ø/¡ø1Ýçgîöƒ¾=ŠX '‹”qpbòÝÛûßbâÚÕ(µä¹$ÉR;8¹$2?³MâC1w <ôƒUZFPDNzsÇAJÇSXì˜UžÓbiwžäb݈xÖKcâž§ÁT^:˜d,,“ŒåN©§©p·•IžÎº`’ñA¹c\bòÆ.ûÚªÞÿÖÎÿf fÅ9·DÍŠ]CÔ,h†EÔ4P35ÙFÕÄäÅTÔ ùö¿C¼Š¢„ÅNç †]„˜¼ÕŽ˜¼:;ºC—@(ÝbòÚ/;-’3m‚BÉO¥¤ ±h먂" „5¥¤«ÏB8 Ð „Ê%BVÑBlCK$v&ÂA,&& ™@(¹ü÷–z1yÂópM'=jF6¤7É#[bPY™‡@Š %üBáŽZJTÖ „xÌ’I:òl”|â÷LŠ>P&ÍW1÷èø7åøuX7%·±}e¸…fF÷`¤;Fv®ÛÙèú`»u®¾?´«ïÖãMN·åøC÷€q 2ÈryÆvà©$zÆ69ÎØ¾;œ†hzÆöÝMfÜÍfFºè‹À‡Sކ©t³§ vù¨D"á42®/ d°ý¡"ŒtsŽôDžø4q>!àk¢•=ÐÇuÛñÚ¬ôáñÚ ~<¬|[Ô‡®"{¯îäÀ9ÜÑDýX};âÔ:ëAŽÓ¬9À“Æ#2ÅD½xxèA~Ÿ9´+{¼ñ’£æœK°O¯ÎøQoNã˜ÐÙÅzÓ8²y|8^»0®Æ9«#šTVM—Ä>•ZÔ‹7V`C= cdêbT8õq¸ÔÉ85ËÔËc:usòzqõîÕÑÞ¥äù vî4RlV©±š©³ÑÁÍÔÛèõk./:4[J=ñ½ý>ôIì¹{n;:ˆŠ «-Äy'V[H¹#¯x>œ¤M'™wÜÔüºÚÂá*²…î¡Cf”é’S[¨IjÒAœWëj UnÈ'ÚÙetNœÑAè٭ ^a™­ÿöt°Ô«G€¬¸ë$më’ÏÍÞA¬€`…'kƒ"Œæ*0ºKbŸ“±¹#'év,œz«i"°f®‚¤úÚÂÄsþˆ(¨¶ •vÉ!7¢¸Þ>ûðé-bEâî"¢âÝNmx…|¥c¬ Íè`¸NùbÃ8@9ûµèÙf`B\ #1ËU|4Ñ?•¥I ŸEáh0iàÝR—I?6¨ºiö&Ùj¡ñ¦É8‘M(hns)°ÆÝh¡Zë£uÔ:°~7òL᲎¬ßÅ×£ßj¹1˜GÚ°¢BžR|Ö…2îm¾M }ÎaL“@ª@ÜØº«ÛÓnãÁzæh·ñ`gvi·ñx×[K½‰O­LÔ/¼uAŲl¢ÿWðp‡þ÷Í¿üëKxù÷7ñåoâ> ø«7MJ"ÂBJÙU:@†—šö±RÿóÍËÛ7ÿðòßö¿Ï¾V?|ÈýôÛüò³—ßœŠó¯8ä?ýÙZÎ/_ÿöEèü£ãÙX7üõ»—ÿ·éo^¾þÝ›/¾Þ¿óQÏzò»~¼|òÇKݨ£oü8ï–3ª7úùÛ'7úþÔ™Ú—ßéÛAºÍÞqº1–‡wd­€µwdVÄÚ;ŠÞlï(<Ìù~Hþž[`í•lÈwÇ´*÷}»°{7¾áß9´¿Ï¶QŒçÐþÅ Hû¼ÁÆöŽ¿Äú+YEtÚ àãWÏUÃæg?aá „î¸?û «6ns݇ß[³ÿ÷Ýš~y‡–qÄ-‚•þýÓ«~þÙºkšÎgÿëS>«»Ç>ûÏ>;îîáÐóKã–·È'ãóüügûÖ žŸýÙßÿò«ÿøÔp>þòø˜¾×£q¿ð÷ÃUû '­,ŸûüÙ¥~×§wëYùô¯þä§÷Äþd¸Ï&= ¢ñ³éCë€ôx×Jàý¿r×sn­¼´8Z¼½uï“–Yúí÷œÉüÁí%dY“š7Õûùö×ïþøûoþí¿~÷ÍëðqwòƒÇþáóЃíÚbTyýÞRûß5ŸÝWÕæbîKÛÿ.$Wõá/üí³«~üšï¶ëGv©}MûH¹wŽÜ:m¼ð{Ç/~œù”–Ù=~â|>+íçóù>Ïg§Sä|†-ró©/ü̧†ÿ>m>Ÿ8ûá/|:ŸÏÎ"û¸ù,zÀ™O¼ðW0Ÿ-h¹Ì§Ìç³Ã†>ü…OçóY§ùœÏ¶ón>õ…¿‚ù,; ñ½æójýá/üÐ|^?r>ë.»wó©/üÌgªª$ÿ>ëÓ7ûð~p}ú>9Ÿy« Ý|ê ó†–¿}Ê|>«ÿð>ÏgÅ@9ŸqŸ+äæS_øñçSÀáSíÑ3}ÿ‡¿ð¹}"îú¸ùÌsŒqæ/üÌgÏZ[òñóù\¯ñá/|2ŸÏãü9Ÿ#íƒQÎ|ê ~>ÿŒ±…ÒÖ7W=E‰ŸÿÓ¯¾øüÏâ~ø'ËÜõò“÷ó¿ýÙñ‹¢ÔÞÏ¿ùã—ïy€‰Ÿl•®î~ñö™Ö²Å:­_üò‡øÅ¼ p÷´¾ýê«âãNYÈ/þ²¶â9fmÈ/~ùUL£âGûn:¥ëõoý]‹þïÍÿO¬·Ô endstream endobj 236 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 201 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_dens.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 237 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 238 0 R>> /ExtGState << /GS1 239 0 R /GS257 240 0 R /GS258 241 0 R >>/ColorSpace << /sRGB 242 0 R >>>> /Length 11957 /Filter /FlateDecode >> stream xœíMÏ-Yq¥çï¯8Cø%÷wæ´„äVÛ·¤`6¸ð­¢M!Yýï;V¬™‘ÅÅTaºe¤ðëžsrçǎر㉻¼~ú*¯ß¼þýíþ²ÿ{mïÛÆ?½ÕôŸß}ñú_¯¯ß~ôÍ?þä³×/¾y+öÛ+ÿýæññ?|âã?þø×õú·Ÿýüµ½~ùV^?µÿýæ­xsÿöÇ›~{}vž`ïÇþjåý(¯¶ÙÚ«­ù~ô?8Åíý¨õ•ÿâÿ³ß¿½~õ§.a{íº„í[—ÀƒïÇ{¯¯¯ÞZÛß·"ùñíƒ>.k{/ëú\úúB8Ýë ÒךþLGÆúzoU—÷•Tßö÷}øÇ¥îïužŸK¦/Ôíx¯åü‚dþÂag;®/Pæ&n™'Ü÷­_çK™îH=Þבîuº#vƒÇHw„:}á(ïmK_ N·lÙ£NGÆö…Æâ‚¨òõÌý}µë–Qæ;b—3÷ëŽP¦/´¶½Ïë¡H¦/üè'êX¯_ã6#kÚßÕ–÷Y;â*¯Ùß·Ý~o½¡v(ä¦ÖþšÏÑTÁ7µ/ª}¾æ|ï;T}oÇk®÷²Q Ê.ÆT{ïëe—Öü›·h0W£C-ÿÝÀYX—å7.eù375ßË„ZRóxÙ}fëë½¶×jïµRÙwLþÍku‹Ý—þZã}¨-™…¶Je–°ìÐæöÞÔqPÙ—îê,°Ôegí߬8ÃÝnü šÛk·oøï޶Wö(Söôö†k6Õq¾{×gv†ãµýÎîùñÚí*'ÕÞ^è=®ì|çk·s9¨Žíe–â½Þîyï/ë µQY÷<*þÍÔŽ«>üLè£G‡wreí“¿ƒÓh¯c½IegqìhÇ”ֶۜ±Sàt“…gjO¤šÍmÍän&·Ù5úoÛ{&Íj¥]BÙ}˜=#ûoÙ¢!;µù*fÝåÀ1JñŽnrâ‚K±¾Õ(­“—â¿1iÑÚ-Ö;J{6¥˜uzCû{±vË¡ë3£³vkaçµÇjWVª=ÇF¹[»µ£û}|³ÇܬÝ:xMš5”ºpD“å½ÃÅììÏ&íB‹Ùdñ/{w-M÷ÊúNi çêÒN§4õëv:fQÚé”¶ðìM¸õÒvvk“fÄ¥o°“ö­Ý^`”.ÍŒK¯:gwÜ¥7>z“fÈ¥äŽû]ºu²Ei¦\ÌÙ{ŸÅxcíö‡B·C»r©&í[ÅÜÆŽ“´nh§Sà)J³çç€ëµniw´˜wØwJ³èbaÇY7µ®X̸™4›.0{ÿ´¿7k×,ÝŸ¯ÉíîøW“f]ÌžK¥<ªKïWÖÉ»µ;7>“fÙÅLÚ»:½µkVÌßîèÈ»¤w1;vÿq°îb¦ëOÿpç é—ï6b ›õŽ&m&^Ìbýë0šz¸Ö÷ ®½˜ÕŽêºâ`PÐ÷+®Úשּׁ£ù}ŸZ!@¥î8ôÁߘ|¡ÉR›Ñ3R·Î²M˜}=¤í3Dï 0T˜> sHÃö×à#ƒåÂøÍWhX?¬çs¸ù›½Í! û7 ó'á¦ní›M¹õ@Øyï‚íØyÄRJu°wözèaí›1ðú‹[V±îïO n~”ß÷çV¬Oo¡á¬w~ß¾býVßî ¬/º/°Þ7i8ëQ>¶•²Ü KmÒpð¤<ÞŽî[­[tï€C¨Ö ô¹;¨ŠÇìǯ\BÅc,Ò³›žê/ð`Ëô®öM›W@˜Åþg.ÍÜBµÛ¸Ué…ø§ÆñC-r ÐÖ1«]¶ûø@³‘j—¹†´ù†j—ÁþaNÑ.¤Úiw¶7=\ªñFMçcã‡ù èzéüm@)ÍuŸÒsQûý°¦²}öÓ«gÝqcÒ÷;NĵŸ¯ IMíWéíï~þ6Fu]ÿ.}L×ßwæ²QkCûCýÇôØ]ÓŸØ0V𼦞'‚m´¿8b\+h‡Q/´„.ðÕn#ÏÚÇmóóElíÛmÚ»´9òŠÛà÷²µo—IgÚüEíKþÈÆFø œ¦_/Âe»_£p¶ a?cGÈlí3ª¦†¿@´L½Ü_Œ?8[û6Òþ‡_hµñLíï8±:§Æ„ÏÖþ<äÏMÃ_Øxâñ;†Xø ê&m®¿¨‹û óï›_?ikÿôçÓÃæjþºðóæþâØä¦wŒz„œ£Uó¿«HÃ_‡ú?‚j›lma¦Í´-ž7kLÜù' ̘ÆxhsÃ\lêz^ÛÔ«nºß60›!4¸Q¿Ÿ±7Óà µù LÑh¯60›¿hÍ£bê‰ ·‚ Ôæ/Z;˜Æ\Ð̈÷ Á¶µoݾióÍúïò†nפÍšõúKÈíDÛˆø»µ?‘‘p=à/šÝfÞÏÅÙîôaÚžvÆ#6ÐÛ‰µUâø þ¢Y³¼¿xðȈø0Jmþ¢Ù×v¶ £4DÜEÚüEÛ‹ìß{pÍeÁ·µ¿G¼e_´ÙöÉy ´¸Yÿé~[ûÒŽÐæXbZo¸µlvw¬Ðû6ÑŽÂù" ¸ g‘¶ŽÍûµ{ çŸ/iLöM«½åùÓÿ‰³}Ú£hë~~¼¿»ßhhöœxñë¡¿7}ðúé_Èàú#þD<Þü~m‡´ù‹¶WùoDäÖ>f²‡´ù‹†Y¯ßo>»g´èŸïmu]¿Bæ/ýàý1äÇ<ä_—£¿„?3m®ÁLÙþ„¿htÔæ/ÚgTGz>³-æïذÍÜ2íà ß.ö±‡FªÄìgàx¼ ìe£‚6ûóøXínŸu—†¿@üP]W÷uÒŸAÃ_ÔÊø›û‹=¾ßÜ_Ä$µZ|añX®‡û‹mñþAú«ÎϧÇv#4â‹cÐ>ªýÐT£¿A#¾Øû#CÄ»ÆwhÄ‘Ç@ Øè¯Oø"æ HŒ!¾˜ëÒÆ‹ºx|1ŽK{Æq0^D 98^y<@s›>¾yüø¢kFXŸs|=†´Ç“Ïi-ŒÇviÄÿ¹¿C Šø¢vÆÇЈ/òü|2>viÄð÷~ÿŸ7ÆÏ‡ô±<þæóC|Žx¼2žÁ19d/Иò·|Kõù„Û'´ÏGvÚCµŽãó‘Áøz5Îø¹ŸÜ&ûâóÍç_Þÿq¡˜¬Jÿ ½ïœ/òü†'X8ìQc>bö¦ã{ºøô‰ lXSzhÆîÏ£ú@Ž0ˆ÷Ï´ù „U…ßwÃõ0n—ö,Eåø‰Ài <ß)mþÂsÞ>âóæ‘™ ‘D^rrÜñ€´"éà ¤ÀÞâPÞmРvæ&•M©Ì-… æ""‹ê¡ì@•¡{~™=Ê†Š¨„_>ÐÄ ï‹h|CÊ×?¸…9‡U.i7umú2BqÏ2{$æ.§#MG0/Ÿ…Ž'éYJ“´„Ö${ûòt¬ÉŸz–rDF\]^§Û6c4cgߣ´›6¦®w÷$åˆÞŽäÛ„¤íïË[¯ÞCÚÐ5"àØ=Ai’ã×î™Ý¡éâ 3vÈ.iÿg(ØÃ,Ï®t(Û]ám&$o;Bé ²ðÈž™¤%RZ?"pìä‡Òï H>²Ý³’˜wI»–¡9x5—hÆ>ªzÎîIâ!b‚©¦û¨:Ôáž~„ë£wÅ,ßOãðtäˆÑúðlä(ò‡g¹F‘áÃLHŸªÔÃS‘C¬ ÒŒ«ßÃ3šH«o’f#ŒýðùØØ¢! Ʀ ápºb’cžIìÆíz ¾”Ò±è&iÆÞµÍó&ÝB!í¦Eî¿Yt\œÆú`iÆÞ•Û ·{HN ªH!®=÷~0Q ¹{»¿õ¼c?ØÍ o×ïd³p¬{»>)Ål~óv[‘Þnå—ÝdúA‡ 9½ÝÊsöÈ¥´Èåí^àëërnËÛõ` ÏJôƒ±äîí?rqÓE$ o×»w+>ƒôËG\¼ÝäðvÝØ1}ØH½wÉY’ŽÌv$Èy$éSã,—·»ñ<‘šåÞ“ôìb–Ûåõ0ö,ã’Õ3‹—ôŒO–sK²"í‘å\I6/Hr¥v«§?!ûýËý~¨~o¨ßO£ßO²ß/¡ß/°ß/¿ßoN¿ßº~¿±ý~Ûûý¡ôû#ë÷Úï;dÉíž]%ä–nÎÕÍBn¹Ý袒ÑOÙr»ÑùOÙR»§áœ²¦vO£;eIíž{Ê-µ{û)·tsNG!nä”=·.è”-·îë”5·®ï”%·nó”åj÷r¹§ÜZ’î®/éÎ<Ë^“ô ËÖ“ôA$ËšÛõ(Ë’ÛõÁ+Ë’Ûõ/Ë-·ëƒæ%}HͲ§v9gÙR»ʳLÆ®0 Ëdì !²,¹Ý‘]ÁÉ%{6v6YöÜnÍÆ®é’%»Â­KnÙØª’\–ÉØf¹¥v@f™Œ]Áç%=4Ͳåv{6v½—lÙØ0_²fcW°}É’]ú%·lì òOÉ)À%÷lìš>\Ò'Y&c×Ä$ËdìšÔdYr»=»¦K—l7cçTë’õf윦e™S¼,³±sz˜e6vN-³ÌÆÎii–ÙØ9­È2;§Ã—ì7cçTú’Þg™“ô,³±s‚Ÿe6v†ÊYfcïÇÍØñR»LJ\rÝŒ KΛ±3rIO•d™i–,³±3E“e6v¦w²ÌÆÎÔP–ÙØ™V:%“NYfcgÊ*ËlìLxe™é²,³±3Ù–e6v¦ê²ÌÆÎDß%ëÍØ™&¼d¹;“Œ—ÜnÆÎå)™ÁÌ2;óŸYfcgö4Ëlì̽^rÜŒ™ÛKö›±3ï{Év3vf/YoÆÎœó%=%e6v&´³ÌÆÎtø%÷›±3™~Éu3v¦â/9oÆÎDþ%ÇÍØ‰.ÙoÆNˆpIg Yfc'¡¸d¹;ùÆ%·›±“Žœ’ð$ËlìD/Yfc'¸É2;±O–ÙØ ²ÌÆNätÉv3v«KÖ›±w]²ÜŒ°ì’ÛÍØ‰ÚBŠÄe™Œ]/Ëd좀—œÙØÅ/9²±‹@^²gc¿¼dËÆ.úyÉš]ìô’%»Èë%·lìâ¶YöÔ.©o–ÉØÅŒ³¬©]ç,KnwdcξdÏÆ.~É–](=ËžÛ-ÙØÅé/¹ecå?%éd–5µË‚,“±«!Ëdì*_¸äÈÆ®â‡Kölì*¸dËÆ®Â‹KÖlì*Û¸dÉÆ®¢KnÙØU2rJV”d™Œ]õ(—\ÙØUÍrÉ™]µ0—ÙØUIsÉž]u8—l7cgÏ%ëÍØ ÿ/YnÆNÞ‘e6vÖe™ÕKYfcgíS–%µËÊ©,³±³î*Ë-·ÛoÆÎ¢®,³±³$,Ëlì,(Ë2;ËÑ²ÌÆÞ›±wÏ=^r¿;+å.¹nÆÎ:»,³±³J/Ëlì¬ñË2;+³ÌÆÞo :•^²ÜŒÅ‹—¼%èTú˜e6vNf™e—Yfco·j:/9nÆÎŠÐKÞtª'½d»;«Q³ÌÆÎZÖ,³±³6Ëlì,Í2{½%èT¤{Éu3v–ø^ò– Sð%ÇÍØY^œe6v'g™¥ÍYfcgat–ÙØë-A§ªëS²(;Ëlìå– SÅw–ÙØY/že6vV›g™µêYfcg¥{–ÙØË-A§2úK–›±³?Ëlì,áÏ2;d™Ë²ÌÆÎÅYfcçÒ…,³±o·ÖEd™«*²ÌÆÎ5Yfc犎,“±s9HRÉÔ¹$©dè\‚rª™Íü¸eæŽ[bŽË^NÕ³‰·¬WÓ$•ì›ëp’JÖÍùYŸü¬O~Ö'?듟õÉÏúäg}ò³>ùYŸ,ý¬O~Ö'?듟õÉÏúäÏúäg}ò³>ùYŸü¬O~Ö'?듟õÉÏúäg}ò³>ùYŸü¬O~Ö'ÿ7]Ÿ|;÷nO3¾ñBž¥¦·sŸýAª~c|±H¿‡˜¡è·Àžè÷ƸOô»°3‹~W:EÑo!0ÑïÆ!€yºÈ¶ÑÉNÅö¤ß6DúÐIú='½2é÷TÔÊñ¡Žx·=Ò)ÓýVþLô[”è·æR¢ßídá ßòÆ¢ßCÊM®¼g“~Ÿ Ý¿”'ý^ÛýÞ87ý°ýÝýn"ã¤ßš~Ûh±_ô{W~’ôAîE¿wùÑoeþE¿ƒa“~WÎrD¿{®Æ?¯€ßH[¸ò¨òí"ú>” ò½‰1‹|+“ä»Ò…‹|›ô¡Rä{Ó@*ò½‰"Š|¢û‘I¾·9‘ïíàÐä[DPä»hˆ|›¿iWe¨˜§«D¾áQ®š,0/gD¾‹‚‘oΘOò]·\vw‘ïZé,E¾k£+ù€¿jÏÀšHÍI¾«r"ßUSz‘ïgEò]5£ùÆüÑEò Ô_'ùn…c…Èw«¹ÒãS‘ïÖèD¾[ç°#òmÒo»ÈwŒ^E¾ÛdAä»-Â"ßm‰¸“|c*Y_'ùnrR"ß6qôXOä;\"ß&yÎ$ß½p– òÝ«Ú%ùŽÉºÈw×TFä» U‰|÷$™ä»e6E¾A6‚tƒ|w¡A¾m>H’!òmz ù¶ b#™&ùŽ,Èw²'ò=‚ì‰|"!ò=‚DŠ|UHù]!È·ùë$ä{ô ë$ß#ÈÈ7bnj’ï™O‘oL+üø"ß1S ò="s*ò=· Ñ$ßæ‰g—F¦ À$H7¼€y\Þ/‘ï©þä£Ë”†#˜²¢ ßð®C®“0j’ï)C ò=O’Oò½"“-òmþ²'ò]NRDò}U|{åA"ßžéÚ¤‘iZE¾¡Ð‹•Ì\“|#s¶BÃ/,eöD¾x~$ßüüI¾ j"ß…$ÚÉ·’j'ßÐÌÜ“|#³'rîä@`&ò  ö=øä þ¤>NhHÃI`~BíC¼W. i¸ LIüzI¾‘À'©'ùö>I³¤È\’ì“|C³?|#AÏþHò=¯‡ä™P’’o$àù|E¾·M÷Oä{Û˜‰ ò½=?‘ïÈ”ùÞšüÈ·™=IšÈ÷6d¯"ßL <É÷6E:E¾·$œä€"Ìôv‰&ù.›ÈŠÈ7àAºA¾K½H82Óå[ä»ô Ñ$ßeˆœˆ|—¨tù.A¢E¾‹2ÁA¾‹&PA¾ë&2#ò]£?ˆ|WÅ¡A¾k—}‰|×8‘ïªBïºDVD¾ëI¦I¾›vú òÝN²Lò}Vˆ|Ÿ¤^ä»iùnǃ|7̓|÷"²%òm…×+òm·™ýQäÛn[ ò|$I8Éw?Ô¿E¾G™ù¶ÓdåÈ÷/D¾‡‚² ß‘6 ò=‹Æ‘ïÙT $ò=• ò=Wg’啕wï¥ÜaïÕe_$ßH*µÐ¨”18HÖ|{òçÞ‡“"’F’odeH^I¾‘ia ùFö„ýä)Ò¥Q)stõW’o'õUÚIVTêˆ|o'I&ùÞDî‚|o#È8É÷¶ëzE¾1'?¤A¾‹ÒnA¾çí“|Ÿ©sÜnþco'ÿlß‘È¿Èøb¥Ì= ùn]Õî"ßÍÆ ’;’oØ×žÈw³0…9s’oØ+¯ä»ÅDRäö_Bg!ò ÿB^AòÌI!É7RŠ„$ßîߺ4üÅV‚¤“|+È4É÷¡Ê£ ß»òA¾÷í‘|›ñþäYŸä{©ò6È÷T¥~o K$Á>±£bFžä»žé|’oŒ§$#$ß`‡ú¾“oŒß„$ßïy>$ß¼ƒ|8¯D¾ñ¦ÄI¾ÏøGä·áÔˆ/JïOVâîªL ùF7%‹#ùv³àïI¾ 5"ßG ‘ïc‹ë'ùާȹÈ÷®ø;È÷¾ÉÞD¾£Ò&È÷j"´"ßK•ÊA¾çIÎI¾1ßãïI¾g¹“ïz‰|U ù6ÏJ ‘ïóù‰|wUùî]þ@ä»+Yä»ôçA¾í0"ç$ß8­"ùÆG¢`Gß>Íñó%ûÆ´‰•„ߘ†m‰~cšGbBü]Ø-?ÿÆ4T¨ÙS“˜Æô€û4¹K¯é‰2>2pLÓß=E‰i?íÜÓ ›ôAòÏJrðB7ú1@8Ò$¼?$áG˜“îGð=R”cp° ?¢o %Ȱ÷Ùc»‘ð=Iø÷‘ü®‚X‘p þÆ­{ï*· ßµºC$…ü²“ð¥Zp‘ðµŸ÷™ÄZâ¨$á+nIøzú$áÌŠ„¯&ÌHøEg"áK5v"áK%èA£¢ˆ$|ª€W$™bþÖIø\*! Ÿšƒ‰„#R&¾ö¹ÓÔZ2‘ðœ$|F% IøìAà½ßMÕщ„Ïgå$cg“zhÁºÝ†§fR"áSkŠD±|… x~˜ÆÍ LÕÿ‹„ϸ“$á³jL# Ç]%í–Îxú$á3J»HÂgT¢‘„„4óŸÊ‰„Ϭۻ¤_IøÔ’6‘ð5s$á³÷¬eT°Š„Ïà¨$áSõœ"áHªùY‘„GL*Išís“ôP$ás»ÐwórŒ–HøÜn$|*ZeG"á‡:’Hø§A5"áGÐ{’p1• áQp!¾+ê ßåÔEÂ5 .ø$\µÁAÂwÝX‘ðˆ¯D—:°H¸²AÂ#8 _êH"áaG"áª>È“„OÔˆ„O]¯Høà¬+HøPù•HøP'  iD H‡J¢DÂáñ¶×I‡f'"áCˆJ$|t¬H8Ðßz$|h¦ +‘pH~Ùó£_`üèI: ‡$ëv~Ùs¾7owÖ×IÂ!Ù®' q ûë$á£ù÷þ•"ác v+š«ˆ„ÁÔœH8nûñ:IøÐDA$<òè"áCiG‘ð˜eŠ„£3¬×IÂÇäˆ#)x‘ð¡Ò3‘ð¡„±HøX7>– HÂQŒÃßz¶q(Y+ŽÎÏC9 B"áC™E‘ð±8Š„‡Y‰„]|ž$|hÖ/>T^)*ŽÌÕeìYƲðçMÝÏ›º“|ÞÔý¼©;ÉçMÝ—|ÞÔý¼©û”Ï›ºŸ7uŸòyS÷ó¦î$³±?oê~ÞÔ}ÉçMÝÏ›ºOù¼©ûySw’Ï›º³|ÞÔ}ÉçMÝÏ›ºOù¼©ûySw’Ï›ºŸ7u?oêvõ¼©ûRÏ›ºCýÕ¿©ûÛk•¯7u?k•ŸµÊÏZåg­ò³VùY«ü¬U>§ƒÏZåg­ò³VYúY«ü¬U~Ö*?k•ŸµÊŸµÊÏZåg­ò³VùY«ü¬U~Ö*K?k•ŸµÊÏZåg­ò³VùY«ü¬U~Ö*ÿ÷Z«|kw·G†«±õõÖnß áK»V’„¯Î{G¾dG$áK$‡$|iO’pødgØžÝZÁÓ=$c¬¯ á±KIø®m:H‘Âðö<Ý5Ó! ßÅ5HÂ÷`æ„ÂaŠ}c‹Q5’ð]C;ór±û3©Ë.L~lÚ'ÚÉ)òêN­„Ê*‘„ÊQ‘„²>’psWž$ ‡·rNíÁ桪HÂmŽA~èýøSaæÆJx潇,Òû4a8bÌ]òà.Ò~‹‰Ã”ù‘‡ƒ‹¹ñˆ#~õù‰8¨W¹Êp =zÝ«5‹Ý«ÅV´{uÑäÚ½ûs9Û&/qââ1//ÚÌ2v¯î´‡Ø½º³ ÅîÕCûbk÷ê)¶}î^Í/k÷jmc\\†\\ñwpqíp\ü`l»WkOíØ½Z»ÈÄîÕŠuÄÅ«uÁÅÅí‚‹k³ÉàâÊ2]\ܣƋ‹»÷.Þy'ƒ‹s»jç⃡OpñÉx%¸ø¼sq ØââU… ââU¹Vqñª Y\¼œ ‰‹›t3¯šG×f½ÁÅE‚‹ ª/úT\\E"ÁÅuë‚‹7†MÁÅÅ7ÄÅA©üPäâ6éu¯%.Þ´³¸xÓ¸".Þ„ªÅÅOÅÅÅ1]eûäâ]y«àâ6=e\\¼+þ<¹øç/.®]VN..Ï~rqíövrñàªÁÅãz‚‹+Ï\<‚¸àâcÆnÒäâ#®G\<6 .>vq5qñ‹Ã“‹¨+.¾‰;/q¾ââçîÖââ5v¿&ŸÁUÄÅc2\œ#ÂÇ“‹ÏÇ#Ÿ±Û®¸ø”YÇÀ@M.>c÷JqñyîîL.»Ÿ 1‚‹ÏàDââœd~<¹ø<âxäâ¨àçäâ1ß.¾¶àèäâKûì_Á¡ÄÅ11 gI#uÖˆ‹}<¹¸iíþL.¾”— .¾T\|E?ws_Á‘ÄÅW N.yõàâ+ž·¸ø {_±û*¹84í›\Üó~»ôbÏ‹\úN±zpnïØÐÜ ™\šý—\¼œÜ€\Üq9ôÆÝî‡Î—\ÜñØ”öÝîµû¡¸¸×eÒ“uä®äâÐìäâÀe5qqhÖi‹—»é’‹_uäâ%j ÅÅKD•ââ^×ÁÏw»/±»µsqß rIûn÷±{;¹8ò´:þÁÝ%c7prq¯óÒ¾»äPݹ¸×ylÒðû nì\Üw«Ü¥±»ä~ríÆÝîc7{rqÇWü½Ï¯ºNP‘‡žÁÉá/Žàfœ:yG—ö¼õ·#N"#>bÿǰU¥ÁÅ7ÉÁÅ·&Î'.¾iJ\|‹:0qñ-ê¾ÄÅm˜ ÿߢ®H\<ꃋ—ØW\¼´àääâ%8™¸x ÿ(.^VìnM.^¢®L\¼Fÿ77Êþ%.^ãzÅÅÁ!ع8ÝÞÇ“‹Wq”àâUéØàâM[.o%8y‰ÝîittHçózÉÅëÉÉÅ‘ŽŸ‰‹#½^†4êhzpXrq¤ËéŸÉÅ}÷X¶ï\énq|çâH_Ó¿‘‹#}=ƒƒc7Zì”6¥QG»½‰‹#±Lû#÷Ü1Ûs.Ž|°êœ‹#ÇKÿB.Ž¬î‘¸8·+qqOÆNé»­k7hçâH𲓋#/Jû#G®“ÏŸ\ùKí~í\ÜS”<ž]¯«NεoÁÙ‹#=¨óq.Ž  ¸¼;Bdõ´û¶sqdêX—B.Žt›8»sq¤Ð´;·sq¤ÅZââ•øøcpqÏf‘s“‹ošÏGåqæâà»4¸8f~äÊäâ[ì/.ŽéO.^Z|N.^Æ}÷ê²T÷#.^´[npñZb·mrñ㥸xÕî¾ÁÅëŒÝ¶ÉÅkø3qñzÄnÞäâ-rÍââ­ ÄîÕ]›÷ÅîÕ±û°¸x›±›4¹x[Ú7P\¼íÁ¥ÉÅÛß'G.¹6¹x— .Þµzpñ®º„àâ½Þv¯†fV^\¼7%Hƒ‹7q¨àâÁR‚‹Ÿß'ïõÎÅ{ÝŸÉÅÛ‚“ƒ‹÷Ø"W\¼oÁ±ÉÅ{pNqñðGÁÅ›jöƒ‹7ù—àâm—&o²Gqñ³@qq<_}î\¼UÅóââèú¾ƒ0ß}|J£Žuqü¾sqÏËiÔÑ ÇÇÏ} Dfÿ!G?w³FM99¶sq¤H{hÔÑl+vƒv.ûÓnÔÎÅ‘3f]¸8ºqhø‹CYŽàâGÔ]ˆ‹DÄÅw¥#ƒ‹#žáù’‹#>¢&_{ptrñ¥¼–¸8üe º»yÄîÛÎÅ¿´›·zÑÉÅéÒ^w[§’‹cüàù‹ˆ²Ž\¸•<„\ã±¹8Æ?>rqŒ—d äâ^—ÈÏ=§í§œñEUžX\·<‘\™uäâ5ü›¸x”•¸8ÌBuÎÅa†|äânæMú`|%ŽìÜÏW\ü#.Žøœ›\ÜÜ8ëÄÅ÷Ø]\|_º_ââ{Ø—¸øû)‹‹¯¸ÿââkɈ‹¯Üž\|Õ8_rñþ@\|®àöLZΨÃ!?ëÚÆË IÆvÒ>‰ÆÆnÊ1]èp¼0Oý1è¸ï¾N˜Ìäeߦ;÷i1¶cWLCØHÈK×Ò!rL“´Yµ3òÂÇú1 9¦mìÿ¤ä˜rwubrL+ã…uôÿå>­åù1Yc—f¢rL³…û•Ÿ‹gË1­ïÇ=—ûí—ŸëvÄ˽nb—öe>±;Q2Ò"ÂÏŽÌ‘faÿ 3÷t/?gJ³Äù“šŸ©dasO3 iäc¶!„IpŽ´–>wrŽ´14ѹ¯³Jìüˆ26²óc³óÇ|,Ý\²ócÄÞÒžÙD k—´gvDÙùQä8ÉΨ?";ßc‡o²ó]ëâÄÎatEÒÎkÚ;QìÜS‘uOðîU”šì|?A»g6÷-¤Ûu¬z;_±Ã7ÙùÒ\HN~ÅPBv¾„âÄÎcA†ØùŠz#²s¤1(㪫$–!FñÙùŠ]ØÉÎW”ò‰GeÙù£À‰ì|FI Ùy,ä;Ÿá¥ÉÎg\>Ùù¬*…!;Ÿ1ÏXÚ3˜³\°¼°F!±óyî¦Ww³Và|±7oìóžïç=ß—|Þóý¼çû”Ï{¾Ÿ÷|ŸòyÏ÷óžï$Ÿ÷|gù¼çû”Ï{¾Ÿ÷|_òyÏ÷óžï$Ÿ÷|gù¼çû’Ï{¾Ÿ÷|ŸòyÏ÷óžï$Ÿ÷|_òyÏ÷óžïS>ïù¦zÞóêyÏw¨ç=ß—zÞóê¯þ=ßß^Ý|½çûYÝü¬n>]ȳºùYÝüzV7?«›ŸÕÍÏêæguó™üyV7?«›ŸÕÍÒÏêæguó³ºùYÝü¬n>K7žÕÍÏêæguóë¬Ô{V7?«›ŸÕÍÒÏêæguó³ºùYÝü¬n~V7?«›ÿV7xû‡×¿ÿ—þ÷Ùç|¹øüþ£oþñ'Ÿ½~oø•ÿâ-ã?ú;à^Ÿÿêå©¢íüãÒnJ Ür?ÿêõû䇯Ïóö·Ÿ{ú§žqŸúmù~¿Åì±E»õ{þÖæí¶ï÷[l¢ež„¿íñÛ|£²·öÇÞнp ë/J|¯®ÿxûÙÏ_Ûë—oÛë§oåõ›·âíýý[KK&¿zk·*õúÔÂq~,y}îû]ŽósÉôùá#áùù¡íûâsß_ìú½ä÷í‚‘Ûñ©"Ì|¿’jŠÛ>xf™+},y}^iiñ¹äõ96úÃLJŸK^ŸÿÅ-gÜÄ{ÒwîƒÓGªë—ß¹çcö‚ÙîùËþ]‰„òˆç/ç§zý÷ñ4Ûµ>×~ç)”r?jÌšl÷ qûë²ýÓ~õ¿ÿí«úá§ÎçÏj;5ø7é<Š'Ê?³°­ÿò‹¯¿ùò÷ÿç»Þ™Á·O¦ø ä¿8™Ö=#,´|2¶œëÿׯþ_Þdß ’û¼YD ýÅo¿þå—¿ÿò·_ÿ±KýdÓ‡Å)ù¯_–ŽÍ$SYDkø{¿¬kß‹?¸–a;Öâµü¡_ùö×>íW¶ìfÇ`΄¥ žðå_œÕgþe"Üëß÷2÷†C Û1U«ì2¿ýµï~™›ö‘ûK]&oüý½.óSÛ™|â2?Uø.ÓÁÅúO.ó¿d:Ÿt‘˧k¾ársÃùò~øSÞá/Þúæû¢¡õýÛ?þÿÝ> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 202 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_dens_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 245 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 246 0 R>> /ExtGState << /GS1 247 0 R /GS257 248 0 R /GS258 249 0 R >>/ColorSpace << /sRGB 250 0 R >>>> /Length 19840 /Filter /FlateDecode >> stream xœí½ËÎm;rÙßO±šV£¶&ïdW‚-@€ eŸª! …²n–j§TV 0êí‹c NòW¦”)§uØÈsrœµþ¹æ…sŒ/ÈŸ?ü„Ï_}þû·ÿôÏó¿Ïóýyðœâö¯¿ý³Ïÿùùëo¿û‹ÿü¿÷ù“_| ó?>ŸýŸ¿ø}üû?ý’úýÿÝþkûüoôÇŸçó§ßÂççÿþê[ðŸûß~õOûüÞ:ÁT¾þIáûŸ8æÒ'µú}ä¿wŠÏ÷ãgÿ§â?ô÷ß>þ]Âó½¤÷ž/—€ƒ÷ò=¤ÏÏ¿¥Ø¿?òÇ·Ÿøq(í{ïçÔïbßs}¿@ý~!=á{Ý~zûBKßÛöÔþ…êÿÁ¯ÿçTùéß{ñCÈߟ±>§Ü¿0ïYhï ·/Äö|e}r?ÂÑ pÂy|ò{¾Û-‹á{ Û-ƒÞ¾0Ò÷Ô·/@o÷´–ïeûêí–¥ö½m?Am_håûó^Ô~=%Ù^wr¿#ÉÏvÝÈí éßÓó>Èí ¿û?ÅÒ>ñ Iì-)­Î¶Ô¼QÏû5ïqñÆùsS­™jqþõü÷l]ÅÞ¨>%|vñóß)™JjþÞügµÆVâ÷yô©Fêó(ñ{l¦Ò÷Ly«›jÌ£${¦Êßsùà®F3åWRÊ÷<’¿'?o|Sõ5Ï~~#ù/4»ËSá×Û¼à}Ã?›¨ì­IPõ15\ï!~ì¿U¨š?óŸÙ>«Ï÷P?ÕÛ£«Ú?uÞ ;Ïùïø|jÄ5L5ïÝTÃîÒüwÌŸšp§š÷¾füÞü¯qÅ›«>Ò¬…Oå×Y»ÙUŸG™ÖÎlþÅü÷|7JêýÓ‚=·©ê÷ü|æ+û$¨ù»mËϳ}Ïù3Û`Pc¥â.Í_Êó(Ý«1>mÞ?æø^¦ÍwÏ~}þîÿ>p.ó|CùŒ`ÏÆÕüÝiÅÿ.ã3ßÉ1 æ›5е“ö>Íç8æ5ålGáÉö§œ‡(SÎ; çՅǛՔÚ|˜oXó×Ã|ïü¡öç{ŽŸÚ┳„qó&ÎÛfÎ3¤P(¸Ñó¦–y¨ÐЮæ]}ìPn3e±C {+¦Ìö<ÌÍüe™²˜ÙEk)SÎŽc*f\o÷‡â¼Cv§æ3™ïpˆ ¯ò”ÕÕñŽôfÏ(¤ zÊùGa:Œ¿ ó Îî0ÌþÕ_Ë)ÛFezzSœ—ûÜâ<íöPOŠó4xÄè¶c:Ø3Ý*õ°ãe8ŽyM ®Žç½Nœ&ƒö8u)®Ý)ÌŒ¦cÅXᲦKwÍã¹g™FûŠnZ¦Ñ^£»–iܯ趵i÷­íûn\~<^ÑËOºáxnÕ!ºw™Ž…ºáxî’fˆ ÇÃýžºG¿>\ÿtÈ”¡ u¯Ð~üi™©ï­çðßóûŸ’u~~‘zðz½=LÍv¼¦óq3]q<÷±h— ]1èöšA—ä3¼É­,ÎËhzzYÄi›v3‹ó4x¾îfqþ¬ùÌ·gCIÏ7¹ŸÅyï(Bv?‹öµ@=ý,æC#3úég1G¾OSÏ Óáùy´ ‰¹Ùi@Ï;fƒBN6:s˜Ù2õìNâtjÜÏy i»qZ5ÚïÔóDc<ÿìãÅ8exß²ûY¬ë÷ÝÏâôÛ¨§ŸÙ¤„¿ç~›Þì~çP÷7»ŸÅÆîͺŸégѺõA=ý,Nÿóá™õGÓÏâô»R©çÿ±‰&îoq?‹ÓÏà_Åý,ŽÞÔ:°ég鉙ž~–¦?%èd/žÍð¾XgÓÙÄ÷7.M©õübš¶ðàóbýK²×:PÏ O³}¢}Ïm2ôð}.îgi¶’X'™09Bû,îgÉš…ߟâ~–æcÄûTÜÏÒ¼­ð+<¸d·%SO?Kó2ð<ªûY*˜ž/b²¯ùõV÷³4ŸwïÔÓÏ’õ¯ø¾ûYªoyÇl3ü€!«éég>öë› evŒ‘zM²Ñ£?ßyàÙð“;õ¼ÐdCg|¿Zÿ’fõì_Ò«á~͆7û—Ô9Y1=ý,ÍþÑ¿ÖñO?KÖ^êy#’ ²ð{îgɆÕõ|ÑMã÷›û™iô×ÍýÌ4®¯¹Ÿ™FÿÖÜLã}iîgö{¸_Í^˜ϴû™/ú«æ~f×Sq|÷³4ÛÌÔ6™îY¿ï_êÍýØñ‚uÐó‡Ó|¿àO6P©þ<ºt±xFæû1ÌüÃ4Oó‘žýKªòƒæ~–ì1êù&fSw÷³T¾ßÝý,ÍfŒö×1U/™ýWw?K…ãÙÐÝÏÒ´<î~–òú¾ûYʺ¾î~fï ü »ŸÙû4¤ç…&tK¦ÝÏì}¬ÒÓX“M ð}ïhÓ`<7õ°ØCáýŸ&[¬"°ýL=_ì4‡ih_ÝghkFçã~fÍÚûGÓÓÏü5ÂñÝÏìµõþßôô3³þ½û™ÙPˆÔÍæ3U¿ßÍè̆y¾Ý†Û<ô°¬uÏCmsú’yýsüo“úB¿6Ý1 LþûÖ°‹O‹ô|1|X1\»ŸÙ0…Çs?³aQÂçîg6ìj…Úæöóyh÷36–AíñǦ㹟ù°Ÿû…Û0š_5ÁçñÝÏ|Щ ¢ÞÞlàosü°Îßý̧Aþ|æl–?oc’¶i¾=&ÿþlx6Ï·ÇÞ©m¢?›û­O¢EPF§œïÍlä­wlü&§™ÍWÌÇ&6i˜^fsöH9ß)3Hw2 4Êid]÷)ºÍf—å´±Næt¡«QE7±Î1™ †§‡M ‰ƒrZ˜…wpdw°Æ ›„ç•"ˆ9ÿ{ãðÃÆÅó=œ­·IÎÑñ4Ÿê?4GÉs×¼Ë&çKS93˜]‰$å´ÈiTnÌ6¢žw©r\orö#ħn[6xˆ”Oä ÛFÛ(¶HiE)Í‹,¤(HîX6ÎÁIºaÙ0¨SZT1 V“Û•…6#åt+E<Íõ¦YŽeÝã1Ò)³[• Ð:åüE‹§úïfÿÅ9œóq¢ øç l£»@YvŧÉz)qc§œÿgJxVöÆj2PV?2»C™Œ”Ó LâËîO…1N“ó_éîôþ­›“I¿ÞìÞTd%Ù­É$®×ÉÎê¡l~(gÅâ¾d2Sv?”â¬ûI~(Ÿ4›ìm“ÑžûûåhC^“~V)OïïZ0½¼wâéí½|D° CbÖ ?žQq3²ðx£œ&RYq+* #S“Å£è Gv#*§˜œMhJ<£â6¤»Éê‡B'WÝ„lÌ^)§Ábu *Œ™œ¯¹Í3üÈÕ-¨pþmr¾ª¥Ð>çK1ŸlaôÄä¶Ù?”ͧ„×Y„½Oàß{²6’{(ç»ió#|ê3ô´I0 XPm‚ƒƒëT’~×-¨D:au šÞÜ‚Š\´¹Ù4ÏϪ¹Yƒ”ÕñL…t š—ÐÜ‚¬±áPnAb9&+@ßÉæS’®ÉéTSâ må%F@Fh„w÷CÅNÙýPè,ðî‡B¯Ñ¼EeõðÍ›nf@Îdw¾‡þ­¹™ ”Ó‚²,¨»ÙœºS? ¹»M é€Äƒohw ²À>u 2™(‹ FÑÝ‚ðÊCV?^«î¾m2RV?ºÜî±/“²ú¡ðÚLÏ…‡Ò}`›¦[±û››5zênA™Á‹Ìó1ùPΛfÿÝád²SN z¥[Pæ¼Àdo›t 2Y)Gؤ[Ð.GÙ¤[Pæ Íä›t zeµžh—¥lÒ‡»,û¡ºÝ‡]ÖýPÜ—õ=TzÜ‚vÙžMº‰*›ly“nA»l}“nA»ìû¡Ü‚vÙ÷C¹írì‡r ÚåØÕ¬ûØåØÕÍ^9ÌùwY¶CUwY¶C· ]Ö°I· ]Ö²I· ]ÖýPnA»lé’Ç—¿êË}9/'ùå¾\à—Ë?oΗ[÷õÆ~¹í_Ê—Göå~yÜ_צò¥!}if_á—&ú¥iÞ_ÿ—Wc½8’á=ÔöÒI†²ÉõÂJ†°Éõ²K>û¡–QH>û¡–ÉäÓ‚$ó~¨e_’y?Ô²>É´jÙ¦dÚµ,W2m‡zíZ2n‡ZV¿dÌ›T7±d|6©.fÉP7©îiɰJ]Û’Ï~(u‹K>û¡Ô¥.ùì‡Rwü¨ïõy;Ôêè—ÌÛ¡Ö aÉ´j 0–LÛSÀàd—q{ Øì2nO¡Ä!Ó+ âp땇q¨öÊÂ8Ì{¥wùl‡Âr—[JŸ¯ô¡é.ó~(Öîr³ ‰w¹Y‡Ó»Ü,ˆCñ]¦ýP‡qÿÊÂ8AxåaAœ\,‰©Ç.Ãv(L[v¶CaʳËg?TÝŸ“©WžTN *§•Ó‚ÊiAå´ rZP9-¨œTN *§åÓ‚òiAù´ L‡_é3Á]†ýPõp~LÃ_YçÇþ•§åÓ‚òiAù´ |ZP>-(Ÿ”O ʧ¥Ó‚ÒiAé´ tZP:-A˜Wzˆf—q?”‡wv¹;?BC»Ü?”N J§¥Ó‚ÒiAé´ tZP:-(žO ЧÅÓ‚âiAñ´ „þ^éÁ]¦ýPTÜåîüHîrw~3w¹[P<-(žO Ч…Ó‚ÂiAá´ pZP8-(œN §!öüʼ>¹~eÚŸŒ{¿2Ψù+Ãáüá´ pZP8-è9-è9-è9-è9-è9-è9-è9-è9-è9-è9-d—ûàe—ûàæ•áp~œW>‡ó?‡‘ír³ ²¥]nD2µË´ê° b¯WDhöʈÜ^™öÁ'Ý+ã>ø$î{eØŸ°ð•ÏîüDKöÂ*_yX1ç.7 "$ÝeÞuX ì+ "¿}åaA¤¿¯<,ˆìø•a|’<¿òÙŸÜzI`í]nÎO(¾ËÍ‚ˆÔw¹Yü.ŸýP‡‘öï2ï‡:,ˆ©¯<,ˆ‰¯<,ˆi ¯|öÁ'“ –DŽÄ.7çg†Å.7çg~Æ.7 bvÇ.7 bnÈ.7 bfÉ.ŸýP‡1m啇1ée—y?ÔaĄY 7»ÜŸL×ÙåæüLöÙeÚUwçg&Ñ+O *§•Ó‚ÊiAå´ rZP9-¨œTN *§•Ó‚ÊiAyìƒOæ~½²ïƒOfŽírw~äírw~d­ír· |ZP>-(Ÿ”O ʧåÓ‚òiAù´ |ZP>-(”N Bžá.·Á'³wù쇪‡ósÒ’åp~$Pîr· tZP:-(”N J§¥Ó‚ÒiAé´ xZP<-(žO Ч!#ö•u|2Ÿö•åp~dã¾2Î\ÞWžO ЧÅÓ‚âiAñ´ xZP8-(œN §…Ó‚ÂiAá´ $g¿²ìƒO¦v¿2ïƒO&†¿2δòWžN §…Ó‚ÂiAá´ ç´ ç´ ç´ ç´ ç´ ç´ ç´ ç´ ¬xe>ŸXeðÊt >±Fá•ñp~¬pxe8œÿ9-è9-è9,h4‡ÿŒÃ~Æá>ã0ŸqxÏ8¬gÎ3ãÁꔥÒ>àĺ–¥â>ÜÄŠ˜¥ÂîôXK³Ô³ûü8ü¦vÓ·é‡ÙôÃkúa5ýpš~M?|¦6Ó—é‡ÉôÃc°üiSÛØ §– ûÈK®–zvSÇb-)¬äÚÔf-íp–vK;|¥¶ÒWi‡©´ÃSÚa)íp”vJ;ü¤v‚uu›Ú†‘X·©m‰u|›Úüëÿ–ê»{×ÃEêa"õðzXH=¤Rÿ¨‡}ÔÃ=êaõðŽzXG=œ£Æõ›K=û€ë>¥ï´©Íª±–tS›Q—Ã5Êáåpr¸F9\£®Q×(‡k”Ã5Êáåpr¸F9\£®µÀRyìcÃ<ö¡á³¥ððSøåkŽm%|¾kŽïšã»æø®9¾kŽïšã»æø®9¾kŽïšã»æøÇ]s|×ß5ÇwÍñ]s|×ß5ÇŸ•‹s×ß5ÇŸ•ˆw×ß5Ç?îšã»æø®9¾kŽïšã»æø®9¾kŽ—ü_µæøÜI»Ì·v¶ïù˳YÏ[øî¤.@T»râ ª=¿¾T»’Yb²nSª90µš+'Pfïñ#ª=íÜï`ÖÆMŸ¨våÄT»=ü;Ú6n|ªÝ8äÕžª“qcã. ×qÏÌ_B2n•jÛÜ·°s%ã®lûdܳaûŽŒ{¶Wo·dÜ7ŸÅ¸gËóHÆmÁØñYŒÛª'8 ã¶ÖóYŒÛšˆK0nFãnl dÜs.ÆÝ8¾'ãnÃ22n›û§`Ül‡Œ{> @m0îyq`Üvûg1îN.FÆÝŒ»sjDÆÝT%ã4?1n‹AjcÜóJ³˜vDÙ02÷`j†÷¨›ŠqÅɸ-ô†ßãbx£-tö€1» Yè LŒÛ0˜8˜Ðü32k0¡g1s0¡GÌ ŒÛB]`@`ܺBŒŒÛBUQÌÛ˜ÐìHq|0n EU1o‹¡1'0n 5‘I#†*cæ`Ü:Âï‘q‡ÅÀÁ¸MQŒÛ˜14w ú>wŒ:÷Ô`6dÜQ1s2î¨7·…xp|0îÅPɸ³%ã^Ì“ŒÛ˜'9·rĸÅHĸjZŒ{ðy‹q1_2îñ…q‹±‰q1e2n&2-Æ=Ø>ŸÅôĸÅlĸ9YŒ{ gYŒ[ÏGŒ[íGŒ› '‹qw» ?^ÆÝal‹qw21îÎö$Æ­ÏŸ»/÷bÊdÜb¼bÜn°7gibÜÊ-ãN™1wzÄÐÁ¸“r2ȸ-Ɔ Æm?Ó¨AsÄñȸóÆ]Ø>Ÿ+ï—·r8ĸßG2î,DÆm¨zP;ãNd.bÜ…íGŒ[ TŒ›&1îòðþŠqG1éŸ~Œ[ï÷Ƹ¡É¸ÛŸw"ã®Ì"ã¶Þ Ì›Œ›ÃÕŸß'1î*&?kƒŒMŒ;ˆ9“qg¾Ÿe1!·?vÆmíq[6¨m&_™³#Æ]ù~‹qOÛDTŒ{úE—®`ÒÃ’q—,fÆ­…bÜ™ý‡w®º~0îÌ#1îÌœ1nË Ô6«OÊ ãžï?ÂàdÜI~2nß%j›Ù[$>ãŽbdÜÓ*ŽÆ8>ã¶ù˜4·ýg1mÏaEã~xȸ-$)mS|›fáû`ÜgÄbÜOÔçdÜ‚`ÜqÎÆH¸×_p'Þn¦pwánKNÆ¡ÜÈ”»LÀmn%¢m€[™Ü"5ÜawS4€{¶`ž³;XÓ !àVNwÖYu†Ç¸ïÜôîÊtPîù&à$¸+ã†ÜzÎÜö psV.À1¨à>#àN˜Â p'¶`n!0îÈÐ=wIà†;p‹[p?âÝܰî2„ݸ«x77HëÜQ¼€çün|y€ÛOrnÜ«¸Ñ€_À-Þ ÀE´ ¸%7Îjnñnn¸¸@àŽ'àZ]€;œ€.»w87Ù±7ò ¸JànlÜ p7rXnö®Ü 4p7uîFÄIÀÝØ6¸Ü•­€[)Üõ%ÚÁ©4n;·ú$îBË$à.¤–Ü…†LÀÍ¥jÜ…7–€[EÀ™ðEÀM À½¨47ÃâÜJ›!àN' p'æ3p'ö2ܑψ€;ê4¸ã ¸9àŽ$ÜowÃà/ï.N¥qsàŽâÝܰî‡G&à~h›ÜÊfY€›4\€;‰wpÇpÃëà&³ÖΔhÏkßJRxíj ]€íjîzî*¢ À¾pnœóÜHY€ñÜéÜDØ pãPÜQ¼€›{îHIÀ¿à†3¼€{îBIÀÓX€;Rpãà~( ¸E´¹^{Pp‹hÿrÀ-¢ýË·ˆö?p‹h_À}÷opßMµï¦Ú›¼›jßMµ7y7ÕÞåÝT{É»©öÝTû•wSí»©ö&ï¦Ú¯¼›jßMµ—¼›jßMµ—¼›jßMµ7y7ÕÞånAùnª}7ÕÞäÝTû•wSí»©ö’wSí»©öRwSm©»©¶ÔÝT[êßä¦Ú_—¿›jßåÇwùñ]~|—îòã»üø.?^sÁ»üxÜåÇwùñ»üø.?¾Ëïòã»üø.?¾Ë©ïòã»üø.?¾Ëïòã»üø.?¾Ëïòã»üø.?wùñç.?þ—Ù_»ÏæifT>6ÛþÚ?­ªÑŒj±jt;ªFs€ÁªÑÜŸU£«8ps,MÀнp TpÈpÛ€.|¸+#|ÜÖÝø1=\[Yp €»6X ÷ꨭ4nF͸YÆ“€›5¸Ó^5Ú ½€[嬸[ehP*NÀ ?^€ûÁ(„€›µµ ¸FUÜ,0DÀ]ø Ž–„͸;…Üì‹€; ƒ%àŽêÜOš€›c  À=Â{mñmvjâÛ¼äÛäâÛ¤nâÛ#:ñíÆúËàÛó¥ó"¾M/¾Í9ˆøv T|›#ñmô#ß –o&Yˆo“¬Šo‡U3Úù6™âÛ¬ûL¾–'ߎ÷‘|Û Rü,¾mèÄá0ù6«,’o'F É·KäÛsÔ6¾˜+A¾=ç8cãÛ‚äÛ‰±(òm›¶8ußžóðogN¬É·3«oÏ™ˆ=øvæÌ—|Ûê>hß¶©Gù,¾ KäÛ™òí)ý¥R i–ìR iÞI•îhu*!Í‘†JH³Üù¶ ÒYƒok¼§Ò¥*!Íô •æU%¤Yå^%¤ ™UBš#g•ÎéàÛV¨Æ%ø¶çógñí¢täÛE%tÉ·Ÿ!ß.â—äÛ+ÞL¾=5KNƒoÛÄS%£#òÀãÈ·ëâëàÛŸÜø¶W¼†F ió7ñn+!]Uâ”%¤+‹ç¨„tezŠJHOÝÄ»r!X%¤«Jö²„ôÔàq,!=]Œ%›QBº²(’JHWñE–¶TªNm%¤›Jœ²„´•-Ô5»F Vðí€ÉÁñmÛo|ÛKpo|ÛÃô8Tc®ù¶…åqÀ·-ÞÈÏð¨Æ0ù¶iÜ_ðm»‹g›MalÿC|ÛÃìÐ0ªUbÚyiððm‹‡V•”öøi_fü´ˆ'3~ºJ@3~ÚÄ?š%£?íìEÈ·Ã*‘ ¾íù~¾àÛææïÁ´æ›N~ ײ˜›tEÉpòxøÖ`ü|ÛâňŸƒo{˜:S›uYXçï'ß¶°3x%ùöóœ|û âÁàÛxù¶½fþûäÛóµ"ÿß¶®qçÛÏ* ¾ý0ê"¾ý¨ä)ù¶JŠoæ‰o•Ì%ß,¹(¾mÍtçÛfÏ6¾PßÊ ßV'*¾ÅÛÉ·£îùv ߎ,i)¾«J6ƒoÇ®ïƒoÇÁó#ß¶ÇЩ;x>Þ'òí”ȇȷçmB¾ùvÒõ’oÏÛ€öC¾8’ßÎL™߶ޱRß~ù=ø¶:?ñí¬|òíÌxø6þõcñíTb™<(©3xP?!ßFtêÇâÛŠË‘oÇUR¹°ä*«"’o{hhP2L»ñmèHR¶ù¶bx<äë´(žŽ|ÚҖ¯ÓÈÈ·-°|ðm V }o[O´ðm{Þ«¤tIž‚ëßö|•‡ºÔ­}o[ûƒßo[Ékœø¶µgŒGÀ·S¿oÛû|ðm‹ÂàùŽ•¯ƒç ¾mïg϶|GùŠäÛ£rýàÛþ3‘ÚòAgß¶hæ ¶ñò|¬ˆ—“oUÍ$ßîÂTäÛ]eCÉ·;óCÄ·›*“oÛøÝχ|ÛŠ 'j›ÛW•¸$ß¶þñ¡¶Ù½uàÓàÛŠŠ‰o—NB¾]Šx7øva`E|»Lò¶ñrzȹ}X-èÝšF²ÝÏ| mÓýyœ@·MKp@ºmžÔmÓ* ë¶iî`·MûÒF»ƒÆËÄÝ6 åù¹ŸÙ´øÀÛ¦É,©í~fÓôPQa ïi`(@Þ,y(|ì¡$8Ü!o9‘7Æ!ï^U4Úƒ½G"ïN"òî‹b»‰uz‘·Mñe·°&è äÝd0@Þ³}ƒ°y7¥oy£Sÿ!äÝô²`TÜž—€Oïª[@ÞUÀÈ».|켩2Hä]•hä]••ä]•ôä]3Ó€¼-túPVOÀämZðê‘gœ3÷ª· ä=%2:€¼+ODÞ–+¸!o¥ y¯jÜ c+—Q©Êq1‘÷J-òž ÈÛ’#e÷C… y[ b¤4ä=˜1Cä-žHä=TøÈ[vEäÍÑ‹·h#‘÷ ·%òf(EÈ[,’È[ùDÞƒ¾Mä-RIä­Z¿DÞ ysŒ%ä=Ä‹¼ÇYRšb!ïÁ;Iä-RIä-Iä-€Hä=^Þ=³b@y«ê9‘·²2ˆ¼UõœÈ[yDÞ]§äÝõ»@Þ},‘w;KJ7fly7Ukòn/ã~üPÏŽ¼« 0yWº ‘w¥×yWZ‘7cËBÞ…OŸÈ»Ð ‰¼ [,‘wÑi ¤t汤tµGIé¬ÊÖnAMÅ9»&œy—$ެ›ÄîÈ»¦yÙ&wa®4‘wQjw‰*8¬D‰¼-KA¼ø¡Ðmy[ô8PZÖMàmò.Ì9&ò.œây— ÊÖ>ô4Àßú“]e¿Ñ_ywav=‘w ªN¬› ˜Ž¬¥òyï²§÷Ë@ÞëP@Þ뇀¼×iy¯“ò^—ä½.È»wy¯›ä½n·ÝØHYÊ{Û¼×Cò.+y¯ ä½7÷j @Þj*DÞ ³y[3ÛwᤜȻ0æCä]b#ò¶ÀJÿ,ä]˜ Kä]8_&ò6[ŽŸ…¼ {g"ïBJä-”@ä] ò¶÷Ò‘·½Ýá³w©˜çy—ª tœ²†ÏBÞ…½3‘wá—ÈÛ<ÇÏ9È‚pÎ@Þ… ˆ¼ )&‘·I¿9@ÞÊÈ"ò.L^&ò6'|> y› Ÿ¿GÀïŽÛwÇíCÞ·_ywܾ;n/ywܾ;noòî¸ýÊ»ãöÝq{É»ãöÝq{É»ãöÝq{“wÇí]Þ·_ywܾ;nKæ»ãöÝq{“wÇíWÞ·ïŽÛKÞ·ïŽÛKÝ·¥îŽÛRwÇm©“;n]üî¸}$ßÉwAò]|$ßÉwAòš ÞÉwAò]ìú.H¾ ’ï‚ä» ù.Hv}$ßÉwAò]|$ßÉwAò]|$ßÉwAò]|$ßÉwAò¿ä‚äsîÆ"Ó¾ŸùZo{pko«Èôƒñ‹L³²È4ƒL,2Í‹L'˜5‘7§DÞœ,y³Ö)‘wcyh o‚,"ïI‹L³,‹Ló…`‘éˆÞ}™ö;¿ŠLͫȴJN£Èt!äF‘éF^VH;áí¬ÑÂ"Ó„E¦,21Þc‘iV%ò&¦!òfUW ïÁá ·Êøy¾¤,2ø (2ÍZ:DÞWDäÝ0è#ò«ä´1¦‡s0o#g>öô¶€wlª3Í—YØ›ôNØ»bú ìÝð {w–p&öflØ;°¨…êL–^u¦ʼn½é8ÂÞa2aïBtý˱w%P'öfŸØ{Nñ»J¼ˆ½ƒ°7ër{Ó÷…½9öŽèŒ…½¦ÚÄÞ1Á­ˆ½#'ÆÄÞ‘cbïȱwähƒØ;Œ ˆ½­(–)² <±÷œøùëKìmóÂþYØ;rþL쉉½#ëS{«z+±wäГØ;rlMì=§ˆÞ9{'ÞIbïÄÂtÄÞ‰Ø;Ö{öN¬¢Eìxc‰½S”œØ;±ú5±7fŒ {§B(ìX’Ø{JT¡ö¶jvŽ®½c/ÄÞ‰µÑˆ½K’{+Ÿ€Ø;sîDì=§y«®t@µ´cïÌ4aï\^mØ;³Ä°·Ñ˜{ç. 쇰:°wyæ#ö.ÂxÄÞ«®&±·¥ÂÞ…^$ì]ª~Ø[ƒvaÆÄÞš´-ì¾`ïHŒ!ì-¬.ì­º¥ÂÞ…a`aïª:ÍÀÞUur‰½ëv&ö~ˆ}„½F[Ø{Õµ&öN +¿Ø›u®öî_°71öÂÞý ö¦&ö £{wÕMöf¯¸°7Ãr {+Ì+ìÍxÊÂÞÂŽÂÞœ -ì­:·ÂÞª[-ìÍb { {Ï·¼îØÛz¹DíØ;2ì+ì­0³°wâýöVÝOaoÕöæpnao¥{3¥oaïN¬+ì­÷ƒu¦ŸUç™Ø[ØGØ[u×…½Ó ^ì½07±÷ÂàŽ½‹êT{ c{7atb﮿ö~†êH/ìýs{¯ºÓ޽•¶!ìUçšØ»¼u¥‰½ù÷ÄÞ÷‡Ø; bš{ganbo´{ãýöVbaoÕõö"öNªë.ì­:ÚÂÞ Û/ì-Œ!ìÍ*vÂÞùáõ{[Ø çìm¡´DíØ[TØ[uʉ½-¹ Çö.IØØÛf.™Ú°·JÃ-ì=„‘½-]tÇÞ•“(aïºaî€:ØðboŒÏ~,ìÝö6ºˆÏ½Íµaï¾êZ{w¥={÷…±‰ºÒ¶ˆ½»êê{Õ!'ö,Ù&ì=”Bì=äßÄÞó}%vGi£AÀÀ¨3ý( ‹u¦ÕÍeéù~±.3êL?ŒO©Îtà`Eu¦çûD¬:ÓAiBÄÞAi ÄÞåú„½ƒê{[š¾ì…Ɉ½§m"Í‚Ø;f]°wTÿJìmÑü‡ºS£}{'–—ö¶¼ßbo3EjÃÞ‰!eaï¤4'aoNLö&6[Ø{k{g¿öÎÄ ÂÞ9©î5±w¦ {«®²°w%¦önª‹Mì­´+aïÎö-ì=ÞºÓŽ½Õ_{aHbo sö.ªûMì]ä·ÄÞŠ {›¦ö.ĈÂÞïñ½‹ÚŸ°7gÄ {+­OØ»³ö&–\Ø»²»°·Ò„½uÿ…½Y7waï¡ß#öVš€°wáû(ìx?…½Õß {3õxaï*ìKìÍéž°÷|_VÝiÇÞß {³Nò†½yü…½y¼…½1žøÕØ›ß'öV ì­´aïÌ´Pao¥¡ {WŽ'…½Õþ‰½13ÿñboF„½Ëæ&ö. {3MDØ; Ì { ä{'¾ { K{G`$öŽåÅÜŽ½™æ#ì˜F¸°wÔù{?ÂÈÄÞ6þIÔŽ½VGéÁ ™êL¤ëöî"3ÄÞ {Ïת ƒ3Má[bo?Ô†½›¸±wUÅIbïZU'ØÛº…NíØû‘ö.«®4°w“#ö. Ë{2«Ô6ÁÏ {示ÑÀÞÆq}ÀÞIiÄÞ‰K%„½íù&êʺÚÀÌæùÄÌÀÞ± k{G?±wT™TbïÀ4:aïÀø“°w-!ö¶þóÀÞ ‚{?"`ÄÞ ±÷S„Á½g3nÒŽ½Ef…½Å½G'žõ^Ð{0D æÍ”.1oUyóîB†`Þ]ù`ÞˆªüXÌ»¶“y'– &óV¼žÌ;05Ì»©É#‚Ñ”(æmÁ,!pcÞ•Ï—Ì»¨H5˜wÆèDÌ;©H5˜w$#ófµ˜7ÆÉ¼«¸&™wNó^UšÁ¼ŸúbÞ¸ÀÅ¼ÑÆÉ¼U—x1ï²3oqúżÉËÁ¼³Ê_ƒygal0oš¿˜7é…˜7»1ïô–¡nŽÏÃμÛ™7׉y3ÙWÌ[Åäɼ•:Cæ­2ÅdÞQtÌ;Š.ƒyor„íËœªÐ˜÷{dN&#åÛi8p2 @îÎT•/æýJ÷¥]N[z¥»’I!ð·rOzÏÊ-i]˜·ÉHÙüPÄÉîG5¾¼ù¡Ð&**W°‘yWÎ}ɼ-§acÞ• ]ȼ-Å!QÎŽ¡rDæmBàÃë·®ûpÜ‚Vó®ê#Á¼«*<ƒyWŽȼëÃ40ïÕŸy+kÌ{¼¼´—ñ“yþ-™7aƒ˜wW•f'UY'óî|%›€Cp¹lNdí…K(‘Eæ]E¦Á¼+Ÿ™· ŠÌ{Áu0ïòšNŽýâ@æÍb1ï×Á¼•±Gæ­œ$2o9™w?óÎ*é æMÞ"æ8h"óVŸCæØ%‘ykDEæT Ì[&Cæ˜AæTÌ{“-n_óò'ó^?æ×Á¼íšÌ;Ñ È¼› ™wâ%óÎGÝé’ÙÓ‘yg6B2oxļ¹NÌ[YŠdÞ³{1ïÂ÷ˆÌ›”WÌ›ÍbÞEÌ[ùvdÞ\N"æ]…íÁ¼+SÐȼ«ø1˜wőż’óf⿘7©Š˜wÉy‹ò’y3gEÌ[X—Ì›¬PÌ»¡!‰y³ón"Ó`Þ›yåʈy3Ê$歬ɼ›É¼F#bÞ oŠ˜wÃû»1oAîÇ_vŸþ‹ysM£˜7Ónļ+ïFPÚMŒŸ—yWYi7]i75¾R«¾ï&ÜwîCÞM¸_y7á¾›p/y7á¾›poònÂýÊ» ÷Ý„{É» ÷Ý„{É» ÷Ý„{“wî]ÞM¸_y7á¾›pKæ» ÷Ý„{“wîWÞM¸ï&ÜKÞM¸ï&ÜKÝM¸¥î&ÜRwn©“›p]‘¼mÂ}W$ßÉwEò]‘|W$ßÉwEò]‘üYÓÿ»"ù®H¾+’]ßÉwEò]‘|W$ßÉwEò»"ù®H¾+’ïŠä»"ù®H¾+’ïŠä»"ù®H¾+’ïŠä»"ù_xEò¹ wŽÆ¼Ë´ù¯»p›oÌ›ô’Ì»bÀAæÝð.y³P™÷ =vÕX2Ì»12Œ—Vó<¼JåtÀ¼‹G‚y7F¼È¼é‡dÞÑ!2oÆæÈ¼9³"ó¸Ó`ÞýA æÝ¹×=˜wäïμ;ÇãdÞ, LæÍjÃdÞ¥‘ysNæÍrwdÞœCa5XU„Ì;`Eæ÷\“ÁXñbÞ`å`Þù(<]З‘y³‘ysçwžfaSž&]aáéqïo£€7K& xG ø¼9¤ðæ4KÀ›åUyš•*OsÇ|ï§.ÂmDéá ’Àû! "ð~'ð~Xg—À[4@ÀûÁƒðxJÞ·FÀ›ƒ6o›ï¾éXŽ»Þ\-“þ6xÛä–Ò&ÅÆ¶\x޼@¼²ð¶ÊLõ³€w¸ÏÞLðh[Þ¬q.àÍѰ€7»Oo–ÐðÎ,&Mà]ðÞ x3ì*àÍðÞ¬¤BàY|–À[µ ¼a|7ÀóÞ€Ç x—xZxó¡¼ÀÛï³€w97KŽ x³gðfQÀ›Ó9o–ä!ð¶9žóooC9”¼"ðfé#o¸ðVå_oV[À»¾•¨ ¼`~w•ðà&ð^•¨ ¼D¼U’&ðVåSoN1ðNxô x'rï¬ë#ð.üÞ•@ïRP&ð.|;¼‹*‰x—¡JÍÞŒ” ¼,¼›€w`åMï 0¼+s*¼m’ {ª™SïUY›À»/ª (xWX ¼WeWïÊ´ïÚðaSfä•Ú|ª @xWUJ$𞀎ÀÛ*îÀ»=ª àݰ'ðnÌ×ð¶JÝ;ð6"]P¹€À»­ÊѰ¬–TéžÕT©™À» ðx·/ÀÛ":äð­¦JæÞà„†s¡gø±€w%ðn üš*x›&Àv@dÜ„ÙçÀAeß¼-àŠû‘XÙp¨R5ª] ÀÛt“¶¾£ÓL¼½Rb HpàðöÊâð6n@àmœ„•£aeè9~x'Pð6ݤÍÍ:§ ÞoåqoÓuÞ^ù±SW$LÀ¼-€Mí€È¸®ÀÛ42ªÆEð9ªC~àíÇG@u$U¦F@upFàí ‘º3aǃŸ U.ðv®áÏÀÛ&êÁ„ x"¼§m¯JÔ Hè!ð~’€6€·†NÞO9÷£Ê¾Þf³;ð~˜Õ'àý°@œ€wXÀ;,Ààļ§Í¡-wÐûEàš*]x[‚>€wdZÀ;2éRÀ;*ÀÛlÇð¶ ðJ¨h¬<-`£ÊÓ‰ÁcUžNò#VžNY•ŸˆÇjª<½+O'% x[ÀÛ¢²Hðð¶Hk‘6@´Ò¼-"š6àUÄ‹ÀÛ+ꆄ VÚv?‹šŽx[1 pÇê•Å—¶›„ð"§–W[ÏüV–FO¯¶›ÖáûHàiª„àí!0t$ð˜Ÿ6jKài,öGàmá'$x[À þàmA$´Oo €—ìrUš~ª'T`¼àmA™gÞQÓ(o´@#g4y$ð %´x¯(ï'П¼%äx?Y@ÀûáäLÀûa™Aïù~†x%àx#ðcïÀ‰—€·q¸@mÀ;¬ß𶄦JmÀ;°Š˜€÷ªdNà½Þ_oV¨xÛûüP$txÏ÷û¬<èÞ,-·Už&&ðŽLè$ðŽŒx xǨÊÔÞQýwTBwd­€wdWo?_œû™_O¥î*»ã|™~¤{öû…ñ0€·ÝO$0xÛý~¸óãÏ mÞöüÕðNš•x[{Èð¶2x €·EÇCð¶ö¹´%ð<*Kà­€€÷%ðž·1ìÀ{¨p w:_ø™Æ Þ]WowTyº- ÊÓMUf¼Íº¸õ/• EÞæg¬äì‘ܨ%Þ†`bð6?˜ðv¬¨ÍÏ2ÇÓÞîç‘Úü,‹¢x{B]£6?K*É àmý+KÃÏæ0ábï¨y7·õäð³Ðõ{ð³U ~8¾ ð¶Ûˆöàí ÎÛµfCÀ àmÍÀÀ{Ubð‘ÜÀ» ²xwÎO¼»Ú·Æ»ÞM(…À»-æŒñÙìVb¼5Ÿð®•tïU†˜ÀÛ8V¦¶ñ²%à|PyZuUyº¨½ysõCÐÛ+jŸûwVÙööôDí³á€oOp¨}þÏÑ·³…Â+ñq>€ß6Ìg9k¿QÁçîg6í@ûÿ¶i À,¸M{øûîg6‚Û´ Ï ܦqDóîg6í‹Ò6^ŽzÁ}Ú™©m¼<›-Ú3@¸Ms‹À¸—ƒj€Âmšß ·i9î/`¸Oë¸EYX m8ÜÃ÷ða¦¶ùÿÃñ*‰x€Íý·°ž˜¸Ç9µG'ý½ûÙl âcýº»™Å^3eóºåÈ/ŸVŠšº âC T|Dgv#L$&·aN¢ìž|·TÜ’/2å¼ûI¤âó'ï ¸“ŠwpHÅ»*Ï7YÌr£âàl”ÅK ãeoòPqáËn]óÍ’Ó¹”F*Þ”æ*ÞF"o*G *Þ¸T¼ÉÃÜir°/h* *>åÂàÉó8òNÅ; ©8Ãç¢âMõ¥AÅ+½•Tœ¡-QñBK*Îd¢â™I¤âz ¤âB¤âÌ&7ì²íUõŒ@Å+gX¤â«@:¨x}„ÐÝŸÀ=~,*Îhš¨øxKU’bò¥¨8cñ¢â]tT\;©8«ÈŠŠ+OlQq¸©8cµ¢âU¼]T|H‚ŠWapPqÖµ/¡‹Š#oQqüÐKÅA§EÅŸ“Š·“Š£Å.*ŽF¸¨8š©8×kŠŠ¯"Ø âJë W{&W¼jS£òüªMͪתMñÖªMÍ2תMͺ֫658°jS³Î3¨ø£*Рâ[;©ø#þ *þ¨¾4¨ø£êÓ âG¤âŠ?"ê â\**Îüwƒ]\þÚ~ΰ6ç%É×Ö½È=YûÂUÖ¶¿„óÚ imì6òn(Lh¬ö²08v'È‚äØº€ [[ø)kQ”Ö¤ ’cV®Öî¥àÏk{åX­O×ÖÌ¿«]SÃøìÛ:œ³6}σd{m6*ž‡jbk³éX­­¨QæzmT@¶µã’Üá|mþØ?ÇÙkãHIn«„¾ö½•ä®@_d>¿œÏCåó‡òyù<É|^B>.òîÓ}÷éÞäݧ{—Ïݧ{É»O÷ݧ{É»O÷ݧ{“wŸîWÞ}ºï>Ý’wŸî»O÷+ï>ÝwŸîMÞ}ºwy÷é~åݧûîÓ½äݧûîӽɻO÷.ï>Ý’wŸn©»O·Ôݧ{SwŸn©»O·Ô?iŸî¯k–ß}ºïšå»fù®Y¾k–?wÍò]³|×,¯¹à]³|×,ß5Ë®ïšå»fù®Y¾k–ïšå»fùÇ]³|×,ß5ËwÍò]³|×,ß5Ë®ïšå»fù®Y¾k–ïšå»fù®YþW½fùÜÉÛH¸VÿX¬1o;y7ÊŠ7Öðo |Š+Ì *®¾ T¼5¼T¤â €’г0¨x' GATÜâTÃ{e|Ó§7ÓC⛱з ×Kŧ'¸cƒŠwþHÅ9Ï^½z¾Óîå â#âN wÐ@T|pB*>¸U>¨ø¨è‰@Å ‘‘Ï—p𩃊;þ*añðd‚‹;Üjq¤‘…Û˜ôaáf qâ#‚kM?}ÇÉ¡DÇ}¼ø¦Ïx9iÿ2hT`a–±,ÓCBX„„<¤ƒΔIÈA y`1%rП·Œuƒk«Œ5ORe¬ùΓGŽºHÈ#k‚kIBnãw—ÀO‘¸€„<²Ì1 yd9òÈ $äV0šÒËX̬UÆš…TÆšq •±f•±î¬Í2Ö¬¬§2Öޝ2ÖƒÕ¥YÆzTƒ'ŽŒIÈ­Há›Þæ5ªÞÜ7/ >‹[Ih?XÓœ¢ù«KBžø'–é!!O¬®LBžXȃ„<± yÊè-TÆšA •±fÌ@„œrÞgrXDÈ+æc"ä ?‰7È&!çpV„œ±TrÖÃ!g¥uòLBnÓ;ÿX)sb BÎF(B÷lO“•HܧÈDÊ!÷ˆÙKÈ“4ËX#Âù–±fYèEÈA$DÈU&Y„¼})cÝU&Vds7|/ÊC›„ü‘'!WYLòð–­vB®ˆ´¹Ê*‹'•Ý&!ç¨sòüq'äŠà‹³pû"äU™„œo¢ù"ì$ä…ÕÆDÈ­¬v¢® î $äe¨,5 ùC" Bþ¸ˆ«Ì®¹"°"äQÄ„œ“EÈ£~„\DY„\eEÈ“2HÈ3ˆŠgF´EÈEDIÈ« yå B„¼ªL9 yU† 9ÀÏEÈ«Êv“W¾Ï"ä6mLÔeÆ£ˆx@Ù@–¹†iU•Å%!¯*#LBn³Roø–*¤‰WN½DÈ+‡/"ä+„Ü ®Uê†ã±Œ4Ü«Š˜‘¨RÙj#äÖµ6j#äšb‹WFhEÈ«Ú ya%!¯ã-[mGSû#!o*ƒJBÞDœHÈ[ÐùÀɧÏ"ä³Kf™nx™.fÖTæ–„¼ÑêEÈÑ!o*ëKBÞD4IÈ[U™iøYSgò¦ òÆA½yؾIÈ;K†‰[§Šã#kÚ:”® r‹ejó³^IpIÈ{q‡ŸYò£ˆ¸ù™ 3µrù¹Ÿ!"þ L;3àgCePAÈ-"=6Bî „~¶ˆ¹ˆ ¹2(DÈ™D¶¹Ê"“?« 6ù#$!D„DȃÊT“'zrF<!¯ú=òÀDÖEȾo/!/ÿ!Çý!ï"Ð äIedEÈYoòü…Woò!¢Bž9m!ωï‹yQ™jòÆ÷‡„|•E&!/,Ë'Bn ‡Ú ù"Þ$ä ÁН²æ$äYËÔFÈ«úrnò&¢OBnï³ÊZ!o*óMBÞßrʈQê* LBÞ«ˆ:ˆRWoò±q#Jó}@û&!7P‰óQšíD“e¬ùËXÏaüe¬•gëÙ¾Ñ?²ŒõÓBžÒ~¬2Ö*ë2Ö³[giò öGB!_•„<fÈ[ˆ´ò¨ñ yT{"!7ð#"n„$ä‘#rÍDÈ“Æk$äIãò$­2Ö‘~¢2Ö‰ÏOe¬Ç;okø¥ÊXGiòÄÄcò´8y l¿$ä)¨L5yz^"î„|ˆp“wiò¦ï“+CN„œDròUF›„<°¿ !Xüñò®ó'!Wû!ç\hòˆÅ"ä I‹+\„ܦûÒFÈÞÏEÈ•­†ŸÙi€ ÃÏÆ*{ ?ªôÉ2ÖÓMòÙ,@LIȵd@„Üš½tÑ1&!·×Zº‚hÇW^ò*LDBnãå=ò²ÊjƒPò¬b$ä™ãWòéçCļD~– A yŠ*“ ?‹Ì€!,§'B® ò0NB® ò ú·$ä3XEÈÍ¿*µr+Û,"Ðÿƒ²Œõ`†‹ÊX/ Ç2Öcg”±î_‰w%!ï‰÷‡„ÜÆ[ø>yá'!·@ 4ÆgãÔ6>kÊZc|VÅQHÈg7‰ó'!_lH„<¨Œ6yéú>¹*RŠ—L”(BEìIÈW™krë¿EÌ}æ¯ê˜$ä6Ì1çÜŸ„< âòÄŒZr–7j/|ÿx ùYÑÚ¦e'äQeáIÈ£*B“GΗEÈ£ŠªŠÓÏ!ÈVIÈ•%Bnã7pòPDØAÈçk@ÂNB1¾]„üáù’ã5þ±ù#¿"!·ŒOhrWEȵöfòȪ¸"äâ6 äƒà‚€|Ò‚ªÚÛnfÓ+WYëyÐ!+·‘;~l\©Kdã*/6Þ‡NÃmÌâdøÔ/ßÒˆ…ÊgëµÀ²{X/¯œ÷¶sDC6ÞÓQ庯Ò`ãöD6®·•lœah²qeo“ÏW¹ll¼1wl¼1U˜l¼1O6ÞdƒdãY l<³Q'f%‘«˜:Ùxd Ù¸,Ùxà9“?|ýÉÆ™ï¯*×b¬r­¶Ç*ײ²ñ®Ø`ãL…_0l\¯Åbã„ð‹ã$ÅÆ‰ÙÅÆùCbãCÒØxf'W!v²ñ¤+çèYl\µÕÉÆÒ*\ 6T|l<Ð(ÀÆ+Ç]dãónÃÁÆ+q Ùxå Hl|ÕÞ‚á`ãärbã]_ï/ OŽÙÑ}ktD6ÎàØxc_O6^ÉNÉÆ+ïÙx%í'W¿L6^˜øC6^T"l\iodãÊ1!ÏÂÝ`㜡‰«ôªrM¾­*×M0œU®;%ª\³ö¶ª\“öƒGÞI²qåv‘Gظ2ÈÆ¶}Ù8Œ‘lDžúÜúöòžòý<%êsÊß´ þVn‡<µºtöÚüœJô÷'„‚Óú˜òýܦ.1¬Ï)ßÏíÅ·Ð!?§|?ÿ­¿9sDb¡ sxKúµÛ`q:òþå¯Ýòmzhá‰õ—ù×ýK8Ží/ë/kõ¿‰Ó<<¾þyܯÎs€¶iî’4ë ì~üÍ_„ç¿ü»?ÿÿŸŸÿ—ßùeçóOúííÿ·í<‚¿8€pœ?ý³¿þÅ_þÝÿ÷ëÞ¾_O&ø ìÿ´“I©ƒ#{ »îB›4ϱÎßþÙ·ÏŸÿ¯¼Ë)ûз×ðÇ?ù›¿þÓ¿ü»¿ü›¿þU×úKzÌNÿ§_=g—6ÍõŠ›øçyYoÑŠ¿w-eÎæ%5\Ëß7–¯_ûåÆòì>kóæâge0ÛëdáŸvV¿÷O¿Ìè3µßð2Ë<çi!s 1G‘ó~Åe~ýÚ¯™É+Òü/slrÿM/³';T˜#¢éf!þªËüúµ_ÿ2ƒÇè~{—é±õç7½ÌÆÇ4öðï_æ×¯ýÚ—éh5ü6/Óê|Çßô2s´ó/áù‡/óë×~ýËl>£ù-^fõYØ?Í‚Ž:¿Ú‚ŽlÕ_ï2«OEõeþOùý/íØ«Oº-²–ѯýåÿñÓÿõüc½Úoý÷“W_×ï‡öß·D¤á¿ÿßþýO¿ÿ/p,3.¼'ðÏ~Œ‰Ì¹õ> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 255 0 obj << /Length 494 /Filter /FlateDecode >> stream xÚ¥“Moœ0†ïü Ù^Û€½DÍVmU©ôÔæÀ.fc‰Ål“þûÎ`“’¢&‡îJx<3~?30r&Œ¼‰Ø +‡'#œè”æ… Š4Ë$9ÝE?"*3øÍ +s-Ç‚cÿöN‘×}ô þK( ’ÉJóªŒö¥HNuÎ8)RhDê‚2%IY“oñw¦X¾K$×ñU¿,~€MÊâaÇã¶Ÿü¦o|ÆáãûÞª­›F{¼L¶ï Óù¼¦}Øvµýië „ªÖÇNsb²»)ßAÙ –ʨ-ª8Š¡èº|¼˜HÕò?PeTAòyT‚ç4K·¨Ž•È¢J5¢ÂÍ0sBëÞN·hñx4CkOÕdÜ«ò3býzíSÌà uÆyÏ @mÙ<ê@®’¡h­н4‚+´\ ZÀ9“4S"°ÍU!Û?æ?Øæ¶‹f²ÝÂå’Q%S¢%eRlç0Óñ¸ïdFÄŠsˆNUçCÇ]Ü÷^œi.­L½÷ÙÚtˆ{²Í/ï9·ýqC”ÂèmÕMЮº:HŒ¦«·m›Îxôm4Îḯº¤üBYÅ=¾À@s›†ÊŽÎ›øá “‰ÿ»MûCª‰¦:K³XÆ¨Ì ’à ó>¿³'G¡³¿–©Ú endstream endobj 203 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_box.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 259 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 260 0 R>> /ExtGState << /GS1 261 0 R /GS2 262 0 R /GS257 263 0 R /GS258 264 0 R >>/ColorSpace << /sRGB 265 0 R >>>> /Length 1449 /Filter /FlateDecode >> stream xœíKo7 €ïó+t´VD½uµ‘0Тíè!É!qêÄîÚnãýû¥^3œÝñcm×—òàÙåˆ"?q8’h'Ä¥ø{øõeþ„’JÕ‹5š||ÿCü.®‡7·¿гÛð¦ôz{Ö›V Í«£ŸóÝ þÞJ|@œàßåÅÝOÃÝ®q8#ƒ>H£„QVê(ŒKRë-D%ޥ׌x_ÿAœ?4%™† 6†Px•¸B1J]^«®Oª<)h›¤ƒI¡É“‚'#±Ðd¢µÔÄB“³Âü)TuðfÒ®"Fÿ)à*`¢!šLп'šL€Ñ¤²¸Ê“‚Å!š4)49+$%ClÏôªIV{étpÄà„±½‰DAGÌ?*4‘(¼9^iÄלTºdét-y¼‚åÖš3æi/DŒ2Nae+ƒ1åH風ƒ©ßÏP/A~έMË`[Ÿö½Ø+zUÖÒ¹Þ¤Ý^ùžõš¯"7†Ò‡ò ‡LÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLÌÄLü¿$Îççî;çíüLeõc”*§›[T>¸¢ŸøÓ=¸QbÁUzbOo.x‘ „rbO‰ËÁ9 zôÒÄfs=€öÒÚ-¹©¯ç½×Ã7q8@>M:¤Ù ±ÄÝ^•· _âXa>Š*ÊiÒ¤IvôåQ~DÕr …œ¢—É­aJ«.Œ9Òo”Þû•LèVÇ4é>[k¥iýkÍmÆg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Æg|Ægüñw=°Ü|•òå«îÛ‚’êaßvK› u˜T ¡k³}8š„Á;¼zÐã¡ep*ŸÜÌ®­!—¨Ý”›þz£ÿÒ¹ånù ¥[¬r ;n5S ”𩨩ɹ“¯Ú-­œ40©Ô oß"½’jI`5Ž_[WJ÷6G]nV×CnðzKnúëþKãï15Ðû•è«\@Ÿ[iùð´Ž5æ±’‚ÅFåRÅÓµ§ˆÓs‘ÆúÈåRDˆÒY´Jœ^‰½»/N/‡·§ÅÅÃ=Áú|d¾tÕíª Ih09¹«Ú±gHÒV§;ú4øhbõùèÖžtNÄÜÓ÷žô‰ô~,ÿ¼üæÏk'o•Æ„NãŒG++—2Æ¥•”R&••§vRI™V&íq,¤Lê*Oí¤Ž2)«<µ“2ʤªrnß%_$\­l³•Îe›k fZµ¹5ÏŠ8Ӣͭ}VÙçIïZ!¿ù¼óœØ[ºýq»ÿQœžlfõ.sR}ª&Ü‘ `þfU¼É¿ 2ÕwòìæúËÅ‹›ë¥7ìI~‰³€S‰ønàÒ‹çõÍWPöÎÿúóêÃþ’÷ûyi¹´½±Q&\¾UÀåX„· !J¯ZÝøÿ0ÌÆÙ<_êyz0Ðw _›·Óµ «Ù¶!ÿÊ Š+a½Î‡õÈ~{g¤èüˆù¢R©foÊÖd9´eŽjw|Þô üÐj£ûVPç¿ð2ÎgÍ8Nÿy¯‘ñêÿ'06{©Ëtèè2@vŽ%N´ÈðJ±4u—2ÉVú4‹¥5mAé²Ë{Ý;c¹´ñìÁªÆïŒ¥I¹0ÿË*?+–P˜_)–€ÿ>Ð$RèÐÂ,–ÚK分.Q¸3–K›Ø¬jüÎXâ¦;Ë*/­ÓOši–vJgµ¼ñw86¿¹Â½èrrŸwãò>`s‰|5÷y_¬ž»Æ>ø7ü 3ðŠ… endstream endobj 267 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 204 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_box_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 268 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 269 0 R>> /ExtGState << /GS1 270 0 R /GS2 271 0 R /GS257 272 0 R /GS258 273 0 R >>/ColorSpace << /sRGB 274 0 R >>>> /Length 2240 /Filter /FlateDecode >> stream xœíKo7Çïý)x´¦ù~\e$ d±‰ì! %NìŒì`¿þ²Xd“£éÑÃ’ò?LÏT³Šõc±šÍTh-Þ-Þ‹?–o¿ìG(©œ5Ó×§_Ŀćååõw¯ÏÄåõ¢ËI%æãõeo~u¾Ñ|þêt6Šÿ-ßÿ(”øyÑâMù¼_tu÷ÍrÜõ"ÎV@ke´"Fiµ0ÙI“„uY}€¨d6FÌGB¼Í~oï‚’ÞŽ!¨CàεqÒeqµX“¤Ò]Þ-ç]!E©õ¤ÀòP0…¨|­ M ViÃPhò¤ÌiR`™ögÕ³•zÒfqö^&5³<ë$™€YžRqë&–'`geˆ0ËCÁ© ÍÕ&“B04<§WMr&HÏZeꪷ7qVð%þn(°8)ådP«Bg_R5 g…œ)sV'…—¯ÏâWÊ[S/„q¬—Öës½ÝÊiõþ•%D(Í~ÙU.)DÐR—Y÷täxñïKÒ³tQ´6'uè6ü»öWõX6R«n£¥Yû«¿«ûâ6f`›‰ïr91ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ 1ˆA bƒÄ ñ“SÝêmu©Áí—K³“S­_nnmðRY±¢ókj‰tS0ÚI›Ya®”UÕ›¡£µRV‰÷‹sÒ /]ä>wKRµù†ÈÊ»}ÛÝò›8[4ÅiFS ZÞX›9‹„OQËK%æBhe4SjôužµJT“Ì ÐJœGvh]zõ½Ukl·kš ýDínWÓ ÷ºæH÷ÙZ™†ífVNlàøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àÿeñZ#Ô|™¨èçªû¶ÁÔ— R‰MW±¦¾æ°«”>eÚ¨Âñ66èrL)¬uB…> G]äNw‹6Qº ™ÕwûÖ[•BM!Z™ê8š=Ë_²TÈ{Šý”-íϺôv–ü²Ã)[|•eÚg©òjÇÂÈ–v‚g½Ùq>´^G¶4Ÿ­•išÝÄÚ’øÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøUü— ±/«•Â\ußNUßJ…ø”±N†0TŒŠÒÛÃ*œdsñ¨‹uéB›µTHÛ,íðÔåÖínÑÑÉl䦿»a¿U-Ô{L¦• µYþ‚åBF ìȘ~¢Î¼QVzÓrÂ(7*Í.«ªÕf¦ ÎûÕŽ…5cú‰:óÝ®æDïu͘2M³›X9á|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøÀ>ð|àøü‡Ö4_ôŸü>Š«îÛ©Õ´SÆiª1XU9n¼ž$¶×“PåjÿÊ_kRixêrëv·c¤;”›þî†ýfÍAë19©ëXZ,WÐýPÅ€ñ†ê9¬62SEE—cº*´S-!Äžx0|ghø^«çZ 3üt¹õ²˜e:›öî†õÖà›†‰Qª:xî¡ÉÇŸ3ÛêBLU]ŽIjÝϧÖÁÏâÁàUÍ6Ÿå\vcðI—¼Xýt¹Öê(íØ´w7¬7ϦpgS([M®˜ßŠ?õ9»à‘&éËëï^Ÿ‰K²UFÌÇZ¹òµZ\¼Y*Î>TQ'éHYf/.®Ä³x¿|uQ]Üm©Kú•xWSs_SceÌÂhOIM¦ê–%’®–ôi]¹&lµ¼÷@Ù’Ö r‘eè–óŒô¥Ž'ãÕù‘5OSþï×YÑjT½}³X%s^×zkç´ý²ˆ·_2ÎÖ9òS®<ºÏÝé#ã*K¦£½ç8Öqqß´#(kCÙ”í÷‡uÏUòp#­æ›Š/™\&.Ñ2Bëv—¹ø•öv&óžzÈŽHcl«‚êc¼Ïæ‘…ºçÎyƒ˜v6š#-5ä)Óœ6y^Ë é>t¢X†òe¦H…²öè½X–eßøI£ìàéæX,·^£ØƒÅeÙZg;Å’åGŲ|)}ªX–u;º)R.ÑnyŽ¥2ÇIƒÇr«Î¼‹;?Ër~Š%ËŠ¥ u›všXš²Ù S¤lYÊü^,mÙå9Ú¦oß6c¹õü܃Å¥õÒÆ)–,?*–e çü©bYn¼ ï²­a˜bIOôzÒ0ž.›£±ÜzïÁâÎÆ²lâUžbÉòcb©éO6§º÷è²™ÊÓ½Gç Ýþ½GÕ?RXÒ›nï¾÷ì=Û·`µÎÆ’^d;ß{XÞz€ù¬ÝÄÖ#¤ %ÀtÛ³ôºÛƒ­ù“îoóê>ê`o2ÿ.Ó³èáÃÁɬ¡gŒÃ§‹“hG›÷;ONÅ£sÙS?ÁóÍŸåÿæc’µ endstream endobj 276 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 205 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_scatter_1.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 277 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 278 0 R>> /ExtGState << /GS1 279 0 R /GS2 280 0 R /GS257 281 0 R /GS258 282 0 R >>/ColorSpace << /sRGB 283 0 R >>>> /Length 131818 /Filter /FlateDecode >> stream xœì½ÉÎ%»r:¯§¨p‰]&É©4 Àì3ðÀð¨Ü‚~öøõoÆ×Dr•$ß‹ ò)ìÁÞõ+ÈX¹˜l‚ÑÔï÷½~ÿûïÿãÛ¿ÿ?÷ß÷ò£þoôvüó?ÿë÷ÿøý¿ýÕŸÿÃßþõ÷ŸþVbù~þÿÏ?Íþ›?ý3ì?ýÍ¿ êüþ¿¾ý§ÿü½|ÿ/ßê÷¿{þûûoÝýÛoÿr×ß¾ÿu*ØÖ1ŸÿÏõþ^[ÿÑöóOûQ¯ÿ:þoøöý¿½_¢üØ­}?ÿ_¢ü¸úû%Ê/_‚­÷ZÌöýë[½ž?ÿ÷?ùcÿ˜ýøññG¿Ç®GåÛ_àKp”ý£Wðwýq·—OxðkÛ?öz? |~âãwÒÛíã+ ÷òù‰Üëó+¿åþ1Çûáø@?Ê¡2á¡ñl?Æxù„ç7z~ŸUŽïL|~âùê<>A||¢üh ïÿc8X•ú£/jÖ à¾©^ñð}:áó®A¸¯öu¼Øcׇ¯}Þð®€x&\Ý? ›Â#}`›‡ìýcì£åç¹Ö£ßûÇ–V+àŒw:oÂ>Ÿ¯/x ÂM}ßõ£tÀ>ÛøÞ÷þq_„ã~àz^&Â{V}x—Îx‚|ž{à£z#ìÑÔõ㪄W45¤ÆóúDSpàmìϽa‹¦êqŽhêQò&¼Ÿ¦ÖþÑÄ}C_VÑѨ?êÓÔºã§ìOSëŠþŸÙ ¯p^|žs!Üñê6>çû*ñºŽú½Ïcð~ššëÇu®§©9ù$Gw²ÏûGí„Ï´Õçˆ_ðЦôëüÛŸ·€MõнO ÑŽf}â¡>ìß;:|†Y¿§¾ïø±žï{ß±ãúQžGw_„|æž~ø!Çóèîßp>î~¾X!ÜÑTxÇÏÞï¢ßñkôk«©ûÇõ4u­x €ÏëÚ¯åóGyšºîx¾€1Ì.?œ‰av]|sÃì9Œavé=øûÕ~ìMØ;`[„Ï#ìÏ|t‰×U8€ø䇟T1•ß7áó¶,‚ÏKУÅB¸bÞ×s~Ú(oè{4uó÷½°èúp ³x ‹0†Ùñs?ÊÆ0{ žÆc˜=?$fã ËAÀ®??l!‚¦Z(? C@¼’|tïÏÐô‡g¼÷Äàp½k#ìÑÔÓßMxÀ[ÜfñvÅs~~«fñîÝ„1̆&™Æ0{àŒaöÀkî ȦðúÐhAqb´?ðŠ¥jó}àÜ€x»ŸU* ¦¯¶xuÂç׈ ê7›ê‚‹M±ß‰a“Ú ìl cã1Ìúâ | Ð¥_b˜=óóóN´B8Ÿþ á=§>ü+áäËÎåŽ×:f†81̆–¶ÎK0†Y,…0†YLAÐja˜=ccaµŠ^œÜ0rÐŽÕê™ +¾¶aÙòÆjõÀ5 cµz&Õ&îêœcCöYâ §Ü=·Ú˜ÍÃ,æåIÃ,&b}8†Ùñv?‹g ³˜y7a ³˜j!V«›@¬V•sû³cµj\ʈժqнêõ¨ bµÒNæZ­ØTǦè™ã°uy`lŠbœ„>ì7b;°1TžÍB ³˜Ôaã:&áàº+a ³˜§.ÂX­býÅ£»°ZÅLtÆj‹µ¸±Z=ófïÆj+{'ŒÕ*¦|øÆjõ@þd7V+N€±)z ÞîƦèyù&6Eñ’ Æ0‹·Z0†Ù)‹TìU0óO,¼1¼ŸmW ³çuÂTðÀX­âe»cµŠ·kjS„%õÙÁaS4cxbS49ç<›¢Å÷7¶{ãÜÜmn¶Ÿ½alŠbàÞ„±)ššsRläðÒ-œaâ×_Ãì1øÉÃ,P'ŒaC¤Æj5qz\ÜObë;ÖØO^Ñ`¬VÄ\·°¯Œ½(VØNnM·dcµŠ§~;6EÏ#+›pp—‹ûÀØMìœc˜Å3BSÃ,žB!Œa¶ 'ŠØtÇÞ»ò]x öÞ•3ácµ ÕÑï…ÕêK0V«Õ¹%^xEbs²0oÅ®+γ÷Õ*:X„±Z­‹sÎÂ4ð„±)Z7Kqn€Ø¹ñtcã1Ì‚º c˜-?:Œ €Øô>'’fq0¹ cµzþâÂl°8·?ÿÆjõü³õáX­ž3püÛ»`¬VÏ?ØAñ߀ÞñïÄÃyŽM…MaïýÀØmØçߨ=ÿ`ñzþaPÜf![1Ì’[1ÌR/ýÛrÅj•ýV¬V©UÃjºVÂX­â› ÂX­â{êËMa‡üœ O|»Ý€˜6ãLÙ»àä¯P !†Ùäx~Σ•?(¶<<.Á›ccÜ„‹c{†çh«Õ3¨ó…Õj]œÍ«Õ\«ÕÒ¾ý±ZÅÛîÕ*F{'ì<‡6qcSS@!\|­°Ä<çïØ-í‚Øø†bž|` ³ég51Ì8{Æ0›:ÅÄɾcfÀ ûÀX­b¨„±Z=?7v¬1ñ9o¬V³ëûb³Ù½ cµš:Ml¹}86ES㪬51Éb Û¢g†š/NàX)ÇP»¥wàÍÕ‹-˜€cíXÆ1ÚîÁ1«VçXËV#n\·ªõi\¸ ONc庴(Ž¥ëY_/ãX»®É‡QÃ3±v¯"›¤gá߯±Kz0ZàØ&]ƒã¿–‘–Ä!CïÒ–3pŒ½ØÞam•nËožt1AÖraZãÇ26›À±ŽÉíCàXȆL=µÜXÉžíã]„c)ÃÏ/Pn\ß<¦VãÍsêà÷Ø5Å~{Ç@Œ½û¾x¾¬Mxò<¢ï—=N/ú¾Ønö>ý|1«¬n=¬nK8–µ~ùùl¬k.Ʊ°õáß'ÌÞeÎ KÛƒË-[¨îïW öP½rÙ ›¨óûTüPaåx ãçÓ^ÛúþßÀü=ã±-=¯Çxl‹SQ¥5»·É¥'p,ríæÛXkÃ*×nN!c™k'çÀ±Îµ‹[ÞÀ±ÐµÁ=`­ØÁ.M8vT­s«8¶TM[›À±§jZëǦªUë30[åz8Æc+z_*:ܶpŒÇ*Ë\­xq7ãXóêòó¾°è=¸ǪWç+Ë^~7Ö½ê÷õù#¾zsê +_ˆ]¸D¸¸\Ž-VœHk4\õ{`þ Ìù¨buêU;áÀ1\)ÍYŸe Çx|pë±Öj}ÖÀZ­v½Ê>S+¶Õ߯2X‹ïu°lž€ÇBX6w®µaÉïE›—À±ãz0ö'cËU–æÓ†›†^´ãã±L®³µÁŽ˜óqƒâ=®.á1­˜+b¹õ¾=+–ÄgššM8ÖÄrùó ‹âƒËŽU1¦IËDzXüû<9ÖÅWãØÅ´l°Òyœ ;°süÄ‹Qùû>8Æ#— â¥é}ypŒÇXfªpŒG_RÔx 0ßÏÇúËÚŽõ1–½.ëc‘±#p¬±lR¿ëc,«·p¬±ì^±‹eÙøyQÛ³lãœ^Ÿ‰%n{ööïƒ+ÀjÆ€ÀœŸü ¤Àœ¼Ùžô[1Û–©*ð3Qæx‰®_þü³>6îWþdÏúXíc"\ÌÑÞÔ~ axš¿;0׳Ž/˜ãóÁ}s~zðÅöš?¿ØÇ×3±—hOwÛÌñß+oìnýž¾70÷Þ˜ëS‡©)p¿…ûnÆ× ÌßëÁsb Ä›Ð!Üð2ŽÛ¹}é÷|ð}߯kó÷}ÂÊö8þ:ö„9ßtÜúæ|Ýñ¢WáÍö¸¿é0ˆæïõàÏsð(øîÀüý:&^`¶wǃÌß3n×60Çσ/¶§ß÷Ž1ðÕ…7ÛÓï=qÕ¸‡Ö«¸bc{úý'ÇãÐz—llOßoqaCe{ü½Ã°Ïö°×¯£r=,pîl§žÀÛãïV¶W-¿Ùן¸c{Üÿ=x°=®7qÇöøû…Ñ•íq?4.ŽGÏÿa…]¸‘çïfØB<…g#¾„÷ fûw¬À¼°/ð–8ÿºo|ǸŒÿÑAàßl\Ö°c·ï_ß[˜ïïW‡Éé¾ÿ—îÎÿ©?Èÿ‹sÆŸ~q©øÿÿÝ@þ…þ¹T°Ò¡AøõxhÑa9œ*ˆܸ›x?pë®Ân ú_éRyña7äÛ+$ùrûȤ[Èû‰Æ ?òù•ˆKÿüJ¥ÿò•x£þ~€øøÀÜŸß™øuI•í’Óï#ùö y¿Ý>Þïl·÷tûx?a·üÄ_ýíŸÚ³;ûïþgÞø@ýíŸê?Ïå°y–ä!ÿýû…k™JóÃ×AX1m=§üçxÖ¸¸¼ ~ÆGqûg.6Ì–@«ú(¸˜´ÜS¤[ÀGÕ'¹Ò†r§®?¿ýõóáŽÙ2ÆIÀ©5æ64Grü~ÑQÇ’j.¦1Ë%xZÅGE¼U§\çí[ÀGÕ'¹Ò†r§®¿…úqxŽÍ=C¾>)1Ö+V™FG•/£Ÿø4óá’”²‰ž¶ýiP°5KÙ G¶ ÄO«oñ¥—dO½ù]žïûüºýU^Âsþ¹±l ¾E7·\Ñ×Í=•¸pÉ%З0ÞH’{ŽÄŠj•à'ˆ>Å•6”;uý-FÒ_¸ú8•>¿ÕŒ¯ƒò¬™Ñn㮞 b a°>§ÆX!ÍÇ5Kʱm~Z¸NXöÂÌ붉øiöm¾4•ì©·_jX$[8Û½Ô¢ÀÒ—8!uÜöÀ3øâÁ÷(ù°¦¬Úö§AÁ |Êâ·Ì¶ó§Î¾Å—^’=õþM†UÁaì*^“RùcV„ʳÆVXˆ?=ü(“—“”*^£M¸Á°ì€ï£Û&â§Ù·ùÔ˲§Þü. vâV7`'áÙ=< N­·$q]\ ¢¯Ï0sÚ–\‚šVHËa÷àV~RôI®´¡Ü©«–\:Õ8¦Ü\D€—ëa[7¼'n|¢£‰+skœß$g€VñÑ$<¯¬åðë¹ÕüqÝ'¯z܇®zpK¤IõMÀ¥ÝóÊ<'‹aÚŸþb›êwø!š»©åšw„/~«”ãUªZ­mî“ÜTwe‡®zúðH©ñ>}à+pãdà9I߸ŠÐ2»Mq/ìC%'€VõQ`K´î˜Ý*>ª>É•6”;uÕØçù§Â—ïë%4xZ†2Ü=<m^› `”ÂiÂ\XU,GÀVñQVœ¥$†áV ôš`çA®Ô£Ü©«ž><^ã§jzúIØ5Àuã燭üüxo‚‹›SË%h#tàhb9xD¹Uí¢Ð'¹Ò†r§®šEi ŽómÑ‚öRîgÊ-8¶o‘@8 ÷\@éAŸ|X6R6Q)ùiP`7JYøneÛ@ü´ú_zIöÔ›ßeãI´†K—¯Â3ïn®— ç«Í¥”à§¾5úâñëA÷°äò[‹‚û ”…¿€›øI-Ð1¹R ‚ çTЉ«S©fÏ»x_݈G¸á·% ©4~&œq$gÐs*MÂ#a¹†ÉR­¶œJÕgÓT*õ‰]?ö³û ðà¿‹õ=< †W‚cO!.w ’K ƒ‚ ôГ\ÅÝ¢Z­>(¸Or¥ åN]‹-Ñêÿ_ þ‚ö¡þÚŒÂBSrÒbG‡úâRAÉ  ÕCýµèÊ9ù§±U‚C}qS=\¹ºjö„/M£KÁ×AhqG[‘0ŸÙ$Lqˆ‰1N.–@«ø¨X²-‡ È­ÿ¦î“\iC¹S×\‡ã*¤`­ø:°u?SU\\¬7š¼¸^Éݸ£œ@®I/á™4(W7\°Øª€&ÎÚ’›ê…Ü©«vA7­0Èí$<›“7y,}3¾|œ=ôœâÖR\^)RîõöGƒðl`žýäè$ V ~RÕL6”ûÐUêÉ6ƒç%Ķ NŽqDy~O:1 üä8‹K)váo¹ôê‚· ËÁyÀ­Î<ë¨Or¥ ä>t¥úãÆc"’ïë ÀQfàú7Àó@\Ž¢£‡pßÉ…¿¬åÐ*>*£ %ß"· €ªOr¥ åN]õô/ÚÍfl'¾>qzÃm±·³7nÍ.Ç¢¸ð ´\mëM¸ãQ[anUŸäJʺ~Lœ»ÚcâÜ›Á70eÅaÁnIðNœærj”œÀò‘ö% Šƒ.CÐ4§¸©^kŸºêéãö7¾ÞÒF¸¹/^‡'Ï_~4=§²’ ŸzË ÜyÖIÂ3KZ¾Ín@gôInªr§®TŸÁS˜™–/9Dx>ó€ÉYô™µ¯‰kÝ\ÄÆW\8×Y.A]þè­¹²I.žâó–³UŸT`®äÞ<ÞPîÔ5gáéöu`ëXti¸¦²€¦“¾L؈”œZÕGEh+åJŒ!·  ‰}’›êµõ©«VÝ›¤áý¾ p|Ç3ž™vÓ:N ƒEŸÉ¥ë€ä†'ó—ÐvÊáVÀ­vï÷Ý'¹©^Ⱥjâ\¼>½¢Å¯ƒp#Ü!w.̆q«I€Ÿ¹`DÀØHÉ\^áL@@¡åF|m·:üPÜ'¹Ë·»³|êªÁCÿG¿fñÆñm˜ïÚ2ÐĹ¯ä.¯ž!'€V5q‚ïWËÁ§Ç­ø-oÉ•6”;uÕž¡”•îY_Iˆ÷ãÙðÝ”Š—óÝ7<é°;i˜¡Åm¸m•€ZÕGEhSrñrήV~RÝ“›ê…Ü©+Õ§ /¶]²¥›€UZû<ãs"`[X˜Û±s”œ@³Ý„;"ËÁ‘Ö­¼Fs¥ åN]õôw¬>ç_„…ó7æJ¸O2Ô®àÉmî5ä´âoÚ¹þ]#åàÍàV‹÷±î³h»¶å>tÕ¼ßylÎeË,?Þø:±0]Øxà}Ä,c.æË ä²õžÁrX˜Üj.[î“ÜT/äN]µiH³Ä¥MƒŒÅrÉ$¢ ÌX¢Ì­˜3hÞÄ›óåà¥êVdß½š Ö†f‡SW©ÑÌ‚—ú냼ȌýG¸×ò‡@Öá«$.g–KPÒ< ÂÅŒ”cÈàmûÐÒGÕ§ m[õS×|uñª!Öçë àõšpPÁºŠ—l èQ’ W'Ë Tï^B¯)Wâp«ÅÓ±û$7Õ ¹SW©Ð´˜067Ì&ÀQpÒ “Á“.–šN°!·ó}¤\·_Íîþ¨Ïh9ø»Õæ‰Ó}’›êµù©«6 ˆZ†šê‹@?ùPIŸÚ ð“û‹1’ u˰U}tç‘Pr•æS¶ZÓ|ª>Å•z”;uµÍ¹Úa mÙœ“w ¥q…°–Š)—­¯{ñ‘„ e5[‘I¡–­ˆôpÛD¶P÷õò©—eO½µêœÑ†_àB;FN~;Àê˜[9f.v>–~^³¹±F—[í~Ü'¹©^Ⱥ¦Ù!L¸s»lv& é«îÛ&oÙÂl,."©$g0­þKxÞGË!v­޹­RŸ ¼êõú©«^„ÆWÖ쯃ÃÝ8qEp}gx ÀO¾3£$—Þ3’@«ú¨aÑ¢‡„Z=Þö)nªr§®¿…ÁóÂJ‡k>®a/ᙵ/,}¸ê{p,}?¹ÙhWr±[.A›þèâ8{f’›HP¡V tNˆ>Å¥6’;uÕ«;¹+Glñ×A`j¨ÅûBxôúiø”q'wÃÔ$9´ªŠo¹äpßêVó6Ö}’›ê…Ü©kÞvÝ::Lßv€óÃ2qZXÖ6ðýÕu™â{6J&º}úJ L7)‹k&7—Pî˜\©Á…Óî¶‹M_ïá˜i–ÅʦäûË㜹8õYN ¯‰_Âóê‘©C­ Èî&“npS½;uÍMœ ƒWó&®sŠŠ0+d 1PtÏ$ðM.ý<%'pÛ@jÂÅÄS6*F$˜Z½l uŸÊû@m(wêª ÄC+òêKÂ3.oìçãù6\2×ià«ë‘\„«[.Aé6™wÚìžßrñ|WS«¾º®É•6”;uÕ&o?ö^ÚƒŠpÅâDÚŽÏ™çÛËó\ØUgrEh9a[àKxþ±Ý*€Oš#¹©^©Ÿº¾6gù Ì´97œž¥#BpoœJ"óÜ䩺û%86žŽ–¨vPy ½¤³nµØAÅ}’›êõò©ëo±vý¥«4J¸AÒÌ#‚¦–Z·Ž´×Ü–Ü• x’z å’,±U­ èLm;m=Ô+×§®R¹^pÃ)+va²¦X±«RT Û‚€éÉE¤œåØªŽ´#ïN%· ¬V ô›FŸâJ=ʺæñQgBy\™€$O³q¥ºu¤Å*u{™ ¹_–¸|5c’Y¥nuøjÆ}’+m†ʯ®écRiEß—}L*ÇËó n.Ó77db*Õ„Éå Ъ>*Âó P.†ÇjU@«É½’›êµõ©kNœqißèöÄ ÖCö RD ÆãxÓÐ’»i¥œÀåÁcBÎ-‡£¤[<î“\iC¹S×sæ C½-?Iˆ\¼íj73bñs{+¬Û.q\&¹e3OëGI¹Îd`l5w¨î“\iC¹S×|u㲩̼¬ -ª[×qw7ÐûØKroî –|×p«ú¨­¥³I¨Õ;/ëÔ§rMX=^ò½ºæ…Ÿá$7àƒ76¯a¿Çt‘º°èÝ„«¤+Ñ• ÚMà%Ô–rE× hµx/î>ÉMõjûÔU3Ï¢IYå¾ü*'ÒSÄA¤¤Ó.NÖÁÜâÒá—rÍkÑKxž¢å˜Ê­V¿Qî„W½GîC×¼¬k4"iËf ,úeT)}2tW« ©a%g°<"^Bi)7c-p«ÓçP÷Inª·Ö§®yÏ~Ñ¥æ=» 4ácR៸xoJ ë"ôLî䣡\y·‰Pàÿ#¹‚”-j•@×Eµ%—ÚHîÔõõõ¬¼[Ôý ÄVðõj<öjäsàž/I|S6Qó©Q®¬–q4϶‡OîÙ·øÒK²§Þþ.7-/wì¾N <>"ULãö¥¢K·ée©`êËGJ¼”BÛü´(ÎŽ–E¶‘lûòbœ}‹/½${êÐ‹Ë‡Ž‘& :~1V²`š_²ËvãÕy/EîàU冑&`š·¦Ýj÷1Ò}’+m(wêê˜'[ÇEø×A¸'¯tü„`3äÂãªHד|äMKY"¶ÍO'%n6$Ûq³î¶‰~J“k¾üÔ²§Þš_‘á-î=n¾!& Ì\ô¹qQ·èArû%ò Öän\nINà:&MâOrHBàV‡·!î“ÜT/äN]‹SÍÖõkÞéí¼n—ŒÈ¸òݰ¦V^uÜÎíåòNÏ€vÞ÷•­æžû$7o‡CîÔ5é2Bíôáëìù†ßÛRÔ5ÌÞ±j–<ÑoÜÌšËË-ÊÔôåHBÛ)‡ÄÓnµØ—Ã}‚ðª×ö§®û›»¥wz$TÌÌ“¡hž«Ð©ú.`U]’«KÈ °U}T„GÉ:Q°Õ’.ê“„W½GîCלEaxöá3«Æªv‰Z* }Í¢e'Ù1,'0ìÃgBÓ¤åVÞ­vûð¹Or¥ åN]õô/º´¦' È f;¹Þ­xñë6øÉIjÝÉ]Ü»QN =iL@¢8ËáÆÈ­¦'û$WÚPîÔ5#ض&£æ¶Í‰³q·995"ð¬­6ð/!)—,'p9Ô¸ Y»|·:|%é>É•6”;uÕUÆ¢åÞ½_/¡Â×èZôšÅ»vaÏ)€Ã+“¬p3,…rlU¡wËì@Õ*ÁO*pïä¦z܇®š8;ò¸´î ¤—ð¬Ž&ÈÆäSÌ# «ÛÞ“ ƒ¨åÈèkBÃ¥‚ä‚Ë­6}Ý'¹Ò†r§®éz¾ŽUìz¾xÇöl7“ÌÄ•œÄK5@G52·Ó½‘rËï£ È7l9Œz·:ϻ͑\iC¹S×7Ò?,Ü}ùÝM  ï;fë‰Øû°q“2&Ê|XRVhåmŒ)“!Ä’ !VÛÓëJö-¾ô’ì©·ÞãÉ' b_„›N¿ôóäZœÄš£¢RÌ›«Åƒr ï°riéÃrÉ‹Ô*NC0#m• MÑ)êÕõõŒà¯³kzFp$=Û@æ™Â},}ª~ó›n‘äÊ£™ré4½«?*Â3†%ã¸U½3e$7Õ ¹S×¼ÓC€#Þó¯—ÐáÑÅ´j.À•nä#TÜ'š_¹†¨[öa”ÅP=Ê6Æ,¨m"Ýêõi‚µ„ä‡ÊéYÆUz£}dŽë\dÅÌŠûL{p«1÷‚YPrÅæQn$7•ÜÒj•ÀWÈ5¹ÔFr§®ïF‚w´}çF‚ëøsjX•ï?Rf-$òÐúT{r;/<)'Ðì;mBõ¹Nª•­VûN»Or¥ åN]3šùÒŽp:šù¢‰ ¾1 “4Ó÷·¤¿UWh„R8cKN ý­^BdÌ„\e@M.º¿,#¹©^­ŸºêéwlLëÌH’$0pwѲ‘$ƒ”•'\¦“GbË%ð W„!—7Tµf«ú¡´»ª5µ¡Ü©«ÔG ‚µuHÂÂ&EÑâ[ËV ÜÑL.ö-–K ½™ (Èa9ØÈÝjšáÝ'¹Ò†r§®ùê–ÑIò"Çf,œßâ» ô>®ž\MŠ]¹‰ü>Š/8Ë¡ƒ[mŽ$qŸäJʺʺ ÌX+w¡/!Ô(ô .P ÐQu`Ú€ú)— 5tËt}[.RW·J Cp™&XÈ}èªéÿb˜¶î_„X<àŽha¸íÇæ‘3ôd¨¹er  n¶ï–ƒ™[‡· úò%\-åN]õô+}¹f^̈€;œð>xˆÍkÀ ŽBYæ"íµåf^̈€LH–C¼‘[½óbF}’[íjF¯ßWW} ±èUÇw7|&ˆ*†^XöVÆÕ]Ø0›‹Š–ȸº—ðp$7áá¡V ~RèSÜT/äN]Ó8½õÆ¥q¼@K ”°Y“‘–—GDT2É]ô€¤œ@ÏÃZêL98¦£Bï CŸä¦zu~êjƒ.jÿ„ Þ2èŠ'ùȧ¸ž0U&X!âF·r#"~ã†E²BÕŽ%ìU–…ý$Ûâ§‹óLÿÕ4d?ôÖ{¼a”iÕ‡aPµ‹Ùs,nµF5òÆLn‹à+DÕLŽT2[F|mË¢Ñl»8ìÀ]ƒ`¥ ù¡r(¼áÝ 0Á¯œbyÜ/¦¿êÊY…៭§œ@ú«¾„X^%‡ Þ­¶Œ£QŸä¦z!wêšÞ‰7Í?ý¶w¢Bk"ĨÙÄÿ¼a—2€èuVÀNp•9„rÃn=_çBQ„&u{Ö+[¾;wŸäJʺ摾ɸQ|¤oÌîÀ³-ÌÄ݃äŒ3ݽ)ȽèMA9Œ35íY.‡n5ýöÝ'¹Ò†r§®ïFÁÕky§AM@ hÇž®ïŒgr±(¹:Þš€™ÆrHTãV¯ŒgVŸäJʺ¾Ñ亓›M®;¤á€qVá{ys.õïíí{·ßƒä^ðfì( Œ®–cruµZrÙPŸâRɺ~¦á€Mìëƒ-J‰ÁäæJ˜p܈›‰6V9€B!L¨,ûG9–çR«Å•î“ÜæÛñ±>uý̤€ì„g&–§PVƒ[¾Beê‹«\ ”È,ˆ/¡e‘…ð·šáfî“ÜT¯ÝŸº~>ýêè’÷+^ûxúuO¿Ž_ž~Ç¿öñ°ýH“ðª?™p?Ÿþl¿<ýÙõ^õÝê©~¿” t>•¾³£ ~s±ôWcÊ%С֗H,m¨K¤Å‚™¼DZ™dK—HäêÞˆr§®¿ÅØêÿ¡þêÿ¡þêÿ¡þ_ úÓ6XÅ;ð;wœ§úäJAUÿ&˜¶ù›?¸÷k·q<]V¾¬e¾+ɺþO2uV»3“‚(×0‘–+s%ôe€3È`x-¹¨ºj9;3)ˆ€ÜÛ–C­·ze&õI®´¡Ü©ë›AG©hWfйq"»ÀFG¡ð[½|H²WëMqroú®SNàN¯Ö$´šrðžr«é å>ÉMõZýÔõUŸÈr0a†êB±šÆšXÑÑ2°ú#¹©þ}Úîý‹ú½§±Ýêeç÷Inª×û§®yå{ó.Vcÿ%L8åV^7uXW7ð=î6G%÷‚’þ»…VôÑ-Wpó«V dŠ>Å¥6’;u•ÕN;q4“Ó˜ öÆïLF_æ?%€} žÌe"Õe€ž‰ D@i;ËáÚÍ­æÍžû$WÚPîÔ5Áz9 ÕxßlÔª(0µY-‹@†üu%wóþ‚r—}ü_B+)7FM­OÇî“ÜT¯•O]ÓŸ>ìGïÄù&üéëí©ql£É‰3JxçLz!²Or/Ðà1aèêfä\éVsâtŸäJÈ}èú[Ìûïé}Í_- ã°4”ìˆàÓÒPÒ6"¹4,¬3–ƒzXî;[ø´4ܧq¡ÕO]ó²´3Êfœ |1ëøÆe)¼@¦mkÐO„\&<“œÀ›R ‘ Pr(iæV¯´07{^_÷¡^-ŸºæÄÙéi§§o—ŸÉ— þ»kñ*dùé¯íÓQ ³¥œ@ú¿ºÕT¾‚±D,_êèé»OrS½V?uÍX’ÁËTÝ´¿„=ÏÀ¸[Þ·:*¼ùa!ØEr/ðM»ðè°ÊÝjuÎF÷IîrÀÄ#÷¡«&NNS 1†_„ •Âû†Üh³³¡¸›If(—Ài"H¨ð,Š fµJ éXÉ«Y”r§®ºž¸Íbu"™Gï da¸ŒP#dþÀlˆÓ\ÜÁYN Ý¢_³۱ì‰n5Ý¢Ý'¹©^ퟺ~æl„cÍ™³qœÉn/– ¦ûå+}ç^$WYǑ얭3ÏîG²ÛÝŽd·ÇÌ#nª÷&»u«pnõÊUêk¹]sMSp˜B0L@(Å…7äÜh*d' …Jl ùa{I9 Á0¡–C…[Í ÷Iîå×2äN]3ãVòÏË!"ìá zbÝtuÎTSžÑ[A\e§\yj™€k[ËÍØ¸Õé͇û$÷²ÇzȺ¦ãg§OÐ•ŽŸþK )±ý†×kgè&?ØÌe šä–}#L˜(-¹Þ4nuÚ¡Ñ}’+m(wêšÉtÇÓÇ>ëALŽý…Œˆ£ £éÌ÷ _în)'^B©)ó[½œÎÅ}^ÞšÔ”;uý<Šm;~¾„g@ûþ¹l|»\ò9éî™\¶(—@Žf& £¬b@õQlÚ#ÊG1r¥ åN]?×ã÷é§‘´çIòžçÊù>}­«ä¦Éö­âq¿O? %O’÷¥*eœëñuÔêÜ©kŪªûÜ>ŠÕL̶`®g?RõöË@ç«R“»ýß=Á™_„^,W§Ìdý2ÐQLÙ¸‚›êõò©«&Îïõµ]„ç%<ë\$u͈£›Ž“:Ç›ÐOW™ur#1ëª8ðÝ®5½a#PÄܸdB‘—Àड“ãÊV3¡ˆû$7Õ«íS×7ºRŒÌ€®ƒ½†éÜX0‰µj`kÓLîbDW—×ðhnU}êJ¹ª¹¹U8¯‘ÜTOEÊÛ*Cï*>ÝJ¦0çðó-<~ß Ä›—6èU¹oÄïöå­åE"`J”¯)[Uä¶k¹oó©—eO½?M*8Á}}æ8ÌmÆöñ"ˆ«iˆr ÊÇ‹°áìiq➆vÚ}5 ‘›“⨟ºfJèF—J…Þ™0c7q)„ª‘H‡>ªn ËJnã…ån‡Þ½„6Rî 'Z·z9ôÎ}’›ê…Ü©«ÔG¡4x’ióŸ„g6‘β2ó¼fPíêL.µ‘Ü©ë¯÷ï÷‡Ïá-Ç{ÿ¾Þ›ò´[¾÷ﯟžär3wøÞ·üôd‡ý°ÒŒOqsËvxðÍ7%t‡M FZ¿|vK1 bÝØˆï¢ð2­Ç/[^“/¬pwK9¶ª‚€ØjÉ© ÖÌwøì‚Í?¹Rr§®©þÍ×h«CãÊòQÀs:‡¼ŒÞ}1ç%¹ˆ\¶[Õ,Bë–“Nl•@ÇT̰ÆR¯õO]eÍB.½0È: «p,‰+‚h"Á(l ×Hnw‚”ë¶û: kêJ¹D«judVõInªW×§®y‘Ñx1®ÝóK¸qÇí2Ö™©{ç¬ä¸ð‰°K¹h÷l¬\–±”ºÕáÕÚ}’+m.¥yuÍh‘{Ûûun¦ãe™«¸×eÌ]ŒlbºæËg"@Ë ¥å7)ƒ©|%;húRÛã5©ï¡T¿÷¶è‡Òy¯J³²©›ÐqùÊ" …r-`+Ë莛ÅeÉeÉ ´Ìož„ZRIÝjõÌà>ÉMõBîÔÕvD˜)Ú30Ó&* Â<‘ç©Áæ¹_‹ˆk3±‘ø0¥¤¬P{m¢I)å•­°¶¹íê Ù·ø©i)¿è¡;(=·²(ÒåZt7œPn&Ö­ð’éÝ@û/W¸Ã%æ5RN`¹0ÌKˆL)‹‰`vµ* +‡H{'nª×æ§®™ 26z=3<š€lgˆ­SÇñÿFI5èèfÊ& (gð–ZéÜê°ÍÎ}’+m(wêªùˆÆ­(i­D:IXHå²8õuäpÒ :—£|ú:’A­q€šU<Î3ÙZŽw·j5¯¬Ü'¹Ò†r§®¿ÅÕÌ‚« o}B½~ Ç¥ÊqÆžé‚KÃ]YÞÖug<‰Ð,‡„­nµg0ÜeS#Ñ[I¹S×7òR™¯–q¢„¡¾ûëÅ'÷jôSç9øuž:v{eÕ–ŸVÙ°q½²¦}·=¼÷ξɷ^”ýÐû]˜iC˜éaДöƒ Ô˜*g3¡S7Ðj[¶ ‹É)'P2%ÜK(—å ¾©Õ’ùàÔ§¸©^¹>uý0k•,rcŠÕ¸.!ò‡ÉEp˜µÄ¥áJroÒ…$ôšrȈàVߤ Y qÎC½^?uý-Þã?ÔÿWE•î­9£ÔKØðô¼h^¨öR— PÊÿFns5à]àŒR-ËÏ”ƒ¯Ÿ[Í2î„•Ùè®ù©« ê“õFz–&IÂf-¹ÚàzõF†ÍîðD¸™·šr/PŽSàsb¹†â#jµeiõI®´¡Ü©ëëÛÛî‹TÈyø€G§0rüäé!Lmâ28]r=ã„EhЇ"æÝj¬sŸäJʺf~t9À¶Ì.†féXp©–fèó°¹ÈRj¹-ó£OmþgÊax¸Õ<î“\iC¹S×_-Ò×ý‹EºµÃ"3´À§EzÎÃ"ÝÚa€¾>®òXšïµH¿1¹÷k·H‹tÏ«<ɺþ3Oípïm×Ìt²¦0ËPÇ(ÒÅvV´&Â&åi3²˜±“²BýpP"©ˆei˜sÛ‘}‹ŸšBöÔ[ïqf°›YsžaNʶY(}àèJÜÁlΔ.½¬A÷jM9¸°ºÕtpuŸä¦z!wêšw›Yt)l¼pöÅD~p×Ù §hYNp£Lµ¹Ón;½'è>²½„RR®EãnµùÈæ>ÉMõJùÔ5ÓÉ.f@k™NV„}yéé("·Y®g9列1’K Û» é^$÷€²Ü*Á±Ü‰«jr[Y^_]3Pã“P.¦— äŒLé?FVæ}—àÉ&äªÄ/åèšÂ.Á’«Èœ~»\qÉ*k$WÚTeÖ{uý-¦¡>yÏ^}1fRw¤®üûba”Îqyá#9š¶÷$Ô•rȃëVKÚÞÕ'¹©+F½º¾‰é®ÞV&B$aãZ²0ÐhàZr^¾–¬ÉUá%Ê%hËÝôÚº[Ê!‹ˆ[Í‚î“\iC¹S׌ X ÈR8¡ ôÅïÌþË$l:$ÝŽ_ wÿ+¹˜’È +& ÅIM•õèÙjVXqŸäJʺjðt—áòU^&–÷p4š·.ëÊ6ЀVù¯Æ»†r |•'Ú³\—NÙz£Ð'¹Ò†r§®9xóüË|hÂD’Õ‹Iª¦_t­YYSý¦{ ¹7œì$'pgMõ$´™rÈËçV3ͽû$7ÕkóS×L£Ì´^u»˜d´Nq»<ôZÚj6½šÅå–Üå´M3´µ¦LÍn5 Ñî³zMî)wê*;úÍ 1ø{|ø| ¾ë a cñü‘¥º 鈻¹%¦œ@–ê~ ,pxÓîêÙêtþ+÷InªWæ§®éZ9ž”Ãô%lÄLŽýç EÀmð“§4¥v»àÙÅÅ%—@v.xØråVÔê°‘Ë}’+m(wêš™ S»:mÔ²ßgÁÉqÒ CÉfµíyËfÂ-›ä –¯ŒM@ZXËM$†R«3ÓF©Or—=B#mÔ©ëo±êÆ…>÷}8ìñ&Jܸp6ìÅ@ÇÁ}'wÐI9f%jŒúù:}ôlµ:Ÿû$WÚPîÔõÍoþ¼]!æ ,º”IJ2á(f"X‘t+ù¬;kÙDµç§AƒjÊ–ÑPÛ™í(û_zIöÔû·Iüÿ×ü·rbïð냰PÙ³1Îo°æg3À<9y´%—Åà$—@Wù.·ãùI®ÀKU­–t„UŸâRɺJ}Ö—næ^ÂóŸoZv¨ªq_ôÅ­ÞÌݽȽš7äh3'3£KŽ™ÑÕêÊøxõ)®ê%SîÔ5}‹#êy¾A"0¸¢Æª‚±-ÀjXz"­Åí®PrÝÉ”!ƒ+$ǰ µúe¨Or¥ åN]Sý¥L§Ûê/eeE x¿á9_™µH}81“«ìª”XvÅ| ½Y.ò®.·J õ£OqS½Þ>uMKnaÒÞš–\é=é i^‡ Èæº{r7¬K’KPÓ’;˜Tc\)wÅ-[½2w½ú$WÚÜv:½ßV5ö=Æ5ó¼„gOro?Ÿ¹å²Û3ÏÍp0qY˜Xr J¾&‹ÛÏg±‚aÜê}ŒýR“+m(wê*õ[ ±¸Moô z 1ƒ4VűõîL„yÛâ}% 5,—À@DÀ¶ßr=[íYD}’+m(wêš÷§…áðû&,96iŠk¸élÃû–'a‘£cӸܪîOEP­*fÔ|Æ™[½=öÝ'¹©žjc·ÕÓ¯¾Ú¥ò%¬Ì ´`qµëióþØŽ©äÊs¾¾1jõX¶V9³Pâdë|l»'WÚ”# ¥[ÕAæ¢SÚÌh¶‹þkÑlp[¹bi¹x½N Óɸ’;éC9a ôK(#åàEíV3rÔ}’›ê•ñ©kf戌ÀQIávfüÙÇ Àóµ/¤­øy̱äV˜Î)gPíÈôT³á6bÜÙj9*ª^Å„W½R>uµ“”4dWùú¤ÄYµ(†g x&ÜFÜcZbůœ)û¢òúA4šâ¤kY¦kqÛ³’}“o½(û¡·¦!–rÙéÒñžøfÙ—°‚ÃI© ¼q¾âÒÿ‹r/Ð9×øcX®n5=9Ü'ÖrºfŠšªb›Ã)j” [{E­c Q ÊâÞ°'á~–#`«úèÅF–) Úín•À— %¹Rr§®y¢ïr;­>Ñ‹ÀÒJ±ßðƒzÎÞ¨~ûé?'óv™ð€¹-÷-Á& Ž’åz<_·ÚýôÝ'¹Òrºæ-Æ ¥@»ç—°pgŽR\ˆ¯ˆÜ—ìN½&Wu,(—@»g`z±¼TÝj:ºOr¥ åN]Ó»uñvD‰"DˆÛ²™)Ê;®¾|ñMc±;ó‘=e‰Ø4?”Q“lÔ©)Ù6?­ôè ¼z>¢J§MTæy¨›€ý]ô\H²}U ×:“{Û«*ä2û² ØZ©‘Ýjf_vŸäJʺÇaÕÅ^ïq˜¾Ð:WºIÇN¬"Õ‡P‡ï—1»¶d…²$óA‰ÍšeuÀUÛg›}¿àýÊžz{i€sgøhL%¥s`L»oúíʳ3UzsúæÆaܲBíœìE©×+[9¨Ôv}•ú?5…ì©wÞš´VÞ^•^¸!ÞªêÛÄ{hôšÜÁe‡réœüZM9T@s«-ocÕ'¹©^«Ÿº¾«t<èûõI‘`î{úÆ…:‘Wé0û‹'û²/jï§Aé,”&ÙN_wµÝ]Ô"û_zQöCï×k…ŽÏ ¡1‡wfÈÀ†w1í±ÝÉí̾W•qU·ªâ°ßÊUúÞ°U-è(TH.´±Ü©k:+;¹t­MÛs¤;hñúN†1èК «8 ãœdú£"”’rØÑ¹ÕÜï¹Ï¢œR¯”O]ß—ºÑÿ¨½EÙ|•¦^ñ×,ÆbÏïøE£ˆ±ù ÃÚ²‰²D³(¸½NYf™sÛé=”}‹/½${êý¦$Ñ:µv¦$7@PÖ­±ÜtCøûëˆ.1¿³®›d»«¼­Ÿ¥õ” ·‚•myEUÁ6ðSÓÖÑ[7±~ÎÅ·Q& DüB-‹›‰:›®WÇJ.«-KN d|@ÊÌ|–[U¾V3Ðýn½’›ê•ù©ë¯.,½|¸° Òäua¹êáÂre•?¹°\°”ô‘r dë0¾¯ KÙ‡ ‹ó`¦ KÙ© åN]¥~aÐh÷ôúXƒ¸0"g Læ¼ 4‘+—Ó€«Ï¾S.‹G‰€µÖr-îÔÜjË|hê“Üâ”O×þÔ5W7oDšW76ª-{Ó„Ý©7MÍK–7Mp˜ïµl‚žõ¦éJ9_¯zÓTýM½iª© åN]½iê\Þóÿ Äe{ô™ä=|¥‡CÏ«ü ÌñòñOÊ&*Þ4‰Â«zËöÜp-£Üµ—ß½Éí½u ÊL­®n%âio|du¦»0¶+‹Sß°xš[%F9,NýÂè'9¼Õj§vŸ ¼êõò©ë§Oæ¯ùI&ŒOoª“÷²bþšŸdžùI$'ðk~’‰£åÎü$ó×ü$óÌO"¹S×âRúY³—Ò·tJõÔx¸”öÃ¥´ž6®Ïð\_—ÒLÂGpÞàûº”ÞŸº~ZòºKbš0Ž k2Öø%C†¸²Õ3CÆ›µC„vfÈho|…À¡¾¸Ò¦2ú[ó. >vI0§”[±¦¬°ÕÑYrI¸§JnF°†œÀ°K‚ pA´\GÈšZí6Õ¸Or¥ åN]ó„3ý“@¿myà„q­.Dñ‚so}ù›4ŠÈ3–)7¥-{㋹í; ê+É•s{}1íŠú˜€¤â~ñqä5ûìÚ3÷ÜÎ8åº-¯/¡Ý)‡dänµ¹*Žû$7Õk÷§®ÔWè% ¿P‰/Þu®32´i€Ž&“Š’Ë“‡äÞT"`²´bÝê›J@}’+m(wêšñ“‘f3ã9¦bßj,Ý&žE}W-ùr/¦Ûlm)'p¹®ÞK ƒë¥B‚=[ž«Ü'¯zJ‡[ÞV•íòf€ÝlÎvy3rY .™±z#¸t-m-•Äd#݈¶L}%è/!"ÉîÜÜÔlµysè>›\J½r}êúëê5Ú/«WÙÇêu÷cõº?§rsõ*ûX¬ÆGA«‰lƒïêÕê±zµ‚VâJʺjïpãÌ<«3¿„ÊË‚ wa%­s\ÉÅ…»å(S° p²\‰#[->!¹Or¥ åN]30=¼¼žßÓu"L%hŸL·áÜÖ·î,èY&.}Î$'p§C]"‚䮸ÚnõòCqŸä¦zåþÔõMŒ·>¼?~ñâX=ý;îØ8ÞóHÀÞá4f¹öþa¨Lô›DÝ­¾Þê³*É}ú”`ð`w}¨ÿX󴦯lÐg†xlþÍeuBÉ%p†x˜!^rPЭ¦úî“\iC¹S×L ‰Eb§Uˆ„ OýyùÄåýà* zäN†)7}µUhº0ľ-W`¶W«%úêS\©G¹Sל8÷¶Ñÿë ,L»L¾Zaá\ÌËZ3Z!îØïäNF5SN`Ú¾øXÆBW ,cÑŠ&NÕ×fq ©×ʧ®zú›ö…Ë_ÂBÞ %ʰTõÛáÎÀ\O$÷]š½å` w«ÃgfÁ(5µÜ‡®é‰ÜO­Ôl&à3»Óƒi7î¶ìõNîÅK6Ê Œ¼dŶ-ã¿[}ïÔ'¹Ò†r§®J¯Än%CéE˜üe'F[Ço¾»F„JT²nˆªœÌû.á"ÂT…Ùû×ÊVÏ.*_²VjC¹S×7þ§yp}},"׆ƒñ?Ý@ÏéÞÉ…Ó¿åÈÓÂÞè΋²w¶zeÂ7õI®´¡Ü©ë§×ß¶ñä%쬂ÉSÚ[†áúÜ4›§Â½Ð?6 Y›I© jnîLÓõ¦‘ªoNʺ¦+¯f´·&‘漊yQ¸=";ïm€—l0e5¹ƒfä­šD+ÃûõQU‰ˆ9VrS–÷{èhPZr¥ åN]Ó 0¡†òú™/£qÓY©µð`y_tòmX5åš3½„ÚSûf·Z×Ï}’›êÕþ©ë›FblGþ~}R6¯ZblÆÅ˦ÃC1¢y‰¶ó+vï–MÔV~”Žc£e;–d·Ý ”}“o½(û¡·ÞcåÅñ#}„ 1&ð p£@Ã] |É+ÿ·›é“TÂ÷q% Z¯ü´êH«6wc&rFOßÕà'µØWr¥RWLö«°¦Òå4‡JòdBSòÄ™öWzr è¤$“+­¬ážö×»?j›ÀZ™B£®l5믮L¿QWj¹]=œ`©ˆ‰ËÃI”×’ÝüÉc£®4í=ËPeï—9f²—ÃÉ/ÿ —/Yq‡(Yz¹íêìÉÙ·øÒK²§Þz³+3»eé I4Bµ5Fé¥.¯þƒƒT\¦Í’œ@–®x Ïâf9Üð¹Õ,]á>ÉMõêøÔ5í(UA&Ûv” ¤¾÷õÊêÛü^RN཯OïÝuÃyM¾¯WŸä¦z­~êú^‡ñJKvojg‡hN•xems[/î¤ï å†í(/¡\)×uɦâ¾dËúW=Ô+×§®ÿ$WpùÅŒÞæaF_õ0£$š6÷ÍÌ03úG¢il˜ÆaFå0£;©ó›+¸œ´ñ©kæYŒûÜ{ºdÑK˜™ ¹÷jȳثÁONR{&V'Ë%Ð wü6–Cè¶[½ì·à>É•6”;uM_ö!»\Íqþ,D™o:‚m,‡w5©¸Íä¯ÊrWÆU&¡Ö”£ëÔÊœ[·ÇÙÉMõjýÔ5Ý£®4‘/ŽƒŠ§oLpR ´Öיܕ×óöŽ[ާï#åàèVK&uVŸäÞŽ§ïãS×ß"¨6fo¾F:m™B·¯FsëuÃ)«ÑŠ«|£«•ù 3Œe…F:m½”ØèY¶cKí¶{:m¹oñSSÈžzgn•C¸›sè`ÔË{¤ÓmÎ8K€‡¶}Ü î¦!rhU•io_)»»[Í`÷IîôXØ×§®ÚAt¼Ú‘úOA–" Çø„CXea’ OB·öL.\-'pg¥ˆå¶opÔêy¿säJ›KÁ™¯®¯Ÿ–ܤJúiøäóYL v#•ôU ÔQ¼â2W‡äÔª>:™—rÉ!ceQ«Ú­‘\©G¹S×LnÙ¹ßé™Ü²Ë…¥XL×!¹¥ù+Àx&Å*N©Ý,'ÀVõQ›jŠå ꪪU‚ŸT`]É•zûÐõsZ¾Æ{½ë´JÔvX%êGá7qs‘½Öa„Ø¿Z%Úk•Àrçi(Sø¼ÅIæi•h×§®zú“u:PŒöëƒßwÚ{á9—Ü‹FÁê|S÷¦¡‡\$î°\‚’²MË$V«?©À.É6|„Ü©ë{»°u÷<‡]·¯Zãtžleÿ"AÅ4òÉ >œâ£ä_Ê ÝÞo'åÂìbÙ >&nûò–;û_zIöÔ;MÓ‹Ñëú*&ìÐæ9buŸ×ë;¶³žÀM3¹“¿ åV¦íuûN¹*ºÕ™‡õIî°EŽåì^]ó$pÛ4¿â÷wµ“Úfb»j “€La¸% ¬4'¡–”›Øï¨Õ™»¡ê\ÖÁMõjùÔ5£·ë39’·¼M ›Ðë.Ò麓;QZr ìí&BSÂÅ{éµ²Õêí„û$WÚPîÔU·J•‘iéM`¼.Ô4“¿ÀÕÞ–«MÜÿÔävD7HN ½ ^³ë¶Rh¹Õ–q\ê“ÜT/äN]ß;½ÉHÑ’wz‘ic«EUÞéMßéä2 Ir+Æ'¡uËÅEòv«¾Ó«ÉMõZÿÔ5Cã6—C˜€°›¸‚åR÷kšºº]#¹ËNÍ}$XöU} ÏþÂrIÕê̤ê“ÜT/äN]í×W˜Ãër‚ƒþÂ’ðÛSVÜðØ$¢f×ä7ºõK6Qù雾yðZ—,Ò´eÛ#}Ý·øÒkØãýÕûMô$¿ÿÌÑvÑÚ4Rt«Ät6·Î£%÷ö\ßF‚ᇠY²\éÒ­vï<Ü'¹Ò†r§®i½™DG®Y& qGT;fS,Œ¬¹f…Ãi3!üRoË4»f™Pe$jâ¸ÕêMŠû$WÚ@îC×ÜÌÍLŸüuR/~-zØv!*;/Bãrf›0+Ý„oÕG©Ý­jƒ)×äˆû“ÜÐ6dwoRîäJÈ}èš'úXzÞ›€[ÞÍ{¹Îlu¸¨Ð1=/‘¦ò0•Q0QÞ”VRßÜ çsq·ä¦†­|ª«ñs{ïª â—°°èÛKëRUªÄË{æ¤v§\‚–ƒ¢Ý^Z-‡c[6»Or¥ åN]3OmD+¬×9" áä€Üá Ò‘ìu;^çˆ cޏ›@.9Ó Ø9B:9H®k¾‡¦ç½’+m(wêúéÚ|3ó:_Ö,Y^ù¯gÏ‚\òï$7]Aë8Ü@ÇGÉ¢eÃähºS«ÕyÝ'¹ñæ§®y=?X i._ÏËûn`/SX´{ÃQÿÞšåTFP•½vÊÔ,®ùj³\]®Îµ ´]*-¹©^mŸºæÜ9yƒ½òNÉÙ©0]vZ›ÊvŠd‚㢈çZÞšHër«ÞV’@›òÍ=óý&^žÄ>ÅMõZýÔõ·0hí‹æé•¾" ¯Ú¾iÖÞðÞ˜\Rvnê§ãKç·…”XGõÐn§¢MÜj¦,rŸäJ›)ŸW×ßâéÿ¡þ¿jš6Y&júvˆ€Âsr¾ÃIhÊŠ’礹í8;á@¥‹ïz'È$¼&Ðn»vDÛÙj&áuŸö®“á„~w¯®¿ÅÓÿCý?ÔÿCý?ÔÿWS!«ü/q`ï~¶Š7ìúÜïÃÞ/¹7ì# o5Ùûöî÷›C8°w¿ßŽ›· õ‘£*zU0ðKØ(6–u)QwºŒ "6ú’{~(p©e9Ø.ÝjšGÝ'¹Ò†r§®rèÈ#Ã¥îë `[þFÌoõí&¶†aŠæÞ ´ œÀt<ùKh-å~ífž÷Inªr§®:®ûø0W²’Ýô¢ðp¤N8 sU(“Ûp.¹.Ì%ãŠj†=¯lõ-Ì¥>É-Ž ºú§®2õÈ£h؃τ+ Ø´8_HyenÞP’+3å†=øLÀí£åx«Vß°\õI®´¡Ü©«mžìŠQùÐùP“W¬m @n}ŽpqëMD»$uɧ e¥S”Ÿ<ËÒ­Òmw߉gßâK/Éžzfä\>·›°‘{i0þFŠ=eäÜ™€O9ÉEîË ,ŸÛ_BÍŒœU‰ÝêÌÌÏê“ÜT¯¶O]õ" 0©e³JÂ\v€¯ps\ËAr=mV»%‡,—à5dî­ÇrðŠt«Õ ©Ü'¹Ò†r§®¿Å¶˜Á(2 ^~úKspS¡òa°Û.`ª¶ˆL¼LØ…^›3hh!®®,WQSS­Ö¬¸©>«*n®•r§®™L7ü_v³_÷KØH_«RãÝÝNÝ7° Ë%s³ 5%,‡ ZnµÚÛ}’+m(wêúÆ¡òŠUµ•L€Qôyh®¥Ïwß2DÝ=¹Xñ-'ð^…ŠÅ-‡ü|nõ>~¨^L°6·¬À¯®¬lJ*ý&âno^’tž;»ލ¬*.ÓHI.Aͪ€3çòvËV³N¢û$WÚPîÔ5Õwj/ç³x 1ċ醡¶ ¤S½’ ÷Ë%(oeÒÂ˸–rÙq«Ðã>É•6ÓqoëmUñH‹ùdTÕí%lÔœ•#ìxC{Ó†¼¦- î\ÙM€“åÒ­WusŸäJʺjâ ª|'Î$°*ȬÇÔkß1q² s†y^ïÄ™À§œ%çPM´zV™õ˜V¡'ÜW×¼ë‚ïÔt ÌI·K…9©7ꈖ´!Ïâĵ+/°(g6ä—PjÊÝ1 Ýêíî“ÜTï‘ûÐ5ö6Ó +•ÎKØðÓ (¼Žö™¹>6/äA…Õ0 ÷¥Ò1[=Ë]8æ¨ÕËNBî“\iC¹S×47˹ÃyEXq—¶/GP±nS¿ dn–‡Iç¶ÆL0í8ùêH¹[å[úm k{'7ÕcªÂW×cÂ8ÏíK€óËï7órFŸ¿ÉÕÉ|©âP[nõ<·3;äî8dºÕÛ×î“ÜT¯ìO]uð ‹„R¿„8wÒ?eÃÏë{è4{—äN¯E÷:€^pCg9¸ýºÕô/vŸäJʺfÈ˦»c°E@èÃbŠªŠ$*kð®-S¬,&ù÷bµÔK±Û}»ÕŸ’"0–Z5Xe­ ­ŽÁî®ßz߇z­|êšN“‘‚õ¶“€+³Ö?ëL‡3üxÉ6oìo†f¦µ»]'$?Ô¤ Ý“hGÖ5Ü3'‰ºí*A:{Êêæ–_Q×åö–_„É÷Œ. —–chË_¯ä2ø[r Jžn:fŒ’rÕ×ðוsBKîtä5«Ž¿ºÚés¤ŸŽóŠ‚P ÈÑÏ$Ò GQµnÄçªhñu Y¡++b¾”r½²H‚—mg޼ì[üÔ²§Þi‚«Lx¹Òáê)};6Ži‡:œ`´´–n®e9µªŠP‡äàVÔª€Vaí^ƒ›êÕñ©ëoqöˆ0úÚ¸E&ÜT¶;Ã?d7&OÎÎi WrQ.Ãr œdO„KUNoåƒ-Ùê°‡¢û*+ m(wêú[<ýH$×L§ÂŽÂuG.ÍH§0.Mµ%w"àUrËÆF¦6•^Ì}e«ÓÆF÷9EéJ¹S×´ß^L+ËÃKˆôžô°+pSyÀl2ÊÂ)ŠÜƬ”KÐò£J´§¨æ¼‘ÞS­¦åÁ}’+m(wêšá_Ê“¶§Ã¿n& ¿±­DWJl^&÷Œ•Þ°”›»éæN9•®ÝIèÕrmÊ DÅ_/èSÜT¯×O]?\õžD{ —áÅÜ#ˆ4Gt’ïP“s^³à2;¶({a‰ÞZë·ç=´º%W QîTW¾nªÐ}ǯõõA˜ðÞ,åÕ…ð DGëYŠ{Ù.ä”üèÍcÖ()7âªÀ­ü¤óN®´¡Ü©k&Áª¬³¤àÍ—ß7zÝpн&£~Šƒ7én&wa©”\‚’Õþ.nÆû¶Ü‚ë³Z]Ì¡>Å•6”;uõ&¢xˆTo"’2éÁ©:™ÿúmÄaÑ\É¡3¿ª7@6Q}3ñ«˜ò~·¬e]³m"¹Y^¾ô’ì©÷{—ÑËI‘G6ë‡>h3ï*ò„ß¾À D}ù“o·d…ÒKú Ôöʉ9ÛNGéì[üÔ´¶_ôÎa¥ š.—™–½TµÏ þñ*·är™Yí3¸YÏ3ä¸\¦0ˆXkÕÕ>].3«}²˜¦,÷üÔ5ýo/]¶¤ÿ­²€_°ÂUîçj·%­diÅØ÷äb®³Ür8¶°/¡]’« ´e«^)KrS½v}êúk4[ù(¿QLä î~Sèœ; rß,:óå3 Ö‰w'2÷±O‘µàÝÅÌ< KîÔõ·Ø]ˆªªô‚ý:8I_´Vn„U\7÷ð—7Ž×Ím;¹“õm(7]ìF¡-/¡´”ÃNÄ­æ>Å}’›ê…Ü©ëoñôÿÂÕÓõóú¹¾UwÆÈ¨o5œKr!7Ë}È|%æÄ½œ¨¡w¶ªŠ¹œ(wceR«?i•Š>ÅMõBîÔõMд™ÓV¾4I¡É¾WEGäOEÞ "®3È)œ|&m·ls%vçÈ1…Ë2EÛv,Ⱦɷ^”ýÐ;ýè´Üíjä#•1íRu²Ëe 3ìlɽf!9,fR¸[©sÜjóe•û$WÚPîÔÕÛ‰JSÓûS˜Âù¡6o.ô¨u0ÍŸ¢;žüáÍd…ŽŸbx1Ë+Ëû·=Ò&æ¾Å—^’=õÎØþÁ\zJM`R ÌÎßn)YÚ}‘ÈQ»&Þ5–ÈÔ& Å€å|À­fj÷I®´¡Ü©kž1oúè—0™ôVµóÂSÎ+Ž2j·sDP®{xØx.BÇh¹OØ­Vÿî“\iC¹SW¿Ôúí ÏnÎ~ƒëÎÄ8ÈÂö±2lM›ýå_ÎϨðì¶Ü6?-Jeˆµd«Ã³Ñv}óշøÒK²§ÞïyyÚÈðõA`þŸÆà˜Á“í2ðyy$w»*únpé `h\…ï›Z%8ÎËâJʺú§¸œMtø§¸œú´²žÌ¥@qÖ“iň‹±æ/'½ªåEÓ¡dIA,eé*á¶ï¬Mè¾Å—^’=õÖJ}3“Fqiœ—°pYXXÉMõÚüÔ5çÍs»®™PU€fpšx^ü}Ù}D3̦ï¸tÒ“œ@ÉRƒ$Ô­tµ‹©„[u«5NêS\j#¹S×7ãÅPj}×ÍI4bÀKwÆÉ)UYç/“¤ø—/^ +”ÙÊ“R0ùN°½¾mgÂòì[üœ`!{ê.Séh¶]&+…=ç–N¯¼¨Ïä—SoÜæ a ƒŠä ŠÏ;/¡4ÉUÚñô†è•oWrS=½òõmõ̾V]ŽØdÍvê$×vê—î÷Ø©_úY·„r™Šm"uN;RÆÌ·²K±iæM73סÞ[ÑÄ­Êõl0¯XK×36|)íaŒñ»蚢­ä²‚å^ÐÒK Ô;±ê¸Õq\îÛk¹]ϧûî5ާ€«)ÃûÅ·íïÓ7—ƒZr™î%Ô•réjux‰tŸä¦zY%[õ{¬,ží}EYÌ\£, C[Ÿb”oæ|ù·ë†B6ѱ‚RX3M²…ÕvyMÞê[|éU\oíÕ;/ô#ÙDØÝòBÙ'°è-¦µÝ”‹ÓÎÎ!»sZ;èW@9¶ªny^TË…íív«ÞÐÎäJ=ʺ¾¹h逪¤&4¥ÉMõJùÔUƒG‡ 8>~„[I§Ü9að×÷£¢ó¼¹§$©Y,'åœMH2-¹$Ójux¯ä>ÉÎàµÊ§®¿…½zOžm.Gï™p+µ-2àòê­ž¦÷Q)qI@¶Ë‚‰®·lRÂ@¢Céñë0¡f¬ä¦†­ªû¹r-»ß¿„ýÖ`äQBkÌ{ÐÐ D®Ö&Ê%p fœ¶,7Q00kc•ÏŒäJʺê¤ò±[Ñþÿ%lÔhR¬Oø“ÝŽóјÓaAÁÎßr œ¨YØf-WcãíVk&j¾ \iC¹SW=ýî”’Uûÿ$,ŒøÎì¼aÜË@ôɽ¹€R.,&À=\r4'¨Õ×b¡>Å•6”;uý-ÞÞ¨D÷]m˜îÕf—¬tx_*˜>õ,Rinsò¨k`¸ó£ \rª<Š1$öj?©€ÂHGIm(wêêÿÕßþ©}ÿïþö¬„ÏÊpþÿOóï¾Á{ê}ûOß,HÏÿþó÷òý¿|+ßÿîÛ¿Ù¸öìÈiõõ½±ÂÔ(°OÿÃ÷ï:ÚnhõýÿÙ6[¬O‹ ¤^ðY¨2mGŒÒõýþ×oOƒÿþûÿˆÿ¾óƒ*ãðËç¾ÿÇïÿˆžŸeþéû¯þüþö¯¿ÿüst7pÇÿÿüó¿ýïZúöý¿åW`3ó§oKÕ¾Ÿÿï‚Z:ù]âéÔïÿ-BÊ÷«N®›kkl†ÿðíObÓò•l—]»i‰/¸I’ßáK¨^0;BÜZ²‰vm¬ý#¾àùßI Ñ.© á«ì¼>¾ áñ]jÿü.ÄÇúLjã|U­­^ÜWYn9ÍÖôø.Ì ˜_–ðüÀØÈàÀÈšÿüêá×ù}±÷cÌ3=刚°Ú8 w¤½DØÃí„kQ*ùÍÆ†@‹Û©Úž…E2ü;‹@$.Õ2Uy2£½ši2ÙWÕX¥N¥~èwÎ׉Wlù8svúºð·Ê³0çÜ~øÁHæRnt‡TßZ¼&Ö¥fÛUÏx*õu¿ùœ%sè÷—ªq\î^ãPÙôoL*`^‡Ö¨ÿ]“‹ÂL–Nü~çG÷%-,õÜjêî>Å¥6’;tÍPä¨ívÙ¡V)žYQb!Më K#ÿÖ½Nó¦Ü´îî¿/»Ò&îÅ2#Ž«joØV}‘gBæÐï"ã²jâéì%Q§üIù÷;DÄÃ0Œÿ.çÖuð S¦«wYúû"â5¹¨Œú¡ß_ì nx4ñöÙ%¢ÛÍøvÙ‡}a6ø$ŸA–M¤ÝvR†K;@d²íá wö-¾ô’ì©·_PgÚV¦†—n¯ÕI¹Ã)(ÂÒ§_%&ô׉À!gP[~tãÖ¨ÎGÛ¶JÀ¢OsêÛŽ«w¶ú—:x<k¶.[“ó^mÕ~2KÛ*†4Ÿ^b_‡zuâw'Y†lwJe`Jl§$U[¶MÄO³oóSSÈžzç‘¡"޾^>1?͆qI:\Nžü|mù(K>mÊB”ñߪÿ-Œâ¼’¹b¼«½Ë¡rê‹<ê@™C¿Œð^p“¯­ZË÷VØHVì¢Ìo&ãy›‡»PÊèïÌ›-Œ É ¦Wí]GãÑ…¥dNýÒ3â†g«vŒ ^§ ©0ü&®”À ñ¶ŠH¯õþÝ2ë5».Ë\±ßW{W:ø²/ò¨eý2wÍÅh™íÔ5Ä™kX홣ž¿ÊJ¶UÄC„¯düwÉÏm8*&™‰Lëlofvö%u(Úk¦~Ç8M,¾^ŒÒnÌ»šôø{uý­;©«˜‡D_’áßY«”84¹%3QF”íÍ,Tʾă’9ôÓ3FÜzDwdzðl$.„‚­)(Â̳êoíÀû4O@2ü»µ-6+0mɬ­Ê¡ñÎ=ú:HæÐO³öþÏÿµ¯ÞñkœŸÿߠ쥿ñ+–øµ‰/œR)£¿—÷Â3~ ÉÌø-ÔÞÌ,pì‹<ê™S¿  Žê£ÃÞíÂp£·¦ÅßÌRÄ@,Y£ÌЫÙäe(þ=ìÑ.ìDC »êÕíu{‡©¯®à VD]ׇ~ÚW¤Øö#Ž7jÆÿc§€+°ž üû83ˆ—<Éào¶§Ï-”;âÙ‰âì„öø÷Oö»»yÔ‰2‡~r|‚­éF.‘¯#Œ6©éª'jeóoœßZ9ÅCÄ€dø7ÚÃ爑žD2ˆS{Õê‹<ê@™C?=cºÓµ¬RjôËì±5WÔKáÙ#¬V‚`i]áßx£®wâÝa`•Œÿn™ì¢¢”â5-Sc/¢öª÷)ê‹<ê@™C¿LEõü:E9$„”QÐj3Øbéo¼Ûp¼¯b¬AF7ï"×fh¢öª2ê 8uªíC?iŒì[\™¾^üÿ°÷&;·%M{Ðü»Šºäì›)XB þĨh$ä×xÀísòi"sÛ0²E}ªAÊÈx#3öÞkeÍXkNÜÎD¡/ä`­¦¶¬“=™‡ze’aãÉ*šXul[Ñ/â+5yÔ2~ñæª./¿y¤ù¬%æfᩚMm=Ÿ-™Wtâ:2nû"ÕI2õ|k¯Ú•¨¹È£”yô‹ÛŠHZÔ½†"ZOÚ*‹@µµ”jŸ$ãv޵bB¿^-ƒ››ÆK¾«h.ò¨eýZ³OÁ&ý\º–®R¢r2åÀ7ÎqžZñ)-¶KÜ8M—iØt5^Ø{5yÖ©Ì~¶v"Ëö@O ¾E,~"”Q-3c6u´V6ÄEä¨åH…·£–c¬‰Fͯ µ®àZ=!á„®<0°¹×làÒ~Ü_ËÔ¯ þ×ÃÕpÀf óâ!;\2nk+ tÉ uXUmüç":PæÑï¦>ᯤpÒå,â6Q+iÓÆš|ÑØ(_.ÒÚ(Ã6ÇÓß-˜Ó÷Ì1]fÇ¶Žž{Š–NyõÓC £ùšÎ” kôFŒÑËúŠŠ·› Šäak ÛQî6èT-3`F©Zˆd Ñ\Cfê”êG¿¿ªI«c+ÿõ´ÈyôÂö´ñÿºžÆVûOní¥›‡ò’q[Î3Ñn3Ê0ب(q6Eåä]Ì£”yôÓ›øð ìOÐ ¾¶äVÚx瘠ïÜZ°®sÉl™hf/HŸ GÈLÀqq<¶e IÍ<ëtdýÂ32–ž~‚Þ8øî-Ìû³.ñB‡e8Yºs¨Âÿ“g8fâ¼|=5(é9¦MqP¶ñ0cBñ¨„^%ÃJ´y>_¶‘^¸ñ4Ä”ñKÏYí?ã¾%Î’q[û6鎓e:2®9^œnÎ%tÌ£_œ|Köù3hfJ-1UΑøxìSm½Û­™‡Â\’q[¸<¢QìK2€²ÑxÙðõš‹<ê@™G¿ˆȼÁ-G0-.ãh{~¤I Ø!gäPM”6'=±ûRFíÀ–]ŽgC2¸i¼~5ÎUôKæ*™W¿XÝx$ßɫۂM¨cuãÝ9Ó÷ÒÕö.]ÌCesɰ|˜º4É ¤>s<¶íËÙæY§Ò>ú½kÅ96¿ž\áûË ßm¶ïZ!Öɰ= X"à/’ˆñj>Æ¿žñ¨eýâÍ;QQaza¢½°ÚöÁ¶Þ¨s "o8¤ßvŽ¿[°öbÜù5^Ø4yMþ½|ô xÃñu‡ üÝ>ÑGw¬ØøµÇP[6ðZEw ãQ†mާ¿#}ìlÍC ŽÇ¶žž”̳NeôÓZAi ÔˆF’þñ‘ÒsT±¸žæ¤@ 󲲤è[bN”~mED¢e&³óÀ4œ‹4u Ì«ß…P }©‚íP8oOx3+´uµå£ÉYô¹ɨ]í} º ËùDZW[Öý¹Ì³Ne|ô /jçžRíEíÜóà-Ï(-•ñ¾Ðãìâd8‹+ŸdØî¾b]†e|¯…ß‚s‘gÊøè÷ Ã%÷“;&Q³’p»'£×lv@kŸŽ=ƒ Ë‘ˆJ$îèD¡\?K²GíöCyNq©ä]­þ8ëÏžö»c1Êþ— äˆCì.‚­³Ïš»Ï&e9óBƹ±É”ƒ/Ç£[i<§¸Vr®õ¹Q#ê“4m VX–/ÉImü¾ÀÔ0’q»†§·ÂÃÌçœæ\<Þ­bȹȣ”yôs°>Ó4bÝÓs`2k€j—/;ž?._ðÓ’ *2eÔƒ·!d…¿©±Ã³s‹/½$ûꭘǓ¬Ó“éhÆãå߸-x5väÞ7H¼ ÏeÜvâ=i€´Kf*ê|6µÿäJœ–yÔ2~Õ[ÀÆÛÍòt?/͈®…hiFtõ¬¶L‚y™‡r«’q;ÇßM¬ª4+f¬¶»y¼á¸ÍEu Ì£_˜qu3Þ6ãVø‡3ã£à7žôˆWµ5CIæÁ3Bµ›`D#öF2+F²·âÆGMÑÒ2¯~zŽ·â;„y æ½ c°Þ÷¤Ø‘õ~k2xʨ¨hA—j™[VÒyÁðœ tèÄhàÐ/Ö½‚_­ÄºGzáä1ñŽ4Æ Uµµî¥mü’q»Äߨ ’A©(Ũ4yÔ2~úŽ»Êë6+:{‡®Úß·ÚrMaý䌧V9æËíäÛlÐ¥Kf"¢„㱿:=žu*ý£_dÆlx²FrfÌ®ºñ,ä¦Î¢\ùÜÔÖ^°’yˆ¨” ÛÙ%}D'%Ñ/¸0X8:7µ}.œæQ‡¤úÐO¦òÉáL¢ç¹¥vÒ˜¨]б*̨l0€(Fz$Yêt{Dl„éÔ,Óå³­]í?9ïØæY§Ô>úÐQƒ3ÆP5¤Aµ@¼‰cÔÎ_ìä¨Vó`Ë” Û9@jLk¦â<ۆǻP°œ‹<ë”ÒG¿ˆ°]tèÜÚDIðHg-l*Ì·á(`3 kY<8 $S…/i¤iÓ©Y–WfšsÅQ§Ô>úÝüÝ 4Ÿê;PõäAO¦%WÜÞ¤ÜÒƒ ÐË‘˜ÞpÜ1P°Erµê4êðžã9Å¥6’{tÕkˆJtÿ¼4K u\\* Em]:Ö2 hSàÛ¾:l ¶i™¢@³R³æ":PæÑﺺÓ ô"²xS¸çfHf˜¸7êωǰNʸí-›4ò%ƒpO¡ š‹<ê@™G¿ðÿ,‚ð ûkðt€!W:tslR5åëÆù6?óP QQ;b˜$ó².¸µô»àÎH1[Ý)ŒV‡*1PfuÆÓQÚM)%ƒ6ÇÓß‘Î[2Öoà5çÏ:åýÑOßqÅ1oŸ§ÿ'èŲÇU&×Ótã@ë.óMfµ³j´9žþŽ4ƒíóÖµ„ã±­ßbùÊ:•õÑ/;³r‰F0´£4H`‹xŒ]ò`h“ ÛÕn ÑNõX8Àð[²Ú:ÀÐ\“u Ì£_¼yLå-Q+‹ô¦û))ø¼£ÌåŠ2׿èå`ö+X½mÔ"RIÔ°ÖxQàZs‘W•B<ÒG?™á˜=€[rµ™>‘ A¤ØzÒ¯ëh8‹ÅÊ*·ËÀ‘K‘8rˆŽ7#š€s–yõ 8¿ÅãÄ6šéÙUíx,ˆeÙÆú‰¨ñT(·S€«ÄÍ´b™$ô¿TÔöî4Ìëº|µòÑOßq>ogÏ‘¼A{O+ S<±C(uÁ6L±x²ÄödØÎ‘¼aúÄQ†fcŽ—lIÒ\äY§#óè§ç[€‹ÆšÒ‹ º²>¯ &çùJæ5„WR†í€+:OË4!r¼fS±æ"Ï:åùÑ/ ¥ÏjŽ"¤ Ýa6f¡V&fù22lâ<_2nÑž4¢À(s®Kã±-CiÏæQÊ<úÙÒ[:ÈŸOÇ¿8Å\’Ž&™u,HðÀ¸js‹λ?DqÕ4v F„å °™4j1Ì®ç$WÚPîÕU¯á>–†‘4üsö÷]Œ{زyÒ .ÒÀ)f"]LDw(šàÀcyT:Í.:T#b¨OÊ2^òÏ¥·R*øN§æˆ±äg{y-H;®–a;œ^A-gl9¦8Þuzq.ñ¬Sžý"â‹©û-"¾λ‰AÇœèE»ÈˆH.‚L ¤}¥f§õ+¾¯;µŸ)IŒÍ*Éã¡­·‘»LIÖ!)T;ô‹klK¬Gñ‚‚T€¼«7pÚ²Ú>¡Oó˜nH¶“c2I34š2 æx=À8—xÐA2~×pΨ†s¬• QxÖr¢Ôô.°€Ô*Ó(Ãö°iÓ¼' üÎmx¼î‹·æ"Ï:¥üÑï&Šn%‡ü\z)¬ 7³NOÒynÀÌLšmʨ= «tY–»Aã€UXv@µ«SYý>8N0=8NUØ“ 5ٓݾl_c³xÄjªÂ¹,Kã]csƒ¹H20i¼04i.ò¬Sný^g,r¢±Zq”‰eŒ3ÌXã8»xÐJ2lÇt1ìåÀ ÆñF¬nœK<ëTêG¿ß°²öç;†CŸ0úN"HFßyü)c¬¬ýùŽ»BXø»Ìt³ùùŽÉ³N¥}ôû¤]¦/ºχJ…ÌÝ‹í«±xL­¤ŒÛ_t/ “Kãõ {­ßнփîE™G¿Ïw÷’ÀËÏs<óóäïs<ã;¦ŒŸéþÛs¼â;.aµÅ½Ds‘Ïnûè÷Wuóü­ñ1÷·¤AK·¢ACž»0Ò3IŸÕt«Ôý-fð‹ŽZuÝRl?¯[È@2~—Aâ/²S´Ï_Wϰ}®Ðìû®’ñ÷Ýß@¤:µ>LØ[ªw$¶ç­Y#™G¿¿øSñ·Æÿù5þû9þû©x4ž°Ïìá0KÑó\º' Æ7-U>!§ûÂþ#Ó(Ó\e±úï:îR{Z¦Ë"Z—ÚrÞYÌ£”yô»Co?—&„\“-=ñ>3ÕÖÝ7¼œ-ö¼¥ñôw¤ó´LÖ}¹Í7¤s‘ghñ ý®Æ¶óþ¼ô²ûÓž{fX¯­xÀUKÞP¨ï·m[1iXÔ$P>€š‹<ê@™G¿ð÷ X@ívŸÑcÀ`†c1“¨ªm?ÞM«eÔ^¾ ‰ž*§Ö`¡­ÛãM‡Æj.ò¨Ã”ï/ô“½³ŸÏÆ´‰Ÿ—ÞÈ{¬]öéf€¿Éc™GP>Ê¸í´ öjX[5^Xr5yÔ2~™±q#WýZшð:u]Ùá}#Àƒðï­›·ñÍP†í¨,ºÉ½·àeat`^jËFÝ‹yÔ2~.¿Ú˜½½e¹ŸtÔ%!õâÖ²È0+p°pÈ>œŽ<ªA™GÅ8¾%Çþ\:¡ yáa$ ÙŠà„5ÍC‘Qɰ§LCÔð’Q¬)Æ»îoÎ5:•’eýþª›È1(ÕÚG Ó‹.e YW»Ú8 `C¼”q[G ÑU®ì‚<¨s|àx%Žœ‹<êPå2ýìJeI¾XánÇ©qjÓMÅÐ2²½¾aziÀC(.3*$gÂ0õêÀQÞrXÍúÅö²€}&¤qÑÈ7;8õõ´™iÁº;z"ûú³2ˆnÖÒE3“K,è4%Ó·²0ÒV‡¹Ä³Ni~ô‹hñAõæhñãABNB!’:òÖR‡i’·pÙ¤Ì޼'¢™Ã:õ×,¹–Úø;Ì%uZÊzý"@ŽØ¯½ZÁÍûë‚Y‘“Â6Ö©%Wñá-¹Š¹úͦñôwÜ8YA‡®]³zUûO΢«ñ+XW'ô ,Š‚çV» ' l“G`G´¢6f˜Ú‚+>Íɽ¤ŒÛ9þn ˜² Ë úYãEd´æ":PæÑï7×ÙÇÙ'L2Êuöõòuö‰ÇƒE¾Î¾ž¾Î¾žgß~œ}û7gß¾Î>É<úýUwÃÅÊ8¶¦œã +%foW[”ÍÛx )ãvŽ‹LÇq½-Ë㕯œ2…ífª°oC?­néôôáõX4MNð3ž“ÚÕÆjä:d °êÃ2lÈ$6]“e:Ö¸¬£ñ SÃØæY§š>ú}Üìùk'ZZ¸ÙÃÎö}*Ä£+½\s8Ç»OÅL×>Ó5‡³}Ÿ ñµ>>ú}\Àíl´ëŒ.n¾ ¨}¢7íÇuÖµ¦\WºÝÁ}=7×gIªê÷‚íçÍ#Ïnß?úIcàÅÌîð_ÑADà¥a)ÿÍ àш·qÙ¤ ÛÝÏgÐeZ¦áwáx-~3ÎEžu*ó£ßç;Îl úäÒÛõÝ#\¤88(\æ=ÂE²róÙ®7;ð`Ã¥™wgþ¬näÙE:úG¿Ht¾Çü\º"pò¼Ëì®ÌC›Q4K<„ÀJf*Ç¥†y0 /YaÙ/B¶5yÔ2~Ç–÷•8¶É9yã¹OÍßîSó¹O-eãÕäv óËR-›=%3·L,ºOŽK÷©*$óèçì øõl¯µ;ð©N´#ƒ Qh«(1ÊpUÅ"‚[àXGÙ[ÚíH5ä’«TÍ.‚Ê9ŵz.aÕbÔç¡F$Ï'Ú¥záèˆæÑ–}#…¸e“çm¹ÆÂq#…L§X8XÔÑ.í³pgRþè` –­9 Z’~ª™Tžˆàº:+©¹‚ž#ú,Zu{,”éœ,ƒ<oÚR¢¹¦7©aoC?iŒxá–œ’&š°¹]W.V«©­ÃmOæ!†Y2lÊ[ЩKæ€ÁfÇöŸ<¤çižuââúýUE·ß¾,øŽÜ“Sâ ~¥#“Õöò¿Ì[8S†íõ\Hç)™Žã3Çc[Ç{ÌG¹:åùÑ/48À /è¹LXÛèo H˜¥ˆúÃ3Æàê·-p<шö®ÆÜSã±­kÁÈ÷´K02¡Ÿ 1  ç#`ÑIOÀ¢g€ÙMôd€×M? 5?Å«Žó«n?¢»ñq0)Ýãõ€Eç\äQÊ<ú…m¼ØdØ6Î̞Ɯ’j0_üæè÷@ºtÑ Ip”Q»øH4“Ï3rY˜”޶ںβ¨/²Ô‰¥§B¿cW†Grû€}åT±L¸Å0ÓôÛi§¶‘ô\\¦,G"Ù{;r³Ü UO•DØL›:B¹Ü>І›UNÏa7+é ÝÂO¡Ë5©-·¨œª€¾¤#–hzrÊêïHÍY2p·h¼pÅh.ò¨eýlèBõS9W¬€›pÍÕìàyôw©;)¥wMr$nå\uÈŠ·ëG½•s5§¸ÔFr®‘9@œ™¤7.z¥‹4Tµu¸!ÈNƒ¬7˸]âPÕc°,S!Q«Ú2fau Ì£_€£%ûR€£‘žˆ ï0f€€•¬ö™al%’€£µ,™h§Gkô¢Ë”&äx%Ê.ÑÖ²”yôÓ B³Lu´ƒhÄqLš9A³Qxj&ÍFäÑTD¶«ß/ÑE,% À_ãÝ✋<ê@™G¿ß®‚ã·«`}®‚ë¹ ®ß®‚ë¹ Öç*ø=Ñ92žWÁö\ÛoWÁ{¢£Ì£_<ÇGõ R…yàÈD˜X~èákIm=Ÿiš7‘º•S5²Æ³©4=‹ü—>þµ‹\p.{©Sšýn®TÏ0³g£JEÏb×Dó=óÂß Äs¯ëòqÄ Ù "_=(•²õ|î»ú[‰¹É·^”ýè}÷Hœ/g=’\žŠñÌîáÓò²Ùån·è媊qÙâxú;Ò2öú«{¼ñì‘„*ÑY$óê÷>ácœUç>áƒQƒÌLÀÕNY hß'\¼®œêK9Ç»OøÀUO2X+5^¬£š‹<ë”ÒG¿¿ìyúoÿó›r}O5r†é…³YgÎ7iKm˜S²ŠXVŠ…/V¾mÇAN‚bñÂCå¥6þs‘šC?™r‘CÅÓöÏ¥qâîøÖÚ”Ñv%µazÝk=àð¡ŒÚÝÓ sµ bD5^sIÍEžub™®ÐïÆš°D«lÒ°:&ä]'V‡ é&þäÙ»•àŸn9Åö"w°X•ä\­jvøSÍéúW½…Ü«kàßV\]½8“¦)"ËK¸»ê~\ÏàAÕ*æUy [v;Jç–d:ª r¼•9—xÖ)­~P7æ\Ð;Ò§Æ=.°ý”ÆM¤“ŒÛå} {S"ÝDbwòkÈö} Å£í&Øy¼Oàx¾Ž »ÞCÌZ÷€³Þ„/ñl¯Ö˜ã=¦r·“_Ø _9§¶quŠíÄãáøQñ~æÒÙ=¬4÷¤Ïê@÷”H®Ë•FFóܲ¢ºÓkžžƒcY‚ÆØ‘hs‹šBöÕ[/hQÒwVØiæ…OÖ8EóÈUîÒ«yð+HÆmy‘Dge¯3…š¹ãuª­Årfó¨CVöyèVõ]”æûóÒLn•%Bf®j˪>·yS³Þ¶E£œˆdQ¢ñª5WU˜Ô.–yô ŒÂˆ!ÑfŒ6‰úl›õlFhìAñXÇq%eh<}ǤK² Ð55^õÁJs‘g˜¥ú¨F!‘€CoÇFÊÀ’áÂ¥üDèûË#¸“ÇcÊá¨SU3†±O†QqIÀí¨N(^WQŒ1¾jþU!¡F#ê1ˆ®‚÷Ù¸Æö§µe`,Õ¼:”a;ê1]³ePsAãE=ÍEžuªù£ßðbØnøµHo¾G8º4 ÂЮ_+› ’dÜ.ôµVœ,«‘Æ ‹”æ":PæÑ/¡×ÄÂÏ¥ Á@Ó"PïWÓˆ=Òô9cç5t[¦+ZÐÞ}ÒÀæ”LxRZjã甆s·]&ÌÐOOöµ_G,U;ݵ×6Øô:LLgè‘B>»yHÝ”a»=Èæ‡Æj! ›j¼flÎEu Ì£_<ü]å <ÜóKá´5 Þ°ÔÖ¯]»yt¦ÀñT4ÖïÅt¥b™®D¥±ÔöSQÌkzµ:ÏO°\ùs2,…v¬Å {HÍzžØÖ %›‡ïN2nËS,à6’©*iÕ›ÚZç×2¯z÷iýdã=Þ¾z“IuJy\°æò¨¯¢!*K<Ô’ÌÖ™S;„h„’S¦#|œã±-[0cEZ·N”yô‹ØºŒ fj‚fõ¤&ŒÙjÿÉ«Mêæá­–ŒÛ9bðXO´mÉœ*†Mã±ý'çÅ<ê@™G¿@ %P¢ê3Šf¬Œ$'ì§sz§õWH¤„/Å”5§¿cb×Þ–Á¯­ñÐÖ%kó¨d^ý~yø@&4˜Ótª2¡Å‰H§áq!$ãö2`*÷Ô=žùç]ÈÊ<úEjcÂZ:£QBÀiÃÝg Ö”oF쨻¨]ƒéŒÙ2lO¥³epºÖx‘°¥¹È³N9ô»(¡½½¾ uÐçë=Nbö×W‘Û=x‚1Š#q}ê ÏArôFhÔë«ÐœâRÉ=ºþUEáÿ…¿ðAxÔrÞ­ŸK£Æ×€üÂma^µêû,ó «dØ.~wƒ>k"e½­ñ²ß]ÍEžuªå£Ÿ4Fûè>qˆç®;X5p¨HÆöŸüdcš7ξ,¶»O¢qŸ“ 0‰5^T;Ò\äQÊ<úE,&A¬TH4à†:â³~µÇøÛØ )%ÃvàHÒIÉ­ {~™/p$ç"/ Lkå~¡ñ*Ïs,z©®zzVOäg}žã“Z»ÍŒŸdØŽçX4žIÉà÷×xñk.ò¨ÃPýöÐ/LŽ ÷Ûœmq$=qêTÄ,ƒeª-Ãà®æmm™ðͬ7¢‘]@™c¨Mm]nG2:PæÑ/žã†ì¢íÒäÉ+áéSm=ǵš$oɰ}O&¦K² \Æ/5yÖ©¤~ÒUš'ðÎ.½ãº~çFšŸšéí3·”a;9¸‹4ë“Sflߊ³ÚrÞÝ̃’yô 7[j Áúyé§Qö ñXšÚ8!°˜(è…ßoh•í!+¬–Ó“eªÜv¥©-7[_æQÊ<úýÇ£êDkÚ×µUærí˜ùïJžcZ»OxïÙA¶v î:SU#ù'v«™¯Nw7Ù·:QÇJwÒçÏúkã»3ÒʞĹÔÖ¾uóPH2l'ÛH7ßZWm3ŽÇ6þs‰šï¡_¤ÍoÁ­Åió¤7d:âZ:âä™ÖîL¤´÷ÎUpJ&ÚõÂâ–=†e*j£&³º–窪óÆì7Öá ýìú^ÀŽt¼Û± Ì—äIž“¬&ÕÇ¢äÌè ?6ëz¹ òõÆ §+F"MCþTs’+m(÷ꪅÅ\è?—.øwŸŸçW»/•žc¯ ’FÄË(][„ª­2¶Qp½Ñ!’-ƒz»/ùuÕ\ ¥d^ý "':Bô¶yØñA7:âø™ªyK!^-¹ÑA§i™é”Ä©¶Í×É<ë”æG¿¸Àž’±ù\Œ~.ˆ·Nñ„ß}ŒDlëbZºèómlɨ}1°ˆSèƒ/Eö5ç":$ ýÂ@Þî‹ ä¤'6^aA‹ÑÕ–á¤f󪋚¬ÛÎûIŒñÖ%Ãbïúà\âQÊ<úEœ S‘•>!…5 q +`j§¾.YY£à%LÄ %‰Ž²B®œ=jqŠá…Õí*WÖGѰÓÔ|…ÿ¤&Á²ŸÕ¶Š‹oRØßG›`ci>Œ¼'¬°ò’.É2EÆúžÕ–ׂƸ:1…6ô{®‚XÕt¤»“·?:zjá¥m‹ˆ«ànW¥È™°[N(D`9åJq„¬¨@*‹žtb}B61‚EcG Ô˜[üáš{þ¦÷E(ô?Á‹/ý‚õSÏhÛ"8 à˜[qúœ‰B¨r|éUð~QëBÈû¯¡ä]åµãí±FµSÒ¬ÏÊêÌÝÙ·EmyãÚ2\’z°wd™Åƒ.™¢"!«¨-/`îæY'Û…~ol±§'6a¡` ãŽí:+–€mï™Û¼)P¤:ÝžQÐtj–*s”«Úò<µažuJí£Ÿ4Nð•Ö8z™æÑ+¹:ç±…ô§òçYh] túŽ2nûèEºàU„´ÂãÕìjëè•¶yÔ2~±Ñ'Ðc "ГâVDǸ•žÕÖÖ’§yMuxYFuw{lA¾F³¶¿l7£€Hq&ä¶SQ3¡ŸÏ/•ÛîpÍÇè™,ñÕü¾Ÿ˜Ü¹Ï›|Øyèp-‘ìðªù‡êé¼ÙI·ý»Ûs‹/½$ûê­Ëýîëh{ïBŠ7lc«K7ò¸Q†íîëPÐiX¦€p×,®¹@‡Ni|ôû«ZâÃ_Ö_Ö÷ðçÍqýyó–ÊØŸ×_[SAÈ«5fûñç‘gÞÚý>Q‡Ùeƒ‚^òDTpgûj,ž‘'"<œã];pK"õ597›í«±xN¥íý£Ÿ ¨ÍÝA…ô€äÀß Hè3AeÀÓ#^uòbR»‚ŠhúÝ!àYŽ×A…s‰Gì«ýâÊÉêÝzŽE/E!Aw)*i‰T©ì²:Ûw‰™xR¥Ø­ÅrJ†â¨ñ8kJÐR…Áršqjí¨k¦ŒÑY¥?ÓPx+f”…=ÎÚm^Õé¶v·oYXÓ©H†õ)8Þ¸e•1—xÖ)•~‘u”U,Ç’è,Ó°LÚÈ’9[O›¾YDvY†íÖ,Ðc+³X&ì©ñØþ“óÊÜ=¥Ã0äBè±ì<•(*LzÃíPÄR˜ÌN»e2™)¦PËb·ïfDzޣZ†‘دFµ,ÎZ:@æÕ/ ÛY¤ƒGÐT…¬…³ÔÖ¡0•5t¶eÜvÉñ)H#„:~…]4Û:,2߆NMµñÑï³ÈÅqôÖÌ…§?|qÕ‚EÞ>ÍvGƒ.ó.ŒsÒ/̉ÔY¯Ne~ôÓf`§6¼‘ˆžò™0’OXä|Ŷ,w­›·Ïò&¶‡7ÑÈY“Œ1çV[†û\Ì£”yô‹$Ö¼õösézþ¢!„çÔȈ4Ôf»ACèxp¼I†íâ5%hÕ)CvóˆÕ웹æ"Ï:•úÑïÂD1Œ¼L«ÎLi¡ŽÛ€ë’`uÎrB¼«x8ØI†íYN¤“rZLRë/9[Ts¥>†2~z*`õ|\º¤ížÍÛv×¥Û”ËN§aò!JíëÒ%M÷lS.;k~®ñºt«*SÒÝ;úãîŸv'7mì rlì¹ GÊ2ÕÖúÉjƒ+©»dØšݕѹራËãEh¡æêBŽHÃ2~±ºmÜ{{óêF$Ø‚‹sG ×ä~šÔÖ궆yù‘”a»:ÈZ´ÃFY¼VWbµì*ÎT{[æÑOßñVþ¼Pºƒ¦s@’U$ëP3d>ï,=>$íׇKºS&iÅ®Cm9\Gd*RȼúEøf±½ñç¥i…T2?·Úº«zÓŒííæ9“|’]Qã]›eÕµ/'ë@™G¿È´¥ Aç Ѩ½ð¬_—ú]ÕÖ¯M“4y®‘À_:Wˆ.ºäwüfuz¼âs…æ":í¡ßM]€Cožh8€ •³¶‹kWµõŒm^Su¼ÒÝ^~óDO•ýfu<¦›Ðæ Þ¢êxuYÊ<úýU¯{³è¤èÕ­ÈU˜ÕÏš´°ÜŽ­6Þ”¦ôB\ž Ëp;ÇêF:a¥¢L ÆñR¬nœ‹¼¢ë®ý" ¹в; ™ôÄÕt¤Ñ»/ÛØU"#ÞRèòÌ·­ä1Ò°a”鍨ì+[+ç:HæÑïfŒ7^i–AUÕ”lxµ+Œ—(Þ®šÝ5ü$¶ˆàÃN²¢²ÑžžƒðaYÔܱS`|xnò¯¦¹ý¦·ÞIÂ#Oã‰^*Z¿–ÄKaVÛ>Â2ÕqˆU$eb^ÀWw¤rNÊYí?9ùîæY±Ô?JjñCÑÞ9|´=ue¢{vz¶u¥`zÆõeTɨ=Â%dºTË 3@ãu_5W×™:qQ ýüÐÀìxŒ€KÏŒ;–2U^A‡cõ«];M©R•¶¸ÞB΄R,ÜQYžr…6ý°¯ú*Ï9Å¥6’{tÕ[ k¯N½Í32ü8ö &Úù'ô¤˜¨dšêóÊ/)ºœ[‚dʹ%h¼âŒ[ÍEu Ì£_X ²k”ü½’nì÷¾„ðì–ÔöÊ5̓Q^24ÐÇ®4k·¤©:%ïÖ@á\âY'Ön ý"±ˆ¦W¼!½UÛ»GõX$÷>Õc+<—ä5þ»Ú«¸âé<%£Ê UÕ„{Ź¢ªu¢ë=ô ƒÿbMnƒ?ë˜vV¬fž¡ŠÕlk¦ 1y3Y¦ªºà‚ÎÛ2§¡"ÿˆ,úVͳNyô»NŒ•Z8U¶F™Y•0ÄH[¨†Ã t©ðˆ|Û)uY&áD7\+8ªÑöjuÈJ2 ý>Üù \o]ÉÀ€Y¿aÀ¬†2lÏß0`æƒó$u·ñÌx0`æƒ3¯ÅKp–qjÍ<$¬ðdDxË{j:èxÓ¼r$’a;NM¢q’̶XÍÏ©Is a‹†°ÅB¿óe‘€VæÛxE˜ïÆ‚JX‘Õ–Ý’m ðfZn‡iZ4Ö(ÉÀT«ñÂ4­¹È£”yô‹H²‚;׊H2–) O7¬…‘ÔÖ«À‚$dË,ÞÄß‘V%!ÞW¼Vh.ò¬+ …~¤à4=H/¸5 }¥·ZÈ,Íw8¡¶G4ʰ8PA'ý:ÆÙœíû‹gJþè§-»&—È@·çø® L¹À’|2ðOô )l°…2æ¯3qÈåX.õäͼzÊæäMêOiræ6ŸzYöÕ;ƒ[~o2S·—ŒúmÛ ±Ÿ›ÌÖíe ‘¤a_¨žkˆà«8’³mgP3Çrɰ}#7H7”Ú¦LS^\›j۔ͣÍ广‘,ivâÙ²svH3c¬c+`}ní-™&Þ‚£ž2në]ÎÖ  *i¼âíDs‘çò²½ôs4U:LTަR‚‚ËÌDö6LÑÜV+~yÂ"‚Š@ã§çDWR–±zغf67Ô,å7¥/Œ ï 5`TºðÉv>Ú@ªÀjëüÞŠy¨*¶g€¢‘ÆC%„i¼ˆh]Ò¥XÊ<ú… ·ua¿‹FäõBåieklEq ‚æñÑ'Ðo8Z;+-R¯AÐDGî¬A95ÛX¦1—xÖ)ç~qZR@gòii²Î vå‚í }¯ª­SFë‘«dÔnaQ2›e*²`8^µ ^s‘grûè÷ÚÁbcF‹R3­ÂNB8n$„îM¼éÅÍ;Š‚AEVèÓSRˆ"*Úf…§%74d¡´«®ž’_ Åþ~^š8±V ãkêjÛ0[Ìã÷•„‰È¶BIÏm”YTHSã±­M¿nó ƒdýW±¹˜ÑOÐÝà#ÛE:Þ¹[éx²yÛ8ñCí[)èT%Ó>²„÷®Ûçj3¡N©~ô{ÏÔ»ŸKtEà[ sw,Ê¿1ÏÇû¹K¦ËoYßX”íÛøl*)§ñn²i•í,Ûª´Ÿ[ºÇ“·–iÔÊ zÁ7›_ȬšW'âlDgm˸]Â:G‹j–At—ÆKöäh.òªR¹yÀ ýbµ#*¤#”LO<Ÿ•>—*œN¶¯#‚4±>)í|n°86;3PQöxÝO™æ"oiíný£ß_õ¦u>ÞQÅI>ï&LÌþÀšCO€Žd,*.’A{p¦è€¥©,ÀZ5Þ¼¿æ:QæÑïó¯ã‹¾ã b—ŠÐÔvCS]R(Þ6ÉøûvI¨øþmÛ­ËÐw<£$Tuy»õüÎå£ß_õ©ˆRJóSê ñ Qêi;U½EAŸ(õ´]ÈN2Žšo8ñ/:µû»ôç7ë¿•zêéê”ÚG?Ù‘ Ú§œ[ѸŸø#À0߈ ~ÚXçüÁÀî¤Â¨ÉíêUPt9ëˆdpÒx‘ý§¹È3pß\ýþÚOÅ_PãuÖóÏZ1Ú}¶òºÏÝÝSù±¶a´«½kǘ®ù®sÞµbÎïZ1çÕ©æ~íï¸!è³V´€É@,Q€•¥·X x^+Ú/¹Êw­ÈOY¸‘ïo6òw­ùê”ûG¿ß?g·öœÝÚsvk¿ÝÚsvkÏÙ­ývvkÏÙí?ò‚ˆXË8»µò—Uulö§ ãö.ÝŸ‚Œý·‚Œý)È(Çm 2v˜Ý$(d0Éš‹¼ˆÏ.ý¤1`øŽ 2’Fq И>TO¬4µåÅayåÕ\ò˜yØîÕárÈ{Z±¯Ùj ¹È£M>ÞÐO>cÜfϸŠ/!+‚ªTŒ!™[mh‚›´xp{I†íñ%¬æ[9e*v>ŽÇ6þ®É»UŠtÌ£ŸNôÑÈs…èy®¾ŠL]0»²üòA­ë‰t¥ ÛÃq_Açf™3l<¬âK4yÖéÈ<úÉ~ßaNG ½pº`uEf3+€(ühàw_ʸ⌣^,ÓϨ¯Û‚£¹Èk®R>úÙ<× ‰ƒÚÏÛSè…íeOí•I/hÔô:=@íQ¨Ø™Z²Çæ_«Q#!›8…ÆN6¾ÇÜâK/ɾz¿s³8ÕT4ýxÍþ˜,@8¶ñm±ü5y°«]ß_ÑxúöK±ï2ô÷uÙ;­¹È£”yôÓŽ4߸ݢ3Êf2"8¹«-Û Aø:ì-mX†í@\!}ì(S2'2ªj<¶e{éÛ<è ™G¿¿êÞrÒ|D°ã;f†Òˆ‚§ç“+ªDZúF4è“'µ%£vrPЄ“cEÍi×ÛúÍXLuÖ«S™ýÚ1æ7Ú1™ozGâã*zÙöê°ÍƒX2S…êí÷$PPÊtÜ»9^÷!ç:QæÑïæ³Á^ªl„ ™Ï&Àš¤‚l˦2ªyEQs{ܶÞ(ÑEùlÑñÊgjë·`4›òÙ†d^ý"g0ÃZ¡˜è 'K$#>‘¹'µªÛR‰]V'ëÍ2n§¨ÏÄ’¸uKf.­åµªý'çÓ<è ™G¿Ð˜¿¿ò'‚ÞˆXõü~Šm«-Mr7’q»æÆL÷Þ›yί6ç":PæÑ/ò'²Uà^4à{ØÞƒ\œ 8Ÿ\À9Ì[Xíki3]úuüu‹±²çj®fLŒe™G?­nÀ>c¤ìÏK/ZPm§âÖQ§ÚXjÊ’Ç,9ʸ-W§èªèºäh^®NÍE^ø\ÏýÂcBL4¹âIO”›¡·bâô2XÔ;Ù?ËJšžʰÍñ®ge,ÕLð”¬ñØþóöÔˆ·mÓ?úEœÔ¨.Ò#ÚÀ ÏÓF…ÖÜÔÖÉyeÑ-É^Ã;m%3b«“½%C¸_ŽWâ~¶ÒJ(`êÄ{xèVOPŒZÐ ­^¤ ?\jËꙊy¨|,·süs¯Ú² <)/F]W®Õ6 ™dý~6Ñ›À&,_Þ°Så6Ù–Š=T<›ôØdG%éÒ,3TÖœÀ&@á\CåË©Siýb­`‰T¼V¨¨W ìÕ ÉSm­«š·„ÁÇT¶}'XʬªÝ2pºk¼w‚¡hΕ­eý>vahˆÒ=•†yWG¬©îñm¯;>yŽ ®A<"oØt–éÈÎt%Êþ± gÒøè§`C4RòS!mB rZµwS[7»‘ÌŒ‰d¦`‰õT]šd:|`¯‡s‰gJûèñú{*çþçÒˆô_X•gˆ<ŠeV_ñºö`ذZ¨kbš&®Ñ^À¬/~ ÍEžu*ë£_øƒ'ËŸ-»ƒ§’…š0‡‘+„hÝLàeQMat‰Ü-(ŠÃâj5Kp£†:GÝQŸ]°ÉäY·š?zÆ9™€Nù=T÷vUµ]KÈS _[áS›¡]Û2lw…‹ešvõ¶Õö]̳N<%„~Ž¢k ­pUw¬ÊÔÄ{TyÊ«~C…‰*!sV 9WUÇ$H*å+ØqÔá}ÛsŠKm$÷è&¤ p4—47½ˆí‹@ÒŠM¬NµµÁ¥*šXÁÃæ$¶sü]ç…![Ææ¤:ÕÖFȃÍFyHæÕï¯zùÛ O-¢v’c%2¢Üª~E /&té+¸>·œˆ°Â¹£â5“ú{L‚×_ø@{óééÝcÄ3°uýb'¢H3ñú¼`§=çðâ5¢hÛ‚ÉdžÔ° ÛO7†ò$ƒ²W¯ø6£¹È£”yô +cGDõ,¶2öbñ,¤€; £suiæj«ºôr»Ç'3ºeXî$;r;Ûj™†yÖ)õ~‘™2 Ò²3SìÉ\Æ…1“„ÑÎ$Yˆ#o+7ž¹4|¨[@æç¤l0É¿³¼])æ £ÎþÑï’ZÝàè¢qÚ¸kò·d$Ó½ ¼Ÿ4 Š„Lô7[–8jØÐgö-på–¶¦– _ _fÄ ŸÃGÒ YÕa"Øè€%ã…eûÌР'ɸ­#©hÄ0K8ú/Š£k.ò¨eý@†ÐúšE#üèÀCt­ImÌ0ÏÚ/ÞBªCV!Ùž5þÎt’9‡¸¢ñØþ“ó°z–«‘ßC?oáI§‡€¼tÇbÖ5ïó•'% \¼e¡²“f“’È÷OY®Íkµ¬C„$a1ÕÐFr®×z®H;YpŸž½A V.G*‘Ð9‡ï °yçËG¦tÈ%knô´³†lÃÛᱛߘ[|é%ÙWïxxVV©—ŸKÃRÜ€(•Îbe#4òë@™mLX• ò1’gÑxÃ'3ÍEu Ì£_D.vÚô“#;ò,ø˜dà,ì,ÛÛ¶ÄVóàM—ÌRð²íF¦Sµ ñQ9^q æ2"+uJõ£ßg?¯öPL߯ƒVÀ÷͈l VÀþÝ=œ2ö+;ƾåUŸ3À~Îû½3’gÿñªýþªG¾N8Øé(ÑëœÔ;ìlç^ˆg+UµµhÍdÞܨnO—ƒ>Keá¨ñÞQs /ÞÅ2~Õïø¯§ñ¯gº½(Z¢]=%gEc}|2¦±BŠ×ï§TûfL÷;»d˜Ý„&æŒiÎEu Ì£ßÅ@Ù[HÇ?OÇ J ‘v‘…òI×þ,¨©Áœ‰–CŽDw·;¢°á¦ÊŒQ›ËPyNr¥M2 ]#€xšr:€˜GvAÅc%ŒSêjËdÈ+ÀF°m– ÿ·aÃtΖé &N]müçê ¦NÌŠ ý¼™çŽ/Ú̳ƒùOÒo.Í_A9œßÛsx~–®SÓy±.arÞI\ÄþÛ—ÚÚ›K3Qk’a;Ž™é¼$3ïËñØþ“óîbžuÊë£_l–,ÆnܾªBëeÜBØ‹ÕoªÚÚ,W2IÊ”a;¾cÑM³åŸsU[›e›æQÊ<úÝ ö÷Kµí+€Ù6MW\®ˆñÔ绘™ ðzËà¨þÓå¸É18A£’ðº·{p©Þ20\èNè™*ósé|®pu©°+d²— ¦.z–´óë…§ŒÚŠt’a¸Œ^ÏÅ©¾*|uÊã£ßçê'Ê"‹¶ÀQ߯ú~¯Žâ—½ÆÕqûÈtŠ«#äzÔÞYñ¬Sªý"(ˆ‰m:ƒ­¤©¡L'™ª¨- yYæ¡þe¢­3ˆh™“ @4^Fi.ÐÒ2¯~ïw|éïµæŽäœùFògû~Çâu9W¹íü^kŸ2Ê$„:p¼¡~•¶¯5’yô»¯áVI£ïáVÉ#ý§‹Ì׫$Sñ~ÍË<²HVT½FÖè)ãÊ¢ÒJŒuXbnñCÓ2~Ó;œ½Ýðî?—ÌØ"ü[ÑÉnVµåì­†£?f»f™&x÷ua6B^ÙËÒG5{¼®ÎE^Ø2ñ¤²ÚºœÎiª×I†í¸ÄM\,CîÍãÅ%Fs‘gÒúè¯a†™Å™ ÆŒk¬5J¨ÄIð$ìlh"PåD³ácXÔ].£ s¿ˆ–,o]—ÚZ8T4>]rÿèwcàpLj‡è"“ËÀå;ûʶ.v)™GðXʰÕC‚.Õ2¨ð¡ñ¢zˆæ"Ï:•úÑOONæ+¶ÑØf“wxÂ3Kϱ¶“9äUž°æÒÛœ·Û±ˆÆÖ ™$,­ÖÕÖÓ3·yÔ2~¿yû÷§"˜#Ó,nd¨Rgšåy=£^oÿ~ y ‘w ¥(Läܸ9®N5}ô ¿®¼d#ª·»Rlª·Š ͈iÀUíèÜ­Ý‚A¥ z…žÍú¼Äzd}^ ˶ m™e¶ëý^M;Qç3¡âq¢®ùž¨ë›¶,žOÍó9Qç3fE!‚þ.Œè Q ÞZM”yôÓÅÈÃ`ò?/½Tt<ÈLÖ‚i€mÜF&pÈ›‚Þù¶mœ&ÍD,ÊT)Aÿ¦òNÛ<ê@™G?}ÇU°j =ôWT°Š9ÃØoÊ7 æ}¾~yºÝ4!šÁÖa H¯…ù„s‘Wï¶ÚG¿¿ªkCKË>–ן ã_Ú1——.¶e9ÍËN:¼ø8çÊüÿÈ­øo=MÍ™¡MeÁ}#úßþã_â/Úf³ÿ‚ôûk~ÿ‚4þbÁ¢ócº%„™ž¿(%ËVü…è÷/:°Qî_~þâ·N_à.ŸO&úÕ»¦ïg'ýþÅXßOFúù‹vª¸¶û¢ñ1e÷³“~?YÒðýd¤ß¿ yèþé÷/_|ÿ‚ôóxòæü:Ü/~þO¿q¸d~^Š_ûí`–nN…yzN¡Ü+Z͈B̓Ï1ªy0ØüÁ'O²Aé=X‡C±´1v‹ [Ï-¾ô’ì«·l$¹Ëñ´<=•Úá|w¨SiA¿é¾VhÁàS=dE]«Çí9Å,›©ÆÎÞ¿bnñCSȾzÿó}–BG]Ù;Wô l³Ð©w¨3­ý¢þÄ_##;øðo‡¬¨°žtN!›Înc'ïe1·øÒK²¯Þú,‘ZšуçòP¨ÿ6ηQ2ÐÆEa¾¼˜³!>²BVT³âéùµ‡,`”cìj7DÌ-~h ÙWï¾gìŸé³”ŽìÿºšSŽ¢i,¥ó—_H·9{èy*Há9èØÚ‚”üÕ| ~zÎG²,ŠHÄØÕ—á˜[üв¯Þú,µñÇVÿóö Í£øØŒT­Cl)R˜¯ºLÄGæQÈŠv‰GO?¦žíç„cw‡?ÇÜâK/ɾzÿ>cm¬6nîá)¾èjʳ~iÈ…ï®ËÃüsI.!+êÞ,¢ga]•,oûÞ/<·ùÒT²¯Þú, ¡@µ"=êçéiˆF>ÔAi€- žSQ˜/ âň?Y³C²¤86ÿZ=ël%–­€ôðØ5?<·ùÒT²¯ÞzÆ¿›rÃÝCèïÍo²|c£…ç`ã·~áª/YQ7Ü=·,±Á=ö…÷Üä[/Ê~ô¾Ÿå×iµì[_Ý=¼m8O59ß\¦üYÎ`~>—Ìuë«»7C¶ãÎå±»ccnò­e?zë³ÐÝ|öÖ¬Be·ç×?Ôàþúë ÈtA‹Â|+±Â ù Ø––½T¾šCæå;Ûós‹/½(ûÑûža`ŠÉÎxxzÆÂÉ·EÀÕ oG€ÙsÅšHÈ%SvôÀ°gY&l{lRükÝçÄ—^’}õö3¶ˆü7ÖÆ=¬ó±8_A(wfµCQê‰<¨„âÿz*ž‘dM€µqüc!Û‘˜à±{ä-xnñ¥—d_½ý»lVfÙNÍtÏàé4PÿPçA/À#…ï®$V?Q²¢86ÿ:z~=–íH÷ؤü+ÂÒLþÕôÈ~ôÖg),Oß§qí£Ö²C-Î0Î|ÛEí€Q|B°[VÔ4Æ}ôÀr²XŒcìah˜[|é%ÙWo=c;ÑéÉѳ¸Êf:‘ìªuH”WÙã4¿ÂUiYQ‘ªüôœ8AËâhcGÂrÌ-~h ÙWoŸa€\ó9è‡ç dŸQ&žŠ÷ 3Ê|ൄ¬¨{†¹=çbYžQ<ö=ÃxnaBSœa^½ÿùÎc–ÿŸ~–P¾>ŸÅ=Ôg ž#¨ëBhÆûYNP{¿üÉ3ŠdEÝÏr{Ž>–¥®û~Ï-~h ÙWoŸ“Wü€€zÎ'!X£vÄ ê춤¸0XüœˆçKÙK)*Á='R¬„ì‰![16)ž“9·ùÔK²½½&ýã¬mòê==çLµrVÙsÞÚ¬ÝGŠëæ>¯zJb;Ê>Tö™_=g*ËÚ<ÆîQ›Âs‹/½$ûêí})¤µ­¸¿¸ú‡:ã›ÎDr4>g&Þ ÌÇÕ(dEEÍ衱ٲ€&‰±gÜ_<·øÒK²¯Þ÷.v¬ m:Y/zÖ9¶jeP;㾄ÐÃåxs»:Ö;ó'N¶–7„§ç¸&,;øüjì¸!ÄÜ⇦©þ¦·Ïü¨Û\Ó°W3z&s¨3^BÈužÈìÅý µ$‚ßðË[VÔ¸»Ÿz:lç–ígKŒ±»ýœ1·øÒK²¯Þ~Æhçlýܾ=³‚Òws,+¹û»‹·yø»-´&â{—lPiÆ_£¥°B¶dŒ]ퟌ¹Å—^’}õö»ß?ø‡ëêï†É ïš|ÞÁ{†aMÆ]¿ŸanÏYW-Ë5×cß5Ùs‹ßß3ÌGoÿ.•¡Q|>zà]?Ÿÿ ¾2ý|wi›âw×Ù!>qi-+* ÑGÖCaê1v”£¹Å—^’}õ¾kršðШFJô qß]†¯(i…ž¦üM ùHîYQ=ê¤ÜX+$‹¼¤;ÝcnñCSȾz?w1®tJú‰lF‡êÚÏïKÍTÜÅÒåg®«”5u­œ·'Ï+;ð¨yìaH·˜›ü«iž¿éí»XÁçëø¹Þ”:Ôùn:’2ÊqS/SÔ®ÃJ|T9 YQÝ7ê§'í+‹¢E1vó:æ?4…ì«·Ïc@§ªiù^=Œ;Z¼/%{ZˆVÅ3S…UËüv®µ|¯Œž‰&ËND6{ìé{eÌ-¾ô’ì«÷]“XÞ Z=ˆ»9o$ÐÍý9ˆ-ãõ÷h•–?¿¼dEuC×DOƒ Þ²í\•cìfðæ˜[|é%ÙWo¿ûHJ¬9±ÜSluähµÊ<3!• 0±NlXàož $K*_T¬Û£ÓÝ‘ÍË'¿3vh,Ïm~hZóozû³ ªìįcу‘fµæó[†š‰â9ÁmÁÏL+€ìCÙ¡ž²¡Ø²ÇbÛclRþ仹ÇzQö«·?ËâÉu‡=Y=¿þ* ~wŒ—8©¥{3p*ù´ˆù¦{Ž>0в¦JåEÏ¢5‚²eù7­ÉTüæíò¥©d_½}#6æI¡Õgq®€çÌtìéçñL f1Å3q;Íïð[VT Û¸{ ²¸>ÆØ%>‹ç_zIöÕûÚÆÏñ†€m?oÏ>ol‹ Ô¦ÕdS¶û”yù(ÕhYSÏ=9]YÀQÆØÓ™Ô17ùWÓœ~ÓÛϱ?o.¨Ç¢Õ¨“+¹o­ ¨/æ#$dEug E„B'ž;"cnñ¥—d_½Ÿ}ð ö}öŒÍÛßö¢½yšŠ}¿]~f½ Ê^*=û>ý7ç~#Ù_oÀ*16©¸¹åàK/É~ôö] ιÓçX÷àtzÖ`X®5…#DšdaBOð«?+dEE²äÓsâ $[é±K¤LznóCSȾz_ŸÅYã{}ã.ÐÓ;Á»h@\ã.`Á¶!+ªÞ¸‹èQÜd‹÷YŒ]î>¬¹‹ã.¤i^¿é}ïû(š JýôLyENHhá &wQÖîœ͇Ù=dƒŠO®žt0ËžÒw-Æ&åÏ;ŽøÒK²¯Þ^“aÓ­'-Dë˜{R=h>T×¹šúÓ+xºü+eEÕstOGвȓ‹±# /æ_zIöÕÛŸ¥ÙV¢“è¬ñÙŽ·´!Ï0AçÄmŸ· ËŠZN6yzN½SËN¤Òyìíž[üÐ4íßô¾ÏØñ¬õ|ï/ê)´Þ-x²:Œì£ëQ†OÍ~AeËšÊ÷þ=y\ÙDËŸÆN¥á¹ÅMóøMïB{òÄ%êÄæ ÿâé™|Ntr8wˆã½]¦ìë=áìæožJ$Tò_«¸–M({é±Iù‰ìùò¥—d_½ýŒ%„¨'áçÛ³Î]4#´ýÜyÎÊTøNŠÏAAX¼ù¼Z6¨b»¥zB²!±‡ËúÅÜâK/ɾz_;Ìùû>_=pâê$é§îCÅ”ïK¸ÙŠÏû”eEM?‘Oì4Ý7n¬à;r$bnñCSȾz_;̉]Js=ò ®ø¦kXNRX#ÎI}d÷¢áI6¨såg‡,bªbìˆ¹Š¹Å—^’}õ¾gþÌÈ cÿÞžE«ëäi²rÿ8ÕwÇà†o>¢qB6¨Ø1ÔFÈâë±«Ó cnñ¥—d_½ïï‚S7Æ=ŠiYŽ>˜¼‹u³<ñ0ÛþÜÉ»Xm– ê±v«Gñ0’U<ŒÆ~âa–#ʾzIöÕÛgK`ál({òí™<ñ›o­|jh­&åÓ"¢¨ÄGõ× Êöd÷à¥Yd´ÄØ‘ïs‹/½$ûê}cH&W•‰Œžé;Oåûpl‡kÛ 4nTÈhÁß0aXÖÔpt[ôtZ#$Û,ì±»ï1·øÒ‹²½ÿ ÷ʦÏBØÙÂzÞ?·§žåSöŽjp…†w'ÒamífO!®dEil¿ûèY@I¥ì¡ÊðØ¢ÂÃÑ/_šJöÕÛïË`VN=¡Ÿ·‡§x{ªû1y†»ßè¶åػ̭1®¬¨Ñm·§´+‹ìù;rëcnñCSȾz{SõÚ{»=gqO¬Z[y×úµòœûR½w±„ìÞà7ܵ,TܨÕÃD)ÉÞµ4v¹w1Ím¾ô’ì«÷}ÆwŒÑã[ò‚ÓÓ…z‡À8OEj¦bÉî9ÏPé– *V½èÊ@Èž;Æ×j£¹Å—^’}õ~~®›}Üß…ë걬œïF¾Õ‰ïïR”VÅw;/¿ÙS YQïèéçÉÙN¯³ÆîF‰¹Å—^’}õ¾þ—ü‰!‰¬E‡šCr|$õCr<*©_~ã)YQ±Ž==GȲ´ÚxìXÇbnñCÓÔÓÛ¿ H`Oóï=°owž’ƒ||ð©›âwÇC¬ùp•„lPñv©§Ò6.ÙJ{Ôð·oW÷ |é%ÙWoï/V>÷Ÿ-oÏ9TA;÷¡sv:ÙÞÒ3ñ,Kþè†e/gKõLž“o3»ß±²"æ_zQö£·— „·qãуØïsçiŒ´=ÆÞsÛ¦|_šýò ý’qãуØïÅ}*Æ~nnš›|ëEÙÞ¾‹uÜ펭ñ êYgÁ<6µÂ¨‘I Ûî¦lÃùò¹³ZVÔ¼‘­Ë^¶¯ì UUcx÷=·øÒK²¯Þþ]&ãkšËFO§GeÒvƒ‰éT‹)>ÓH{þ¦•H²¢Óüé9~Ëòšâ±k¬ž[üв¯Þw«Œó­wSϦ¿v3>¹W¬5}›òÊTÆå7¤¹[6¨z×1ôpû—lçö¯±IyÛõò¥—d_½Ÿûþ±ªvŸa¢g0Â0EuLF836‡”oðçve~'¾¢dEuŸažžÒ®l£GAc7ŸabnñCSȾzß»¢òë‹Äõ1j¸Ñz÷k‡Ý”ïbµ\~¥íQ²A=7·ÅüÄæI61nOc§×§¹Å—^’}õv¾"jN–âúžž³“WÚ¨N Ž“³…ØQ˜¯ÒÆe>í_– Êq}îiˆ‘·,·1vœDcnñ¥—d_½¯_ ÞÒaˆòèAQæFU9Ñ¡Î Š”ýbu]~c®„dE댞fÙμQ1·ø¡)d_½ÿïb›*f=Ù6®$û6O¾@ã@›ÂRÁÏô˜H6;Ö;«zŽW ‡l£Uc·=U÷X/Ê~õ¾þ}¼ëžù—ýˆo`L@ƒM£SžoÖËgôeƒZ÷ÌŸ%¹×•nwŒ=¯¥CsOF¾.û4öúMo¯cÜmùþ¼=ÀÁ;{¢‚Ïw8þˆò^¹êåoÞ$+jÝÛUôä²|»<6)ï•=]~h ÙWoï/V\®t?oŸ“LßTƒŸãP«š²ÍŸU|ú½,+êñ¨°§ò“lݶ»ã“í×îžçåS/˾zû³Æ•q•-+*Êr»§¢È¶eëvTʦbMΗO½,ûêý¼/ñ’ŽësJPã™Í Njâ~F*Þ—vùòIVTdÊ==çw³,ò×bìÈ”‹¹ÅMÓþMoŸ-i­îž×èƒãPç›ì°µ#w­›òù¯äËÇ0!+ªØ÷úô¤ueñ›ÆØñ›ÇÜ⇦}õ¾÷—Sãá×:­\ѧgò|¸¹ÛËJ„«Ìqò=~örùÀ$Ù ò͘ÔzßZÈžøùc“òItï˧^–}õöy¬3‡>Ûg=€1:çÀë~¨sÇ%å3ÓÙ³ÌglžeEÝ ÷લ‰Ùþûf˜xîd$è%ÙWï{ÃgG¥Ÿ·å^‘gÂý¬ó}(É”ß{åoµ9dM Žó Ùî{Æîï=¯×Ë—^’}õ¾Ïئÿ~Þ;2zxÍþ?Ôfä0›#(ñԴ˧uβ¢jXÓnOÎW¶ð¶£±Ë½QkîâÛ4ÕMéêíwð\³ìzÎÍ´0r•@‡ÛßÏÅó˜ø‹ñ9’ *økôÈ"d]c8ynñ¥—d_½}NžØ‰s œf÷àÊz¨ssÍ€/ʬ %*ì>åò7V}ËŠ*÷T=ÇroYFxì|OÕš[üв¯ÞצTyw#lJèáÊtŠÁèÔB SߦlS*ãò3¡ð´ª‰JŽtO¥=@²çŒÒclR~w ¾ô’ìGïÇÿÂÄš¯ÿ…=:ãÔ‰y,>ŠòYö-؃³î´ìCùêžN déïðØ×â¹Å—^Ý™ Wï7^™·á+÷TZ¥óª×ø>L… «^>s§-+ê®à·'Õ+«@ýäjnñCÓTÓûú^7G¨ÆˆPBÅA bDäiʾ׳™Ÿ±NIÖTv6[ô$gK/ž£óºc'×չɷ^”ýè}ãa cˆ‡÷}õЦ–±…Wp¡ÒLŹ<]>m)–U¯ÅV=…¹x’-ÌšÒØåZl5·øÒK²¯Þ÷l /õ>G£ŸoÏZ´ÅWDé¤yNÚ¤¼ŸÛ ùı²lP%Ç_Z´uš<² =6©ð!ÔË—^Ë'Í«·÷—Êziþùöt¡u¤£â3¦)îÝ{øÈ¬ Ù lñrOãÙS²k Ç®±Fznñ¥—d_½oŒâ‰Ü8¦3ÇÀ« ‘Eˆ´D­7SôB Ü1ÌÇñ”ý漤…}p{Ò·'p{ò€Û“?¸=éÍy÷Øÿep{BÓÔÓÛgþÌ;̓©’ã\”Âû0S„þÁT©¼O‰ßx×’¬¨S%z€‹"Ya¦hìSEs‹šBöÕûþ.½ÿþ»ôþþ.i¿¿Ëì¿ÿ.íâÇ\¼%a1í¯_ìöèwiåý]fÿýwIûý]z—«·?Ë JÞóYÔ£ÏÛb|–À² kœ9Ïg-éýÊ'Néé‘>ãbÝxìç³hîläèy±n>zÿú+ÿþ,–¿?ËߟåïÏò÷gùû³ü|–ÆÌ‡ç³¨'ôéãꊴšÏgh[ðǹO…¬¨ç³Dô‘¬tÕØÏgÑÜ⇦}õþçû]Ž5ÕÍrø’ÜSp°;e ˜Y!;éj¦Âªš.0ÞE²¢rø’Ü#$\É&Ü®3®,»µ´o4€1òö•%ěǎҒ1·ø¡iÙ¿éí;2±Ö*­ý¼=ƒèëHn<ÔäÍ´WS¾Ç*ïüÈ–†¬¨QMîi(ôkÙvì1v‹¨&Ï-¾ô’ì«÷µõoùÆ©g)¹ҫNë\N¦l½CÙ=ñ; òI6¨°ªª§3JC²Q»_trÍ-¾ô’ì«÷gM>Þ&û‘oÏŽ5¹2_릨gM~³§k¯—ªù]“YjYf–zì@)¹ÅÏoVêGï¾ý91ûûYÔsí0×f4P¦ø7;L½ç‚ ¾×óµ]ÜÙa곯kì¯江…¦²{\½ïš,œûy÷—™¯UµŸ3[Zøüû®ÉÂçß\“sýã±È ŸÞýňýóʆUu‡Õkré—š¦ù›Þ7ÏbÓ¯åýÅ=1ƹ1mâ8¨sÅ”ßfáÏ.!ZÖ++ꃈWEµ×•íŽnËÅ”×Ì-¾ô’ì«÷Ãèýåœwõ,D8YS‹1+Ù”ýpy]~&ºeMÍ7zF=%_Ù<|=/ßs“5=²½/>LÊ„ãÇÔ£Uv2*qF|X5EícÅG„KÈŠ7~,zàs“¬VYÝ#ÎÎs‹šBöÕûî•'ë)÷ÀT¹=“;bjήÌÈ…áø±³ßÿ¨ùŒ(¶lPÆTqðiCI11v`ÛÆÜâK/ɾzßZ£~Ö±–ûJNk8pÝÚgÛtˆ™_# YQ¶mô¤~e…]«±l[Í-~h ÙWïÇÌZ Îå¹=“X¥ÊÒªô¦a*üÈåò™{`ßjPÎåqÏ`½ É2+×c?Yš›|ë5ÿxõ¾ñü™Ïê÷E=±MüåÇ“Ñýò¸ònµW^h2#]YQõ"盛ñ%q½ÏãŽ8W1·øÒK²¯Þÿ„ûþA2ÙÄø2¾eôL¢Oaˆç±DõFêaë ~fnaÖxP¯²,;E|ŠçFOè•!õö™¾Z~E?oO#.0®»‡šÌqÜË”=ö'"Ìü†,+ªÞÌoõûÿ!‹ÄÞ»o<æ_zÇ\½oŒbbõ™nÿ¾z2Qëø{¨ÅÅOÊûþZ—°á…±½ï7â1í²}µŽc“ò¾ßûåS/˾z{©ÄÇØ§ÄžóËV"Ïøå¿ñD9>ÏÁâ-ÝüލËvÖšÚÁ"zN¬e‹J¬slQö…Îtù¡)d_½o®èÙ‰Oà¦}âêÆmLDÝžDY˜ÍÔŸ:‰"ÒO|"SYVT¿§Eõ4"JH¶ñ]ÓØí¾‹š»ù]ìõʾzßøÊüû÷oÐÒu&ªŒ\uŽãEDÖ™ªòăó–dƒ „/õ4 X–˜ ûb6xîj¤õš®ì«÷…+Ä©Ê-báÔ³ˆV»Ÿ\‰ÍÖ†)ÞH¦k©?q ´lP¹Å_Æ'·ye‘ëcGVyÌ-¾ô’ì«÷}_ã…¡úôd«Å ¡=ˆÊÒ¸ªƒò€xñ dÙ R¿²ÃAa°le%·æ}ÍØfž[|é%ÙWïû»¬ï^éÝ ÇƒÖLÇßüûÓ˜à/ãY@VÔs¯ŒžÔ¯¬ê%ÍɃ=4GSȾz{ß ÎgßWöîjo¿öõöÛ¾õÇv>ž8QϾ=²çgßoOeŸ)0·ø¡©Î å·ÏrÞ¸ÄX·æº êAð ÞHYþ>uK"Ç~²~øQ÷²¢†WÙèéDÞ•lgd¶Æî‘â¹Å—^’}õöûÒ‰ãµÕéEŸ®½÷DŸÅh/S|¦gD§ !i_ÙQÛ~¢ç`ÎIö`—›ÿšs›šæñ›ÞŸ¼×ëÆ=Ä«É<¤n­‹_Ê~ÖÍj«Í¦½.Õ++êbÝÜžÔ¯,±l<öźñÜ⇦©ÿ¦÷ŹúâöDOÔ~º¸=ç›üâö Æß‡9ÕŸÚO¢ž8¥èA¬ÑzÞöûSûéâö<šBvüGp{€/‹ýáÆó«g/Û Ï9¢ÓR>«)ÛÆ¡ø,`jÙ b'WÏÀ`YÞà=ö¸§jÍ-¾ô’ì«÷ͱ*¿ÙúÔqJë±õ­çFl{Ü}[ ì„ó?ˆSšOœÒ~ž¡û§´[_h ÙWïçŽ?oO£]hß³;Û4ý–m€ðúàgÖmlÎd-û›m=%_ÙB”]nF–æ&ÿjZòoz?DŠ%ïa[\I•#Yé1é¼§:þ¹ÇæËg#Ë–ˆïñ6;~_ÙÆÖÃn¥{”¿Æl‚_Ôâw3³©°/¬Ëß°£ZVTz¿éÍÈõ½Cv(÷c›û¦¹Í§^–}õö:Æ`ùwSO¬EO â¢yò]ÇÞ¨ÅcéyÞ5SM)½Ïüz£cìg[o ãÕTõïÖ°ŽUœ« àæ~žžŠsðnzo3ý£Ã”mã³\þ0f}Aqìð½ªG Ù—^c“ ßë¾üÐ4µßô~â-;nʳxz&× Ý*ˉ‰¦¸Ö,ú¦ÅßôbK6(EµGO¹e ªÑzìâ<‹˜[|é%ÙWïwq–…oÜEÉw]mï3ôë4ØÊwMÏSw¨ÇæiêwñØ-q­|×äö>ƒWSÅ]\½Ÿ}Ÿ;Tzö}ígÜ÷ëg“už<(Q±ï§ËW¤­dƒJϾÏûì’m¬¤±#G0æ_zIöÕû~–ADd׿p.}g†Â½{ð4ˆ–µ9¬øL|±¬¨‹òèÜ¡ŸOVú»GmÏ-¾ô’ì«÷Åî8±)N¯{23g+NâÇHÇ̉“‰úÿ°÷&»Ò.=—Ðü»ŠsDßLa€„üˆÑ¡‘Pm$¨·OÚk-;rWHPRU½úç=²ŽðÎ|žhÜ,ƒÂÊäù7!w¨¦Ð%U½fâoñö Ô5ª MJžtÿ[(w»B÷µ;ñ-/ðfb#ç`-êèr€Œˆn€ ´ÖœšrߺB—ÔÎu,8e¤îÂ:űW®cœ›ò°´Œ_vãÃÌ“Øéä §‘ÕÓL÷©Uz»«(âm••|ºCHê7ÏüäШ¨@±gþåœ[ò°´­_vë¾Oœ]ŸäçåLܧP‘fà“È}XW”â=}¥¼â¤.©!$©‡SWêúcGÅoÌ yZZ×/»…Ý^Qk…¯OœíNöQ\gá@n¥3S”wû…¼¡ûuI­¸!ˆã­+Bד1bì7Í=…ÓævA÷Ën½û‘g5VäLÔI1³h¢†jÅgfú®J~¼C¸tI¬±"§£NŠºÞà&Æî?¼‘çäòÝ,Û/»õ»4Gþi;r¼%Cë~Äf',£Îåß]÷ã}ÈÑ·Qº¤¹ 8@°.ññ8öƒŸÇ¹)§]Ô}íÎÚ·B«0îÈYêE5‡°äl%l²Vð³SÞJ]R3ûX§–ÔècűGô±ÒÜ”‡¥ÄeO»ÿ¼¸˜ßŽðÜ ?Yœ)¤¬÷e£ÛÆh¢Â³rR>ü´(]R#onätäd U‡ö™c÷÷æÆZR—Ó.ê¾vgî(+„•C" Ϭ†þ:uß9¦(Üz‘ù!ùôìé’:YñK|ÒEfƒÆÎÜ4ÍM9í¢îkwúaÐo× ?ÌÂNßQ Ør'hžFPò¬Ì™rô©’.©£›œ%?ÍDÚ7U¿z>znwKyU—‰Y’Šž§îеžŽ=Æõ·nR7äi©é~Ù~þú«æ}ËsO?ÿ[]¸ü~ûù¿s~çSËLêËÏ?Ÿšâß9»ýWÍûWl6-¥Ÿ¿®?xû<Œ–1||‹ýy8ˆÊî L ü<ž†ÊŸéÏ«agoÉ·ŸJ¤ cëÓÎu?”¹í86¨¿i‰Í-9-¥îkwæ'`“ÉiêôÖº€eXš(åy¬“ò%DÚ’ªÑýBœ¢ü×-êçcùÇbî¢No§¦îkwâÃlDŽ„Ý‘œìVF äpÝ# gÙdʽƒYè%ìqºè¤ÛpòåØ-ò…57åEˆ(³ý²[ËiU>ÌÃ1t´vµÕüÑ2†[Ü1Ú†*åÑ*ê%ôMqÜ)!Ý6È>¹%ßBMuÝ×n=c´å¹‹‘Ãû°Aç Ô .Jß]½)¯Šø™®¨¼‹‰ƒû”tq×ÒØÏ]Œsó.F»x{íþóÖ1ï,Ͻú¿$çп˜·gáúJ‘®ÙB~+lÝÂÖ!UÓÁ(÷,©;Ù]cÏèÿ¢¹)?Ê‘ò}øµ;ãb¿\ÆÅ~½Ü¼§Ê*ë¢êIârS„3éN!ô''FQè:¦\ŒÝŸsS–ºîkwúÆYÃØžÞOàÜìÉ5¼†÷Í:¢äg å@DpßÔ êéàµ[Ê>A øÞìy=¨¿iÉ­)§]Ô}íÖy¬"Û¡gþ99` ½ØòÃP² g¦ŽnN”#|-]RÑÑåá”™º ùa»eþç¦<,uÝ×n­ÉŽ¤ãØ½Âè&‡x…Þ÷áÕ¦]MGTLØÑH9Ñs©Kª'FwpÊI݆ÌŽÝ£›sS––óËî\“ŸÉk2W†j—}Ü9ÂéÿÆ*Û}÷k'u›¬>¿8À'“.:RjìøüšrÙEl³×îÌ›ìg¦xåŒJAÄÒ *½¢Å3‡H)×OÊÑíSº¤ÂÏœ‰Šê:~`ŒH…17å´‹º¯Ýù¾\äŸ|_œ3=ÃùóÌzÍ â+ÖeõŠÒûrfÊ‘—.©Œ¿$Çc(Ôe|…cgüEsS–²»xÚýàÀWÜjU÷J2ˆ…]‘!P½í-)ìÍž/rtÉ“.©#‚Swê.Üþ9vvíÕÜ”‡¥uÿ²ûÏÛ÷=¯ 5ýÑ_Œœ†KŽpæÝh±¬!*β%åUXm$U ]dœH'»dåç†\vA÷Ënþ-Öƒúò'‹ÓÜ'¼ÝøÒ¶§p“òù¶· ¹§q‡.©ˆ §ø)^ºîLб#‚sSN»¨ûÚý>cÿü]þãü] ê6šçœü|snd¾:ãRæ*)ùIËLùõoZºAµŒ¿8gà|HÝL Ž=b½×Ü”Ó.ê¾vgnÝZ›#·ÿ¼“ñî¸# ³n9¢þæmÇÎ!’»{7tIuu> ;ëR×;yÄØMù–17å´+ºò¦Ý¹ï7 0·û>9ûëFï÷b¢(íûµ¥½u¤”º“S艄nñäD]¢n[sK»¤ûÚýàZc¾)Œnr*Î ËcœHYuìé# óm[KŽïVº¤Jþåà _ºÅ,]nþå˜[ò©ïáô_v癿¡2Vyãɹ8[oÔ»'ÇÛº’Ò)žUåH=k¥nPQñ»Tùm¹ßÒE"–ÆÎî}š›rÚEÝ×n½/^JfÏ]äõÇŸKw|ÙÐpN.[”β|?™÷ggzéUòœÜðN07Ïu¼«±kfqnÊiu_»3Î;,×··`Áéý›ß\á¤óì´!J™Þ[šrĵ¥Kª¾½Éé5u‹z úØ%{ rî¢Þ‚´Ôu_»sø";mdOaõW2Ð@|!K·NQX7ÑHòíyHÒ%µs'ÇkãBw¡7Ç^éàÜKý½ïLÝ×n½ûªxëŶöCÖ|½õbW{aÜ÷ïWMIÁ yÚE÷õ¨ ŽßÙï[¢±Ÿz±óU/–²Ö,íÎÜž ìÅø’s×ÈZÑ~e{ŠÒ36jÊ£:ôœ—RŒO/Î ]o…cõ€ˆ¹)§]Ô}íN|˜ÆÊ¦ø0êÞŒÏÁ`7ÓÅlº8ŸãQ!ßÌ̓®¨è“‡± ]ôAÔØÙ'QsSN» ûew®ÉÌÔ»7ÖdçD¯Ü…|˜†u³/QZeKK¹7­ ]R>¶>MŽUÉJ»{å݈sS–öþËî\Ç.³èg¬cqƵÆêš—Ø:T·(­LÞ;žòé8é’:êJœgp¨ï|9¶Sz"}nÊi×Ö³ŸvgM⺔âbâ AݺI§ªW…»ß‚Åb7ƒšº¤fÄÅÄAr»t‘ή±GÄÅ47å´‹º¯ÝùîûÛÏXp²§½Y°ù&º&Ö%JßÝi)GM¼tIÅ3öpzKÝ…ìiŽÏXÌMyXÚÛ/»‹ !B³…AD=lXãœòæ;¹tIÍð[&Ç’&¤;| ÔØ#ÖHÍMyX꺯ÝùŒ]xÞ…¥&ŽÃèx·O<OM½¢â©™)ï@ ¢.©ÄRK޽¤[!÷±KMsEÁiiY¿ìÖïR•}ª˜…8ÇS#;z­/oeì™EK¾;ôj—}Ü¥Kjç7MŽ£R†îòUOc¯ˆYhnÊiu_»µ¿`­èÞZõçåTtÖE0ËCB¾þn¢°°ãåìH]R%ªÙ’ÓZè6vÖÅØ ðiÌ-yXÚÚ/»3vâŽ9ðää±_ï Ôòx‘i ï'²ñÀ1êéµ# 9µ¤îBŽ;Ç^™Ϲ)K=þµ[ï˶ÎT?¾àx Ǩ‹_ÞB‹ÝÛD“ÒsÐnʽ}µtEMõã Î@%u*8öÐ5æ†\vA÷Ëný-øW‰Þµâ¸/Å3;€:´±zR· O å+UkÍ8[+ÓÀîyzè΋X{fv&ç–vI÷µ;ý–D€Ô™_œ®{VCW¢Ñ6QòDÎòZ€ù]Q-ÎüÉaŸOFÁ÷ɱkìÚ»ª«-íí—ÝϾÓç“§DÎáÚ÷ä!së;OÉ¿MÊêÁ¨Tä)‘ƒÆ/Ò<¥YI±ï?yL´‹º¯Ý:[üížÀñóp¸ª[µ«ºõeÜ¢ðM7ÿ¦%o:;ÎÔÈJ†äÔº­S8öˆ[¨æ–<,åv?¿ âÎóù]ðý4þ.8%þ.MTü.7åè;/]R50»Ä)!Ý‚Þd»dï2ÎM9í¢îkwÖX5ž§vÔX9Çѯ²³ì:ZÇMÞfž™(¨ï§.©ÝÏ’c§jéVÏ:ÔØ5:©knÊÃÒ^~Ù­w¹±õFÿÊäläû=…÷•y·Ù¯2/—räìR7©¥Ô9ì©ÝÊ~{»æ™ŸsS.»Žº~¦Ýòuw¼þ1rèëO·'‹ÏÏo|KÛJ|Ë&œÒ%õà)‡˜HOo'ýøÇúÓ ê±”¹4i÷“Ÿüý·ˆùÉ+ÿË!þþ[,Çø«g×|bj¤¾ó“ŸØu3?ùûoÑÜ™ŸüÔË¿v'†jýî› NøWb¦œút‚‚'²>Ý ,_æ÷ êñ[‡YæÙí)Æ~0"87åa©2ØãöÜoÀ ß9DMÝðµø§û%ßEé)÷k^è¥*vrª×+K·^!ªêíÒ§1·äU~×}íN_ß ê_± |j¼WOøãV%ï]/)_¸ÁS—ÔÉ[ïÒ —ÔE:»ÆŽŒÆ˜›rÚEÝ×n­cE¹E9ŠÁYÀÛ4oCo@-FSPXkÒ4äè*Ý Jf6`ôº–è[blPø4æ–¼(gÃu_»·ÇÏÝ3°:ÅYÈ¡98¥¦©^äy¬Äê,Àd†Ü:dÎÐ5«“æbS]4ö榜vA÷Ëî¬Ý8U”¬ß'g!×¼c·m¨ß¿G”|Xk¤|q–ºAâ>9G½Ê×N±AáÓ˜[ò¦*¥¾~Ùç1âð–ç1r6:c³3CÃîÇ® í9a•”wÏ«nP‘¡ENG¶Njïé9vË -ÎM9í¢îkwî•å·GœØ+×Ó;p¨~2öJO={å|0íI}í•óÁ´§nì•íLsÇ^Y²væËîÜ+/|ºŠ%%Çj¾ '‹ ýÚEi÷Û7䆸ßC7)Å’Äñ.¡;½LcϨÓÜ”Ó.ê¾v?ø–ÀZ¸5ñ-‘9Ùƒ9“±\bDÔŒõZ]‡äS®;…qk|šGI¡næFÄVíçîBÚ¤¥mþ²ûWnÃ3þ|s ?Yù5ù7+ò;•ŸC9sw¨TýêgaùËéʼ ò×›7ôÕÏ"ä´‹º¯Ýß½9jûÝ›£¶·7GíooPÏßrôÞnP¿zs Ì2t&£±kþ圛ò*ÄÆ§7‡ÆŽ:q ÆN/9X»¨-8¼Ûoz t'·Û ä×1+¤Kj$º9X»ÔíªH÷±ÌlÎM9í¢îkwÆ_.jú… 'δi#*B¼ÿ¥> 3«¦öMùV‡R“YÑBNÇþC]_¨cì•?š›ò¡Ê‚uÙýà*ÀW¹£ä\ì~Íçë7p¦(í•fäÑѸõ¤NÄ,ÄÙ@©§îÆîDZ·2´bî­ÝÑí¢îkwâ3êñrfÔ€Å0{ÄW¶(y»çH9P¤;„&ñr*ù©ë71v¿EsSN»¨ûÚ­÷eñoæ98ØmÖå[—–°[FTnûëéÈÄ'r—ŠjirP» ]\5v¢.jnʧ° Gýe÷¯Äw¸ÖÁÙˆ nF0pÞCTÄ+kÊH3tƒ \krÐýŒºã"ãcƒŠxåI9í¢îk·Öd4¸~ïÈädO½nëÎwäý…I|^_¨çŽ|Þ;»tóü n=(Ä¥Ä+N»ó¸cD1rêä0e:ú‡!— ”žïhNùzMSo²³5¶>MŸÈŽÆž9vÉþbœ›ò°Ôu_»u†Af*Î ?ßœ \Gæ¬t`>ž*J÷Xf±täþðÄC¼³<ÿ(b_P2fêúòcç‰GsC.» ûe÷;È`Q¼’x×-HÔÿ¸Øq±•ràÆI—Ô‰êeqvÄÅ7-ÇÞ‘¥¡¹)¯BÜR\ìäØZ“'ò)놜£Î wv¿ 6x—¦ux˜°pl_—.©X7ä,áÕ vPé9öJ¬ÎM9íZò¤§Ýé·ôz¸­Üžà :ÛüƒÕ)y1(ù-Ûy-ØÉ¡+j+·'8KžÊäÙ>rì¥Üž˜›rÚµäÅL»3.f5Œ«elp.¢UvO]¨h¶‚-J‘.;ãIÞ—AÝ …‹?†®Ÿcì8[ÆÜË.è~Ù¾¾ œÄ™¾>çø´Þ³è  |}ÞÅäË{7jʰ']R5ëÅÈqFèºÉ1v‰Sµæ¦œvQ÷µ;s®¸®Ä_Xí:Ðq Ä@Çåšzä?>¦ä×ór¥KÊÇÆ§ƒSZè6OèÓØ tm%åaii¿ìÎý¥#Î6Jì/ÎiêÍv•[8uÌ+J;û­<·K—T(š8Egöuk%Ç.‘3¨¹)§]Eg«´;ý0^"Åø’s­"6N§åŠŠ³ìJy‡'’ºA)ÆGÎð6cÒˆ§sì‘ñvÎ-9ì’îkw®É©QœÆ®:ã‘ÛWÑ2DiMÞ%å<%Q7¨–^Õ†Sõ*©‹F]»G=²æ¦œvQ÷µûÁNÿuÛ_8½û §÷E†Ž˜Ås»¶P_1‹ÄØÝìƒøë<¶¿pzÃRa§ÿÆé]ôAÝÈ!ÇÖ ÷Ý gmš®S§‹ú›'ÑqS¾Ô¥Çuð_n""§UéZíÿÚ›”¼u¥<,mõ—Ýy¯än}Éa¯ÃîH'“}c'Èð@ä8ú(¶šº¤ž>‰ä°×!uÙ‘c?}97å´kêíJ»³¾’XÚ÷ÅY»X숨r»¢¾b½”{ItEÍØ÷ÅÀ» îð}]cØ÷57ä²kÄêsì?®öÍBñ†3ì—ûy9ç`”eÙŒ´!ñ ”w7xÉ=/tIXe“cÏ t»û=4v¿ˆæ¦<,uÝ×îį@ªn‰7NÎ!Þøð÷Ï2°RE@ÅÛ¼R¾|Ë”nPíÁ‡—sÎÔ]^{ ±WÔ&hnʇ<¨sþ²ûñ󣞘~˜à¸/Ũ ÛF{«¢äç?;å©Ô%~˜àT¿]I×ý,1vøabnÊiu_»{]^¯Ð‹°Ô‚Sq÷[/V<›NhdÊ?¨À¡üø}Jº¤Š°ÔNí¡Ûü°¯±[ÄB5·äa©ë¾v§¶£>à¤Ö9hÚ[P]×M-¨¼¥;Ï.÷kLè’Úª{8u¥î’w€¨½ÊÎÔÜKžZZ×/»Ó“ñžŸ—~˜§W•oÔ¿~ùaú³ï{Tä93Ü_û~p¸w÷gß_rZ¼‹_~˜'µ¾ãTÊ…+À(>òõ‘ã76ÿ¶ðM|Ó­‰Ò7MD傪ÜÑS—Ôz3\Èi-u'¢Î{f-瞪E£¥­ý²;±my? Lrº0Uìdû¡îŠˆ;(ì~ˆÊKîäÐ%Õ^LrJf ¬*ÌÞ+LŸ›ò°´œ_v'ÞÅbŽ¡îbÁa÷fvÊêð̳‹–²A­wÉJùbeÄ­I)Tܨ¥ëyS1vfhinʧ½gûewÞÅv—ŸóçáXnðpÛ–¯Ó=ÀýË«jm×KÊ<'ÔõxU“Ófèoü¢±AéÝo;åai›¿ìμ>fžßÌ뫸o±óÏf¦n Ìqo™×WVÊ›þ²µ’*Y/œÞCw\Õpô+Jg=ÚK¬ ZÚû/»¿sHjÉß…œŠïy|Ìó…ïy ’#GDº¤žn1Ái3tËÅ÷ޱËÓ-sK–¶ùËèx¡þ/ÉÙ¨¯è„eý]¶G²HaoĨäYTÔ J·qž+t>ÆîqÛÑÜ”Ó.ê¾v'>?k.—ú𒃮ÚvBÍ–õ-¹Kµ¢êkrÝAò-t"îߥ±õiç K±]tÕÖØC¾„˜›ò©ZQ×}íÎÜQ"ˆ÷¹£ÆÙyìžÌlÔ„‡x-QðÇ ¯•',é‚ZÙV/CîŠN¬áЪǹ%oªÿØí—ÝOŒQ9aÄ~±8‘àèó½¢"Æ7S>€@L]R=Î0ÉñŒ0ê"¡±¿Q±zÊÃÒº~Ùýàö Ãã}p{2œ‰Ûà gâötQº)¶›ràòPWÔŽ#9ê>ï21}ì¯÷w…<-íõ—Ýú]ò}?߯G+òÕ÷Þ-Jßô)÷«Qè¥ -q¶·–.ê³4ö~óZSN»¨ûÚ­÷½sææpp¼XƨEüd{²ÉNø°1òª(ê’ZÂ~8þ,¡˜Ú¯¨±gx:47åa){e¤Ý¹ïWD ä·LŽç7 Øç·ð“ö+Jû¾Çs)çNNÝ ¢*c+ÛlöÔBÜgù¨âÜ”Ó.ê¾vËÏ_…VÔû)8ôÜ3Ó»¡‹µùAÁߣä¨F•nPMŽ›ºž{Ž=寊¹)§]Ô}íN¼ñúÝóQæ³]e‚7a|÷|<õAZ0j¥ÏSÔáó“I!Æ~rá8wà.Ôì÷ewÆ,XS¸WÄ,*J:Qw ^d’–%J'ßÝRÎÚ"ê^Õ·È›–œZR·úmGc׌¢mU0ÎùZZË/»óÌÏÓ©ê‘“£Úrx×;PëxÎ\Õþ8W¹ª}¦nP%£5oWK]Fü8vÞÜ47å´‹º¯Ý ¯¯MÅ„s•œ‹»ac,H;·ŠÂàË}Èxn})eÍŠ3eN]àXiìÌšÕܔӮ¡ ö´ûÏû]þù·üÇù·xÎ#p~vÖX dÓ ø…,:Ôq‰*~ÇýVLgè¢ë–Е()É©-u§Ÿ°4öŒÌ9ÍMyXJÏBÚýçý.ÿü[þù·üóoùçßòŸüßbuŠßñq²¾ò¹¿8XÞïúʬ%=M™ê+Ý_‚£úʬÕØßõ•yIKU_Y~ÿ-€Ž¹kœ£>AîtÜj³ÅynàZ{FXIy‡'’º¤×úáÔº =†8öŠCš›ò°Ôu_»u¯dO`/ïýy9Ý£Øx {”¶’ŸÔ¢C’Ã!]R]™ÙÁñ2þÐõ2þ»©/nÌM9í¢îk÷S›P½š@xê¦èeÛ‘UTÍæ^©xu SŠröt¤.(Œ­O;h2Ôí@“áØ þþGæsINK©ûÚ­óp²[O¼ rð.*ú©Oà]øóNJž{âåV`9Æ uIõ8½%§·Ô¾·ÆNüoÍMyXÚÛ/»ù· OÄïµÿ¼w>e1Å ¤·ˆ;(Ÿo */¹ƒ¶….©Õɱ„)éº#9ÆîêïsS–ºîkwúùÍŸö`‹3qÿºJ˜Âw¹41‡/¼w’a¬–žTb‹Ó¼šMºM‰‘*ÌaÍM9í¢îkwæ(VÔ|ôÌQ¬ðîœÛò€*G{…g˜G’{ë‰Ð%µ2ºIÎDE0uQ‘¥±gF797åE5Q»ý²ûÜ+7²lÇWoAr|} yã#0RIi?»#åȲ§nR-3Žé%š3u‘»£±3·GsC.» ûewÖYu[ÝäL #­¡bò"_­=‘Ï&9rݨ+ê»ã1WŸ’ºþÌÇØ_ˆÞ>7ä² º_vg]ÒB–mQü%8膌r7øÛد¬=þ¸òí5!Ò ªÈËIÎÎâà°clPÓëXGʇ"èÄwL»3–ÔªîÔ?/g©„ïWKqiö¥~z@”›òнp©Äê_7xq†z@¸î@mÇYÇǹ!—]C= Òn­ÉÄ!žÂ¸ üé70Œ/Wè)Jë&1]øÈý&•¥§¬ÔõzÏ;*KcnÊÃR×}íN?LCHá‡!Ç‘²Ö—¼2c‰ÒºY{ÈsõÈ Úø^e}7 Ý|­«¿'Ÿë””â½2i÷¯5ÙOƒ?ßœµr]œÈ nꦕIë*åQ;íºAE{®Ù=u½$4Æn‘9§¹)Ͻ¢ÿ²;1º-›³íÄ·$X Êèe™@Ö=‰o‰nN’o €S—ÔN|Ëàø7MÝ¥nd§‹R\Ìç¦<,uÝ×î¬ßwìœï‹8Ç3ŽÇ­² ƒÃ(Eº,  ùD;uI=Ý•‚Svê.‹ÚÅØNé¶3gÊÃR×}íÎße#ßY˜ÃâLtò¨•ðT/¯âØ¢ô»¬žrt™îVÏGU³‰Ó£ Õ­æØ=ñZ87å´‹º¯ÝZ“+ª.9èiÖ±f„xÿOÍÈÍþ–vY©ÔS32`kF.‘ànŽý âqnÊ«ê0fÿe÷S—„ÓžêÅ’s­B>³×ìF1¢Ë–×µ”_dQQ7(Õ‹‰ƒût¢v{DßÍ=Õ[#u_»³oÂü… Eýó+¶:Õ9.|ëż?¾Í„.©Çwœ2S—¾ Žýø.æWl6,uÝ×îÄ?¸Ýì›àœ‰<àîÅSm‡²¨¿¹³Z¾šäèC']RC•?Áé¶q„®'•ÅØ=âíš›rÚEÝ×î|_˜å¸ ätÔ˜5Ô9uà&tÜî{â* ‡Srd{J—TvT§ hóÑq8vvTÕÜ”Ó.ê¾vgÎUG¼ñÁëë¨hñÌ ¾Ÿ‘5(äy°jŠòèJ⺤Ö^8æ “.ú«jìì¿Úc]qyXÚë/»3·§âV œ^q¶ú2‡ä ÿ¦Q8-åä\Í›ºC8‘EEŽw ݉ `Ž=³· 禜vQ÷µ;ÿ–ƒübæõÇ›Hi+€B¶r¢dÝ®)÷°nè’êq£‡hËÔ%Ú2Çnq£ÖܔӮ@rN»³6aß?¯|äxŸ{;Ù6TxUdZQ(y#|o¦üÂ3J]R[™Ù§ÝÔ]èSÀ±Wö1àÜ”‡¥®ûÚýçÝ÷…-=Kà]$g›šè @ßœ]ÞOÇu ùDwMê¥ `r†ï¥;¼\cƒú›–œò®ÎÐcý²ûü]ꌓÎ0S§ƒ†,ûŠ•çÔÈ¥sƬ)?:µ´ÌjÂØ:ñìFw¤nÇYŽc÷<ëqnÊiu_»õî{Ò§ù˜/rFA5ÐźXÑ5¨¨¢¹êœ\±®R^UÍœóy5¶>MŽw ‚n?Ê ïG”VŠÝÄy,më—ÝÙBÙ8Ê%¨Ûm©ÔöÞäPX7Ù;ò$ê’šò<_³©KÔmŽ=ŸsS–ºîkw>cûgà'“ƒüOû-#Y€ ÕŽ(=w¤5_Ò%µ²J68õéÇ‚ÜP¹£š›ò°´ž_vëœ ¤éÚ¢Yw»Ûý­#kÝê‰ÔJ÷ÊuSîN¾Ð%Õ"C?9-Q檣aÆØ5ê‘57åaik¿ìÖß‚[vMŸ’8ÌÑ\Èß\¸o ž®¼#oäR~ü„%]RéSJNY© Ÿ‘ÆNŸ’æ¦<,-ë—Ýy«ÀHí‰áuPEwíý[x›+:ƒŠ•i¦üø»-]P3óùÅÁÛN];—ßÝRNK©ûÚ{eRu˽’œÃ“ñðèÐÀ^i»(|½rtú•nP-÷Êè‘ݤÛyMc÷@\í]*5í¢îkw>cÏÈÈg¬Mšo€ãâù)Þõ**nŠ;åˆIw«O´*~Å']ºoÇžQñ«¹)§]Ô}íγå)ò4þ¼œ…H—7‘²S¼áÿY\«ŠÒÙ’±¦Š= ÕÔ%519m¤®/1ö7-æ¦<,uÝ×žß¸£âð2…ríg”©Ú¡8ÃüÆô*O)©¯ZÑòÔ{þÆäÚ߸£š›ò°´Ì_vÿyç1î°ÎI¾‹ªgº¢çcaP¸v%ÿ»¡/vàë©Kêñ]CÿuÃ7±»¨¿éEñ¹)¯ê”ÝàïòGý-@/4”bÁqœ^¬e§8ˆ 0Ÿ·Ý 9V&éÕyw!çeŽÔmÂáK”Ö•SRN»šðZÒnùÆê—oÜ+“³‘5rPÕ×Ñ Ën pŠ÷‚àœ¨TT–’sк,„çØ þ¦%g¦œvQ÷µ;s&°8k\r6=ÒèœÖáoÛí¯/Ü“†“åÍ+¥”n;âx+äЭn«Æ®ñ·hnÊiu_»Ó×7ñ½î¾>çx­ìž°1^w#Ié ãÕ˜”Oœ,¨KªDUnrXÉIƒàØ t†©-åa)ë>ÓL 8F=29wÉþKÙÚÓÑ3AE\l¤|yVˆtIµ¬GN›©‹þD;ûinÊÃÒ6Ù­¿åúa”ÀNOŽp™W^|Pzs¯ [}ŸÐM*°ÓÁé~º•®2Â0vÏÞeœ›rÚEÝ/»3¾ïo£oK?ß"î7 ,4ÔsÞ.J{?åSŽN;Ò ª$Zm’;ñ†@´~»$F#ç&ší"ÒÙkwÞ_XÕ¨û¾8ÓuYhëQ£~2ÞæèÔèòƒjê’Êû~rÌw!ÝÌ#Ž=¢æ¦<,më—Ý™C☗ޱïç›sP—Åþ²žûdPš¯Ï”çAºAÕüôAG±qS·«Ï§Ý³Ï'禜vQ÷µ;÷ÊŸmo±W’ã½{·Cû[ÚZ÷ÝÍ.Œ ´ûí’ò«\V× *ÖÉ™ˆÿSwOœc?H뜛rÚEÝ×îÌëc”p¨gÊ”?¯"³£Ã×g#X@z‰Òƒq……>s̆pÝÈ”òva$ÝQê5vÏ+œ›ò)_྿ìÎ5ùåÍþ|sVÊ8œc”VÙ½R¾}7–nPá$ÇÛo…nÁ¾Î±Kîûœ›rÚEÝ×n½/ôXuåÂ=œC?*bÏÞÖÒŒ ÷r¬¢Ò ªå§Ÿ#uý¼cÇy,榜vQ÷µ;×ä…xŽbIâtõ«x?º¬ž&Jkò8)oz[Ù_¬4­5¹`]½=u+bE»f,‰sC.» ûe·Þ”ãäÏËñÓ±¨5²ñì#J7ø1R~ÍA]R;NñâøbºÀýÐØ‰ ¢¹)§]Ô}íÖ:vÜõûÞ_È \ÇúÜç¯ýÏýe{çCÉ­±læˆzúŒÇ룩Ëû Ç~î/œ;0#×ã+xí~ràö©~¯â\eâã n=®(E¹ëJ¹7~ ]R'¼ÝÉ);u7²B8v¬÷1÷VÆ --û—ÝyÙ_~˜àtœ{úӅ˨ûå‡ñܧ™òùÔË¿ËÃ)3uý{±ãw‰¹)KËüe·bžeo«°¡’s…¸ˆûûÉ7nd§PdâRÞNݤ"€”ÁHe0-ßmõ87å´ º_vËo‰sĨÙÿ…Çpß"2)*ü×s‰ owKùA#ê’ªÙÿ%8m¤nAŽ]²ÿ ç¦<,mã—Ýʵ>zf—pÈñJ £ø„ŸîÎ}‰Â|Žó”Þ  +*z Çû‡îò‰õ«Ob}}FûkM~ú$¦¥ÄøíÿFÎÕE¿½xãâlô£qˆ,£ìQ"‹TDSwʺ+tIeæœ8~0 ݉^5;3ç4·s®©}6íÎuì ó¯–XÇÈÙX]ägÁÊÃÓY »»ó äy†ÐMJ™zâ4ßð¥‹.(»FŽ­æf—ÚÝ/»ó s®Ù³7ý x›ŽÞÐðI½ çÊ8g‰ã¨‹tƒª§èÄs€ÎO+¢t†™=å´‹º¯ÝϽ’»mÉ{%vÔŠŠÂ^ˆ*k'×Éw©3#oìLÀ¨Ü­;¢ÎD©‹Þ1;{ËhnÊiu_»Ó×'„®¾¾Å¼\äÁ6Æ¥«SçˆÒ9ƒ˜] ÈÑD5.™8GfRÓQ‡AÝŽ.Á»gÖ,çîê"L”.×}íÎ3Ì’­|}â ¿ O×òêœaV¥3ŒíÝ’UôTO¾àØuXºÍ}y»Å¯¨¹)K]÷µûÏóó;’<½D:ÇÏc¶õÎ!È:t¤¶“ý˜ÐÜ(Ç­VºAò9 gª!”¹»sì™ç1ÎM9í¢îkwÖðÞùõ»dçCö:Ï^¸žÛ v?¯a 9ÚgI—Ô³WÇ÷Jêr¯\ÏmŸæÜÑG‘–¾=¿jߎǥ‹gÌü|s,“âsJšè­3P5nÞ¹µÆ93åÀÛ¤nRMY!äx¦TèdRpì!/gÌ ¹ì‚î—݉ŸÌ wå‰3<—µ,Õ™ ãz]úHDäºuʲ¹©{”Ý/޲½ïLÝ&¶^EÉÇÃw‚8n¬r¿ó—Ýà»_€ËØo®Éà tW/QÎ5—U㯫¥|ù°è^y—ÆÖ§É)3t­]Ö„€Ò Î:rÞ;ii™¿ì¶¿å?û/ÿ¥ýõ¿þë|NB¥üõþû/ÿÅójëÿëÿÃ_¾ Ø?ÿã_å¯ÿéå¯ÿêÝ}¼–M`-oÿ¡ìÍî-ŸÿÕ_ýË3vóQóßwlŒX?#ÖéTÚñ3}ý¬SvB-òÿù?ÿã3âû×ÿaÿýÅOÖé ½ò¯ÿþ¯ÿÝ'ŸÇ¦ÿÏþõ÷_þçýý¯mF‹z>ÿþë¿ÿ÷ü?õ¿þ—ø;0Ðñ/ÿ°_­ýõþkò㲯¨þõ¿ý£Ú·ù×Óœ˜·vÐ%ô¿úǿğ߯üé÷« Õ¨>Ú?q¼Yÿ˜Ñí8¨}Â[ßüé÷–;µžO€~>ñë§ã_¶æ÷_úµ»ôï¿ ôû K}?úý„¡¾;hÿ^ëüÛùš?Ùç*cu€ñ—~?ÑlŸý~Â@€Çó ÐÏ'þ_{Z5:R¶li2ïJ‰þ•ÓvÆEÃdÐö£2hË µBvѶâÏt3zø‰ÛŸiû}‡;/A›ËÏŠìiÛ¬8ú~Ô6zTÒæ6Zrs7¿ƒÞo ÒãuÐËsd‡WL¶Íx´}ÃûªÏ[”`,çEÌþ÷UÒÄžžÚ¢ä(·½€ñÀ¿…ÃK†kwørÚr,4rH[™ÁhúþÝydtm޼Qõ}\ =ç`÷   ½ÙÕ÷…«÷JØm‘ñëtÝÚÚ/isô…çËh«þë~´mÛt÷ŸÉèªú9IÄéÏ ½PEŸ!äc£=nj÷æ½HÛi¡W¼ÍFOÜG'í]‡íÕ#îu6šhÄ~ÝpxE{Öô6Ïh{ÛÒxØ:iVLÛÂ@Vˆ^¨uù˜úâÄÌïéoͧmÊš§Áƒž<3‹Þ¨Yø¼ã8òò"ÝáßC¼ÇšŸ·>†Û.Ú»ìxƇÑ=犞‡-äö¹HOÄÀ»>Oüä*šß—·½0úTÒƒƒ6i"=óù8¨î¼|ß6ZL™on’îëްNÒãU}þb¼ê/Áì šQz¬?Ô¾é3ÞÏ:¶r7ºíg>Ÿ€w±êó›Uþƒ4#PÝí=¾³32ºïçï?ðÅÔËçÕR»1~O+!ÆxxþNG®Æåót¼¤ÿôB¼¬ Ò¿7ÖëÏ â÷¦}Ï£Þ¯ãøþ<èóÄSàüžœãÏÏ"Í.OEòDÎ7ÑuÀK}@vŸÄü8º·ÊçåxŒ›XÞ y*)ôFôïßa7ËÆ÷élõ<˜—ô@Ƚ0Þ}ð>âù:ˆî´ÎýèÿèC¯Nš·Z¬÷ç nbèy:ªêÃûw¼öÌkþ&iÖÆáý;ܰõ¤Hî5„Ú_.2™Úäïq‹*ñ0ÿ‡vd÷ÅçÿúeôþE]ö—ÏÞǶ¹Þ\ökÞ|n",ž¿}°^^ÿ=®ÿ¶¾âý¼ôúЫ’Xï"mû£y:%w_§Ö‡ë1÷NÒ}<ëýe6záó~Ñ»º»WËhÇ<ðŽ›¢õñü£û¼ï7›ôbG€Bú †ëz$øþUH«ât“žÈÓÇùáNí´gjÄûˆ#ÛO›h‹ë÷Åý¸g¶ÿbý@Ô×hì‡@h€áݰcÿ¿D]wO2h{ûÕï…ó¢>áïñ0Œ'Ê&mûãðæ£ ý¼ÖdÏÁy­éû¿8¯9^h?¯ ¾Ÿ½3Çàû—|Cò:h?¯M¬ædöóÚÂïãÅV8ÿùùÄè‰óŸŸ¿¼-‡wð{y©VsÚßg?cÛyˆë§Ñ¶?΂ýÓhÛ­1¥>oû£ÁgcüæûãlX¿<µ³;íû›ƒ‹MôC›¤½ÿïUNoÌ,…9q4ÚÎkæ*»¤íyœKö"Ó×£}`£Ï!íÖ~OO ´ñ¸ÿù}8Íïkøþø¹³ùù˜°óF_Ѷ?¢ehÛ—§´€¶ý‰tF£•ÚêX/¼µÍqšö-?¯­ýÍÓkl¼‰õÆ"‡Ó"jké÷F멵ðüp¿Y/p}ÞžG;vã÷9¾?®£ßëàÎzRnûãºÒ÷dFs|Ô‰âXlôõýq}~0i8ö‚¶óÚ®8/mçµ]±^˜KÝÎk»a?ñ¶ÆÝi_¿¶çÇVÐö<îŽ÷ÛÛ™^§}=5÷½=»cwà±Ïß¿Χs1œÆóPý m´¯[öù>·¾ÿŠž@›çW/ûoNѶ?¢c h;¯mÞ<ø€ñðþ¢‘«Ñø~*:4í…õÜa†Óø}+ú^ñ<íú‹¶ç1?ïÞÊg<4îÜçOÕÌ×T.îÉçµÂkä¶?âúb<¼?a@è¶óÚúý…¹Ö³†þ7öû`=©@±±"ªBÚýç+oÿýñüUǹ1ºÒþÅEGõ{vd_~ŽQk’ˆç}ÞÑ7/ßŸŽøÇ=Üo¬î¼&龄xzgÏ+€[Œ®OÇa¼CúDFì|?¬€u:Íù½/£]ºès½BßçBýeÁ}à u§ñ=Àèt'½Í7¤oè«‹þ<¿8"çÿ‡îYv‹ô\ʺ½1ÖƒÙQ+yù~Z>>ÆÃyÝ.žûã쨹ΩºQ~ÿŽKèt%}0ö7;¨a<þ~PñÌðKZyã“ôÆx¸nÆãï¤øuøüOdÍßgûó¸üI~‘ÆxXŸ§—D8=H7Të4Ém\G¿‡§¸:]H{~Àáþ0ý‡pºî¯H>1öŸé ¯÷_öïÛP*د¹’¶L`;¯KîÏãæùu<:flçQþ’UñïV/ñ°®Š.ç›ïó‡¶ýqmžwVUe¾ßÕ€mÊxœÑÞ]竹Àx¸OZüãa]ž¼æô$Ý1Þ‡ÕQ[E¤Ñã5é_ŒÚ³3LšuÎX_ÖÀó¸ùþXü?~¿’Åx¡Ñ ß'öW´³þ¢wû¦ïxéåûcŽ·„¢ô*ïüžŽôØ»ñ˜*2éÑŽ\’;¾ä yµÅy2Z@?y6õ+‘vÃK`¤Ùè‘u“@VM|@I7ñk’M÷d‡°äc²y Ÿ? äû'Õþý'~?1ë÷'fO u%þhåÛäß„|šø›”n“@:M|@Ù6ùdÓÄ”lð'mÿÛ_{À>òúï~¹üÌüõ Sð³ /o óó0:öåaüÅCÜ´µqeïÏfñZRŒJD ø°`”zžC¢QkàÆpNJe^©ß¶~¥UêÁH·Olì{~¿“6TƒRÿ’¥ÂG}ò)ûÂáˆ`8™‡#Š9'¥°†z­„ù¶[X©˜/ÆAÐéóßÒ|sq[SJ=MJz Â|1E½?6F ó5ç’—{÷Ð{l}pÝî_ð•ü< Ä@«õÊ„ª÷c>™‘´II=J)=™Ž v¨5=‡hÔ‘½v1'¥2¯—o[¿ž1ÕM#~$ðr,ì×þ3ƒxIýñžˆ²ß‡g𠽎S Fuâyx$…5Ô{lý3ž} 7Öæ™g?ß áLÿmkó}·_’”ÿÔÓ¯œ!‡ßAºA+8H_”.œû{DCtÍM9í¢îk·u<pkâ犱‰óyJn:îgO³e7ZIÝ/)=œ BŽÐ;¸¸>*î|æ”ÖPï±õÏx’̧õ‘Ôð,â¸óÒ|Væc© © ž FÊ¿+óIíO€IWT x–äx¢t‹£ÆhlPsK–2)6íVi€Ç?·ÿÐ?_ŒƒTÿQ›];q D€µúNz"Ø©K ïë!½©Ú u( ç¤ÖPï±5»-}¾4­þy8$þÕÍ ˆ‚@Å¡ÿ²’ú =+áKÀ˜ˆE@pŠ5:ÌhNHi ô^[Óüé,õ½ †Ð®ãLOÏ@óĬCBæRw³HO„úÊá>oéy@_£Î€\ãœÒš©HØúÔ’Ï¿NU+ød˜Ïe»Oî4”•» DÔ‘7I§R/ˆ’5FQ÷¯Þ¾j ö„*È?sJ kJT“ÏUljÏûøíìça ‘w³ KŸG„Ο»€¤žô!=%Q œ±/W]o£h£‚PѸ]‹(uk¤÷ت‡Ç](ÅüyŸhzÜÏ~;»a½d 5¥×}‚Ô#á£ê‰£ìÐkhVƒQ[ö²Áœ”ʼ²¿mMp˜ÏO§ê' /ÕlnQöp»$ÞrWH=$J=U2Æ@"è£>\ŸQO®g˜“Rš½×VÕSzâëf]E0,0ÉïmòùÝÂ[æ­“Ô#ŠÒs£ê£Æ8Èzu½Œ â©Ð”æQï±U¥àŽ–¿¼Àêçax"ÏêìFì¥ÕcÅ¡×s2WH=Ò(=>*> FCÐzˆhpÔ&ó5'¥°†z­‰–°ç×  œ-âa£)^ž 6z³QŠÔ‘'2p Î5Oœs)ü³gœ [ÿˆÐ?Íÿjþ™@¥ óÉ€˜û0вÝïkþñ8‹¤€U ˆ4Ÿ ˜A=ÈQÓ|ÎI)¬¡Þck6ü³Ù¿?_ K„+ž|< ïÉ‘•VhÎRZÛC"jvú»¾—zÈeç¨yÂæœ”Âè½¶&†Æ:~ $³·+Ïe"Èr=È BøŸ% Ï\.ÔKBp”d8¢ƒôØD£Î¨Ò朔Âê=¶&¼ÜçÃdz~ÆB30{œƒŒ_%@ÄA¦†Ô3b¤ÂG­Ô½…*A8êˆÆšœ“R™ÇãQؚוæÛaïq]ãâ‚p*÷¹†Šøg+-ÞþBRIODOˆ?cøÕ@z[€­6êNWƒsPìä9 âºRBê÷oê‘Ø‚X»õJP1êʾ#˜RZ³T=¶f[·Ï_t‹ÎûbT”ßùû‘ûß¼¶„àYÌ…H©' KDÑyŸŒsQ4Úé$ìC£‚ø›ÀŸØ‡¬‘ÞckvÚùl!ã䙌‹³‹_,RŽ‚Àé¤Û"©×»HÄÉ3gè£î<ó`NJa õ[ŸFÚŸMbMŒ©ÖBÕƒ¡xȧ‘Ðûh;Îóç—•ˆè“#FGJ1ô:ò™1jÏ¢˜“RXC½ÇÖ§×Ió7îiuÒü}d§“e_² «äKæI=ûCzNÌ€bÃ˨7 OK'¡W÷3§¤0z­ G7üÚo Ñ ¿¦€¾]ƒÓÌ–¡ïcñú]I«ÿÙà$ ²;!LȆ^ÞZì sVa¡B½/[e¾ç‚í&ödð ÿ\6¡’½lx?HÊžž†×ÂUê%!xv2cMz_)Fu"~ÓRXC½ÇVyüæ3›ú{'ÜÑÛC(‡«HFÓÉ´Q%õX‹ôDÈïJFEº.ôªÎJ6j}OR6gÕ9ˬ¡Þckºh??Ò,ò(ÿÓÑRÍOaûIWasiØŽC©g2SDÓ)8µ…lâ¨U-Í i˜çÈ¢­Ùþöú»±äçÃ]ŒÞ€vqП¶6°Ésï%õ°¿ô@ø¨ó$ÕýÞã)ô62ñ‡œØé²9)…5Ô{l}vÝeW–ƒU÷¶…,A<·M"vÝR¿ÐQ/ˆ€+«<­Îz`d…ÇÈcNHiÍxz6kÔÿœïÔgIÝ-ú[ã MàÇ4dxYÅÅG{gÃÃâ%“’z[é‰ÐÅŒ ¯A•ê¤8j‰‹ç¤ÖPï±õéií§¸§ Žê«Äõl á¯Ç–@„ƒ|…ÔÓ‰¥¢e1Ø'’¡€£>nwÌI©Ìcoʰ5ﺟMžª¼ë£RÂSòîÐ]÷ó6ÝñÞuÛ©£…HD{ïº`ð®ÛpVÚ1j ¿5ç¤Tæñ®¶játãØj(žŒŽËrí@Ó þÖ[Bê˜$ÒÑk®†ã/Õ@oEB'ñ¸C%…5Q?¶&Hßç=FbüO2vA<ÈóÀQ&PQ} 9«¤~—že/гdíªQAh‹øÌ))Ì£Þck><ñqGÀÏÃ`tÀOw¨D<÷‰9ôþÄzç¨Z¤ÀJ‡§³Œ£ÒŸæ¤Tæ•þmëŸáãÜÞ­oD„d`4ZRˈÀÞ!¡à!u`é‰P`” ¯É—R×8jS¯CÍI)¬¡ÞckºãÇŒð²ê5ªô7VO ~¼‘Õ3„%Å­‰zNì ö£,é¡°Š£î„ÙÜ’ʼ²¾mMOÃð«Y@ë:ã ãzn/Bì¶ÐHèba·Ç"ØÝÓBω“­—È8ØË‘@r™» ý¥Ÿ9%…yÔ{lMOÃÆ-#QŽÁ8ð |&Bß9¢-„uqTï¸ |.IlÛDM|ãc:ÀõÌcpÂíp´EpNIÝé=¶æÙ½ú˜Á¸ðà}~¨Ñt`Æóû˜?G[I=“Bz"ž³1Ð ™zEfµäs˜ë ½ÇÖdú³OÅuÅX(ÔôEl¡ŠòúBß¾EúœáPƒz"fÄuÉ~ kI1j¸5'¥°†z­:²U;¤ì<4œâ¡€cAqßéï9̲\(uHéÈCC0z = 8j8'¥2¯·o[3)`»óQ]JȘ~å>^Ý ^G¥*FíqU眔Âè½¶þÛÖâæ_¯ª±›t¶¸1»ÒzÍŽ†¶ {dÇFà\°§ÛõDÌlj'F¡7P6~øFí§³Í ©ÌkãÛÖlÓñù+׎•‡Œ£fÛOV/‰x&ˆ¿ùšÔÒ㉠G 8ŒØyÿÃá¥ç(‘5š—iNJa õ[Ÿî•î«Q£´`\ë®5„îUÉ ´œ´R¥IO„Z¤‘A tèUUá¨Nhå¹5¤°&°ÓÃÖ|xŽ;GîºÇÝ“»n÷Ÿy¡³@$bݯd°CôDô8“á0Òó FmvÍ9)…5Ô{l}¾}\ŒK~û×/ÇZ¿îT:—ÝšƼâë÷ÜA”¸£^ýÄFßþ©ÌkãÛÖôïWÜ®þýêç©8»'-@’€Ó¾ÌzÖ±ô@ø¨ú(ç ä^<ìy5š¹hÎ%ü<³†z­O7/7 G‰Y ŸrJ¥8”|Ož'©6JODlÐ`x±»ôè Á¨£sR k¨÷Øš µF±¨ÂÕºïŒYT¬wÝßXQYw^U:’#*Pº§Žz 0ª> F»Ò³þS£‚ø›|æ”Tæ±T:lÍ> ç0QòçaT`k:ÿT— ¨'¢zÒ¦¤±C×Qâ‰cAÅõ6àh1*ˆ¿y_MRXC½×V]W¼âtEÅj–ÙàìƒËèNòȘ;oªS¦åˆ5Ê4"»k£­ÐkÑ=d’PÌÆælÑ{d„Þc«¾}ß3w6û$HQÅC¶ç X>ÊçÜO©_)$õ+…ô@Ì7Ë ÇošxrÔìñÉ9)•ym}Ûš+ÏçÅ»ë,c+²øùèÝŠ,ÎKBËÉgTIÓRz ÖY4ÆD„zS‘Eu¾‘E›s*²Øoè=¶>wÝý6„Ÿ‡qÔôsß'haõ´ ºÀ~¦Ô‘I¥bG;Û`Ôzl …QŸÎQ˜“R™W×·­y]A:M$Ĉq°º^„DÇ0rr”˜Œ–n’zôDôüèñüµBÈ›µgB æ¤ÖPï±U…,hîU<ŒúóÍñ^Ïîu©}²;ÀCJlÇr¤ÜÝ9¡”ŠÍÄÁ"]Ï鈱#å#榜vQ÷µ;C-Ó]¬/JÆBQqoUI^ï2B¡–~B:q=-£2™õ6r¿0êÎÌ0ÌI)¬¡Þcërwqàdùÿ|1/$žƒßq¦Ü…DEVHÝ_"=5?zýÞã)|Ð$%G]‘›Ä9!k¶Ð²ÂÖ òš ÜÓ'~ÆÄéÙ{Øõűm@h¢ÝCê±Cè‰ðQŸp6AË©×0Vj£… YÓqz~lÍÎ/×OGç7m‰ç°éáƒþ+Åw²çYqˆIèZz |Tía`´z`¢QÐ6KHežë=¶jp¸ÄíÁ¥Ÿ/†íÕÃÈrèé B®ÉÏD’z0Ez"ZæKc9Äõ€¯ÇQÐY©îÂê=¶fÔá«ZÒ“,æê÷ˆã!b›u² Is{Òéæ ¢Ä½=mJo_qp#Ê0˜SR™çz­¹p~Þã]Õ%X ^ܺm‡ÈS4bm±pŽ:˜–ô@Tõ€dÔ+¨yÁ¨E±WÍI)¬¡Þcëóìû*°³é‘1лø.²ËY|“Ïþ©oOÒ±²­Že„ÞÄe£Îìs†9)•ye|Ûªó›;Ro €MÀþǃ›‡•6“„NZ­†´Ù]z j”£”Ð+Àúƨ%6uÎI©Ì#l|Øš‡ÿ1ÿºÙnŽ ¸Bªã$cËôñ"¡Ãÿç #©C$ID6š F¡WGmoXÃæ¤Tæñˆ¶êä™Ú×áŒ~Æ즣]`´vÏl¡ŠeßQê)RÒ±c‡#ÃcäÒR-G]±ÃqNJa õ[óîb‡½‘Éüb<˜ÙÜXÌ[!¡ú,I«ãdR/ˆ'™xÒÅØ¡×”Ìß¾’ 8'¥›gѱ¿m͇箯„f1˜˜<3¡ÙÂÞ„f‡’Ô]MÒ Í`45¥=™ÐŒQŸ„fÌéÎw…Þc«^]¯‹EgÍŸdTKåjéÿÁ ZR4“Â{æ1é{¸:tº‘ ” ‹m@ó[Õ¾‘ Äy%•õ~¬c§V­¼dLáŽ}ŽÛk¤ÎsfA„“£…ôz”g~Þâ¨ø(@o¤ræ8jæÌqNJaMªUØš®¸½JºNÀðs‡£ ž’F‡<Ïq Úñ[RG§^qƒï ô† _æ%¡×êvIiM¼aëãñ_ýð'Ûs=lé©}ª;Y$t@ü¼i`øñqSF£°3ê•ÞòBŽ "B¥%¤2Ïõ[3¯÷;"¯¶ãˆØ4²‡*{‘WôT •¨"YE˜«ŠØ÷})ÁhGzû ŒŠ0w$ÜR™×η­¬»~ª~‚u×OÖ ÖÍJ/LE =}4Æ8#¤•ÞuëúᨠÖÁ~f覌£¶7X‡¬Pëî’Þkkf9àlªàãâqßY«Ëd–Æœ¯êš¡'B¥Pd$A¯¨/î$´OàgdbCë¡÷Øút«ô[X{šU^ÕÌGvÙŽÛíð…„v™²Bêx1ÒÑòˆg ôE¢ÞvŽº•c¢9)…5Ô{l͆®ÕÏ,¾OÆFCšÏ!ã¢;[óC ¬Ð^E$©×èIODÉN¯p7>ôJToÓ€]C kª‚ak¦‡UÏ×=™V=£wܧ‚© =¬ðƒ{S+IÝ›'=5K¡Ä¨+ôè]Ǩ%3É0'¥2¯®o[eþ$>ÎQ’ pÈËÓ"€Å¸À&B*¥Žì)=32­ƒáÁ¥=­£9â5'¥2¯îo[Ÿ%¿Ÿ)ÞŒƒ ¦{õúÀW& ½¨Ÿt©»µ¥'¢fÚ Cf“ž€5byD%S)…5Ô{l•ùÞUÏïÏãF³¬ëH‡Þɪ“Ðíb—zæ õ‚hYŒÓü&´zèyb•FuæcNHiM¼TØšæoG,8i¾1*.ø—³VäÞJBæÏ-ió6Ô#QÂ[ŒÖ¥w.Î>*™ßFHe^ëß¶æñlÆ ÆÕW:<ç«°®çx¯”ú—"½N8†KŠQãr‰˜!G}Ã’>§¤2¯îo[Ó[Ò=¸5Ò[‚ã¹!ïW¿9œ¦Vêó’oÉ ©ßV¤¢*ÛTŒ¢“@ósI+1ªá-é!…5EÝÙÃVÙ*kh¦êèÀ¨8$yšÐòiwVtòkÔRÏg–ˆÄ`(ùßõ”üï£Î@-ᜒVVõœõmkFz«‡…ån }‹Ã£Ÿ­t27ödLöÞ.¿èQÄ wC0|+ ƒŒ£Îp7pNJe^©ß¶>Á:ïŒ oõàùÂŽ¾ü®Øë ä¦ïØ›"HzýèÅå雄¢Ï–ã éöx5õH¤W.u„^p1FM¯ç¤Tæ;lÕ¹òvÂ…S _­ð®!/Uxg“ÀÑÖ‘¡%u¼~é Þ]އİŒEèð£®X89§¤2Ïõ[óÛŸ¾›ßüö'6|ûŸãÑ@~@CFæWmxS ôꑈüªd´zȠ⨙_Å9‡@Éa^ß¶Ê|or:Kâб íeVÄ¿6Ä©šø…î Ô6Òø…ÎhT½q„ºü„®êV•I©[#½ÇÖoøÅ¼màaÝ 6Ù7-×A<.I°X#Ú5ò¶EF.sgÖ¸ƒBcÔ¼mqNJa õ[ÿŒøÜ?ÍÿÀ|Ï%{Ÿý‚îx ý§4RÖô SЧ›z°öær"†÷ÄПm³øR‰Ì¯Ì¥2Ïõ[¿Í?BjËÏÔC],'˜èÆ™‡fP*]O?…ðËâçðåzý.0êŽ3ç¤T_x¨jÔ?èáù§ùÿ!ÍÿOöÙ÷óâûíƒßâ\ñýz/¯÷Û÷¬-I—];¤âùöÁà·=~¿õùö1'¥°†z­ÄÃþÓhüó0¶ü‚ùdHüýüDxþJH=~,=+ïß` w1õ&<ufZ0æœò ®z­ºmyÂÉi‘œGFWòz÷\AÇ»ÒI貸nH½m¡ô@´HÎ †y ¨‡„VŽšé®œ“R™W÷·­iþ•¯ýç‹qqÕòÓ{_Ýù8í…+EérGê‰è%Ìï^ƽFèyB­F (UÍI)¬¡ÞckÞu‹{ïV‰».¼ÞL]€'E¤Ù '“zrÔ(.×qtc ~ízB„'sÂiõÌß^5¤›¾tFzÃV]ÄÛõí'㢣Ýqä-ó»/Ÿá$t —R¯¬”žˆžÝÀ×ê¡çŽnÚ^ [›“RXC½ÇÖtS„îv¸©Âw( îߘð=ÕBB¾§½Bê-È¥bFåh#J½lSŒ:¢r„sR k¨÷Øú}ÛÚªfIÆiqâ<:~žIâ=qžç)=õkáˆ{So¢ÅF `iÍIi¥»>ŸõX÷=Éÿ~™Íðƒ¶ ôƒö‹ê‡û=µ<¸ªF<ø¨`z‰€Z¾ÌÇœK1÷Ø’¯­¹pîÊrߟ/ÆE1e›rÏÞyªŠ‹¬$]*ÍŸѲr¤¢¿…ž÷;Ô¨;üûœ“RXC½ÇÖÌ)´ÄRX v†ðü;2ñ|z Mb é÷Ð1*£#d2‰Q1zŒÚ3Iq0óhô°†z­ONƒgÛTíºbp1?^$aÙõµ(EF69¦‘¤ŽiD½ êS9â¦%çP¯"«( FáVÌ )­iJ [¹^[å$ãµfϤ8ô0÷ÌÔ‡¹Ô­‡žˆÈIºLn;ô"ØudI?æ¤ÖPï±5·­Ùi°Å¶]ŒÅÑsèbÜ„ö¢~Cê9˜Ò!o.ž"=ÏѨ‘Q¢9)…5Ô{lM`騮–^(–®ÀüCtà $xΜ¤J˜/5ˆ£*SÛí£ÞFkaŒ52š“RXC½ÇÖ'²è/J ’ƒ1„JÞ=p3¸HDd±…ÔS ¨G¢¿¨äÍ£xDÙ.$BHY$"²x%¥5Ð{mÍDæêÁ£•‰Ìx¯€'¶ŸfCK—„¶÷2CŠ<á*À…U8ª>Š|ß»¤Ç\ŒúdJ`NIÝé=¶þ».²ÜÖˆ3O0T¬ê‰mEцó–ç°âÔ$­ŽB1¦/"*x+AêÆ =´¡ç¨-Î<œ³çÖtÀ–>¶ê²èq¼› g0rv-éKcsÌ'Á´9Î¤Ž€ =5ËM«WdzX9j.œœ“RXC½ÇÖL+…-h~’q‹²Ù§šÛ8ØH};ݰ<‹ÒÅö<"žN7ÁhSzdP5*íºs†Tæ1{>lÕºï™sF ) º½¯:»Õ"éVh¿¦J:Ù¨Ãõ&[x¨†4½„zörÔ5¤œ“R™×Ë·­Yˆ6ü¨L`0j ›9èʈÆ$þæéˆ.õd é(í£lé͸gƒ>êsJ*óÊþ¶53Q›Úuh˜¬^-ıñ˜‰CÙ¬$´½c!›„Ðn¡çÄNÐS2ò,\oU¦ÎJ"ÉR˜G½ÇÖLGjþµØˆ·–¿‰Cc‘À!ÞÏ ’n6ók'ˆò‚m-ß¾m9žÕ¬U âopJHÝé=¶æ³?]™'Îdxãۛ鷧]{zº—z’“ôDÔüèñ3µ@¦žô5j”hNJa õ[óÛ?žJ¦¸.•tÂÙ¹Ý~ni×uøaI½ Oz JÆuÅð¸®ë ¿fqÔ‘Ì)©Ìs½ÇVíºÝ$ï® wÏnç™ÜWÇü墭õqà®hÂAâÙuÁm­v|ﺘ“RX»uûåã¬~ü<#“øÅP?ª ÄOxù'‰ÿ†TÐôLâñ$ñ£”•ðkÀ·fë$´EÌRXÓ…f¶êÙŸl u³ZX-´sè^þYÑÎáxJ½ ·¤‡-¬Vbåº/F/¡çàÞuFÎI©Ìã~¶~—ÎÕl¢Frb³ó…Aβt®‘‡Ò éðrIê¨ÙD Œ‚fHÐ+@NĨ%›(aNJa õ[3Y“Sð®`ÌÀŒiÞhñú—Ö/ }¥HÎtéq8­)̘y9ª>:½Ñ"1cŠ·aì;Fí:jNJaMfLØš9̬ò×®»ˆ`IÏá!­H Brñƒ€ŒK" Üz f–²ŠaH›Ôó¶~uÄoÊ9)•y®÷ØšÅÍAÉqŒË¦ÚÝQö¢aÈ”-Ô¬*`…ÔW:é‰Ä%­å¡çý54j‰,!ÎI)¬)jI¶>—ÅÍ«ÙÏÃè¨Úô½×3¿Ö¯ Ÿ>$õ{õHä Œê®Vê¡l£>E ˜“E °z¯­쇧ÏËMEF…»©0õðÀ“wøÖÕç*ÙVè5¦:†›ª1+ønéÙu°kTø¨ÏI)¬¡ÞkkúyfáŸ÷ó0â¦\pSÆb¾+‰¸TŸ^Û奢Fuu0ˆÐÙQšxcÔÕÕœ³¨Î æ¡3lÕÊãiŒÃ3Ç~’1½ÄÑÖˆá@0Ë!5Âó¸(½ŽŒJ=#Ô‚anè4ýÖ¨ ´HR™çz­OhΧ{‡‹öÌøíݵ¢@.Z‹/–„ŽFâ$ø^½íéÎuG9$ç¤TæÕòmë“ËæY.[+€1·¼2,'¨A³tºðFzNZéõTGêHôû`”)½î%6„Vk F©Ìs½ÇÖŒª·ú+ªÞêãðØó9”öud[ö»gT}½Qõõ;ª¾2ª½ˆªö+ª¾çs kõ‰ª‡­Ï® ¤ÿž»®; Í5„Ûå9â¾?±ë–z–¢ô@œ¸ÙƒÇ£â÷¿û¨ ´ë®R™ÇCWØšæ/jÀðJ)?NÇlõ7ç’xm¢Ô‘¯¥'B]Ȉ3ôâŒQAè ØšÖPï±5ëí—wš T²yŠ´p µP| ,'žÉÁ(7ô–¥lÔ„äœKÕÒ0¯Üo[°­mH¼K 0Ñz=ViŽ‚˜È»6Kê7sè‰X‚§HF)¡ç«¯F}ÖfÌk3Ì+åÛÖ?#JúOóÿCfo²fzéôƒx!€Ää$äôAw/¢¬)½ jú‡Ðì…èÕ‹äîШ+×fÌI)­Þkk?¯.?c!6SØ¿¯ ¥:SžR?ÚJÄÔé9µ‡žÃÂjÔ¡qšÒ0ÏÓå[u*¾ÿ/¡ýy9Ý«^=¯¦x*´AJõ·ÎK'åݽÐ%ÕÂ&:7J­5¶Sø4禜vQ÷µ[?ÅQl–™>dT„üüNŽ˜®}Gu=_Ï„m!­æë¦‰’Qh1Ê‘Þô¾uF‡_ÎIi˜gz¯­é{6ípÁ¸¨f´°ÜÂÉä˜ äÖ)=¤Þ‰Tz"tç!c¨úñvºƒú&!ÍI)¬¡Þcë÷a®©Ž:K{,Cl{Ç®sÞeHR0öX†0ê{˜k¾Q¯ú;ÃQk®X˜“R™WÊ·­|&^‘ÏÁDxëâ iÙ:X¾Û†~~¢üa5PÓ’rGI ]R3PדcðéÒEî²ÆŽ¢Ø˜›ò°Ôu_»3Ýó£A9cbĵºgiu„îK#¡(ÿ:!uh!鉨ÊÔ£ Wn¹#ú®µÄ‹sågz­ 瀼š’€`ldÝtG€kȺ¹‡ŽÍ~YI½ŒôD<À~ꦞ£ kÔžXc˜“RXC½ÇV™¿‰÷ h›ùµ–÷ÑÜë÷1ÐNåÍ;7€ÀDŽY éõ õ@Œ´I Ãh `9jsç¤Tæ¹Þc«À&”’mƒsÑ{î¤ÍZ77ßlH黪7åÕ¢CÒMJ8ÎàX³¢%UKk„â†x)l¢Þ—ÉÄ©È{z ON]0ñȕƒÏö3ÑŠ®?a™MÒë¹²Ô#Ѳ”½†ž'²iÔèú£9)•y½~ÛšÁ˜†~Yr‰ŠqQ¦dU ÓèÙÐÓG¹!u¨ é‰hé]Þ­z•ÐÛ€èá¿Óœ”Âê=¶¦G·£uçWçv·C’³ÑP£3K¦G·zçQé vÓÓ š â$C8É5¯Ïœ“RX3£ÇŽQqò×1¢¿0ÞS«ŽvLœ='Ž,î ‘ÔóB¤b„¯‡ ïÅ%=_S5jÈç¤ÖPï±U ¨£](>rdlt(ýÜ€ k‡„Ü w„èŽÔ[Ú*À˜žÃO½‰ÎæuƦÈ9)…5Ô{lÍôx/€Zbýc#î>|û²>×­R[]°¹RÚhÆÞ¸K` »¼H¯#}£ö8mpή怕ãÛÖLÿ™¿2ýgz[’Žè Ú’œ¥ÌŠú GÉAó¡ÛBo³ËïÊSþJïC˜·£‚P( ¹ö.°¿ß¶æ³=ÉR°ëÁ°ûÂö쌴ëtIèÙ?3¤þHJODñìwïî o®gMƒ‡F¡g¶VfL¹ÞcëƒìïùJØ–ÂH¾^FçÉCžP ¤'„Hêy#Ò1• 4W ŸŒê„„w…t÷Þo[¿/3YÄØéÑ]À\Áq}%" ó”Ê£»ÇC”ïKÀð Z^Ö{µø¾ô§\z­ùêbרÙÝy¸ï•/Ëu讋îÎܘܬ—z õHì¬Ë£ÖÐ[ÊÊYã«ps²pRæÕúm+Í·¶ˆý%‘˜Ðö˜£EÛSØŸX’aò•z»ô@d,‰ Ä„¨‡hGÍXç¤ÖPï±õ8²ýóÛÿëFDÎ{³×ïça°Ý¥g\z/B¿2Cêagé]v'Ð[ŒÞB¯z}G­ñ–sNJe^oß¶fÇñj›'ínö†œ“ÏŠµ–;ÍW¿Þ´Ï=Bzéão#ˆ™iŸ`0‹z‰udÚ'æJûD°ð¶o[s×Ev¿zí‘AÀµê]áîÛÞ°„vÝÚBê¤×™û?ò£HÄ95ôŠ7Wà¨%zíqNJ+3ü]ï±õOÝï³O«ŒS™’çÏyŸ}Ëï!=Ler=OuòaÂÒ)¡‡§›£æ³Ï9)…5Ô{lÍsC)Q3çÕ}ÕÖ½yÍ‚k )ZPO„\\dAϘE£‚ÐyßÂê=¶êÙw÷Ã\r˜ˆ±Ýµ`…©ÅNLÏáç t6Ü=¤3(=ë=œ‚ÑJè!(ÉQÇsR*óZù¶5³—Šw½TÆ¢œr6Ëõ´¢ñ´ÒõÄ£RƒJDÉZTgÚø•ÞòAuݬEõ9%uk¤÷Øšø—×s4jâ_‚qpå×ì@¸¬“–8ïÕ évVsR k¨÷Øš+Ïõ(V?±ò\ß[ ‚éÙ7žûä(G ´œ|ÞSIý¯Þdô«ë£S°zÈþµDýç¤ÖPï±5ë¤FùÊŸƒy0Þ§L2›)‚‘?s˜@èRï&=OþŒe‡žougQæ¤Tæ¹Þck¾ºŒ.Žxu/ÎÖ‹Xùcº¼˜µç>Öu¹ÖP/ÙY/àZš÷× Îk”÷C½ˆ}A¿-H»%®QÏ %Å‘Á¼Ú˪•Û}ÔÈ'˜“RXC½dk8㶥ݧâÛRï'Qq7do#!Û<’Öò<)Ô#69ƒ0ŽÓšJ±ƒøm$0*ælê ó鶦͹˜k=–Tœþ:|ôžxïW%áa¹íR+—ˆíi=Î`cüŒãú¨Ë 99'¥2¯ŒO[u²+VðÚãd'Æf+›Â¦×Ö°jç¾Ú¯V½»Ô¤¤'¢F²ùB?­ézg7ŒZãdWØ‹äV·†zÉÖôíÛW:Ó·oÇûŠ“É5WÓæ·ßHø·]jyKÒq¢í“Ñd1ꎶ;˜“RXC½dk””4¤Í³s²s6:XP¿Ø/ö¶ ‡èYâ©èvq9þ¥K* q¦Ý<¥kñk{zv”榜vQ7Û­÷øÐߢ x§— ƒÙ]­.þ›7—ZÎ$õH̸¡‰Á.iÇjØj©.¾:IÝ<ËéH¶Ê7d9„Ù­ ݳv •ãv„.‡ùξ’ZRz ’[ w϶âŽÛ>^0o—Âê%[SB¨emÌ”Ú-BŠ*àÓ~ˆ ßF$à¹ï¤(©% JÄtÇ"•4гt=:ܱÈ9)…5ÔK¶n`Eÿ 5ã_ÕœAÏTÛzvÈÝf'/I›ÁÖRODS5v$=“9ªrâ­åRXC½dk\ï‘ÌÛãzë¶UAXåü‚ömtÌØ]j Ò3b:“GN¼‚:ß®Q§0qNIaõ’­áÚBmÐ×Ö°½¨Âµ…Pö‚k F+\[e/¸¶ʮ͉ˆF’±”oƒPv›>jD#9çRÏh®—lÕʃkE¥abT4EIë˜n°Z“Öôu£ߨ"5eãݵ ·˜xf£®”–fsJ*óJû´5€8üìJ$Ãú·8'bȧ\ƒ„v›^%}í¦ôH”Ha2ƺHE2½uÑ/ÚF!/Ø=.=*yhŸ¶FeÛ¶c·³ƒù»€lfþî=$äÅYÃ¥“è«Ì ¡}• ÔP¥µ;N8ç¤ÖP/Ù míËÒŒí§Ùé„ ;Hø©¦¸´[a5õDøÈÛùRo|¥6*íp@ š,(×§­±më5ÉÓ³H½ßæÎ˜RûØÓOÏq§KíG?=£m×3ä#ê¸Hš“R™gzÉÖØ¶~>åXyÛºÖ)ª6gXÍËF¥Bí$´í+é6ÿ"õH,߶Șڶ¶U¶ôé£Îض0çÔ¶u›ë%[ôÛ±¶GjéÕbPk.ë^Ŧ]ˆSxK/›BRKÉ—ˆˆ)b´îzÕbsÔ*7„æ¤T汘Ûú™U£}µjjõl(x:¼ý“·¯Vs¨0çÔ yûjµÝÙÇõ€çæízT»íÍ|Zô‘¢^²õÉB1¼ªWõ©,”Åf»¼jVë%p€…u ]QÇv©áÜHÄR’®S †ž„}£Fê*çœ à®âzÉÖˆ \[eg´¯¾U™1  4‚D`D£iÛË%ÝDœnʼnî%dX!¹ôšb µ‘Ð1–Ka õ’­© [pQ¿?+4&â¶5& m[˜y²{¹žˆžv¸Eœ`ém[c’Ðn‚0 ·­6\/Ùp·¨ÛèJããÂÑß ýÝ|Zcñ‡îE;I±½îI„;}Á°&ÖÒc÷ÖFH®œc\] k¨—lÕ³oiâ§û™‡ ‹Ýš=”@£a¼ÎÆAñ†e^Ä›=27ŽéÍ€?$o“•ˆžF1Êt½…D Œº²§±—ʼ2?m —ä‚꜉3Oƒ—¸’ïùl—¯ô@tï‘ï–zx<8jóøç¤ÖP/Ùª Uþ,¯Œ½‹q,.~­ìà‡xM(®ýܘŽÝÒ(=ï"=;§U-+²z)@Ô[>ç¨K1ÍI)¬¡^²5܇°öÕ݇`\QþÙK˜v?_ Ó[qéyßôDhi$cèJÑ,¢^Š:2Õœ”š!L;·5|³|ù fÉ{ÑLO÷®_>ˆ~’‡âÆÞ"=û`¸¢‡£~ø JöAÌ’ö¾YþVBX,Ii¤ö²Õó ì&õ®A_Z#¡¯ô—Zi®ô@بrÞËZÚÝõ¬f\£v!yhNJ…tÊ6nkà9¾£àqó›`6 LfØ©ñ"Í¡Øëæ3XKéz'\é8n>iÎÐÛÈƨÛë*9'¥àØãÓÖ¨|_v ö¾S»qž‹3‚Ý8Aè–1—Kíþ+='N`lËr¥ÞÆ£î8A`NJa õ’­qwÙvF¨qwƒ>+&éá»¬âÒcaÆ©6Æ Ô„‰Œ(ôf©ª\¡„^]¦ð5·fTÅm¤«jù¾#òÑ‘+\xÞ–m½pöî—„Žée¹Ôâ ÒÑ<ˆN0ú¨gŽ/ên1ÍI)¬¡^²õ#]`5õ¬£ãâ†ÐýÀÅ ý•iû5ÍnËõ@´¨L£]×Ù’£Ö€ Åœ”Ê<ÓK¶Fýé<9Ó‡ {_-hµ‹ÅFýé¾$°?„“¤›àƒ­;™>d s¿Qo죎€ÂÀœ”Âê%[úíÝ3}œñðÜš•µgy¹7q Þ›ÒÀ‰jÈ4ñ9xL#7ùP~ÿœAEv|pZ“îµFúz¯ Î,©›I¸Ä0: GXŽd3¬YÌøX“9)/  M—šßJz ¶W?±€K=Ë-Ó¨Ë!9'¥°†zÉÖ„¾auêàAFuô [-.Z®NB7+´¤¹ô ¯9Q¼ƒ‡3ˆ¾„Q¡otº„!ÙTèMzÙV}ûíýÙ+Öþ †E mMÏ ­¼Iè+Ã¥ƒ)5c91ÜùæŒ:\¯[~4Gííàœ”Ê<.Ìn«ÞzùŸÂ­Iý‰÷õpÝ ŠHáYE™€ä†Aíº¤«&8ïl ]Ôh쀫ÑÜ”»¥¦›íŽÍ [„"Á0HWëÚr* ]aFÄê0Žï°ÔÑâOÑuÖ}›½ƒÊÖ¨ äHD‡™²eô’­òB›w Íò~c˜ñL4Ì{ eäž|ì‘I©ÅP¥gDêÉçŒÒ¥7L„QAÈaý3§¤2¯ôO[ûsWþÒåYâ­ÆûªÏSG!áîîåRKƒ§ O .êy)7XäBï!)­^¶5œèÇ Z”¥‚q–„¨ß7z#(KEçd®Xm»žU…‘a¥øÒC>!G-^㜔.Ö^Íõikœ£Ÿ›|Gò›¬Ï¶#tvþ$4Ñ©.5¨ôDÔ8Gw[÷Çt½‰ü~Œ:?Ô—Âê%[ÿŒ f |ûz ïõÆÍ  ·’Àrm˜’æ•´*b;°°vy¤ÞƯ†Qwü¦˜SR˜G½dëç·Þi0ûמÉeºÊóҙ˳ÀJñï—zú)„X¿wdx‚£‚Èß>¥þ,´O[ÿˆ‡'òἘr÷úþ¹{·þŠÜ=­ûž»w#]zÊÝó`b¼jÿÕfþMgÉæK*óÊø´5B×í¼…äÆP´úåÄÇUº$~UîC‘ª[¤G¢Ç FS5jç[÷Q£ò–s6E«Q‘O´&·õOzxþK7ÿ<ÒçʳFzk Gõg¸:r ôôYÔ—ÌÝC¹ÈZyöþZyöNæõúiëŸôí¿¾PíkåÇ¿}+N „EÆ¿±d¼ö Ž6êçÊSgúÕVM¿éª_+Ϫɼ:?mýƞ׉ӱç¹SÁü9’ù:qºùò’ž¯¢ýË|û¡„=o{‘°çuâtìùØ©¤—lý3žcÍigjY ºç¡EêdSbRŸ©eqµ¶æ”6ƒs¥ˆÔ²Œ :èud´aT±×œ”Âê%[ã¶U6ü¶…f ׎ 1dõ´AB6ýìE’Zö¯ô@ÌHc #"ô ¤Z£ŽHªlÑ0º[C½d«n[hdXX,„Ï‘øë‘Š3Õ}æ±û Ûª3%pïíùnÎ8¨SCŸ×ñ¬$äM®Ç¥­dÏLD:µnRÍõ&à0êtOç¤ÖP/ÙJó± ÕjÎÊß™cõQÏ‹¯¤q‘¬Ñ“rX´Öå±rê’Š¶”âXî‘ëZŸ`»xTDsSN»¨›í/ô2'ð,î…^ˆžmóW•ÛèKx ¹–gs©¹°¤ ĨH»…ž}±Õ 4'¥Sí‰Æ§­‘=æ˜J¿ÃÚæ=bYºÞDóëÞIà‘µ²WIÛûGz t“1žïiKo[½G¡ƒ6±œº¬‘^²õÏØÃ¶oø¬Š}á >«e…'u „v›WCHieëÕUœ(^s猶¥÷|S]£‚ÏjUIݼ¶?müóbHâKµÖÆXæU¬Œ.+¬gÿmxJ aÚLZ àÖŽˆéab1¬ÒžzÓb¸êùíabÎI)̓^¶5j/ÈôÂ1T7j1OV”žJ½KÛ¥–_'==’Q °ºë!hÃQ#¦Ã9)ýUjñQ¸hæÉ)Jüc#y )š dŽFBÑäl2ººôœ(ÓÿtÙ Ú¯ôž'gjTr.þÌI)¬¡^¶U §Õ~®©º£`\`"£e"|‡\—Ù|‰CzËDø®/×Ñcõ+¾ô}0êÜŸ)ÇAuk¨—l ·C³ýúVw;´%Ìô—`añþ Àæ±Hh‰«]R®±ÄZ13† mº2qÔè×Ä9)•ym~ÚúywÂ_ ÆÉMP{\|½¸/š ö¸mQODý¸øŽŽnîî,Êe ÷2ŸRݤfý´5àc §šÃÇþ0¶µ9³à†ÕÛ,ÔÍœNß“aHº M[ŽŒêQ™aÉYSzϳjT µm¤™W›qÕ Œ «ÓÈ\®eEÎÌ<¢ÑhâLù@»gê°þú•Ö¦šépk`ÑŠ[]*{ý4826*úh©X '›Å½§¹ýÀa̺bJjuÒ1£Ý‹DÞAQôÜ>êð„ÎI©Ì«íÓÖ0ÿXB£W‹Ájš‡\ À—7ë !›~®º’ÚáDz"½Œ-êmí«îòQ—çÇqNJaÍö¢Èî£*W{Y2tzµ¼Yÿ¬ŒÈî}Ĺ$t ŸÓ¥Ö•[z" Ã:EIÎ4Ž:<8À9)…5ÔK¶þ^Ç>Ñø7TLgijS¯¤µytwæK»i%ähÔ$]R#sÉéx/©ÛmóÓØ=s»àu[»ºÞø°û;zQ>Ýÿ†—ÇÙ„NÒDGá§fêy˜ôÓý_UÅOqíÖÌŸâF ?¥Â<éûÓÖ”ùŒ$.‚À°ÂTÃp‚'€Ð†?«KËY6ªNe±äOzÖÀQ£6‡ˆàœ”Âê%[õ_º#·`cÁXz9·Ã«¦O åxºÔª¡ÕMÄ O1Êt½ñÌШCŸTs¼º2ïõ0̶x5„ä¡zq0ൠ¾üi`ÀõŠ5V¥ô‚£'lTý)€6˜ÜQ,/š=X{'ñ XÛ¥êϲ秭ñðÜS#ݧà‹:@YV<<í|Ü~w_Ñ#n\×1ÀJ ‚Z\{>wõQ‡WÆsNJe^›Ÿ¶ê j¨s錅O·F0vd0H tÿZ×¥óý#=%–Íâ&L„{zÚZpÔ¡#´æ¤ÖL%Þ¹­2²‚ºQÑš}±­BE?ä"Θ­’ëáB=%ºˆÑ–ô¦=ã„Ì·Ke^[Ÿ¶ÆçÁ ;ƒ@&ÛžNDŸC—“éÒÃÐ)‰¨ñ§8íz¸ › G ]<ÝîÖP/Ù{XÁÔc#çòØ9,5tbkE”Ε¶ÏP>ÓN]§zìaÆ1ô×5ø{ø»¥¹)§]ÔÍvÇ“ôŽ);‚¨`CmÙ]aRË]‘Nu¬¿€¤’ˆH§"c©‘×µclñÕ+ ½3k¸tòXuÛ§­q˜{¸S= ÏÁ@Áµ§db“P* æ^œR8+‡ Ï[å¨ZÙÁ(Ýõš Ïߨ-jô0'¥2¯ôO[£jsã­xÕ&J^ýßšD:Ý(C©„lΤ›ø©¦¢G:v–`w9jóºAÎI)¬¡^²õ8‹ZXmAR$óg/à \vÑS؉©ã 2­+.ý·»ˆÇ{1zq=ärÔ€Ï圔ʼ^>mý3¾ýÿÒÍ7Ô¯l>^tzÆyÙeóíø*zþ‘ø¾Š|Ôs૱>ÌÇœ^’Úâc'[åÁmæ/êœ(2Š}5?ÄBŠÀ¬$p$¶“¾¤ƒîŠ:œ˜QÕ0¸¯žæzÖT£uNÔœ”Âê%[#j ›¼fŒ øÊ3Â… Ç ¹ujã‘â^þ6×áEnÁ +¸rvù¨^ä¦9)•yµ~Ú^,sL-%¾9g›Ïº0½µà&jnªãØ}  ‹ò‰}º¤–n…‰SWè¢fXcGI±æ¦Ü-5ÝlwÄ&φÇÀ¸@Ï©¶s²•Î>$<3\jN-é‰hÃÿôZRÃÜ®WÑߣú…YsR k¨—l•ù×ö·Jüþ`l¤ö^;4Äææ&¡ß¼ —V~8º1A”x<¶µ‰Åõ*®¶…*ˆÊ9!¥5Ð˶F x[!_BÙhò1ÑCéÁKUÓ†ÛE)¶ûNþ’ãR ]£0´¼„`Ôý+àÍ#r; ü©ÍK©ÛX÷§Áq<מ~èæíî% s¯Ú92¹þ*ÚaQj}Ò¤bzƒ3T mÐ^sø¨#[0'¥2ánkdŒC¬Ðß v+G6ÀDóu> I-J")*Á©'"5?;@YZ®Wq…ƨ5.ؘ“Ò¡Ìõikld—Öë»Ì»×áò³ÿ¼ª¯í™F@­ô2KqÏD”À:j–9šëY@R£ŽÀ{Áœ”Âê%[#ý ygSÐ``¼‹Ç­è œ®ŽŽõ›N¢è¶\O½bf@o4ëq»ë 9‰Ë"ñ¯ ýºÖP/Ù«çb°Úì߉Qábšip>yqq¬ž{¹Ô~é(ÞdÈõHoYª:G¡ÕógNIe^=Ÿ¶êÙ7ÿÌ^ºÙe­á}„£ž×ó]H(¾Ø·KmÑ“ˆè¥`ðz½|RŒêß¾æ¤Öø¥ßmÕÉN}ù깦È¥j°º,Ò=„–NäT1fRšëQµp»Wì"½}Ð]GNô´9)¥yÐ˶êÙßlñ ôy2ª®¦ÕBü¼´îCBWÚ1\zßš#=)SKŒº¤‡4*Žš3µlNIe^]Ÿ¶j屨á°ê™ßÁ`Ýè²0ã´ª›G<œÑâ}˶µ¢t[Ó:êÀ¨øS1J—Þ«(=„©:]*óJÿ´5¥[y©>θ„þò‚/à’Px´.—¢Ø±%!í"’ºÍi;ëF Œ;ÎI)¬¡^²5nÙËo`$ûv$±-#î%¡cýš.ôÚŸ–…ñȰGKzÅÚÌrÔâMh9'¥°†zÉVùÏ‘âWº{ ÅA×®fÈYB_±UEᘋ¤FÊ;z´SWT€š§­ÐE[/]¿47ån©åÚe»å„³Ý|ÛÿwbØ}ÔÜe†B¼á΋„ûh›K--=5ÒÀ(Ö‹z†RªQ‹'ÍqNJa õ’­Jbµð*P>~'ÆAßäÃrφŒÖ¾H`"[2)ÅbJ=[¡ï`ôîz†¢Q—{&9'¥2ïée[ãø‰°ÂÚ~ü¼†~Ãbev²ÃnS' í6§ºÔ̈áÝmœQªëuôâÀ¨Ý»ÛpNJe^©Ÿ¶j½Önèú·Æ*h§pŸ¿ø¡<[üf'¡¥py «èÒQõ§`Ø·hzž_Œ:S™­ÍI©›×û§­Æ{áˆ*G„–¯õblͲÒln%á±¹íÒöŽ»Ò‘àÀ(X¤*÷¢v|Ô¯€9™‹|Ùpɲ”“­± ¼ê5–!r6º¾c –6k¤:DiaÙ5äÕNŸÔ ʽûäXë ×µàc{ ‘Ï ¹ì‚î‡Ýqœxû¼ßÃİû”å0tsÅ# Ù Î"úkꉈ{˜3Êq=»iiT¿‡iNJe^9Ÿ¶¦{˜E¬½¤g0xhqœiyt E;¨Ž_‘ëfáIQ!ïñ´¢8¤£N×ëH‚¨=Jz0gWŠÌcò”Û.-Üâ„DF“¿©Ù~\á?ÀoÚ¡9]j VÒëÌóvn1Zw½‚@Œ]ª8'¥2ÈÝnk'†¡<ÏæÇ‰áxÁ?jÌ©ÒYÖ  °2XÚ°á°9Íõ@ø&†íEÒ³]J£ú¦9)…5ÔK¶~çrÜoô°äû(å¬î‘¼Ñ’ªzsEYjg1º{£_SšH‡.ÑJO•¨{%ózù´5@ø ¼>KéäX(ƒK‚è ¬uQX*ÐNOr»º.©’aû†9‚îê» â/š1—KÍ&ée“£¨ð4 ›JclX—½w(Ù‹×Y¶9%%µ¤é‰P¿$2¬õ†%eqTøS›SRXC½dk„®9.Úôƒ/Äø/,¨?pºù¹RƒÐéæL—*õœ£ŸŒŽ =ô 9G£vÝ4'¤´zÙÖ€­Ö¦g hµcT…Ïuò禃¡’ƒán—Z²°ô@LO"à ¤gÙ¢uxå ç¤ÖP/ÙúG”, b@NK9õ‹sGAA¹iÝÛ‹„ûlbUœ†F=#0ªþôÚÙü9¡·íæ¨ ´Ö¢ÖǤ0zÉÖgþ¿ûÿÒ~ýïÿúÂR~åÿÿË¿ÿïþQ_úÍÿõÿé—-×ïÿó¯òëùGùõßüã5嘿þ«kùÊ¿–;×nÏ Wý§_¿þ%ÝlÔø#ÖŸë4hýn]ëÏ*ó"ÙÍŽ…ÿçÿúŸÿû_ÿÇûïWãvÿ‘Ößþò×ÿøë?ÛÜ?×çŸÙÿÝ¿þÿá¿þõ׿¾ _0%ýÿ_ÿúÏÿøÿë¿þ7ÿèßÿË?^BLû•ÿÿ>¥ýó¼o¨þúÿ¨†nóßjšŽèÓïŒbIƤÿÓ?þÅÿb\¤×ë/@ç¿xù<ù/@¿¿èè›Ìó[4ÿÐþbÀ™ï:ÿÅ›ÿèôŸ¿œ¾ÀÛ>>élw/ŸŸtþ‹u>?èôãy@Güiû‹ÐÕÂnÒù“5»¾Ä'ÿbHUüèô6a¿ þž¼ýÿüN½îG^ÿßß8»|¼¿~’ù–‡Ž„¦ßŸœŸ%õý3Þ³dãW´¸EýemˆËÏ»¹®S<9ÇVh×µŽœ>öйÈ禜vQ7ÛÍÅòZlZÇRÁŠDõPhù›Þðç\`¢Jn~3×%þœà'`Õ3tíÀ•Ÿ±k}ŒÀé¥àq0]§üK{N¨Ëgˆc§gŒsSî–šn¶ûÏ{_ú«©GÔ¡b8çX;ªG½_þå.?¦y¦HÙ7} ºíQ^Ñnº¢†îÙ‰cç[êZ¿»ëªísC–Úq8ÛÍÏ2,¹¢ÿÝ~çX5WVQô¨÷ÒËÚ …7û$·|×%µ”aàœùήk¹²>öT¼ÏM9í¢n¶û|Æ?Ÿß,ÄÁ¡/K—é¸H>Êš2­É}Y²Ëñ½K—¿‚ß/œc}¿¥‹;„ÆŽ+†æ–œ–R7Û­5ÙÂwo‰[…k28ÃNz¯8ýÚõQëˆÂºÙÞIÌå†íº 0¶þÚ8çÅ¥Û 8GcwÇÕÑÜ’ÓRêf»ùYÐñ®7ïœàœ‹ã‘ûw„—::ç‘™ o³ä:Ã9ÖÁu­G‚í-|nÈet?ìŽÏòòñïRçØ ÷Q/Br­†àþ@ÊAé³¼²yÉ_O]QK9ÖαÊ×¶ýkì©”fŸrÙÝ»õŒ |7†býû“ó§~¨‹Ú®©C ÏÁz¾|—:ë:Uã¯cؽ®[_øÍÇ® {ûÜ”Ó.êf»õY Óþ'Xè’8öø~G_ï7_¹¢0Ÿ9Ø]nc®ë½èÎ)xQ Û-È®±Aé³¼¹%§]ÔÍvëÃUãçÉ·b¥ë3&ÄÖ£TºÃðÖ46(ÞÜ’Ó!BÝlwœ-N®5ÎÉä¼3U±xâ[e;ÎÉo±ågËrkæ$Ý jœDƒ‹‹t§m{*<èsC.» ûawò)½ ûÄý…7ž_ßä3bXóqRîSZ!‡­Ôå]c»‚ë⨢±wÜ_87ä² ºvë³XJùû‹­ÏBÎyáÕ·¿6ØóÜ o·Ý¢´7Ïr+`w]RqCNé¡»ð|rì¸!hnÊÝRÓÍvÇÙÒ[K±Oçìçu~ÿ üóæ‚à (-ß‘Bò‹c u¯…|›3í`(]C°ò±§‚ >7å´‹ºÙný.ëEZÞ¡¯è<æœwrèð¾+ Ô¢ðÝÙÅÎåu*ÛÿÚ8ÖÐu»]j4vW Ò禜vQ7Û­ßÅ¿´&;‡¾GÃÓw¿$‰bM¶»Ÿ¯Ò¨ýÒ~Ëà¼ã½tmÍõ±küŠœ›r·Ôt³Ý±&o¡g¬Éò†5¹Áµ±&ß*JßÝ»wKnÝ(\—TWŵs¬‚Íu ŒÈÇn*ºö¹)§]ÔÍvëœÜàf˜êÚäüˆ?ËÆì8¤nj~8爫@Ð{M¥KjúSóVP×r‰}lïéàsSî–šn¶[w1ë=ÿÖÖP9çX¯Îjr¿¸ 7QXeãÆ!]RÉË霷6H×°í|ì%¨BŸ›r·Ôt³Ýáƒ}^žl¾Ü[p'x\Þº9­ÿ½j­ŠÒMñ­¤’CIº¤¦ß¨ƒSnèZŸV{øZsSî––ûe·Þ}Ëϲ׌ë˜8÷›öbÅÒzÞ$[“Âûi¥Ö.·*l×%uü^)޵rÝm[¦ÆÞ~¯ÔÜ”Ó.êf»ùYDc öÈ9V~c‡þÎN¼&ÊækVx ùË?ï®+j öÈ9¸KwØÃ¥±‡pÓ}nÊiu³Ýñî¿ý³:›8ÍpÔì¬æ£zÉ/Õ@•Hém~Ïä–Ï麠ªƒ°%N¯®[No»:›æ–Ü-íõËn}–iNŽnàߟÛ1¬„÷·ç¿¥;¹¹Þ(·¤T×uJO 9??Á¼®û~écƒRLüÍ-9ì’n¶[ÏØ„ïðº?™œ—LWÖ2já:»¨¿øDÖrìÝÒÕ<±Ï9–[!Ý×êúØ þ¢%g…œ–R7Û­wß’èßÏé¾qr*XkŠÜ¤BJg&[î)ßæ‘.©îŸEK@u]$oiìæŸEsSN»¨›íŽÏrbÝÛ?‹q¬#ó›a èzqÄ,GT²Îå7Eê’Š7 8µ„®ÕwøØ[Uë>7åni-_vë}A+Ü”L¬8õ¾†_½½jæ-$¥÷ó%KnKŽë’šª’rN<ÒʼnGc{Z¤ÏM9í¢n¶[ç±cg¢^„ß–8 7 gV¯ð}_»¼“Þ»A=;åÀï¥T‰œñ[l¡û²ð› Jw±ÚB~²»Q¶;Þýõ@¹ âàtÚ¬Åç»8Í磻ïý}7É·J¤KÊ«I§×m{Æn7ö.Ì-¹[jºÙ˜‡·GÞ9yˆ˜LƒVëèèIÊO¾'äXd¤Kªûg N=¡Û°Ïrìyœ›r·´ž/»uC\zUa´'ÎÆáí=¯U®¤ïµ…§æØÚ(ù±•GºNyÆ 9èÎk7EŽ ¹%§]ÔÍvkChæ´Ž‘3ì^]¬³cÁNAK”ÎLï€!yƒó†º¤ºßHÄi”nC4‘c{•¡ÏM9í¢n¶[ï ÏÝGµ.Î1”îD8å¿”¡FßÃõ|µ6£¡Eé’:ªxIœrCwãä~©÷…sSî–šn¶;î/ïœ0k¾¿Ç@¨,\·ì¹,¸cØSÑce2À—wÛ»¥Kªæû 9ï›–n1ïÆ.‘¥Á¹)wKëú²ûÏóÁ6´Ÿ~[ E‚³±í½#vµw»¡%5)̇Ÿ\òƒ2u*ñׯ)ÖnºÏ…1}lPÑAÏ »¨›íŽ8rÙ:ýþä¼%§[ñÝyàËkG”Ç­GÈ­¨ÂuRö88zIwaKåØK @}nÊiu³Ýz_¬.èÅý®ò”ÈÁÆúnèO\”^(”Ç^kÈ ¤ÑuIm÷@‡Îƒ7?6¶—QøÜË0#t³Ý:u¬m‘s%ゎiäTÕ¡c Þæçi!GK-é’Šœ+q¦²t<‘LÝåR¿¹æ¦œvQ7Û­÷Åj‡ÞMéÁ9<n{<xô;Ê Qz¦_ù›ä Y…ÔuJuéâ 8ñ¨kÕ>v÷ÒtÍM9í¢n¶[¿ËÁm.òaÄaNËŇù.÷Âðv¿ëðty³]éŠ o·8Èi‘.óa8väÃhnÊisi²ÝÚ+—Å@zsrp6N|Làhø€c‹’¡Ž=y}ÔItû_/Þ±kè\·ŸµsnÊiu³ÝáO^ð—³Y¬s6î<ˆm_a9HÚî[|1ëòZpx®¨åÙmâLũއÖcìé÷ ÍM9íòW2ìþ÷Ê?ç³¼‹NÃ}^~KpÞA” }‡Ô…KÔ袰ŸUìÝE/Âê® Šcë¯s”ñX°ý·¥±Iɸ—Ëe)t?ìÖg)¸7÷w¼þ98Åÿ¬< ¦¹ªîäÓ³Û~8넼ë>oº¤ºg·§Ðµò~Û«ÿ}nÊÝRÓÍvÇ:ÆûºîbÁÙH¼¹&21l-Qî'm!Ç]KºNùšœ‚İ#ÖÖ¥uŒžA¦Š™]ÔÍvÇgyËBÛžÓ+ÎÑÆÒ±|rݼG”¯²#äWÞ;Y¯ÆÖSC·Þ½¡»”Bz(÷%ÔÓ.êf»õY¤ë ~gŽAlwô~0WBñøó†Éæ_!7$q×%µÜã%δ £tqHÓØS@7>7å´‹ºÙîKšysbŽÃô)9x´xå;ãõwƒ .©ˆW§ÌÐ…×FcG¼RsWU ÐRV§„Ýá·ƒÔȾqrÌ¿míÄì°„ò¬yDÉÛÝFÈ÷óq¹®SÉ7¾±‚Ó7Þp£oÜÆîáçÜ]¾ñ¾C7Û­}—ÛâMKçyØ^A+CõpJ´! {ó€ò‰ê:åÞr66|ê6†íÐ>7å]g ÓÍvÇ]ÌR‰#o\ä~ÿÜ:œŠ w±{DévµfȼþÔ%yãâ0@]¸È5vº¹qnÊiu³Ýú,X+†ƒý΃žÔ+:8–v«'å~Òò‹\#ê’Úîáoé.÷ª6QŠ·ŸrÚEÝlwÚ÷‘ q{ìûÈ–XØ_7æã‘vLQÚÉk 9³T +Êë‡G^¦çîcw_)47äaiÛ_vó³L„}¦]~räð)æ-¤3¨mQ6ßçES%ovn—®SÁqγº Ô_´d•Ó®#GSØ­Ïbç„Wj¢3Œ8ÖrÑP¯JËif™×ÛÏ0ÓN%.·^V®Kjú&8ïK•®µ~𱇟a47ån©éf»ã}Ùp¤y^Ÿs.¼Ý n¹…+£E^‡”*©”nnâÀ{'Ý‚¼=Ž]"¯sSN»ŠrÃnÕ%áÒ†¶Ý¿?9Ží—´áV_ÈÜeó-„Ü$ïöœH×)åõ‰3PiD];úØqÕÜ”Ó.êf»#.6°˜^ÕV“³íø^ý穌K7Q·>!7×%YÁé%t§Ü‰L¤T–†æ¦Ü-íåËî?ð.Ö+üiŽ‹ãœŠ/Í9í5ÄÑž¯¡Çáà§’ƒtI•ØYÁyQéºi {DsK»¤›íŽ’ÍLùɹ:ìw探(¡QÚÖrùK(®+êø™_ï¯r&•²PDùݨ‡œvQ7Û¹p ›®Çø¦`'*Ÿ*‰ 2ãÞþ0JÄø¶V&Æ×]R'b|ΩÛuùvqlP:r·´î/»£&qN­t¿3‡ÏI5÷Шxi«½†#"*?ÏÁh!oH½òçón­¿¾ø¬öœ4ÕPêcƒò3E 9ì’n¶;jß]òЉ“Ã\£yHU+ÇGë ùB º¤Rž9Cµq¦‹<$yJš›rÚ5T“vǽReÝ*ƒ»”ßûÄu¶Qº)îrTßH—”7¸§[§zé*Œ±{Ä8·ä°KºÙîxÆ Š‚”×'ÎÁ@†ù¨ç]gJ(=oe’ƒÒ%•rÁ)7tŽ•rš›r·”¹ia·îȹúCнŠÓU½½p´bewï¢>âÖ”#L*]RÍc¯ÁQú8Vp¦÷.JÑšµCî––óe·> òž~ÖiÕŠç=—¸'ï(‡‹É(¢0ßUFÇV°Jè:¥“(9ã¢Îº/¾øØ ôÉw9ì’n¶;ÎüÏcµ«Ç,ÄiSU!y¼˜¿P:Å¿kžä8•H—TT˜ˆcÈš®ku>vT˜hnÊiu³ÝqNžÈìÓÏÉ;‹´ ~ž‰å|Q:'rTyH—ÔRKkçLå ™îÄ=ŽcϸçqnÊ·²Þ×ý²û3ŸvÏçQæÔO¿Œï!JóÙSGù±×Fº¤º{Ó‚Skè6¤rì7jÎM¹[Zë—ÝzÆW;b≳‘–`1΋KÒ÷@á9˜P>M¥®SŒ‰;gãCP×z;øØËÏGš›rÚEÝl·Îüðâ¢GÌïÌ¡ê(±b1fÆbUìõ*ݽ"jÇTùyƒjî N[¡ ï³Æ®QÉÀ¹)wKÛú²;ê’ozÚ_È©r&ñTrxé¢ä[d-øáŸ ×U< œuß„ÓÇåo×v9í¢î‡ÝÚ÷íñ³80×äàØy´¿ƒ¨å«ÅÓØ=ªþâpOØEÝlwä]tä•ÔÈ» gãor‘7!˜õÈjo#ä]xh š^­¿Þ‘˜#Ý©¢êyDù÷TCN»¨›íÖ^9‘»”â/SÙLÅSÝ«Üß5¥|Å_6ò¦(?ÈNuœÏöqN™¡Ëø ÇNñÎM¹[Zæ—Ý)·gåÏâä´4kn¥|—æy~ë]؆» VgäÈŠ|˜à°Ê©D>ŒÆŽ|ÍM¹[Zæ—Ýq†ùÄ"p¿ÛkýW#õ‹ rÒšQzäÏesD 町Ä(_X>·c¨Á§Ý‘S¿pÈ¡===CïD׿>ËD6^ÅLŸ…Tú,Î)3tùYFz¢þ¢%ñ &KËü²;ê,æ×û²>mCƒÆô¾ì¯÷å ìÁß—ûñ¾Ü¿½/·çï¶§x%ÇN¿ ç¦Ü--óËî?/öúÏÏòoõ³´ç ùø,äО ÚâJ>QSL]Ré³8§ÌЭzAÏùü,œ»êÕXûWúÖþþ,è˜?K" ¿ÛØ?ìϾp­»a®§"§ïÁ¨ôYœ£”ΕmÝ_¸Ö-í?ÉÒ2¿ìþŸ±~–›ŸåŸïË¿ÍßåÏù,TöÖß™åÁp+„Ú‰< ?élr†gè6¹~K§(·´ ÑeÌ»x,iFÑÍ »ŠrZÃ6ø:–òaȸ²2Gd  µ²”Ðè;ˆ¶®º¤zdݸï ]¦øl!5»ß} ›y´°‹ºÙîÀˆ`yë Œ"ŠuÔBT·Þ2XîÇgyÕwñYÛ4q/AE‡ q®$Ýfá:ÝÜ›¦¹)ŸB+»ûËîˆY\ÄÉïò˜Ñ sZnY[­È·|±«rxà¤KjEöŒsÚ ]Â[slïoésSî–¶ûew`À­LÕ$’³€¾¾Tÿ¼QØKÈÍ÷_vÈ@¨¨Kjz†‹8ÃÞ.é8ÿ9öp¿ˆæ¦œvQ7Û˜*1ö˜*ä\_xÎáÞå~Ÿáòçâ9®T L"}̺ӳ4Ž(Å‘mî© ½]÷ÃîÀ»àW¨8rpî‰pÇÜ2T@á»c¨…ò¦ ù{2¥8r„iÖÌašZbì@)ÕÜ”Ó.êf»ÿ¼ýåOú,ÖõîÐØ»e¯*óù/¼þ,‚øèÊç'gMÛ¡|þQrÂÉ|þÙbìâϯæv---ûËn} —£îwæxIÏBÎÕAt¨QÚ›™U|°7ÏẢ"ÓT¸ô¥;•ׇ(SíÓ.è~Ør®˜?)ç Q“9Wð_§Z‡~s-D?!gê’Ú~â N«¡»´Ì±WàåsnÊÝÒV¿ìŽÜžI” }–«ø“g bSôµï)J«ìh!‡ç>Vè»4vŽ Ì¥¤g"Dr…ÞS”Ö{›{*ÏŽ–2i9ì,è·Û>P@Õñ9Çð×®+ œ>E!F‚-’GˆºA•¨œ˜€)%t]«±ÛVsC.» ûawԌ̒×1矶½ÚTùXë÷]Ì04¢'×CE­¡K*aÛ:‡É%á ÷±Ã«¹)wKM7Ûy°Ojy‚Ã<؉ü9÷MQz?߇üZɨtÒî'ÎÒÛ|ñŒ1¶MQŠ#ÏrÚµ”vGÎϲ¹XU/ §ø‰²›zE)¦xVÈ—ãÒƒêy— ý®¡ +8Wš›ò®3ö®_vÿ{eÝH÷hþŒÇµÉ!!]´/…gúXƒò«ìÓuÊqàÉ©H…§nQ½]üÓÜ”o%¦0>ìÖû‚$´þ9(*ŸH¬ù¡63œ§(ì~x1%GœtIu›Åivs“n³››ÆnŽ7®¹!—]Ðý°[Ÿ鄯ÖSqdr8Ï"ºŠ4:€?€Âû Àɽø¯­ llýõFðí®ûê= Jç£[B»¤›íŽý¥]sE+¢qt¬ê+=H{ÉÏzLJn+¥tµnÞÈpŽIð}8v}ÄØ¤|é.KKÿ²;r^À¹Z‚êïÌYvmªèUÙOòjê7ƒnm’£3•tIM?-Š3ÔºucŠ^cìè‘¥¹)§]ÔÍvGÎk‡jä\‘³™}ÊŠHä\Yºëò{l:•ä ê:¥ø¾8öébŸÕرknÊ›jšÆú²;~—Mȩῠ9I¡ýýÎ ëøEJ¿ËZ!·‹¾ë:¥jq´)]«õö±£ª\sSN»¨›íŽ÷¥!ô/ Õàlœ{ìiLÁ[¢ôÔòŠÏT8RB*gXÒ„tQ «±»×Õiî®Nomºî‡Ý¿»ú9ŒkÛÞ›bÞÕwFE¹Ï ¹íë®K*ÅÄØøñ½ÐÇN1qÎí1ñ{B7Ûýîû}{¯¨yçݰÎð“n¼jG‰‹+jÞ™žËê–Õ(…ÄØúkf`ž(¬(ÑØÓïš{*s›wÒÓ¾ìÖ»_à°¹ŽÕI³Skq\GüÖ5%Þ—»CÞp<§nS£ G÷sû(@úy996(í]onÉÝÒº¾ìNõ•Ÿ÷q˜Ÿ3Ñ[Ñsw"cD>ß÷4âs]R)·Ç9B0Žû‹ÆN¹=œÛs{N¼kvë}ÙÀÆIïËRó@jŠy}N_®z˜ûSⳈJï¾sØy¤þÈ;½/œÛsLVŠ©e» D^ÿâÖroœ,&±B–(<ÓõmV.¯ÚmîÉ”w»$g†º¼Áûz¯Sµæ†\vA÷ÃîÀ„ì_¿ËPoê0ðó‘‹0?ž1›h‡Ü`5]—TZÇœÃüœš~—©åÌÎM¹[Ê<‡þ·;2 ‘ÿÿ;s†W£z}š}Vìr€ÜH÷(ïÔ« œÓjè¶Ü þšs7ÎÐÒV¿ìþº#Ϩ¯$gÁ»îiâÛŠ¨;òÒ±lÔÐ]Zs½¾r©m3S¼_×cïÁ¨¹)÷»ûº_v§zäe9ìŠWŠÃú5G~(šÜ·(ý.ïÛ”|£k1uI¥Ú7pkß »®À€úå·rØ%Ýl·Î0VGûq†!Çóúb_·“ÃW^ßH';‡D®¦¨¼¾”3)Ý8£ü-¯/ÎÉÒ2¿ìŽ3?û_ìêgþŠè®u)jXrÐÆ¼wY¤þb÷„|h¹ëÛ)ŒíO 8og¥nCŽ J1>[²(wKËø²[ëX·ßñ51Sý‹s6e¨`ËÆP¹ïä¶úì³+ÉPcdRåÆª‡¯d´ÐmH¶âØMu>wS¢×.¡›íþÏ–ïL„­ „–œÅ2ÜÅîCõŠ’W•Û­ËÙëºN))Ð¥‹@5‚š›òªÊRúÂîx÷{YO÷{p#¹aý[ãÞÆ1Eéݯ5äC;}mAÊ£8¸CKwšóUcOïÍ¡¹)oB4Ýl·ž±+Ï qz ³w‚F1⹫(̇¼zÉ«*Òj ªxtœ7]~æ,Æ&å§·!í¢î§ÝKb¡¿¯cKÐìÆÆNòìÔÖ‡(¿cÔ³ø‘º¤v¬cÎ)#t—jgºjge+ïY²¥e|Ù5V uPŽNÁÁìlý|j °%JçŒ'!,é’ŠOœ¶\wn)O(†€¹%wKÛú²;âû•Ù Ú+‹ß°Rp!T²WQþÔì7]ÝÇ j8’TpØÁâÂ;½jŒ¿š›r·”Ý-Âî5ÙPé>ÖdC­»Zµ»ÖMRiMv¹­¹®Kjé†à:-¨;Qìα§n>7å´‹ºÙîÀ¹âùM÷ýæ÷êŠM—wnÃýõ;ùŠÊoÁÈ\£î ]RÃïûât»³K·«e잢ðל›rÚEÝlwÄÅ&ÿPï 9GÀ•' BµÃ×#ö€k‘üêTbºWðZ±¿Ââe„} ‘‹17Â㦘[­!§]ÔÍvk¯\r—*Ž,ÎBë _]ÌEqÐŽ!¡Ö¬/". X›.©ÜœSK諱‡ß'47å+;v?ìŽûþþÛ}Ü÷ÛÇ}ÿ~Ý+¯*‘TëÓ~¥û~m¿¾îûäð¾??îû÷ë^ɹ£¦ä㾿ÿv¯D0p ÇOg " æÞ ’ÒºYFȇY´T|Óâ ¹ƒt uDZ»ßÜ47å´‹ºÙnåŽâA_ÇsHĹˆV]+n\À°›ÀÝYq·Ð¡™òUí¥§®¨ã9$âÀ·!]d6hìÈMÓÜ”Ó.è~Ø9ŠL^Ÿ8ˆrÙýaÉ!Á•I¡'ò™zpµ-šºÝ¡îô×][ø=¡‹(·ÆŽÎš{©}![uÓÇvëÝ¿ï'ûÈU ‡þ:"ÍÓ—Gúäë«À§¼%ŽSÉ××’/ÅuéËãØÉ×ǹ™«à–Z®B¶ûÏ»¿üó³üÛü,ÏÇ<È¢š÷à\â- µ¿Ób›vfš%:º, ŸºNµøëƒãÃj®;pTáØ þ¢%w…œvQ7Û°;°½&q.Jþˆ›YÞOïUB^êCï§ „#ú7I½4¶÷~ò¹ãv-™e»µ¿fcÚ‘àwæ A}³ Œ sPØ6úÿQNt4ê’ZÞ±;8µ….ÒÙ5öô¼!ÍM¹[ZÛ—Ý)¾Ö‰8ò…ËžàB A#¿6Qß¿!ghœº¤¢çcpêv݆tŽ Ê=+än)ÑÃnÝÅŽ^S÷[±ÏûM~I»0~äÂĘ WrJTÊ…+9$ݪ`Ùüн-8³fKËü²;ê÷¿ë+çG}åú¨¯\«¯Üõ•磾òü­¾ò|ÔWîúÊõ·úÊõQ_9?ê+çßê+ûFNã±Î†¿ç"qó Óô\Ãu®(ûî2(%·(×…±ñ×äƒV¡îõ.þsS.K¡ûawøùŸJ2üü q Lõþ¢‹%K5Ï»}w¢òƒÌAê’ªÞýBœ"(ä‰4æ6cìâþ1ÍM9í¢n¶;r­ dv‡sx÷«X]r¸Xë0"Çkt—ÿPvˆʼ&%ìq:Ú¡R·!˜c·ÈæÜMÙÕD 1¶kä u[ÓÅx„Ó¶šß1&žÊ žJÝ jäo$Ø`»qg>6(ýŠBôaWQqQØø–ˆ`3ð-¾{Âþ:§~rDýÅÝh£hHº¤â.&îSÒ%d9ÇŽ»˜æ¦œvQ7ÛýžÇ*c¹Ûû¿ç0í —ñŽLR.¶=|e„ü` ®SÊÒ‡@}ÔvzÓØÓñŒ57å´ki»£f„ˆCG¹£ä <— ‘_Ô9 @¦¥:¨W÷±B¨0é!ðª&Œ"é¢XIcæœæ¦¼fl¤»£6aD*pGÉa9J‡ÿ€ð÷ˆúKŸ|„¼)_še2¤¼›29þfêVt@**oðnÊœrÙݻçȝäS燄Í#¹¯¯*JgÙ¶C~Õô’Ø2§ilý59ô)5ìÝô)­*JgŠ;Cî–òÌv§þ/ø­„Ñ-lè“× ¸‚ÂZÃ*Êáû–.©îŒÁ±%«ºÒˆ±›W0jnÊÝÒr¾ìŽýeñ)m¾¿,àr5ì`•¹Ø Nå{åvù=¥º®¨æYTâT¿àaÿáµêQ¾WŽÓ®ª ZØ­u¬¡åÔŠœ^r{†œæèïŸSxi¢t.ï äÞjÒtI­Èé% ÒJô-M”b¡67åMͱL7ÛŸ¥3ë7> Ó…b¯ bÁbVQú,LE.ø¬»….©ˆ¿§®ÐE|EcGüEsSî–Öõew¬c‹»òúÄa†Û+2~V‚8+¯ï­>=ä ·Ç!w·ÆÖªGNÝ¡»pÑçØÑµWs/uñ¡¥VùœíŽû~ùˆ8òçq[\é~råËKëØýð“S¾ñŒ‰D]îëûÃ7¾ÒýÆ-%Sùòõ²\Á­vû^ÙÿÐðMo8_7Kí«(í•e‡¼«¸¼ ª£¡‹ƒŒé"ãDc?ShnÊiWJ\ØýãÛUþdç4EÖÞ²±Ò ‡•c|’#†']RAwNQr±é4FæØA÷¹)/Bë¿çËî?ïlùÏßåßæïbÅ€hŠ¿8ç"Ïð"þin2êß‘A)¹÷Éf)ÝàÅ8Rá1=|½×ÜC™}‡n¶[{%[ôÚû;s° WT<7vÖE54(ÅHØZ†]{[u]Q=ºž’ãuM<4vó|KÍ ¹ì‚î‡Ýú,CͳåŽúÊGñTå¢zÎJ]ê}0QkGç,ÔYL¼/ _8߇•Fg‡{·tò¼>ršró^²Óbìè)§¹)÷÷©¯/»£ŸÅÁkªÞ‚â4{._—‰eÌŠ%é‡Aámf"LWo5×îAUÏÒŽ¥¼N-Ï«ª±‹wŠÒÜ”»¥½~Ù­ÏrÔmM>XqŽz£œÅ–œ«Ì8Ç>@Õ=å>aêŠÚ±‚“ƒÚ8é.õ>gæ[êÎôsö÷Ûu?ìÅóuNn)&þþ‰˜ø»ÈׯsòH1qKìLûìÔöŸp{ÚïFЉûØ8ŠO–rŸýމ[b‰Ô"8µo¸ Ù {ŠÂ)ýÌ$ŸZÈÏÉ”ÇøÈhà@Ýag=¼„榜vQ7Û~˜Î:¦é~˜¤¶z9( =,|¢ÜSC0{é^,ùyì –éÞÐÝ8oqìç1ÎM9íÚ^â9blå#ÿÊÏOúݾ®k.lßx¦(ùÞbL9»ã®^¹[žrØHÒtÑ Bc¯¸qnÊÝR6‚ »cߟ̙Ÿ¾ïOþàÚÏ¢ Ÿt/QÚ÷G9ÒȤKêxW:qð…K_±Æ6Jû¾ÍM9í¢n¶;å\1¢"Ÿ9K m/ïiòNŽËïŒ;9ó¦$GN•t‡À#þz""C°¹‚ÊB¼õ#J^Î]CN»†ÀâÂît«vPºé¬ÚCŽF™Ò½ê™ú¼/Æ$kè6eÌ%ê/ZrJÈiWSŸ÷°ûÓŸ¼½—sp†{>ÝiC‡§ŠròqùªuEE/›à”ºÈ ÒØ‘7¤¹)wKKÿ²;òaÞº¦û-ÅY6ÂDÖÇbÁà²,P°Å"’£ëœtIÍð¤;§®ÐH~âØ#<霛r·´®/»#¾ÏþŽ¥6=VŒúö×`ûFÅ­‡?Óc„œ‰Ô%•°ÔœSVèÝ}cNw£ZCî––õe·~—m¿óÚ³ç ä{ì©XHqú¡Þ)¾»‹Þñ”_t™§îU¿{ÿ¦ÉYˆYPE—{yÌBsSN»–Â[÷ËE-o­ø9U—0ÑäÂÕ-J÷6F.È…ë'tI_™‚óbæÔm쬋±Aéþ2KÈÝRÓÍvG,áß<þ Ômàj$À7dÅî)Jž•QC^•ákºÞÒFÙÁ±Ã‰÷jŸ+ÆŽšZÍ yXZË—ÝñîW¼C=rá*~Ë‚ ‚º6ÊìW”Þ};-RìPé’šÞOœ†¸Û‹NŒ=üΪ¹‡>Í.êf»wô}¾U¼w­8HYpèüPј=E)þbu(V¬@WTZe‹^‹Bw^5±ÙS”v# M^%xÏáºvGý Óöu§£èÔÛFUÔ¿_dë4 I~!g½QÍÏcÁé-t+œ™G Ú‡57ånio_vGü¥"íÅó”œcÕÒ;õZ÷¬$¿¤<¦ŽïŽºNy¡®^Ð’F]æ!qì”§Tý”pÂ.êf»&$7ôð'Ïâ«:Ëæ¸ª£lŽ”<Ä}‡Üê>\ÔˆJ†àÔ뺧jŽ=NdÿcnÉÝÒz¿ìŽßåâœ;ãw¹ø~8:ðÝ|ïuˆÒ7Í31½ú]R50»È)ÂÝ:øÖˆÉU‡(Ý_Æ9í¢n¶›Ÿe!æ¿›ûÇÄé:¿6ÐÑò @Ù| «¬äèS%]RÍýcÁaM‰éZ‰‚]Ý?¦¹)wKy0»»Ã2œ¯÷¯ ÎÆû;±±ØZ‚tÁÞn†%¯@ÙºB¢&å(¥äxù‹ûÔ9>v3?ç¦\vA÷Ãî?/–džœóùYÈñÞO5ùúˆr’pÊbâéêÞû©|aC9‡½ŸF²•c§Ï¹=&>S>p¶[¾¾ï&åZ}ÓĹ:8WówôuýÀ¹ L§>p®SÅuçj~âŽjîªbÙµ<vG‰ßŠÇø‚CTÔoö»ô=³*JY!}‡|èí¹-SŠñ‘SQ¯LÝz…¨º«(üu÷wbº]ÒÍvkM.ð&ÇÂÒ½Ç/W”û}fÈ» æJ*2Å0Œt7NÍM9í¢n¶;ü0 ŽÅÅ‚Cô´†Ý¶±4ñŠÒYv.—T¢S7(Ï4%çàçavõFÏkŒ Êãí=ä´‹ºÙîÀ bÊj‘¯Ï9-Áe»áK[Gæ›H(§|ª Õtg*oÕ_%®ÒE@Vc7¿knʽ‡ªéf»µ&oä§5y ý¹#`0S?¾“ª]°næ å¬ ·‡TZ“Ö¨@ö±ÓšÌ¹)wKËü²;aw Väõbαš/ôYù9G°^ìQÚý˜Ýfrtt‘®SK"g"ÔRsÉz±SDiw »&Šf²ÝQËc¸¾¶ðÿΜ‰/qk4ȶ4í*Jñž½CŽâ]é’B,J¡m`DXÉ7ÇúÜ”»¥¶ »Km ½ê³8g3ñ˜íE\C”æë5ä éJÔuªF¥ÑmÆÝކPÓ3õY†6o ¥Ï8öGÞES®Bâ\?[Zb§Ÿ-I}ä]PÎL‹¦œ*R=²4˜—±fèV@ÞxNGý8[ºÜóAÖü²;ÎüPõ;sàè`³¢—öHéoNqÊ›CÜž F û5A䞺]é6v`fkn`]AmõewÜ‘/Z=îÈ«pÁª>ÂåٽÌ;2KžØ€}J j.9Ý‘?¯_(5v÷ÊÍM9í¢n¶[Ÿ…mÓOÄ,È8‘çX ðö‡-ê/yzÈ‘‡$]R'bälAOüY_1öö -ÍM9í¢n¶[gK``¼œy-ÉéÚtÍ;Òë-E”b½k…œáä®â©V4¶¢Q¶ºÑ‘£\D<ÆÜLN»¨›íNÏ,tGÎf¶]ýå—Ðâ ”ž±3BNhpê:U"òDhq:n_vŒ¨‹š›rÚ5ä¸ »#ŽüÎ ³Fßjç0#Y <̪t‹¾Õç†| A]§jÄ‘¥`ßêƒ3³•U qdUÃÕ°«¨‘WØýçÝ÷ #Ë£ú‹‰ÓP'?Næ)¾lQ:ÅïòmÅ"Ò%U½Z&8í†.ü»x„æ¦Ü-5ÝlwÔ‰7?•üþälAlÔŒ0ª>š(ÅàË 9ªQ‹GìIÕøë…š‘1CwàéCzÆ47å´‹ºÙîˆYtf°D¼Ò8W¥’o ïú\ÂÚ<¯l#ähð.]RÇ«—ÅÙŠm5"´{{–†æÞjyÓWèf»õY*ÞæX7ä\Í+¢ˆH¼ùyÅÇ…ù:êl)ïè~FÝ®>jÞ/‰œ¥RÞŠ KyÇ¥¨3 PG»–Bža·Öä"˜YåöˆƒêìŽÁqÜÙDéTBP[–c¬º¤¶çöˆ³à©¤îÇ^žÛ£¹—šA¶ºÙî”sG°çÁ:‡ÍOgyEó[êWÏ(\Óñji‹<5ïSu4¶²™Z3tT¨±ýlésSN»¨›íÖ½’ùÎÕÏ–â4;¾ûÛ1j³PlˆÒ½ÒÚQ~Ì;"]R5:Þ‘ƒ–"ÒE¥Æ.ÑñŽsë™]ÔÍvÇ}¿ÂS³Žß÷+§ŽCêFÍÌ¡Kd‰Ò™©´•º¤llý59¥¹îƒ‡;>6¨¿hÉ.!wKKû²;öý†ð×(¾ï3ðRP-t°é.ìÍ,oõ:Û®“”»ÿ¡ì jDÑÈAÓ@é¢M`”ÖzÎ ç¦Ü»ÀíñewœÇè3RŒ/8‡®0fQáÈÊS‰¬{§¨r„°¤ëTÓ›^”îºñtŽ="ÞÞ=yñ·KºÙî”C‚<¤ä°q'Cã‡Ê]EùYö„|£3ÕPkRR-N¾1Ç—nG=2ÇîQ̹)§]ÔÍv¾åî¿>|JäxÜ¡¥:½úÒ^>|JMøÄŠ®3tI¥•Â9Äs^îÙ÷±“O‰sSî–2Þ±û¯/ŸÏhW9$^ÏPà»a­ƒƒƒ­&*ß÷%guy’¼ˆì¶`'¶XMÔÇÙ’r·´Õ/»°m]Îw›ºNµ¯{åzO†ëzƒ‘ÕD}¼û”Ó.êf»Óy q-ùaÄé*Å·äøYX¦ßÃóð¦nÈÙ7”º¤Â#¯©[3D@?Œæ¦|©ýÇ­_vëŽ\0Bq,5qVÐ*šâ4”4UY'_|³=Âå]Ý×Ç ª8–Zp¬NºJ‡ÀØ-b¡œ;Ò%hií_vG]ÒÄÕ\Xâ N|…%]”îýº¼#Y…º¢¶W€§®ÐE-€ÆŽZÍM¹[út?ìþý01·¹£äleXµÚAn(К@é»#ÚrÁ/aˆÇе<Ã%8­…îDÔ™cÏÈåÜ”»¥­}Ù9W)EÂT§ý£ÙV±º©Ë%_ß®!·@ë’j~£«7î¬.C”Îüý„Ü--çËîôYPŠRO|püƒÇÒ—<{dêíòao«tR6¨8¼qwuȾ;ÆŽ ­h}wØÕÕÅ:ìN¹£îùü8/7ïÄ9ƒÁ‘ ”­äU-Qƒüå†N×%•½ªÎ1¤7è>¿Gõ±Aåó‘äni›_vÇÙò2ÓîúÙòÂÞ'È@V{ãNQ:[žò£¢Öšõ¥±ýl NÀý¸ª«S”Ÿ-OÈÝÒÞ¿ìN˜]ïxSüw§"m©·âˆqivMì·f'­w˜/Ç ”±¥UOœa‡ùÈ=;'ÆîqÛñܵs®ÓR¶[kòRaþ¢ï¢9XQñ‰Òz°Øò+RžG;Âl5ùQOR"î³÷§²ÌÅö€H]µ5öp_‚æ¦| õŽ/»åƒÅW´,Èó;qvÁeÛ¢b i;G7Ú‰Dr€çKw©S™­âtí…î:Êqg]§çÀcnÉi)u³ÝÙu‘ý¬3Œ8Hxz|6ÿªSæF“äì•K]RÝÏ0Á©+táÐØ¨Xã†Ü-­ëËîÔg„.Å+É9HWj ^±–Œ.Jk s‘*\Ãk„.©;†sxÿ® =î;u¸çÜKiø  Ö/»ci8•´îû 9¯·ê7´kx'‹(íe»|¥žºA)CK@ŽHõY;ê·47å´ ºvG®5;¯ sX>ÑÏ~ºªú·È‡õœÓ#äMy„lH}ŽÆÖ_“SOèòEñÊ„æ_jÈÝRÓÍv‡?™Q÷[:ç ª^áĈªŸ!Ê=Ä%äKn»³2å~Ëån»ºxÅ5vܨ57å´‹ºÙnÝ+›mÕÚÙÿþälxïØý¹o_o¶- ;Æ@ßQÊ‘<"]§ô+Šƒ²éNxî9öt•榜vQ7ÛücŸ}EÅ/ùYžë£7ã .?¹¯¨¨ðçÌÐ…ŸEc‡FsS>3Žô‡Ý±Ž-œ·öòulÁË;ð“6,¶L kZ™ˆž{ñ(Öº[8»;üÉäpc]áœ1vuošæ¦Ü-%ÂJØû £rªGŽ%W<³WÑK6Œ÷¾òMu(ŒP²beÏLé #£©Ô]*Èf‡nnš{© ›ÃѾìþïȽÉKë8WÎaºÖ€Wu V‘ߨy§–ifò×Lå¬YDæ ]âXqì”5˹‡:#š]ÔÍvëw©hi˜~rü» ´ÁGů„ï®§_ÊpQî:©ô»8§ÌÐuÌ”øô+a²´Ì/»ÿ¼gÌðfþÖ‡7÷Kšý’æßú%­Ô/‰¹¬®K*}ç°oî—4ÿÖ/i~ôKý’Æßû%½»[Whðwæ ÃƒÆD0ñ¤¿r§!ÊoŠ5ä(ïîõì!X8G·ÐêÁe=Ýc«¹)wKkû²ûO|Æþ¤ÏˆçÇ:vG¶gœ°Õc«i;õWZÇúú•Ö±¾>?‹s¸ŽÔãc¬cãäÏzGèf»ÿÄßeà»ùXÇÎ'îÖ [­½ê×:¶Òïfm_Ó:Ö¾>‹s¸Ž­ô½sìu¬Ï_i;x_çoŸe>×ÙÇg!Ç?Ëùè}>Ççg±4é³ì‘?KîÇü+sˆÞJþ,s|–ó±f÷ô=d»ÿ¼gÌ"kŸ÷q¼—Mì•£ûª¯üè-XKÚ+úèe{¥ëz-Ïýª¯Ì½“¥¬åùÛ^YÜ“k-°©Ë•ÃÒÚñ½9p­«½%¯ç-èŠ \ëàXŸ êbÛÓØË³357ånéÓý°[ÏB%ï:ÚùŒ‘3TŽ{Qf:Qu²š(?gœYDº¤º2³Óp¡¤nƒ«•c7õÅõ¹›\±,}âE6ìŽZQ¦HWrÇt-¸¬B³âÂXïž’7ø¿Šª?×ÐØúë… û€nš Ç%ÔÞ!§¥GXawäŽZc¿î1 q¸ÚÑ€ár"|Í2K÷¬ v%9š?H—T÷Ó[pz ]à{kìÀÿÖÜ”»¥½}Ù-ÿê2öxËßïÌA}ÚB™ÁÒÛƒÐ)¢àÃBˆäÛ|yÒ%5¼Ú 8­†n¬ÇîÞß[sSî–šn¶[~~`,%Ìaq¢àÀg¦0ð›2æ0ð$§7‘º¤æ09Má]Ó%æ0ÇÌaÍM9í¢n¶;ùúÕ“¯õ§,©¥ßvÑ×wE¹¯o…œâíGû¢±åëŒm ]Vdqìé¾jÍM9í¢n¶ûÜ+ûÀ"á½ç$Ï(*è5=žsÏ2jÉ‘3)]§T+*ÎBüÉgTjŒí¹=>7å´‹ºÙîÀ"Ø(Wï'qàh«]ºùºàQØýàG•Ë™tI¥ŽÇäXŤë"(£±ãíÒÜ]AÒ½C7Û9½ ±Ú¢Ú7ç°ÆªÁµÖpUV¸žit¡—œ¨BW5V¤JàõÔz³ÆjÂË¢7Õ‰GUk!§]G5Vawª/ºSÿÎ@wÖü#U¸U2Ýà;önɉL@]RqƒgÈÖ"a\c¨ãëšì+ìî·+1¶pà>Æ8ð§×‹j¡¥v"»‹ÂºYôÉ/2¡îp]QQYK@*²îeRhì¨,ÕÜ”»¥O÷Ãîè™ÒYŸ¯ú}ç\V¦, S‚Ðzò[>Œ¦òŠéÐ ª ÿë¹¹C»‘ÆãÜCq³Þ\÷ÃîÀ®ˆšáÀ;gá j9ÍÁËÄ#¥|Y!¿Èž¦®S©ë)3³{Ý`ŽÝ”9çsSN»¨›í־ߔÐ$|KqŽ€Æ[D [Ðq|Ë6Íç SLÍ2]RÛñ-ƒSzè"UDc/¯³ÐÜ”»¥¥Ù¾¾;ôüΧ<|iá¯:EÉ×wZÈ/ü,Ô%•º+9§ìÐe»Žm”|}ã†Ü--ûËn½/EÃ1‡Å™þ+Èí–›°‰ÒºÙoÈ7´¦š}ß®±õב©=C_¿Æîyg-+ä´‹ºÙîÈë˜/á‘C\8vMd*×¢ð6wuÏ%.Üž¿.©„ Ç qáX¯ü•;ñ47åU•ÑÄ… »ã.ÆPž×‹9ç2 aKf 1 ÁëÅšÒ&!Cfè:å}š2ØÖ ]^4öˆ¾ œ›ò"¬À5¿ììŽýÕ»–ïß$‡fÔuoîä5õ†b¡˜ë’J5#Î)3t½&ä~æÀkîÀÁJ±›lwàZ³öt«“œiyÀ•·ðiG†!Eé„ewrÊj+]RÃ+Ä邹ÿ7{_®kÛ’#ç߯8Ð9n·Ñ€ ž!Cu5BZeè÷µ“AæZOj»pPÆ»U$73¹Ï^+AíÇ®o×Ü”Ó.êÞvëÝG>s+«•©¢6Šu)o¦Ç9#·óVQUŸ6¶ÆÖ§ý±C7#›cGGUÍ•À]fèÞv+ŽÌÂÈá¹=â4þ ‡åˆ0ïÉÖšucƒÚZäyS»†.©áôàÔºl0Ò´FzÿÕ¦5ÔäniÍ/»ã Ã3ˆpzÅ™:ùN¦FâœA0á«“áƒV‚•Ô…ŸUìµ{è¢\cwÇÑÑÜ,§]Ð}ØõÈùÇÊëé·')´ÅQà nž××ñpIŽ%Gº¤j Ç’S”üeº@[ÖØ%Ðc97å´«xj늱…ÓÛš£ú}qÐç>oì¯õù ç©õû¬O£<Ãû]Q3ê÷c5øÔ¨ÏçØ#úpnÈÃÒ²_vÿÀûþIüÊv/Ap&^jæ¬Ø6»qËÌŽwA¤jÊ;QC7(e“Ó6’¿ Û¼Š±Aý¦%}„vI÷¶;bI©<—¦xãtýÑߥÔçïÒÕ-†ñ™vý.CÅJ3"OíCY×ﱯ߅s{,‰–2–v_˜*LûÉ~ßßXk ná*Ä =gQºï3Yra­©9t·Î(#V&võÝ-t«ês¥“hk!§]UW×°ûÂPÅ¥mž’®yËë:Î~…Z6‚ÌQËÃ+df1Ss]R[»9e¸ne¾>Æ®‘ÏϹ)KËxÙ¸=Êä¦ýð*L&b÷Ëp“å$ ;ÆR­höd,×Ýžé£ÝÈ9e†.P·5v»ð™Û3ëmi™/»Ÿ÷}$Aß÷}æž;7³EÁ°ŒåøÉ¼³KžQ‡AÀR#ªd“Wèv:zýºsG5wW胖æõ²[q1ôYÈÅë’Ä©j'dµ l]„ÎS éJ%äµÐU<»-8gÉ’.`5vöº$Í yXZÊËî8'gYýŽL}JÌï¸#ÿ ”Ÿ“gȇJTM—Tø”‚“FèÒgı/Ÿç¦Ü-Mãewk!(8./•P#ìBz#†ØÙ1¤;tù+O\Í=t Û;to»uâÚ„¢.ôÄuŒúJÖr?âû +“÷†ÊWn@ÕW^öoWo'Ž}Å÷ëU_yYšúËî Óœ¾qnMaTlMêçZEÉ7Î-uã)Î5tI­ðv;'ÍÐuW>{øÆË¹[šæËî+·ç‰Õ)þ¶Õ‘7ó\ŸXu"nHù¼jÍœŠß%8*]Œ¿»ÆŽßEsg/] ¬Î‡Ý:M¨«cC‡-¦ }ª)Œoo\‹XïÆ¹ˆò£UÃjRž °u5è9t3ÚS/·uÖ[B¾bûêžB÷¶;ö^ýÌßt‘"8;PðÌŸ’(íc†|ª%;ý„%klùÉ¡¿nD ‡ÆŽÍM¹[jº·Ý—O‰9î%|Jx¦Ù-páÑf»Ý^Eùº™B^…UUvPÑSXô–î@žvÑkáÙfœ›rÚ5Ô&8ìŽû¾ò&⾟½m¸< Do`›¢t'çKÏÀ`[®+*ðú‚Ã^²l }œ;²447åni/»cÉÏ5YÖ|UU±+]}®ÉÙ{\ÞU=VWPåÞú…J]âŠrì w”sg9s¬É»#–duÃñÆÅAa3v0n*ÚÝHyt¨†áÒ%™sâYDºÝáF¦(}ó’BN»¨{Û½ØW>+Æ9Ç/¸/Yv¡'Z »ãf+ùÒ)‰ þ¤”©'¡ø©‹.(Ýa/¼‡üPfÄNauo»#o\¯’jÞÉáo¹±¸ÛÖJRná\8H 90Ô•=.&NB9u“ýŠ;ù ®¹!—]Ð}Ø}á)¡®£'÷Ùk 3¸Þ¿.L½–Eyn¹üà%×5ÝK$Î@1HR¯öŽaìæê-3{È—÷h/»cß/<³'ß÷ îä gÝÅ{s›¢´“çò Ô–®Äcil}šØ3¬áÈÈle—à6EéT½RÈiuo»£–gq+ˆZAñOÓi8žó “¶(3æù´#­tIÕ@FtNj¡ ˜]üWÔÜ”»¥D- »#·g?ÖdçxmutE=îüX“í~õƒZ³S«/ç0¶=P}ìGmutM½,enÏ~¯É'Ó®Ã'wä,ä[žD_‚®¯C”ÖšTCŽ@¥tÊñéŽÅ±çÐE˜_c÷8qnÊiuo»ãþ’ÿt¹öÊTî½2Õ÷^™Ú½W¦võðu꺿´«—®ëúýåµWjn¿¿äÇýåO{e"ª¤eÌ|?9瀑ÐÎ+¡Ö!Y;/Ròûì3å€Õ”®S%²B&¾äÈ¡‹tWÝÜË©¹)§]Ô½íŸQ”?&N³\ÖÂʈï]BZ»‘ÇyF>[ó¶HUcë´H\¶n¨x±ü°¤ì¶t¢c´vA÷a÷Ï‹ñÙ‡R*_“«î‘áŽmm#XQ²(ùaÖ y¤/§j ¢‡5µl’Ö³ J7„ÞBî–šîm÷ù.ÿðÏ”¯ÿù×_Ÿ_÷#¸ÿýãŸþï|n¨ÿç×ù²lãóÏýJ_ÿíWúúw¿2\ùyX —ï¯^͹ӫõ|þË×××àņïÁ1dþ YÀ;–êóI7ÙŸÿ±bäÿýß}Fü_ÿzþûâ's·¾>ïO~ý篱É?«Ìgúøëúçüúý×3ãgîûß¿þþ—_ÿöX¿¾þ‡ ôOü:?[ùºÿ=_Ȳßü ÙßèëýÊçÏùõï}šÕ€óÖ’ek’þ˯?üë—‚“1?AúþÄHè5ªO€>Ÿ8~ìÏé‚_æ[tY–ÌmŸh–|Ÿ}b™{%>úúÄó§Ó7ýùÍ@ßv§úüf ïOœ„Âû ïOÌýüî íx¯Ýn½ç×7;½5÷õÍ@ߟëDÂâ ¯O4t^÷O¾>aOÞü¿UçûÈóÿÿ³Ðèãµ ¯óóFŒè&¿ðnJ°S”nt³†| ÀuIE0q0”.ú|iì覹)§]Ô½í~ìþ´<8³k-¶ñ<‡Ôµ¸ÜÖy×uêêPcœ¦4oÓ%&3Ǿ0›9wU ³‹º·Ý?ö»”9ó¹8+ù9§ :Ï»êÞŸ%Çþ+]§™…ëèäºíÞûg‹½ŸsSN»¨{Û}åDDy{ü*8Ì[9•$Wß9‚R&Êi÷,y¶ßìy+¤rT‡y+ÐÍž·rÆÎ¼•37岋y+·ÝqžöósÎD¾ßhñ Y®ùã3„r¬9“?Ÿåçäð9¡®cœÛØ×3ƹãÜìrŒó°ûç½/uøR9)»¼3‘3à̘Ö$åPÇѱ Äž”ý¥—ٻܴH—ÆÆ§É#„º+8Çõ›–œ¹)—¥Ð}ØxºÇ{YÃ÷#ý7 ,¬¯h–«Q®ú €¸Üð®Kêòý3bºx>5vÄâ47å´kÚ9ìþÏØÀ÷;]/¸ï‹“…/tPÊzFªþv ‹e½ì]Ž¿»tI%ß÷ÉiÉsÐmhαAáÓ˜[rØ%ÝÛîÀ£:øˆi¹ß78ÎH;#¢X¦ÚqŠÖM+vu¹Õ2º®S9>mœ)•é2Šcèaɹ)§]Խ펼•Ïû•wñ:Hq*ê ­%Rî¡>û)e¢|žy—[øßuI¯ƒ NÙ¡‹ßTcÇo®¹!KË~ÙßåóÞŒïbœŠ¶Âö“jã»ô.Jßåó8¹Ü¦•®¨ÀÒŽ™PXÙ;°´57äaéÑ}ؾÒó·YV<ö}sŠ%†'è6j Ê:º(ùJk ¹Î».©ìÄI@°¡nR{;yÍM9íJBÇ »ÃÇp‰ÏY`t÷1,žSð]Î0 ßåd3•È‘«X²Šw =Ë™tAalÿæÉÎ!{¹î9•4”¾Ë™[rZº„ªvë³åúüŽÂ¤ ΦïkÛoy0g’µ1 …çÀ’<\n…}®ë”0iÄAµ‘tQm¤±#‹RsSN»¨{Û­½ÒŠsέ(é’Š®aÁ± !ê¬É;º†inÊÝR–ü…ÝÏ3̬¯»ØáÚγ]w1R÷FrœQ¤ëÔó.–gAC#êæë.–#wÜçÎ×]Ìuo»Þyìïßåoû»¬u¼ ÷wY[>‚!ú’º¿‹ä°Uº¤lìû»|8ÙknòšjÍ|Æ^Žq©¹%wKs{Ù}å¬}ŒÈÙó"ÅAx`Bj2g­ˆòî ¹åй.©+ ž¨‹DUâ ι)§]~ »ãlyràRô2Ç¢†>üù3 ɉ³(?[΄º¢b÷ N®ÒÍ{[nÆ&¥SÂn.KîÃî˧„–çÝ;g` b·eÆCå>¥rØJÝ rTåNF u™¶Á±A¹O©ºœvQ÷aw䬼ӺVϘs6RPÎÉâ\Wv²eA]1&—²’ë:U#ë8á>5zè¢©ŽÆž÷ÍÍæ¦œvMa‡Ýq¶Üg‡ê#gzž×øP'z®qU”Ζ'b"9nÒ%™!â4QQ}ñ4vd†hnÊiuo»/äDZòŒžfÎaí4ãÜ ìøû\nz.7x=×uÊo$ä g˜îzÇ6J+…ÍM9í¢îmwÄáíýZgö¢ü„NÝ …}@P åw¿âò³ä ×µüâ1¬³Â#1c“ÒoÞvÈÝRÓ½í¾jn²}[ÇØ g*»·à¾”¼æ†”þv}…Üjj\—T`l‡k¶éCƒc_œ›r·” OÂîÀÓ=¿cJž·œ‹UÖ&ªõLO‘çŸ+Öì, þŠÌ÷#åYh i¬Ð=Û½46)y:l•¦ÜìrÝÛîÀ;ä g7Ç;Ô] )¿¯§T4M5°RXe‹îb&烺¤rd¶;§¬ÐMHÈåØFi·¹)wK‰Av‡öå–æ÷q:RåP“ð¹eÀ“•,J7ų’J>poìJ³3ªE×c町tÔØõîzlsSî––ý²[ï~>?Y^ýìuß7‰KÉŠóÕ™]TDáý¬v'—¼žÝÍuIußYÅAÒ“t›ý4vó¿“æ¦œvQ÷¶[98;ñtüiq¬ƒ#!X54‘Š(åÉŒíòjî銚(H˜¤‹Z==ntw››rÚEÝÛîx÷VQ½/àœ·j Ò¥àÝ'èŽíÍÙßÖÅHÞ±¯S×(ŽO;§Léžwû”:clRZWJ¹[ZæËn}d\§â1 qÐÿô,È1`£Üã¿N‘é˜ ÿÊåÖvÊuIE¦£8hÚ-Ý ,ÇΞ¯ª¹)§]Ô½íŽèZðyaŸ8‡éÖk˜ÎIB½©ß|"ó9öné:¥nÔâ$€S×òT|ìägpÍM9í¢îm·Þ}ëCcç)õÌ$û]²µ&Oì…ÉzÜÒ™©¤OóŽH—Tì•ÁÉ+t±jìØ+57åni^/»ã»,øËûöïBoxÁ®£NJošxÞ«nвNò…[&u—|B~#!UùÒEÒ·ÆŽlpÍU%FO9+ÈÂn½/v£È{8ö|pΕ-FrÎD{sÊ¢ô~Žrƒ!r]§R îxÓZ]¤®iì踡¹)§]Ô½íŽ\u‹ØçsNø¾9Þd%s§G´ÿ8¾Jä`ŸÊ“îò³'וýTœšC—íX8vòõ^s{»ZZóËîx÷V-Õ¦‹Ól]…´œ¢?V/-Qz›“Ors¾º.©HõÎaOñŠû÷¬1v ¤zÎM¹[ZæËTÜZGÜ_*n¶e+bâ7æyv[R~ò]!·­ÀuAal}z^·^èfú¢1v~ô´X#ä´”º·ÝQÉß¹KÛ9ÅF|*Ø®x Qxj–­’/œ°¨ë”w÷H7³Æ…OcnÉa—to»µŽšÝ<…«GN÷bjÜÏûìäJJg¦RBn-\—TtYN-¡‹ ]ý}ÑÜ”»¥,û»Gÿ¬mŸAßEœ%³³.έÖgÝ…gºaÇØÞd‡.©éß%8Öè£i·ak;z˜kî!„4Zjº·ÝqÉôÅý%ãf@üE{ªØ ¹à‰*Þ1º˜ºË LÝuI%ïûœ¼\WOMÑ7"«‰Oݨ·¥Â}Ì1öÏó'[˜Åj§ã·‘#aÆ‚QyÒª(̇Ü'É‘%%]§XC Îç‰Ùu'ÛO`lP¿iÉ™[rØ%ÝÛî+Wý¬,õ,ß7§ fgÀ£À6#e‰ò¸u y·¾tIÙØŠñ‘“wè2žÎ±¯x;ç.ò ÒÒ¼_vë})òXé^)Ζdµ?xžÀ™´JR{Í!ï¸=Q·û]J[r:²š¨ÛÕB>wQîX!/ú«Íü²;êSk—çäûæxUè™>Á³Ò‡(Ý®ŽÇ!yÅ霡K*²‚£zÑb÷)Á€Q:ë­r·4¯—ÝQ×UpvîQ×UpæÏÀl¶ÁêOO¥Uk¢ôLçò÷º¤¼>Õ9Vcêº.kl¯Oõ¹)§]Խ펚NÞæRô"çøòƧXExÞº)*ûà “w—»I7(UL‹“,*Ýów7xLd«ƒRÔ¹–Ó.è>ì<ªÂ“¤öJrºYΖ ÁmŠ’!·/=k ª¹W58)‡n2ËÔiQ舚›r·4å—ÝáO¸ïì¨ëbÔ*‘g§Ê³?€’?¹m—Ÿ²Œêº¢Ñ 85…n²l3<«IsSî–Öô²û'î•?ç»[wcÆy‡£¢Þîä¬$ܲ«áà“Â~L)É7•¼{T­O““ºtÍÛ56)ùçpyXjµâ·Ý60#àò[‚³ãì.E2Ç@ üƒàl ›rk¿)S”Í׳Ö1“­\»Þ”£¼­c#‡nÜq™¢~Ó’‘BN»¨{Û­ïbç„rõ7ÙAêܑٿà'vQ˜ÏN%.¯vz“.©èo Žw)3]t ÖØÝ÷}ÍM9í¢îmw¼/ça8‰Ãëv:Ô„ïûü%Stø¨–¨&y³Ÿ\º¢¢Ã‡8Ø1¤[…ØU”<é67å´‹º·Ý?}|éþ9Ä0o!¾Á@æÆ…0, àr (¸.¨ ÿ 8ÄŸ>ºç¥O>6(|sKî–:쎸XC´iD\¬!âT‘GhÙܱ©‚Û܈سX†b[v7¤.©î«lpR ݆ŒFŽÝüÄ£¹›2i)³!Ãîx«pž¦ˆ½ŠC”Û"L P¢±EÉ·h~*Ê­)·ë’ŠØ«8¼¹¹'Ž€\c‹Â§9·ßìÚºo}awäLÞ #‡dÂod½ï–µ NðMœ<$J{À.?9"ÉuEåÈuŽõÍÛÊð˜=ÆNžÛ£¹)wKM÷¶û­uv ½‚sRl‘vJ¾s¾ð¯HioÎ5äó<¾® cëÓäÔ⺉¹4;E® ç–Ü-­åewÔ$vœ§¼?[òuž{s2Êðr³öÇÓ-¨ƒ¢¼öªtI]ýÙÈa5ê²ÿǾú³qî*ü³‹º·ÝQûV0»|ãâ ÇãBöP'ÊÌå§Åò¡Ì#‭±õé8ÀÌ¡‹œ*9Wš›rÚEÝÛî¸WZþBwLMq€W:r†°ìÓ¥›âì!gõÍÐ3Í: Ub‹cl®k%n>vtpÖÜ”Ó.êÞvÇ3vð­’9s¿/NNˆz$ËÊæSŽlj`„.70B×…±ý‰§V×M U†”VŠ>Cî–Öú²[wdkucµkŠW:‡P烷ZÀõÕ*êŽ[K>•U¸ÓMyoyr ¢5SY©ÆØÅ=éš›rÚUé »õ]÷”—cг&ª|Äï[…ù€“½ã¥»•¡ßâÓÆ™8½QwâôƱgä§p·y‡îmwœùNA5Îü‹g¦fçу‘Q­ü×àÆ—(âOF˜äÈù•.©åï¾8ÖZÊu§íM{úÞ¥¹)§]Ô½íŽsrDzŸ“ÉȨI¼™â,;›(“í¯I9*L¤ëTŠOo¼Oµ¹îIO>6(“Ó 9í¢îm÷+Ÿ9α8lX‰œú‚Fp̹/Ñi•9ù’¯st]RÑi58lɧj&”vVû;Rî––ö²ûêrr luø¾8™yá™ÝHá9è8Å'5?Ñé‚ÂØú´q@W¡[–ZiŒ$JOä™[rZºØvëÌo^Üã·‘?YœŒn y„ÙVÙ¼5˜=n}~‚êòÏÏ“¦ëŠJáOg*ºPÆÆÜ’Ã.éÞvG]RC…WÕþBNE\aëÔ1P7ª(ùk ¹u!“®¨è-N–O´ò¬·bììÙÿš;«ãg«®û°[û~…/Ärç¾oN6,†5p.?õ¥ÁS™z^-É­Cë’ŠL½àä,]‹¯ MJÆfMî–šîmwøú Víä¨NÕ;¬¡êI”βy†ÜëMTŸŸ5¶>ÍJ"dœüˆzГ(ÝvV 9íÊ»#f±€@¡Ú·à, °1¢"b’²(YÌoÄ’¨ë”N‹âdà —n²$ãTáàÜ”Ó.êÞvÇ9™o€×X9gíøÛ5 tü¥š{‰*z$JŽnŠÒuÊk¬È)öÔHÍ25v‰+ÎM9í¢îmwÜ‘;0QJ`Ï“³p+6ä†$”9Dé9h%äV‚îºN•¨úÛ¨¾ëÃuÓR}þ¢ü޼CN»¨{ÛgKÃ.Þ;+8 ÷‰5ÿ8[zÀô7§or ù´•GºN¥8[nx2­sªfÕ»ù}BsSN»¨{Û­˜E;çÉ`Q\Lœ…úÒnx;Ô xQˆ+XEË'2Ó©;•Mß"c^™ë)t‡Å½4öð¸˜æ¦œvQ÷¶;ðǘ¯Oß…s6`T7j˜êi°×­¨dMVår+€¢®SQÉëîœB+KS|J˜œËÒ²_vÞEç›®wŸœ†ZÙj§×“ë\“ÙDéÛRÈÎ[Mè×»kl}šœ¸¸ã›ûÓb¯ÿ.«ßÅ`ßÅ9fjèe« ûø.¨Á—õùÒuÊ¿ 9´‡º´•c_ß…sSN»üïv뻘‹æñ]œÃ¿mª÷ß}¾p­«!¾Äw=gªø;òïBí¡®Û:_¸ÖœÛ·váZßvÿÄgìïßåoó»üÀ÷e*þâœeŽtým–¹ûõ·[Š¿øß–rþÝ©Kj*þâÀtÄoZÚý›—öü](Oên1×ËîŸ÷ŒxlÆ0UÄAŸÍ“¿¹ŒšÈö¬M”âÈ)‡9“Ò-ò“*SOœŽžgÔµ‚k»{…¼æ¦œvQ÷¶;b¯yæžk=„,Ç|é t‚ç^Þìè9H»ÄΧ5tIȵv£Ò µ cÆØ‘¨¹)wKK~ÙÌ¢W‰8S 63¬/¨Œ`¾þ…øÂ¬b¶ Ý;t§jg”CœZC×à}ìî9$š›r·´Ö—ݳ âdм>r&sZxÇG67Q»Ê!‡NºNù¯Ø„ÏÇÂ}žèƹ‰RÌ‚Xïk¹]Ò½íìÁ†{¨ãÃÓä}?÷·Õ„3’(Ü—–aTJ¾PùD]RõƇ1Ž‹¸nÁ=ŽcG¤VsSN»¨{Û˜*ô™yø’¯¯#^[sL̤X¢ÜïÓ\Þ22ô¡+ªß-䔺 È-_Ÿ×‰oùúLî––ô²;ð.Jº×ä‹ÃHÂôs𹯷|¯É†võL*tr¤Brࣕ®­¹>¶¯É>7å´‹º·Ý?oq|hC¦zàZKõ¶4B!ž6êþ.’;nu¿P®³2³/NÉ¡›,VcuÉÝÒ’_v‡ßr¢¦p†ßÒ8S~þäÒM<€"JžÈ¾CÞÙ:åçÏUc{TœœB·Ë¿‹(ylYKÐÇmiN/»õ]rr‡~ç`¿k Yº Ã@%¥½9%—wKñ‘®¨È˜NÉ¡Ûm7ÒØ]¿‹ÏM¹[ªÖÄ5Æöœ+`JÔ+ç œÍœ+dÚvæ\QÚÉ ™ò%üä=oꪜ ¢2W¦Š½+§;¶-ç¦|1™Ý&ÂîÈía4* wÔ9Ý¥,. OcKèø=Öûù­Ù=  ÷ÜK×)G“'`°tO‚Ró±Ai½gWˆÕÜ.ê>ì,èãÿ[õÆ‚ÎØ‰}â« Ú*„ûJÈ#´¼2¨zcA“C,脾Ä‚®]ÔoZ2¶ËÃRbA‡ÝQ3ÒÁYÙkFŒÓ¬.ë$p –”€\:“(Xg‰0.¯u—.©êYæÁÉ-t P9vñ|.ÍM¹[jº·Ý‘›ðÔø:FNÁZ4m­)x>o\é¢ô~îr+Ûv]R9Ö1çäº ëÔR×5_Ç87åniN/»#çj#‚¨XRpº®X½«Óª":ÿëPòˆ=uÊqŠoÈœ³Š}ê ŠuÕ^îÈï5ä´«ªKkØýóöý“·X^#,µàlâm¢â¥£›q<}s#srVDR×)GßÜBBa³7iìì{—榜veõ »õ¾lä>´³}ß´»èÆÍ”ùÎ]v?4–¼¨ê±Ö šï~ÁI)t«­z»z&æ†<,Mée·¾Kæ‘0UÄ™@ýBUT^Â<êSÞÏ.4[v‰›3t»n;>M;½¼‹3EcwÇTÑÜ”»¥5½ìŽý%3Xñ}qp#Idf}²íêÚ U6ú4d_)©+jD|ŸœŽ=uQ©±{àçqnÈetvG®Âvê’ÄéÂÒå|¡jž7pÇ B·6É,¨;„gáßœÔIuG;ê’47å´‹º·Ý‘sEüã¢3ŒsXkW߸.&Q¾nŽwTE-uÎ&U"+$#ë½ïÐê~½“(ùˆ¿œzØEÝÛîø]&Ðûôße­­I«­m#uoQú]Æù@–9u‡po•=#δ>WÒ@{âØÓsl57å´‹º·Ýñ¾”nÏê^ű„ÚŠ"‡C{êI¢ôär+°®¨@úNÊ¡ÛqâáØÝ±¡47äaiÊ/»#&¾‰ò¨|Kç,à8œœû¤,M“R”›ÜêtïˆtòŒFr¬‰€tçDWŒ ŸÆÜ’Ó.êÞv¿ö}ÿ].¯s;ò˜½yÞ¾xÛ»§|õô†_ †ÿ.'ÅyttsâØŽÀâs÷»Û“to»¯ZÜU÷*P%é'- YŽKëü„eù.ߪ5¨gpjrÝŒÜQŽ=wTsKî–Öô²[ï~2œ¹µ½ï[pÎÍ%¬'½àÜ]³(½{†¼XtJqŠïÀDR :Þ®¹}lPÚ» S’rÚEÝÛgÙ!¼qrº£éྀƖò×]÷Z†îä ˆE%‡.©æ7q*,¨ke9>vu¿¥æ¦œvQ÷¶[ï =Ÿ[û¾8€Ûpè Ç 9"+‰Â3mPäXŽq–®(Œ-ﱬNuO7§ícƒÂؘ[rZJÝÛî ‡Þjõ{%ç)€ïÄ|6ëzjë&)<ÓC’:ªy¤ä¯ uDÝ5£›½ÝŒ!ãdˆúMKU0ô?Z Ý‡Ý YC|çã€}#·é¤×nëE »q^z—Rr]RIø0'×ìà…±A)bµ»¥¦{Ûµ Ⱥò]ˆS¼Ò•ÙÕ¨×LU”î±3…ÜŠì\—T`çT³I7yl…Osî¤JWZšËËî×¹8æðuED¥ÃŸw[’¨Ç™òU–º¤Š{‰‚Ã~4 þ¯QcìˆÞœ›r·4¯—ÝW=2|X‡‡>‚Ž¿]²;ÿRÙñaôפ|Ú$ü }jl÷F£{N×ÅõRcç¨ããÜ’Ã.éÞvë cu´§r))¯Ï9y}ìPxrè¢tÎ fÁ©$Ðu*E^+OV;u?kÑš>6¨ßöÕ-†sSN»¨{Û}aw ŽÖûX9gc?«È?nÓoG ´ûÍòŒÛ|ñA•8UdÓ“>qÖ•'½‰Ò>\§8nWq/}±±¿tóÿ¡eÔ÷ͱ¶Rµ³ P“µ['PRØ&°):štIU‰‹t éCcGÿUÍM9í¢îm÷ßG>šž±àœç$7DDí2Î<)ïï[²½ë:¥gL<'ÒÅ3¤±ãÓÜ”Ó.êÞvë.f9†¯Ø+9ýÔúÜgô÷3$jRŠ]•îr€¦KWÔåµg£ˆº¨ñ{„׆sK»¨û°;ê÷ßõ•ýQ_9õ•ãOõ•óQ_¹õ•ëOõ•ëQ_9õ•ãOõ•ãQ_Ùõ•ýOõ•u¢wtŸ~†ÇÐëB§éŽLе¶(ûÛáër»Àº.©¨ü Î9‡H×êq|ì¨üÑ܇¥G÷awøù|ž£HŽUb™±Ü Ä—ÕD¹ç>ÐÓ>·§ÔC—Ô•k휜C—¹Ôûʵªdèã¶4ç—Ý‘kÍžô#r­;r¼*r&30RîsŠÂZƒ3åj/×UýËKêpÏü0áÅ-4§»¥)½ìŽïrÂqõê‘ꜛëɸ©ìjÐy¤dÝy(ï ÷\èuU€™½ÀŽ¢î´^>6(ýŠgnÉauv¾åÂ_£¾%9g]íØ_ öõŽÞç%öýÞÞI¹ »®SÞ=€¬«Òµ4e;{¾°æ¦œvQ÷¶ûžÇ2b¹;{¼Rœâ>xºÓÔ%J¾‹ÔB¾l.©ìñÊàäºÉ³A—(í¬3‡Ü-ÍëewÔŒ TÖù`³qß/ð Ÿì V™jžéŠ.”7Võ›RÇnq:žyꢧƾ:qî®ú­±C÷¶;j&{()ŽLëL"o@•lX‡@ýÖ7o!/èSE]RÑ“Kœfþé¢ç–ÆŽž\šrÙ݇ÝáSjè!™–û”È!É&fòØà”ºèQ¢±£‡‰æ¦Ü--óewì/ûÑŒ½’°X_‰ Ž=`%Q¾WN—÷Œ cèŠ ?pr]øñ5vøù5wVí-Íùe·Ö1§cöÏ÷ÍÙʤ­ŒÓ!“4Q:—rËžv]RËÿÒÁI3t ¢ÚÇžŽ×§¹)wKÓ|ÙßåD=fw,èàœ —£ƒ÷¥#>Ú³(}—¼BÞ {GºNÕ¸‘L¼/c†n3OºÆnîÔÜ”Ó.êÞvÇ:–˜58|KÈ3LX=ˆì~vÛÏÊR†(­5;½O¨dº®¨åwâu[ºÓÞ5=ãÎQãs»ˆØ}Û÷ýôˆpï 㺟lËtzúÆ÷Ã7XLuùÆoL$êrâØßø¸î7´Ë±˜ÂîØ+ Þ¡½ÑKŠóhF¶hµ®t­èt¦ì¶†þÑ’Wó¥H—Tñì6q²u¥“®¥)ûØÙ±Í47å´‹º·ÝÏßê/vq–ç]”É,]Äá@Ý1¾ygñº®Sù‘wQfGvu ÍÇvä5Ÿ›rÚEÝÛîŸw¶üûïò·ù»œüb+–¨á&$3ˆ ÙPÃË*-jx‰ ÙPÃ;Wè:ueiLDMˆí¡Þ—ÉÇN‘™Í¹%Ž Ù^vk¯ôŒcåõ笫y#þÉŽK ñÑì·Þ’?¥<#¶ÊnMN¥ˆÖf,×]ÌÒÅØ+ð.87å´‹º»õ] €ÁvSÕ%‘ÃÚ¢ŽŠ¯K²Êˆ«.i ‚ò ¬ÖB>à3¢®SÊÎg(÷¹¡úqç»{ìUsSN»¨{Ûu|J…Ýœ‰:‹Žœ³Š: >ï5ê,î·äèäÔuÊ;Ý’ÜéÕ4ÙØò£¹‡j¢R ÝÛîègqÎÎÛÍï'g!fsÎÝÛ’¤O¼'UQx›;°)B(^ó¦å‡K¢v]K›ö±k üpnÊiuo»õ]º­ÍÀ Zê¿f8B=ñ60†6²Óvô±JBâ)èg¶¶ëŠšÑÇÊ9ìEU‘+7WŒ=ƒˆsSî–Öú²;pb žÓ뜴íŠhØ9ÈéeÖ–çô6ëÅ.yW˜é:å9½ä$`íBw"IcO¿çinÉiuo»£ö­£_™üüâ ?Ajè+ßÍœ ]NñìgFyGNUW¥œQÍýüÁI-t‘ý¯±£n[sSî–¦ö²;ü0¹Ôž GN±v_ÛŠÚ yÚ­¡7Qî‡É!ßftIåÈ…sNJ¡‹Â¢ösSî–¦ô²;òÇ2\’0í3à‘ÎèRTà‘¶ZîåÝ6šÁæJ®î¸Ð Ê=Ääȳë¢>KcGý–榜vQ÷¶;öýŽ~zÊí ÎDïóŸ?öýó„ƒÒ¾žiÉ*ᆪ`IåøôF¶£›¦ÛT;‡(íû9…¼éÙ7ÝÛî+ç 7t¿W‚ƒã‘òžJÒ½±.Qòª¦räTI—V;î•ä “‡r®ÐɃcƒ’—sæuóe÷ucöóuG¿ öþ.«ˆòße…|bèê5E*_ç1üú]àiçﲊ(ÿ]FÈiWÓïvGÍHƒ÷£DÍ9 ySÄjÈ©""‘Ÿù-ærëÄèºN•¨YÄ'k¡;p¦¯žÛ˜s)…¼xnt{Ùï~ClJø0äTs*ªcFE<§;°F¼§ÙáÅåÛbŽÒ…±õirNÖ,uËRßBz{½ß»uPî–æö²;jx â~ª³§¡³Ï„g´¡³Ï¾Ks?ééÕ^C¾Õ!2å ß9V|ﺆKïc;¾ÏM9í¢îm÷ÓŸœ†÷¬uëǧÛZô'gQîO^.ï§èŠÞ³>8)‡n÷_1‹rr¹[šòËîȇ9—ƒZü§Ú2kCÌp(W&E>Ì!_Èi¡îR†ËŠ|rrÝŒ¨ÇÎþŒinÊÝÒÜ_vG|Ÿ±åñ}ÆÄ;ãû¸CÜdzÄz§î 5’Œ‰÷”gÌ_œ’C·`•õ:žÇ͹)wKK~Ù­ßeÚïŒÜìï'‡Ù§ç©¨ž}z"k ð·ÛˆMSŽ,Èê™­¤J|z!»¨¯Ð­èÜɱ«÷/ÒÜ”Ó.êÞvÇýe#“õbΡ7å’Å8Ï#OQº¿¬òaûtIE4œ“ᅦtežŒŽhêŽ>¼ õ:”WÕ ìñ²;ò`OmiÊÑ眂{{“ùJ¬6¡ø»_ÐÇTrvA¡nÖ_EOMpÎŽ!];;úØ~¶ô¹!KSzÙï~Æ;ä¹ ÎÙ|ã*Þfä"Ô-Jïþ9-J>Ñ«“ºNy®9Ì7 .òÃ4väinÊi—ç9„Ý;Ú±»-áÁ’“µc$®ˆzœ¿(Å_Îß–ò¯)uE%U•_FŽúŽŽåcƒÒnd™”»¥¥¾ìŽú—Âú{½/ädóJ— <•õ/ì‡yU´¦å@l’.©-ÎIÓuºmplP¿iÉœ!wKÓ|Ùñ—ŒˆIM!g3C;yG÷(özî:•Tõzf§õzž7%¯8È+—®µô±‹{m47å´‹º·Ý&$P$ƒÈ9äÄ.è™EÉC\gȼÏÔuª²ÈF&nß¡[¡Ï±KÔÓsî¢zzvˆìûewü.'fX¬ÂëûÉa¥FãvÓsp ÅRÈp¶«º‘rÏ 9YÕÏ[9Æ.áäÜ”Ó.êÞvó» Äü«ç]\œÉºŽjUSgÇÈ'¨žwq8ö6SŽ>UÒuJ§qй]ºÀáÕØÓ«¹)§]Ô½í쎄·UX7â £_Ù¸ ²£_®G ¬›¤ç(£Âä”Ü© ©X7Ω)t‰‚„"¬Íͨ[ZÓËî—oüODs—âþé+Þ3ÿ„A4DÒ%õ' ¢9®šÄ¸0ˆæŸ0ˆæƒHº·ÝïÌóÞOùÉÙ:(ÁDt™[”¢ÜmˆS±)Sשè|HÎÉ1®{ò‹ J¨\C» û´[¾¾†˜Cõ^Ïâ4dÙ7äÍ7dàw`ÔÏI¯!GöštIÕA|²¶†.Ð84v‰NQMü&§]Ô½íŽ"¦^9$¬ÀNȇ!†*sHf¥¬b¨2‡„uà)Õîb¨2‡¤¢1sH˜A˜Ÿ•9ƒÌ!!j*sHÂn­ÉÉô³*Ö9k_ƒ/¯ÃÔ¶(÷ûôWÜà©ëT‰,@ã äæQwàîS”Eåw#ÎM9í¢îm÷u澟÷}#§ÙžtêL›Ç¾o¼µzß7ó¹|A“º¤êÝ÷âN™n1„b]Ô+Íç¦Ü--ãe÷AŽ–r{ÄA‡åA^nÇìĽõžßèª-ùÁtI9Ò‡s’ù¤kø>¶#}øÜ”Ó.êÞv‡f­Vý^ÅAt¨.`"ôC­-JgÙ>\Þp¡+ªG¿W示 8vóUOsSî–šîmw`5ì…S}«Éi@Þ5§Ä¡6P{Ç…ù:ú‡$õüi%,…îÃî¸#ŸD3DL¾oÎÒªÞùšà ÉU”öÃ&ÜÚ1Ø#B½cšÆÖnDŽz¸`·"2‘f„‚­¹u‡––ô²[ߥù°·Æ÷“sjÿ„<7ÐÙÇ*Hý–w †Üò\×)EjÅa„c¨£|Ê1¶QÚ„¨—Ã.êÞvël‰ŽK¥9&¤8‘c\« q²<'޶¥X¸|#;•º¤ZD7·rl×ÝŠÈ0ÇŽh榜vQ÷¶ûzÆ1⽟œ3áyéx.+žŠ§’´B^Pñ\Q¿jl}šÈ9³„nÂ+ÇŽîãš›rÚEÝÛî+çjZ,¨+¾ON5|σ¬‹ßybw[S”v¿Þ\Þ•£®¨âo€8™­[Q«:cììóš›rÚEÝÛnÝ+‘ï¼¢Ç8Dã˜ö~®Tüi(¬ t¯l)ä ˜®Ô%=†‚cî—ºŽcG!Í]äG¤¥¦{Û÷ýŒŠ*õI$§XÉÓ¡ˆq¼ØÓqˆÒ™)•w!ó–áÆÖ§Ù§„Þ„SlÝ>6¨ß´d¦ÓRêÞvǾ_†ÎÕß7g+Zµül}öæ6§øS•ÛBÞ”'›vPqŠgªKJæþRbì9ƒE+¥„]Ô½íŽó˜ê}æ—'‡=R×íÉiM”Îc·—›²tIEÞEpˆ†™éRÔ&Jgð¹Bî–ªGj±=‡gYù”ÄjÝç<š¹‘ã>³(?Ë®Ot¦¢.©æ>¥à¤º@­ÓØ5b¡œ›r·Ôto»ßrVx7„KN¶Z‰”Q3ldžHÙDɳ2RÈí)v]R)Þfp*K©;PYʱDž€¹%‡]Ò½íþæpêϳ%B¡q¾+ã>ÿ•@¬äùÐäŽ2<óM¥è MÌáºB·?ðŒ{à{?‹ÕÂ.êÞv_8ðôeFžý¬Ä!iôÁ«}‹ÒS3GÈœ,]RýÆ!!‡8$3nŠ»Ý8$­†Ü-%IØ}åõÁ·íضÎá9#Ó©.DjdPn!`fòÕÐuÊ3(ÉÉè.°Õ÷cî;¶-çN¾-9to»#"=p{.ÎD®êpÿ×Éc-Üëý`óºúª_”׌¬«¿¹ë"N¬±#ެ¹)§]Ô½ínðÚÔ­è·;†8Ëz@×w“Æ&…Oc‘œ–R÷¶;ê’:êŽ<ÆÎÉmªÈoÀ¢#KjVQºcÔíòš¼Ëwu c{–|°3¹îéS0|lPÊ»H#ä´º»_ïËRìõòpô‡&Çûêå‡É×ûB]{öŸü0åz_¸³z_©ùz_|×Ö{Ü_vG.Üêi ,hrøýY£[ g½Ùr #nUõô£ÉÙuƒRf+9É@¥›<+Ôo>!VãK9ì’îmwä\-`ÄÊÏ/<9'C qôÅìµ&J¾¾™CÞÐ町¤Æ}C(<©ŽÐµR+»Ç ¡èÜÚJØEÝÛîë»à†sÜrø]ð.ô]†(ÿ.%äÍV é’Zï¼ }øõ]†(}—–BN»¦—c{îh•øûæløm·ðp7N%ôìíÀîhÉå-!ƒº¢VxÒÃLÓ†Êf©ÒówÕ=¤r·4§—Ýq¶Üðä¤è1DÎd-‘ÞP·a÷ç”Óî~’/Ü¡©ë”gP’Sð—¦nFÝÇÎ~†ÑÜ”Ó.êÞv_˜]ÏqrÎD‘C¢.«±Ÿeä©Kä9é’Š’à€t­”êêઠFÍM¹[jº·ÝWþz'nõ#IÌáZ—¶úGܺ q,?,Kש½9œSjäž!…‚cƒÂšÌÜ5ÊÝÒR_vkMÈ]Z^ÿ"ÎFW/䜉VÂ,Jëf!GötI-ÏžÎ9ãHwÚITcO¯ÑÜ”»¥)¿ì–aÙNΕsˆ×GÄýïòh¢à½Ê&5¹Å¼]×)íFâ4ÔJP·)Ç}4Q¿i ÑüMN»¨{Û˜]D,W_Qq:|Ùòž *ózö¹êŸ»a4¹Ýq¥Kªù‰GTæIט>võæ¦<émßùe÷Õgw?åõ‰SU#Iÿ´UçtTœUÏëkCþmVþÐ÷mº¤Šçõ‰“U½“ÄÃîg­ŠÒn4gÈiWVmfØû £¥­ûþR{—q+ž¨œØZ¥#M—7¢Ô”TTþ4G±Ÿ+tÎ?»ù©¹)_ŠäÎõ²;r­O ½F|_ÄèÐϰmÊ<ÒûΞ>{É­ ÆuIE|?8ç/]ü4vü47ån©éÞv‡?™ø%òÇÈYðò2rÜ?ƨq‹ü1"î3º›zè:åñ}r¸“Sw*~¿š(|šsSN»¨{Û­{e–@ø.‚3Ñ1–™E5ô{ŠÂŽÑÐo†r«°q]§³‹ø¤ ß„Æ߅榜v5õÉ »/ÿ⊋‰ƒØ@À›©¨€Ÿè¥Y}Ç@Äå øÔ%U<.&Nö*vôå)3ÆÎŽN®¹)§]Ô½íŽul –{F¿¤¯UƒßÖÖ‹„;^zƪP0OËÜŽåíK6º™ƒòsÆ ygïAMaD\œRBív5¶£üøÜ”»¥¦{Ûµ¢†µpõ|t΂—hz—G«Þ¬_žEY% µ¤£…®SÞó‘œæ¹ß¨„Û+ƾz>rnÊiuo»#w´£Ï•;Úk¤~„¨eîè,¢~ó¶SWÈ‹åTI—T»sGS•;jº^/?‹(|šs{½½ÙU•;vË?†ºŒf@™ßOΉ9ôhiè?ìÏO >,TH>Í—']§ä!Ç ‘]Yº»:n®æ¦œvQ÷¶[~~s[Ô\~~r¶ù :‚´ä©ï-J¾ø1BnÞD×%µ}Ó9¹„îTG;{º÷YsSî–æò²ûòõá™Í—¯ž¨eÆb¥¯o‹r_ß9<ÄÒu*‡¯Y‰m„.²t5vvŒ;ÍM9í¢îm÷Ü+«Wø;.œWù§"Ïè¡ÂkJÊÿÒ3äŽ>`ºŽ<à¸päd`»Q7÷cçÀ…ãÜ”Ó.êÞvÁDG!Õ&g} ²êbµ—(ì~ð£JnK¤ë:¥ }q²eÏH7£ÛÇÎ^› ¹³ºq̺·Ý‘Ó;€u¨~|âI´ëÇ+®è[œuÓ{ȉHD]RÏ(7v£µCH¢{įȹ)§]C~÷°ûª'ÞL:qp&²µ7£U¬Ï¢ôî—r  HשŸ^èÁw¿ÀÛ»KŒ}õøåÜÞ㷥нíøŽL¦ žâÀ'ÄVͰ•étáÀ·äòb‘7éå8ðäLáÀ›.q«9ö…k͹‡pà{u݇ÝÑ3¥Õª(oÜ9y 5# çˆ^DáœèɽBÝ ÜsŸ•³5rèà­ÔWÔç†\vA÷aw`çWÏçè>UcÍE&Þ³gJºÖììiïý4ÒsM&Ç{¦¤kÍåØÞO6·÷~ÊWÏ”Ûníû–~{¢M¸g!FoɺéZ@™X¢ðÔ4`ÍQÞ(F]RṎÅè©;€qDZG`ÜqnÊÝRÓ½í_ßF\K˜]ÁÙ@«mèiÔõq|% äë[%äލë”0»ÄéÊ11ÝŽ›Çîžm¦¹)§]]¹-a·Þú§é9½â8¹EYAÂݯˆÒºYwȧrÛ jzNopˆŠZÑYm¤{xN¯æ¦Ü-ÕÎZblåUÖ7Gþ9hl‹õÑÍn½‰ÂÛ\QÿL¹%(¹®S:'‹ƒìéZÊ‚]üœ¬¹)§]Խ펻Xclù]¬!ªgÖ±{&òÐÙuîÊSoÖOÊå8ÛIßœYuµ+Ê`ÛÅu3:ªrlPº‹írZJÝÛîÀî ^ÅT9@H ±\ $îä±`Ê âÄÔ%5Q,8i‡î@n3Ç‘ûœÃîý¶4í—Ýk€KoœœjÔsz…“Î:lQ:a;¹äÃÞVé:¥·Ksâ¹®¹í|ìȘ×Ü”Ó.êÞvëÝG.unQcEN6Údà3Õ„™ÀoªÈ®–¼ M§× ¢;lpJ ÝŠü”"ôš(r+‡Ü-5ÝÛnÅ‘«­Õ ½¿Ÿ«/mÀµ68‡:k (Äz;ÐB)ï¶NI×)eO‹Óж ÅÔ*~9vu|#ÍM9í¢îmwœaˆŸ¢ï9g݉ÜÙ‚÷¯z¯B­5DÜ/|“ë¥S‰8M^DÜàc¥3̬.—]Ð}ØõÈ9Àê!ŽÕ2|Áw9«GgôvøY¶£7¨äŒS·©VYQ´à¤ºÀùÔØª¹)wKSÙ8½<ç.Åøû”€žÑ‰’Öá(‰Â9ƒµ ”ã §.(Ž­O“sö»¨=Ic“Ò)çì‘nKîÃîxßïK9Zê5œ ÌðŽ<­ ¤êsÓ…ç€HÕì`Ô JH¢ât  vб›gÍjnÊiuo»#–”Ê;–Dãtýú]ÐKóþ],#çŠÏ´ëwqêÂSjʺ~ŽýÀSê×ïB»<–v_˜*¨_î¦ r‰ ná Ù:‹˜*Y”îûs†|ãTBÝ­3Š{lə¾ÈÝ©+Æžá±Â1©+ì¢îm÷…¡Z-7[~˜àÙê: †Íš(Ì—PéAy¶Ù©”ü0âÀ—"]øY4vøa4wv´å꺻·‡92[µ¢C¹=#z-T`4TC×À>hæ€qùVnÏxôxðJçÔìºe ˆ¹=^É0•Û3ÇmiÍ/»_÷ýåç±à°OÃb"½ŠzÜ÷)ÏæÍ¦nP)Nñ“OÍÝ3}2“ÎüšrÙ݇݊‹mÜæ¬ôòûÉ™@àc¯\ëJg§H)ÒÅî¹&7 qé•âÓ÷Ê–B× ^|l£Ûå² º»ãœœÑ±/u?'“3/ß"²å‘òsò ù°~®ÒuÊ;©“¤ê.Ô4qì5Oœ[rÚEÝÛîxÆ:îKÚ_‚£|hdXV<³‹ÒSÃ*âŠØ¡ë”#U“³Iä‘ 4Œ Jw1ú=w» û°;öÊó¦â/â uuh8'ŸøÊ@¹(í~s‡7Wꊊìÿà亖“ïc_Ùÿœò°4——ÝQ+ÊþÏÊçÎFGJö­î¨îdßjåó£‹Ë«úR³ë)ylÅA6¨t'¢CEož¢5š›ò$éÞvGý‹"]¶Eï’ÓÊ/«z®Šk‘R¤kouuèKÇÖŽANéÒ5m~DÑtnî η¥¥¿ìÖ51c©~ÿâgÚ6à‚SýyÜnõ6 pÎXÖmCrûå]ש”üÓõ Öé–º€xÓØC~Ÿ›rÚEÝÛîxN®«¬y´¾o|Õ2 3`>ϼgQ~ߟ!wÜëÚƒjŽ$œTB—çŽ}8·Ÿhi*/»Þïò#¿ËŽ>‰D¾O|þ„>ˆ^'î}½N|M·Uº^5>Æó»ìŸØîwa6´þü.”»¥>¿ÆVÕBˆr®Äæ]¯Lj°ƒÒÞlÝt(GêŠêáU%ǺNº®%“ûØ-rH87ä² º»ÃŸœóW~²8>Äz"’U·(yˆÓ9P¤KªÞ¨ñƒÞðº•Ø»j<ç¦<)·ÚËî«^ gzÕ‹áœrª?ÔFWg½X…S ú›K^ÐÃŽº¤âw§!_†ºÍ2³5vsϠ榜vQ÷¶;òaÇÚ÷=þrPòÊNƒPË/` çxŒ¿””ã8HëÅã/ìáËø‹÷øõø {÷º·Ýq†!~¹~q*ð.†ÐÎu¢é¢t†±<å¸)Jw ëO¿‹8Ù1?%fï¢ô]˜!“GØ•…´v‡?¹²ÛZur%z!*6"ú u´}‰’‡¸´£³œtIÇ"ÇŽþ®‹ñ;zÈknÊiuo»õîot]Ù¯ ÎÖîÄý¥¡Ž¶ Q˜}‹(Ï@†nPÞ÷óžH÷Üs› JÞ¹].» û°;â•“8 Ê»èBÉˈ"Þà·³(ù}ˆÀ7P›Jëˆ}‹Æ–*#+dÎÐÈ8áØã®Æ,-ä´‹º·Ýqß/ØýÔ+-8 Ù©ý]2WÎ)(¿ïïÛZ$Ý <òÎ@}?uâ¶{D\—sSN»¨û°;°n6n [þ1rà:7 ñd ç,Jþ±9CžÏUYº¢–gƒ§féf@ÛslR~Ûi.Kk~Ù8½X…[÷Jr–úŒ  qddÔ"JÙ{…|Qƒ}FzÕØZ™È)3t‡úŒÔ"Jy£‡Ü--óew¼ûôM8&$9¸ŽŽ~v0?ïgM¢ð6£+äÕ–YÕ˜¬½ô• œŒª?êæ­ŠÉšDéÝg¥gÉnuvGM¢zžÈ×W„g˜,ȹšˆ@r…V¿¤ê«ôDλ±åTtŒ'#Òå«pÍ1vtŒÐÜ”Ó.êÞv~2o÷#𓓯eoÅïûê˜Þ.9 Â¤;tû×],8©Hײf—Æ&%ÿXo!wKSyÙý¬?Ý4žuâýÕ’uʳ¢3j¹Aa­iX«(G?Mé’Êî N-¡›Ì›¦±“{ 47åni-/»/L{ä’—˜öàXz÷ž?(»%WQò÷rt –®SòrŠÓÔ¹ãÔFŒÝ"R˹)§]Ô½í¾r{ªÝVó½²óƬR¢€³¿q‚®þÄbÀÝB—”#V^œ¼B·i¶±[ìÜ›r·”ïbØ­óØD‡¼ì¸ Á9o@·ÄÁ)>Ý\U¤ä[¬3äÞDê:¥\œdût“úÛØ)úsnÊiuo»c™ô;Nß_g£çYõ៼$QÚ1Æ ù¢9uAalù ³k²ë.YÒØ ´wÕrZJÝÛî˧T-ƒÙqHÈ)æù¬–÷dxÌÈóèU”¯›)äUx镇Dœ¤ÛD£Òbì8$œ›rÚEÝÛî¸ï Q,îû gaácUg‘2EéN¾›ËºjS—ÆÖ­—¢”nž[§ J'Ñ‘Cî–5ìŽý%cžÉ÷ã ç,¶ô¡6¢1uŠÒþ’jÈ ·ÚuIïLœTC7#çœcçÈIçÜY9ë´4Õ—ÝK@Êò¼ r¼_@ÁZÃ^kŠòèP ùúu§÷VÄUrr ÝŒ Jßu{ìÃÜ™û¾-5ÝÛîè5@tõ¡<¥.„õŠnè–APÎD†í´DýÖª×C¾Ð퓺¤²¿]âéCºÉq¥–(|šs'Ç¥š¡{Ûyãì$õ»8g²[4úRWäÃúLñ3Ó‰ƒ´gõà>ºAåȇaWîV¥k9-[c“Âï²áa†\vA÷a÷…§„ O o\f>1þˆ§”Eyn¹üà%×5xJ¼WîÐާ”EyD9íB(»cß/ðœ(×ZœæÕðÞ±ŸL›¢´“óT²Ø%o….©+“sÎÛ%]VqìýŠ9·W1ÑÒ”^vG-Ï_Ów!gØ;V»|°ß…>Xï“=ÌK$ù”6× ºŸÞÄiÈ8¡nšÿ¶Äw¡¶Œ°«©S@ع={|½r{öUƒj¡ÈÝÉóéçŽ ŽÚêzá8uÕV× ‡„º^[ç׫¶º_µ×´Ës{ÂîÀ¸#Ò›z£‹3pîiè›`àAêTJkMª!Gßé’êþ6§ÔÐEf¶ÆŽÈ“æ¦Ü--õewÜ_lÏY^3œM<©d5º w ÛÏâ¾”ö;Ê:R×)eiˆce–®;Ñé–cO?óknÊiuo»£N¼¢®î/Á9þºã@µ»mô)J~ŸRCnI ®ëT‰¬ãdtÛ ®•·úØÙïš›rÚ•ÕÉ#ìŸûUäæ>%rúCWÔÓTàð¦"J>¥±CŽ3Ô *Çi±\µ Ð…/Ecß^ÌM¹ì‚îÃîŸã;çî„Ut(†ø¡j…ïÂj3¬ª1=ª@NQ”Gç©ÔpDoq:r娋Ì#ݽ]sSN»¨{Û}¾Ë?üóåëþõ×ç×ýîÿø§ÿðËÒéþϯÿòe@ÁçŸÿú•¾þÛ¯ôõï~åF¿AùþêÕ^-™»ÿ/__\c5þ½Çƈù3bYÀîè–’*ÈÅ@/ÿ÷ÿõñ?~ýëùDƒž÷¿þó׿ØÜŸ5æ3û?üõ?ýó?~ýþë™ðÜô®ÿúû_~ý›Cýúúþ-0Î?ýñëÔ–¯ûßóu,õÍ¿Žý¾þׯSè–¾þ½fé{xK–© ò/¿þ|·‡ä%Ï•à}üéó‰ãÀ>oµ}o‘‰÷öãi™ñ÷–%¹ø@^xþbúÃY —[ò2yöÇWy¥\Ÿ_ ôý‰rz´}o²LÖ‹}}§‚*y}'÷Æ‚Ãy} ¡Ñº>@òúÀ¿ý”ˤsàn4ñœÚ³}þòë¬L§Ê°˜¯ôA´(†¬úœJŠ]äAÞº |gÐ'뽤ç¡q{<ò$}²Šu…}òæÑÄôÉÄ*ÖñòЈrè\HŸ¾ÅÅ¢¹ O'`8ÚAŸ,°by* ù"Ñ^ƒ‰¶ù+éóFWJÐg,UúÝ<,Å 1= +òC—Dúì°Å %@·Ž¿W&}¼;%…þÉè>舘hÙ’@/H¶diÐgñÉvm}<¤Ùœy OýT¶Óô¡‘+†Â$Ð'Ž”»ì±0[>-úé“iÀ¡ ²5gûAoíÁ=Û¤O‡ˆl.ÐÇÿ“ms}v®ãræ·NÌËèRIŸÊ‡d @Ÿçñì<¢Ï>‰šÂCÛÑ$§wL…à‰}ê±R×øÙÞ8¡AŸž‰ï‡ÐÎxUó[ˆùÐ)‘>HØÉÒ¡@ŸšTð{óà9"—ôyïCŸç1%Ùg5V‡¦ýæ¾9t†=ö`ïÇóŸ“щ²e’Ÿ×p›·äçp··tû12ŸÅ/ý%­¤a/ü0‡ü܃ô òó‚nk yHƒ²8K%Ym¨&i·¡ê"9m(ZeŠP|HÃŒŠ¡¬2ü‹äç‡9ó6’«›‘°y5i ?Ûß¶ÃÈÏ‚ìB³ž¿Fj$?\üql?A<Èy'€RH~þÂ{c•;䲡ì%8›U²¡ð˜>jO’ ?©-9‡žøI‹>~ÒO#>oȇÆß:#O>èsý@?,Ðg«ôG(#•5%¼’‡>àNçͨ¤ð{ÊX"}ÈRÆ+{èsÈ?¨=Â@9tͤ+Æ«’wŒ‡ø'‡Æß.›×ÎèJú¸³—kÿYŸôèÏÏ'ð¡1¿dm¾EºæÛ >\öÚ;c%½1^}ÊÝSæ“€P›Ñ™ôÀxx¥3Z˜¿ì\oë½a¿Ç&ݿϴ-]èAoüÞó[G—ë÷EBlJ|ʳUˆH¯rÓö„_ŸßçFvg·\£'éIû$çó¸Mÿ¸æÚõ}Oü¸þ>%áyÔó‚NŠö{áóh;p¬“tÁßs.Òg LEã„÷¡ñ~‹ñØk¿×9Ýb‰ÅkTõ³$çJºcÉÆRdrNöƒô9DÁésh4”M [â¡íyìÜRÎÞ߯û‡³ÁÙbðþœ³Ã6ztÒg ĺºcËâ÷m¶&-¥i Lø>][à¤Ï˜-…ôÀ–š i;’YeË¡-éëlÁm’>G²ÓÞ°>Ï#âÀ Ï󘟇D=íy<À*›ôyóÔxÓ¶À¼¸e»æ¬u÷s™>[ Ê%@Û‘,éïµp$Ëçµ=vÕê¡T¾Ï)Jãz.òg¼~¶$Ðv$zž6ŽdVö¡+àŒ7ùþÕ„#Ùâûïy.›[ßq$|ƫڒ?ÿç³æªõ¦šúÜep¤`jK­8‚úÉNÆA#}ŽdµñïqÎæg¼ÎM¼ÚY1Ïk!}ŽdèMúÉN´v“>G2ø˜]íHv¼Ð›ôy[’¾e½EŸç±éý<†~Æ;==1³ç±®_§Íéçïy:„Š>MèZãßû\ð«Ñس«ÕãæÖ¹~'ñ4ï3º.zÒglƒûaµØû¡ñ|Wk¤’›Ey@Ÿ#Y›|>OVè6ïχ>Ïc›\?¸ó<¶¥ßgÚóØׯj]BÍùÍ=~è&ùÙ›ÎBH13:“>ûc[|ÿª­ÏOŒWA[þò¡s'}’³ÚÔßÉOmê÷µ…áÐü}­cÊ¡±7ësþ^XïšU-ö6‹g:éóçyüüýñ>6K€=4dzƒAnZ›mÄýbAŸý±YÒ'è³?~žœ3Oòð4ïKƒ3«ež4J Zæú÷¡0MK<Šº=Ïú(D8ÆMúûcå•öæŸý±&®wÍÜÙgýÀ•æ<èËÖ—­ÏŸýñdò‚†›à¬Oƒô9¯•Îõ¢ªÍYïð¾6ÆígÍ6»BCnKvÅì¤ÏóXl}žÇ¼q¥¶æŸÓÖë.ý³?¢QÖ¡Ñ !ÛôÙsçúЬõîÙ?p@{곿ð÷´D°³?aýmt”$ý~çµ-û6Îk‹‡íˆÏ4ùþõ„óšõ\mç5]éìŸ]‡^8`¿ìpÎ[tÁyh‰þ<{ó¸ÔíªŽ{0ÈÏϲ'ëæÁ߃ïb7àÈÝù§ëæT3ÈÏ[zìÂsH·>Q;ëkØùå$…$’Ÿ§pm>ÔÝÚH­u^…CÚËxjÕD~žõ5ôa«Ç[]CYÈjšÈºx/z\,w¹~­Â_»[Ÿ—¥Ã=¢È+ÁpÈÏ¢:7—ún…ðÓÿVÇ8'în-SëR·¼ÚÙ¹u«CC›ÉCÚv7›¬²´Û©=çC~¦8f™ägÌ™ùDuÛ‰ P·•v&®gÝ| è1 òcÞXtt -É—»Û|L>ÛÝ´†¶¦ÿÛÜìÆqÃл¿bÉ!ÀhDQÒ5ErhQ @|+zhmR$ÐôÿQñ=rVl¼övãø#Ïš‘5"E‘I 8d†–ø^X€*ÎXŠ2azÊ€ƒÏ4»ØQØw«Vqó¼®þù kB“ÏóøÏØ4LÅEï–Yޝt_ÀŠº¥Ñ¥f c¿+ÍgÒòÊ¡Äî¨PKuåM‘ž]ƒCè”âKW¡c—⚨ VBq´O«×hä(ÙżÂEW²³¨â±²Æ0Ä(ËÕD8~_’‹ÅAv U¡ê•Å´"ƶ,ñŸqH­c{“î ¬Ï•ƃ”cQHÈ…Ò%-† $4wëŠûÒPYµ¤CAqô,ß[Í$vE¹5Q7»ƒ·Ñ YŠ›¸ 爗`ŠÐ!WÀ©""®¯)2­bëêÐ;Ä6]Â!š$Ç»HÀæI8t+ÉþEÅJX„ƒÍ$ù€ƒÍdõ‰µ8õdjC…=b·,v‡c“Õ…t'‹» Ž=ŒiE„ƒÁ¾7ƒˆ“äK£¢I®Ÿ8ˆÅ¢7„ƒ:¦½òaxæ$œV¤È€¹ʼn$øªâüL’¯ÁŠLrI>“3,avU”.¦²D8v- %`Àñ{Y| V(S.€ BËXLøÈâl6`CWÜ¿+-%¸·*KXûÑœ›{E± Ûª"×Gnï#Ì芆¥eq¾ªð±dWˆ‘dÂ1‡²Ä´Ãa'KPÆ”Ä6Qa äçã\U– NbY©ˆ° +nšǽÖoÃA®,®<34Pbísc’p­ ¨èj‡;º¢jð`Ì3¦Žjñ€SÇÕ=`ÅÔQÉl9ΡãÙ©wL-L©ûN× ÝÜ¡_Ýý=^©¼»(hPLÉ/ º"·7^ºnC¸tînšŽ==¡+zΫ:…;¸AÃe•BËÏënö4}b(BË@ë®ä7h˼ °¢+®…ÆãÙæ¬) ¸8´-͸šÐâB}o,®Ñ\Ýj§¹¹±Ñ1ÃákÑY´¡6}ŽÃÆ ax™v”¼žÐŽÊ¬kèÄ`´Z4òî “›ïeÕEZLËU‡ÅÖ º²D aCW”ŽßÜœ‘:8y³V:ÖWc Ã+Ç*‹„ÆfÕgÒ”C»Ý¥JgþXõ‰í¨”—ãhÄŽêï®j­¾YóÚ¢Fe‡w-W§‚Ó¡+ò$o=ÊÕ·¶ÎŒ‹ê2§cûÈ¡Qð¤\])êØzruÔû^]Ùù»Z ¾—©3Yµºei‡sùÀ$.ƒ…—ÃûÞÝ‘•™«Ë«Î’™ÕWŠ•FbW“E'¸²«Õ¡ÔTv•ö4AÌåêzÈ•,节±C—8B°Á ×uSÇÕÝš8ÁÖ&ˆ f˜×,ìª:¬ºƒ½mP–ÅÙlƒd³ ªì`Ó &g³ ®}KÚÁšw°— ò:Š æ¾ÐÔ´ƒ-O0#Di‚kÝAé;Xç³ÿË¢J<¢äEÇî³…”¬¶a§ÿRò­èŽ9¢Ä&)" üAXPß(1³8æŸPr"^ä~cÝÇ‹|{87‡—7/o§™»ÊBQŽ?1Ž×ë!nÿ<À;¶l?§Ö’à’ºýtøíÙëïþùüîùaüúÙÇ?¾üûåùï‡ÛŸo^ÝÞoz®úLnÅ'C’;Çs šx]ß#Qž½õö§ç‡Û¿ƒ ç§äÊOÍÁVO†wŽç„@lºÎ„øðæíL‡ó3rå§ð¤?²6'1§é\ÐÛw¤Ããy(Ð狾Ñ`¡ ¸U}1u~Š®üÔüdÄ->œÏ5 ƒ¬›zRTŸ“+?5?éÛýS!ÄÉá\“¼ è„ :;W}èAÿ.šà¯Ãj3Jz¯ˆ<úäˆC4-´®(¸à­DÇÖÄÙhNsü,Ú »µÏá³Ö²#âÄUt<þ<¿í$Ö05›Éh¹%í/Ü©ÌyÑåxq½ï‹¡X¦7åÞoŠ2±/ÞÔ‰íþf1XÕþ á‘F+ãÝáÔžá*ÛÚ §öÊŒîh'üŽ<eG/`¯MxXÕç¥^Âk-,iòc¹Àc¬7*ÍAáSø&&æ˜ð)|kŸC§ðhßE„.Xn‹¿€ ,vÈRªÎv®ÓÊ%\ ‹§ \Ì×[>sµé“þÀåÓXµÆ›÷¢|Sáß}˜Å›æ<ñ7ONÜu–HA}9&|r÷‚CºÂ‚0ËÜîpjW8™·vuŸs´ceÈÖîp^"ÈIá¾½€ 2­—p‰ÒV/ᥭ= lx7Hx¤"nå\Ž\B8µKÚµNíÕ«D{;áâ^yTDÏ^À¦Hú›ä { ˆ¬-_ÈǤ-´FÎ[§”-òOdl9ÿL [l|-o?¦k=ÔF¸‹¾v,ïø!¥ý$[_ggA6É?ÿ5÷õ›_~=5Ûýá鯽˜‘˜„Õ¡ÜÿÓ÷þwóÐ8ÃS endstream endobj 285 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 292 0 obj << /Length 964 /Filter /FlateDecode >> stream xÚ¥UÛnã6}ÏWy’‹+^ta±-°M²E(Ðn¼E·´LÇ,ÉéMò÷áбœx M‹œÎÎ%Oî’<ùå"ãËá7Ox"ò’Õ¥H Y2•«¤é.þ¹`ª„¿`1YÕá\¼ûµ«“ëáâø?¨²f6ýyqñîcQ$ÓUΓÅn–¬Pp³(X¥e²X%¥_ó"7ðÃg™,UúûLèÔ´ã}ë,I\c¼·ãn;x‡’"mÌŒ§=­Û•íg2O}»~$ɲ5Î::ÛF«;8`{KûÍþ^|Ï3 Á*òc7ZçÚ*]Î2ðÃzôæñ­š£h ÁÎŒ¾mö[3Ò¾úUëÉ1¼æ‰ C%šéR”HFÆ•ldJ°¼(É‹Ÿf°“º÷Yãn)ðYÆIw€ÃE³_¯‘°ùåææöêrŽ—Ûå8,·Æyw9wÝ0ø Ê\jc¸œ3 /rrÓA'jàâDÌ®Ðkø"Ö8œuã …v‡Hˆ‚hßAš‡XínÛBäÖ}ÿnNß,žrP VÕ2áuŤÿ!«õ‹¬ŽÙóeRëŠåuðªd?“ÓòÝh:Úkú~º¥ïªuÞôMHÚWsïyjM—"gZýðyþ"þˆùzü’W *ÿEüKŠ¿ò$þR¨ô¾ÅäDÍ8yìÏê—2iLOÇúÆÜ€ŸTnL´aï·­ÕwD|^}BO«O¨š•U A*ÆkNH¿}s€|¥ÓØmp\óð.ujIºwv½ßÒÚô]Yh3P±]ÛG+8 Giã·fA{lT`c<­:390¹°ýÉ8¢õ(ºŸ‰*µ¡ÉE§'™’)^¦‹Mtéjÿ5—òÚx¨„6o¬béÆÐY¿ü àÅù„;hñ²Â\"Î> Wøâ‡j}FµRLÊ'óÀ¦Tå18©*dsEbä%öÁA¸±.Z¶Dí]ë#U(þæÈr=lWYƒŠéïâ™ð˜ÈC­Ò?gµ„Œ!ë ÷Γ™Û‘K º7ªL·ÛFgzÓYêšYC΋ӶCÂ…—F’,vÇù»fè`„´.Œ؇ê å„F^Ly|8ôf9WӯΡh&Ëê`óx¤`†R4ø!>ÿÉà9 ®BCØš ÍOº}÷>;&òƒúüÔ‚‰…ÚãÔzcŽt¯é®†}ïéj=\öê0.ç§+ÈæÍ‘I·½Ö]„‚¡y!4«a6„Ãüt’Aëþ+ÜoZ endstream endobj 206 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_scatter_2.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 296 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 297 0 R>> /ExtGState << /GS1 298 0 R /GS2 299 0 R /GS3 300 0 R /GS257 301 0 R /GS258 302 0 R /GS259 303 0 R >>/ColorSpace << /sRGB 304 0 R >>>> /Length 27121 /Filter /FlateDecode >> stream xœì½MÏ&Én¸¯_ñ.g0˜R|efäö lÀn³0¼*[6„~ xîÂ’<ç0Yõ-ß+Y5èEw½‡LFðÉŒƒÁ¨ÿú£~üýÇÿòï~ì¿òµüoô–þùþóÇÿýñß¾üÕÿýßüáãÛ¿Ô‡X>òÿÿøMì¿þå`ÿò×ÿÖ¨×ÇÿøòþãGùøO_êÇ¿~þûû/Õ«û7_þ¿«þòñ‡PpÌ¯×øèõë]?úu}½æóÏùõß©X¾Þ­}äÿ›Šÿ˜ü—¿û­ŸP¾}ý„òú (üxŠ»?>¿Œv~=á¯_~!»^ÏÓ‰O¼h³­éâõ@¿Ï¯-=@lœ‡ÿ0ÿyŸD£Ì¯ópv}Šgð Ó½<¿u@˜u~=Žx€0W±}dþäÚ¿#ýdàô“ú™ N?¹ßöÏúÉÀ^a_Ï{ý&À¤QíkëñaþÑÇíí@?0=ðWóK;®ÿòGo¤h¥ú¿·û¿ù¥þÃ\´™«îÍþããª_çýQŸsÙ‡\„Ë”¿Ú×óyKm~íãêþʾ٣Ãþ÷øZÏ#ðRýQ+\ríˆRø£¬\j¹¬ë·/x>Ç×6£¡¾ìÁ§Ñ=Mæ˜V þ¶JÎóë Þe-‡2øÛËó焟ŽA™ãk?TžÿíÏ¡.ð¤“É$ý~VG¹¬á´ûyý—ë”öõº¼}ŽãAÏ—|Ër[‘DVÓxF¥¶øºgÈ yÙzÚ)Ï?×’-è*,Û‘?­ºÉ§^ÝôÆoiOßõ£O#+þ[‚âÚµg¨š]=†•×zÿZ†Ð7ºÛü§‹Ï%KäeãiRê׫,ÙG»s•íO³nò©e³Þ?kKúù4îÆx¦¡^¾N´— øw1t=³ÐóéÆ39õ¢lÖ›¿ånÇõQOÚº‰2ìKÚü¼-CVí3×@^ß3ø—ÄïngJ–ÈËÖÓNi®ˆd«µ¶(ÛžfÝäS/Êf½ù[Æm?úœ69}&Âíßá‘8nöbž¢‡êj_ûâv“ÀÔ$(ÂÓ{ÈV¶Juðïò.µ\Ö•ê?-îi´u\f~fÊ´öYŸ6ÈbÊ£ãÓöG ¯ÌúFâ?­«-Y¢KÖkP¸ ìaÆe”}È€ºÉ§^”ÍzËÐðOkm÷ê44H©_O˜ÏàÝÊóöN ` ö̓Úx²D^6žvŠ÷.YCO#dÙD2b®ÄG#”lÖ[Íê°¦Ú t±]‘2mø1ôÌ9õ™½ž‰Á^Ê äïîy1WâO› C–èÒДӆŸ=mbˆ²OMQ7ùÔ‹²Yo~—Q¬÷´ç‰ç}fÊå–ä¨>=ÚÕéèäïîY´ÍÄï64…,Ñ©”Ã?¯d‡M"Q¶#<ͺɧ^”Ízó·<àipíiïšÐI±^w¹ZAÙžNùL¦r äõ=”;ño[º…,ÊÆÓ¤LŸ”)û gÊPÙ@xu‹OM)›õÖ0Ümš±¡nVä4³âÍâîÕ‡»aCáÑšƒ'ùO;K–ÈËÖÓN)ö¦C¶Ø7²‹¾yÔM>õ¢lÖ¿å±nêHÆ ±°|`€À&ZÆÉc1ÁkfïC†‡qøé½”q„å…qº‡NåÞôûYÍ©ß5þ§×¸öË*]*‹àõ×>mj‚bµ?+—3i]Ÿñêéÿä>à‘ A(¾å9WO¥†îª“\©grYWÏÒä™–[óõÊg¦<Åš¥9mJ7dãp¹mÊ'ò!¬–¯}¿V3$+´VG¢ÀŠ•ì³f9WÙŽ`Ó²nò©-à¬7?Å50’Ý6}&ÊéÆ|½Ÿ4mPzÞÌu~íüÅ]—­¡‚Ùj+dP¶žvÊt§emQ6ž>b ŸKSÊf½e=É3ß´çq¢ ³eÍ|1/σÓÞM›@0_0µˆÿ¼­¹d‰¼l=í7SC¶ú¤ª²Éìê‰O½(›õ^+!sÖ´"RPª­1l5b“æS‚½ÂÇÆ:im3‚bö¹• ¨„?‰”z»c‹²{_Q6VBgâC/Èîzã·<«¢gcË'¬ŸÖÿ<þØ1·OØeèoŸŽnë“Àµø„±FÂeËŠÖäY¤ÿíE¢:ð d’ŠlLí0~«Í\埙ҭ9ZkÉñ˜è£z«ü•>½¬$þ´3d‰¼l=픊6EÙjói”íO³nò©e³ÞlLÏbè±nÓxKÆÍg5öHpD½Šõ¹4Þ^Õº¥¸Í£Áoƒ`ã&å0¢²Ô5Þ²NpC=“˺êS _«˜ˆ¦µ(7ºÙáëÝ·£;^×LüË×:’%šR-(—5} ÿ¶Êvô¢$>õ¢lÖ[ãmóå¼mÞ™d‰ù¼ƒ2¼§JÖ}ÌQvø £nò©e³ÞkÉã3“o¡}î.4|¾iXhT_˜iÉs&~÷ÁP²Š1¤³©%ûŒ:}FÙ@ߨÉL|êEÙ¬·~Ë3“>_} ì>3åðÁðY½X'|Ö‰­ùʦ²¤Úk ~sçºd‰†¼AéXQ¶iÕTáiÖ ¾ôêZG-½ÙÆžÆa{º¥Û€ð™)îy3tÙ(z˜#Õ¶ÙÎ@ÞSäX|óê]!+äeÃt"¥ùÔ.YÌK*;楨›|êEÙ¬·ú¾;"màœêû¤ 4'w[¶ú¼i œ-úçíŸ\üÛ–g!Käeëé‰Áó>–lóBU¶#=ñ©e³Þ«ï›ÿ¨»è3Snw->È|@¶ó{xo<}£ev$þáî.ÉyÙ1Rt·_[[²§½‡(ûÔ{ŠºÉ§^”Ízë·Ü°ô¦ÍúŸ™r›1S§o ÛÀoFݬNòúfóÆ%~‡IY"/O“rÙ,)Ù=EeáiÔM¾ô‚즷~ËÚiÓég¦\¾•öŒ¢,ïšnµžðî¦ôqþ-]]–èÔä”Ãÿ‘ìÀë`Ù#ú¢ê&ŸzQ6ëÍßòXBçpäAW­(>PÔÇÒëÖÕ|Hñn–Tw_„øÝ}’%ò²õ´S.tsÈÖÓ=g,O£nñ©e³ÞËëÜ›íêËl!Á7íÍü´Êçý˜a‚½My¸çâ6kü’a¶^y“ë>S²Ôf ë7Ô+÷®«¬.ŸmžoUù%H€GñÏPsbæ>«yï`5{âv{o’8bσLÚ”ó}c•檓\hC¹¤krh6ï)iv'…³ûór¼ÏbvŸ4»Û0%~wÇ·d¥ÙÝ)—fw—=5»{ÙgžÝïsñ©×¥Ù}éÍO1bf(f‘ Tÿ”ÓƒB| {”˜§9‰0¢œXÞ’ï±(!KTÂeHŠÙ¸GÈš]Û¢l <ºÅ‡^’Ízk•‹ æ§V¹¤Ü6„›£ýÄK9IpÒJt$> ÉyÙ±€Åð}‡¬Í g” ¤ €3ñ©e³Þú-î3jOëëÚÌ  ÒÙDý ›g ­ÁÄŸ¾}!Y"/OƒrÀd¢ì³²ñ8” ¤÷t%>ô’lÖ›«Üa–ñœö>¾íÙ.a57êc.Ø¡þæ’toÚHNü=å !ö92Óg”‡¿ý9¯‹<虤ŸæŠõcGäY¢ Œ‹‹Ø§_n^0žûÆyð/¬t)KäeãiRš{È%Û¾Ö²ÊvôšÌħ^”Íz«%ùÖ’’%1‡‰‚QM²ÍÃkT¶#Y#ñ©e³ÞZ¡u^f6~&Â4O¤; ™¬TŠÀ7.¤î.îÓñà}¿Z€k…!pz8åNÛQ©gÄ ±NrÕyî¶ëú³Nr?ŸÆîâ½>Ðm>7ÛíÓ¶Øá¬' ¨Û–ެÁKN ÌxÔè‹”;ИQê u’ m(—tÕ6ñm“ôcdlá$T_= ˜§Mˆm~–ˆ]m±YEâ6k¶’(2ýH8nì(»ÜóµæT©ÚQÁ…6”˺j°A¸ØåþÜÏb£š…QxÞlC¯`Ù´©èz/~swe’ÓK8n(û,#m dÙ@š¬nò¥d7½×$P§¶y?3ÅãAÝUÝýà*{ó%Š&’ø\²DiS9(å ÙÃ=,*HmêNüдœ/½×wy…­§îø,Õ§>_Üßöq´f/îÐ79·Yƒ¢ÁŒÑ„ËcÓ(w"फ़aвNp© ä²®k§âºÒ8$Â%+êÐhcFÔÈC‘Ys}qý €äb4Z„r‡ö°Yj HªÜP¯Ü»®ÚØöƒOyÊNA¦=ûÙÓl‘†=î&€WêéâÞöÙ%à¥êQ#øäE¹§Ø1 ” €G½Nq¡ å’® Á:bÃKfºÙæðÍ ÷‹Ú‰˜‰²DkãjQ,ˆO²ˆ TÙ+jPuWíªPÓr¼ôÖ’¿xTc+ŠJJõðï^àTpï¡­·Ï@ßè6;¿ûéÉ•|@Ç(¶¡ØC¶"Ú†e}£&WâC/Éf½RÔdÑlEô™)Ý·úŸFó nö =ˆöp§×WNßÒÿôŸ$Y¢ë/Qª{ó$[ü ¢Ê.2z£nò©e³ÞŠõIÒâKТ¸5`ãGEèæÄ³Ò u'~÷w+Y¢CcBP†É2<–ew´Q7ùÔ‹²Yo­¢»Ù#Í¢BÊæÔ=nã™”èûºi}&¾‡8…,ÑXQ ¤tEr¸l—Oî ¤UôL|êÕ§´ô^‹ÆÉžÅã>ÝQ}ù'­pkÏ@˜¥d+þmƒ~ÈÕ°ªD)Þé!ë±àSe…ƒ=ñ©e³Þü.÷aÆI·E.\Aé6ïzìCæÀ³Ez wϘ&þ´÷²D^6ž&¥º[[²nëEÙaOFÝäS/Êf½¡ìÇpí) ^”Û#Ù÷›Õбm3aWÛjâ7?}@Y¡Qð¢\Úxêø Ü“°úCÝäK/Ènzÿ´k¤‰ƒ ~)+”Nk¸ÀO‹¨ì‰ + md_sñ;üÇ”BÙÚÈ>Þy…lƒÇei#[KciJÙ¬·¬ôéSçÓù·EXøŠÝc–Nl…R}sñ}޲B^6ž&¥¹y"Ùêq*»Æ9ÕM>õ‚ì¦÷š+,6bFtÊáã]q£ÃÐÄüx¬uàt ù§ŸÂ‘,ÑXá’¤t€%ë‡b£ìuüVu“O½(›õ–Õåx<’’¿´n&˜÷ô#<ÐÏ×_D°Œnßß"¿ùjN²@,ó)Ó=·õ¸Ì¢²‰ä€®‰OM)›õÖoñBÛ™ ÷xPnÄgysp³Ô>÷í°N¿£©Q6Ü㢸ɲ áu,»…‡\uƒ/½ »é½FÞ‹¿vÆÈ{ñËi7æ,m>:ö@y[âûŽŽd…b/(¬¡r¨l"¼cñ¥d7½S±Øõ*7mP‚¿;œ°ŠDÑ_ßOÒ„,Q]G'I)èmwôÅ@Ñ_Ÿz•è=Ç*KÜ#ü°µÎg¦ yÆ0Ù±ÍlGç!<Ñïâ#ú]²D^6ž&ex‹”l÷©²{¬‹U7ùÔ‹²YoY·‚xÂ$e ¼1êßn!ö‚á ²W„ “ßNl²BŠ”ÓTU¨²U¨²ÏeA²nð¥×)…–Þ²ºŠŸXxVhƒmL”¦£Û¦Öí®#`y6–à%ªŠÕJñ uÊÎǾQ6žFÝâS/Êf½Õ_<¥Œí²)aƒ(‚ä/¬Ùü©!;P㬪Eõζø·/($Kt®ƒ”à $;0¬³ìa ª›|êEÙ¬÷Z _ˆx8ïX ;åÖúÔÞÝðqÊÚH¤µmKüá{•’%ò²ñ4)—ÂMúš­ÓYvqLu‹O½(›õæoyìS[…˜“‰s¥(Íç׳ûk8°Ày º3×÷˜~Gâcí Y¢*?hPŠÍSÖN×(O£nñ©e³Þtw>‚ñž"øIòén%Ï3áÆp·Nw+\Ÿ´$Gp)ÒSÔ‘œG«Tþ(ë—Ú@.목ÞOlÚ„vÊY„3œ¶´9Üбèkð´"Ó¢ûš]|wu…¬#–­§'Üs×)YºgÙDxÚë>5¥lÖ{m…œ~´œ=D„ ‡´‡°œ7¬d?] çu=ƒë†’ä.õ N¹;am£Ô3ŒmÖI.´¡\ÒuF™˜h¯§Q&†ƒé¤ Sç½a¤ŸîzÿösÉëP)žz d‡÷(•=¢Ç©nò©e³ÞÚ¸œ>~<Íb2ìH”æÛªv˜·»a`×óÒŽä±øÖ”ò²ñ4)E9rd†°j*»(¤;ê&ŸzAvÓ[]¤»õ\ÝMÿ™()ZØÌoG6ÞYÜy yHÏÄ?Ý¢•,ÊÆÓ¤L7;)ksN‹²¢C%>5¥lÖ[3bA Í©íÂD¹‘$ÀÂn,ûQ Ǭ¼žøžó#d©Õˆâ4!;`p³ì¡}è{È ¿®%›õ–+ëÑ´Ío5î„!Ùàà'<|hÿÄ)tÊ5m6¥Ê9ÙÛWÙ%Žªnò©e³Þ Ók6bÎÝ…dü(~jpúî©GÆ x{.~¹©ìÛyª›|êEÙ¬÷Š sì+º>(ÃGÅŠ8Æz`!¥Ð7.ûsñ‘ðH²D="uEi>JI¶b¡Î²ëZȳnò©e³Þ2qvxFPRPdXðý C¶?8°/2#0ÉÚ¨M½â7Ÿz%K±IAéØ$¤¬ÇEÙžuƒ/½ »é½~K…÷ÿX¿…û2f{8Ë;°“„úªû;Ä÷Ý É µ•|ƒ”ªÈ÷&äÝVÙe*fÝàK/žÎzkñËïØ‘Ds£ø’ÓÑ|¼ï±x‚vѪ.ÄØ•±d)e‹( ¿œ²\/°ìÕM>õ¢lÖ;9‹NïQt®¥Ë•eQÿµ#¬°ºH΢–øÝ½Ð’%jr®¥*¬°aÀ8Ç*»¬GÖ]ä&»ÎÝô–³høx݇N¢ÅÅ-íDºùÐßÌoé„ÕC¡âOŸY$K4t-(ÝH¶»Y¢²{˜-ª›|êEÙ¬·6á1äàØ÷g¦4dÖ:àD0í}Â!Ù"îκÿÂÊ”²D5ΕŠâÑò”u뼨l"<”žâS/Êf½—ãKá!g8¾”ÁàtCc IK%ÚÉ•ÕQ’=»¨ôI¢ —²Ç«ñPõEÖ-~ØÇó¥7Œn¤/ÀHðâGÔ±E2ÝÄZÛ'Óÿ"ÏSYFR˜ž·OÛÜ$qAy+Á êO:•{ÓOgM}“2-'áRJÕÉ:ž•C;òÑòæñ‚âzP•äÖÑò ”;äâ$t;òÑrÖI®ÔãÁèÐ5Â9žö”^8°^x½Ö /9£Îô¸Tòü€eð÷záÂöò £^®ý…×àI'“Iú…O¡äÔ)Ĩ½Ø¨E­ª§-ݨ!ÏÍ7Êà辰p¹%­PÞÒu'ʽé÷³î þ®ñïÿ®ñïÿ®ñïÿÏi|ù²¥1±×~5•Ÿžú¾•¤1x7Ì)Aü.·d\+–³.ð¤S¹7ý~Öwl«uÏ2Ö”J'(Ù ‡»¤.?-h^¹H^»+ñ/eƸ®…bÉ”êþLÉVl±ìñ$ª›|êEÙ¬·dð Zö6¥û"åFâãáë‘g±š–g@Z•Ä÷}„%šqÈJ”+-ÁK¿s%>Z ÍséEÙ¬÷ú-¶l´¿Å)7ÂIî¬zB>«ï$íFâ#±šd‰fÄŠr!¸²Å÷°U6~Ë™øÔ‹²YﵸôP’;Þ¢xÎÙרù â†J ,ÅDU\}Éž:!:ÖRôêk²õDØ%Ê®‘#Bu‹O½(›õÖRÍ}èúL„ÓñÈg-Ã"5:Or)ÅI<ëåÜÁó .pÄy?ü@®#ÓJí+Ñê$ÚP.éª-0?Œcn¦[¤œJÄgïx\J­w’wh&þðLÉyÙx:(e.Ùí3–=ÖöëJòGM]6ë[s£³U‰àÈÝ?8>¬W\U%GÐÕžDhÖ$$W­µ¨ÔªÆ¤:Á¥6˺þ¬sųŽny>&Æ Ø»WÆžím[ç_ÁóÔ4±Î?ò|ë|“‘ódÞIcÖ¥u~Ó|œõ[£¨onµp7ŠÂ$Ûð‰š‡iú¸6Év%þ‰3ÊžÚf›iÌ=ܱvKYâUv w£ê&ŸzQ6ë½ø ŒkãŠ~Úó@ >š7¼È~x¯(@D¦‹w¢d‰.íy¸${øi•}ÄiÕM>õ¢lÖ{EtžR‘K›”¦¤ŒÓd§ü„mš¦i´p·ç^²D5Njˆâ9ù%k1N=ÊÂÓ¨[|êEÙ¬÷J˜Ê9%½eúK÷D¶GÀd,w lmxÖôà_8çOY¢k‰!åT•Éañ\e+µ ë&ŸzQ6ë­Ù Þçæy„>3e¸ç¿áݵC]4m‰¸é$Y¢®8š à<£d‘§HeÇI£¨›|êEÙ¬÷ÊY^·|$À9zødD·éáÛ<É©zx𡸧}mÉ,§j<ñäà6e©Ë©Ê:É•z¼Š¢¾òuösç\w!‘‚­»QtÞÆšÍ¨Øc_G­Fîù s/e‰f„Ö‰‚^OÙ – ¤Å¾øÒ ²›Þêîîò6Q×-ˆ2±³zbpt/¾W íញ#Fœ²Dk¿@}’,ÎRªì3öîT÷)˰Ì%›õþY§m;4ð¼é;XŸ‰àƒµ9xóÉc³~7×L‡jýz.q›gE¢Àˆ1A(=äÜ®R#ë³ê7Ô+}×U[¹n´óŠ:Qü&8ŸVqÞ¸‚¡øÊ «Hσ_}Ĥ¬Ðt¢œÈ[EÙÓwÚUötª|éÙMï5‡[XÏáIŸ?3åV–([qØÉYžt ¤Y¹%>r‚I–(RL' cÎnÃè#ÊÒ>?4-ó¥· [9Ù¹ršV$L?öÑ=0çò̱—>¼ôfå‰ëË,É\‘¯“„Ó‹P7B°TߨÀ݃ m(—t]ùLN2 EÁnòD^õ†æé»eDhÃ7VnäßH KY¢µ- v“%‹f•½v¢U7ùÔ‹²Yo5+ß!³CU«:RNÈ 'ìL·$yR­ÄgfÈ õ¸dEOM²~ R”·$EÝàK/Ènz+ÒÉ—x§Ç }&‚gó®H}N,Ã| àï­xPq=UŒä®•¢„GÄ!çI¿Uê¡£@ª“\hC¹¤«z…ßs®¬Á$𨈎΅œjêÇâb9J9€”/x0UÇ=C®ùY–Ú"¡ë$ÚP.éºâÌ®;M$Àø)X¡Á,‚3)M0ŽÉ…M9‚e4Ñh]å*uM¬“\©çQnIWNÎHQ°&g`L´~õ½Â~ñ^òû•äùe€áe9ŸC`x¯ð £¼59£.LÎÒ©Ü›~ëÔÁ„Ý!‡Œ(Wœ>¡ƒSG tÆ®5à‰Sõ\²Dg8d…wK1Þ®«ì•’Bu“š–û¥·Ú¾'wöx@¦3=²û­Dö‰\2ù§¶°¯Å~8^²BWœ]sºHWm©lGߍɸ¡i©/½Óiüz‰>j ºðã€yõà§Eðƒ„‘X„`% ‚ŸÃëf©ëkÔ°±Ô£Q;öÕƒ½€‘}5"Ä%/U{%»kŒp/nóE åÒå0"xöÞºü2*uõcÖWÇŒèÿYWyŒ« {—çüLßq1·ÈѸ-ãNZyt{ îaAÅ’(ëž'œ8í¹Ó_;KÀ£^§¸®ä’®t”ù™Þä(†Ó+%™>¿'GÙ0Ë…<Ÿß)ƒ¿—£LQÉUë–·e)áL脈äc~·Ú&õÓ"ôáWÈ~fŠgBî–4ëùgø½Ü‹X"_RžÈ:øžä:d‰†B™ƒÒ­÷…¬ÇžGÙ‘÷0ê&ŸzQ6ë½â`*" ®;â`*68O gÌh£Z‹üCñ¦‘_Ðùn€§,QdM ¶,%‹`•]"O±ê&ŸzQ6ë½RM ìKÈEOŠÝžÜ|¨ÈMãÑJp£ 1àfßï Y ”§ƒRZÈÚæeáiÔ-~hê²Yoå;æÀ­õÏL5òÝ5_ñžH¦äõ8•/>.Ö’,Q‰Üñ¤4¬(k¹x[” „§Q·øÐK²Yo}¿üÊÿÑw Ê„)2“X±p0áݹÿ1øÞ!C6PD‚‘‚[±)kžÔ;ÊúFM®cñ©e³Þ?ëhe/Å-š<Æ T÷F ĺpuÉðÈ/øv=€\ `’#X©Æ@8ÝcM9 í›*@ûB×âº6’KºÊ劤ŸÝƒ>3åÖE2ŸÌ}­]ɪt5Ì=0á“?ânѲЊ[Å$Û‘:‰e÷ºÄºÅ¯º-Ôe³ÞŠt‹Dtƒ¿eF²ºŽ¥ "`±p¼ÉÅ{&~Svç^JµœG’¬g䊲[‰RÝàK/Ènzã·ØY¦ÛoÁð|z·¿ÞO„ å¦þ¶znß/!ÏÇÊøß(ÏŸ.eÏÛ‡òð÷7Ô{ ‡N&“ô“ßâÐÖëÉ+EAnz,YÓðè˾…‰Xlò§ÿ’%š±/ œ)Ûqzƒee/‡ø‡6‘¯úÒ[CjCÆÜ#²]‰r"cUGËÄy°1Ðrãà M9-ñ7˜%Kt¬lW¤à<˜d;²]±ì¾²]±nò©×P¦¬¥·väpeìŒk½‚p#@7¿Yv™®›ßt­W÷=Ir‡o]R.@YÛl§ß5Ëm¶ÛÚ Ðuó›ÆŒ®›ßœ m(—tŽpcã€Æ Ýf+»rG qaÜ@|q}:•A“(Bå]Œ.ç‰ÆTjÕÙÕ .µ\Öu%t¶Ø^ãD€(\ýÞJ­Ýa‹{€¬â{ ‹d…Öm¢¢`å,Ù¢@6/»Ä‰Õ͵4õâª;ëý³NÎf[ئÞÕ´ófUl¾yyv8Ö ¤¾6߇,QÊCGJõ-ÉX½,»äØ ’øÔ‹²Yoü–Q0\ÝUî x{Å÷Í-óõQäÉ›ˆ¬¾QqùÕRV¨Ê½?Ѳ~Æ&ÊŽ38Q7ùÔ ²›Þ?kKúýíÿ/íÇÅ·/ü\Yƒõ“Úpnõ@R½“m‚¯ÿDüù΢QöÒÉ4%î¥áÜ*e›ŸüTÙ-²tªnò©e³Þ+Ä„f»ÿEqËÊ"@:.Oi0Ѭ,ÈXZPvh¡!Z”Ëãø%{z,ƒÊ>ã€ê&¿j á²YoNθ•­¸—ñsª‡ÀÞ7r{*Ë»52]>Óh Âí[r%¼™"L[DR®øi£;¢ånÀ:É¥z˺®C qØw‰SÔÊ:ʵúaÚüuÜB~õ+œ$K„²ák J©![¦fÌ@ߍɸ¡i©/½e~ûi s„èQ®¸@ 'Lä+ ê3ñýÄRÈËX'Ås†,Óë³ì‡.U7ùÔ‹²Yo™¬î^½tÌ'(nÖŽ€¿á#˜ÑX}£…{'>%KtE€˜(Œ˜§,öUö±ûª›|êEÙ¬·ܤµžW˜HcQnÜ‹í—ÎâR”fþ $ÿ„GÙ…˜î!(îŸ Y$ÈVÙ-–°ª›|êEÙ¬·œ'î]+Ê_”Š%ó…uÅ"x"éKE°]vO›>$(2»ˆÂ›°);=ߊʞ[f—+ñO]šÛŽ—ÞÚ•èönÒv. <È“"(-™ô‘Ã+í„q×£ñ$‰à€ Ç¡¥®íÜš"0—zåÞuU³:pINî¢x²'¿Ö¼ù9=¿΃•ˆôéGâ{f÷%êqäuQÊX²~ò ÊŽƒ Q7ù¡©Ëf½¹©³¹ å7á0ùéÄçk¸ÜÀ7B|€×OIŽ Vƒ"¸&97ÀTj¬U'¸ÔrY×åø0×bƒ?wŠ_–볩Gud† ¤‘·'þðsÊR¤Ÿ(§Þ!{Ý:ä:iä=ŸzQ6ë­ð2·!ëÙåÄ Šç½ò«‘/¿n¼’9ÆŸ†‹É÷w²D]Nœ 4]÷ÌKï¹Ê®+ê”u“O½Zdïí«ì?p1l‘£GVQ<Á½¡ëÞü-°˜g"¾o5‡,Q¬þ¢„?æ€ÃÛ=;,»êÆÞ¨›|êÕtOÓÒ{Í"N]C-J‡­Š;24qóâHø\|»¹±†¬PÖÅÃ|BÖVDÙqô"ê&ŸzQ6ë-—ÈᯰݺÁR”^”ƒÅ_82!µËí ¸-¦ïˆÝjÉ¡l=}áþ¬ë Yû§GÙ@Úok‰OM)›õÖ>’§l¶H)Ý£&ŠŸ¸h;w#7 •@Úë¹?<’£,4â5QpÚF²ž.Ê^9èT7ùÔ‹²Yo9KØ´çJ%”›‡.îöÒþ^I|X’ ©äI¹ž²H,¤²Ï¸ÑCu“O½(›õ–¥‚ƒWv´¶5‚r# ‘ ¶ö¶-Ž@°&ü€Ið=árÈRà²(Ø»‘lñ»•TvQôuÔM>õ¢lÖ[± ]!Ä “g®¡dÆ÷@þî,&#ñÝŠY¢»´¢tu•lC”2Ën±K«ºÉ§^”Íz«ñPm‹d/¢t\¦uâÄÖ@2\¤]á3ñ1­Iö–4’½R‘ì…²É^XvYÉ^Ne ¸Ï¥e³Þú.¾¶¹•«GQ¦¯ Ù·´#@Ý›¼>Kнø³Â.(zŒ3¹.ìXë(”EHºÊ^!ëª[üд”—Þ nD4ð¡ØAñpjCŒ¯¸kò6}!nY|Y¢Åå¼=eOµVÙg„b«nñ¡—d³Þú-X¹`]ñ¹SnDJVÞÇzë¦Y"Ô‡Uù<°EÙ…´i(ŠGQHv"ÿ$ËBÙS×a;ŸzQ6ë­6Á2µªï“2|3éò“8†&:í(úgâÔ‘,Qw·(8>"Y?eÇ¡¨›|êEÙ¬·æJ\ãgË&½Åï@õT5Ýs¾Ø½‚ÏPŸßê þ…Œ5”šZ7Åo¤”ì{Yö±îdÝâS/ÈnzË!IOâiµfÊ…›îbÞ¤?-äbôÛÓÉŸòDŽ¹Ð©ý ¸ d±—®²ÉÙYçâ‡OÔe³ÞkÞï¸kæ^÷§vÜNc[AãÐ}U¶O:|“‹(ÆÍÄ¿`ùRekÞ'¥ô]q;w Íû%ñCÓÒ_z+žµûîq»"fQnÜkv#‹ÍPÏŠ{òúìZ¤Ä?}÷Y²âZARNg‘ìá®1•}èÌRÔM>õ¢lÖ;}ÌguÙcœï ÞVÅ¥/o²Òw¹ÿž!e/í ÖeØ3l÷’Åqj•½Ž[«nò‡æY}¥s•ýÍu§.»ÿÌ”S“ Rݸ.ÐÎóÂìç)´‚?<°K²D^6ž&§å$‹” *{Dœê&ŸzQ6ë­¾#€ýÐeAAª)sË^p"nyB;ÀDñqX‘²BG\¢$ÊÐ}^ZÙµUvGª|éÙMoyÀ}ï7§ÁipʺEƳ½nipŠïNŠÛÓa‚å ‚§³]÷u¿LFu’+õʽëá¸åŽ[R8îLá¸×+÷Lá¸=…ãöW8nOá¸g ǽ^á¸3…ã–ŽûÒØÂ“gÞ|7ÙÔôJ›gâH/¼õ•ˆÈ|uq\`½ð øM6}¥R©ë…³Nr¥^¹w]×1· .õ[ÞlRnxív·"¶Î€ä+h‰!…²—"RîO“RFÈZzŒeáiÔ-~hê²Yïµcròì;&Nq«ÅÄᔓ˵@òÄÕ¹ø^²D-²Úˆ‚ËÐ$[”nŽ)ý´–VÝäS/Êf½ú6ü$ìUÂ, .+´ó}Ííó§ K X±'Œkò}û,d‰ÊÊ€”ÒCöô<å*O£nñCÓÒ_zËo7ãAîd‰âé 8ý23Ó?榢Ÿlü Ê •t…”¡ÌÈùÈŸw øíX7ùÔ ²›Þòuy6ÏÎ6& Öß y6˜l­É¦t —ˆŠ€IÉ­µ»(XK[Ñ*»­ëòX7ùÔ‹²YoÙV&¤Gƒ}&JE2œê»_~×2l' \ÂLæ[!Á¿ÜÖ“,P‰Ð³ x€§d ’á°ìÑgª[|jJÙ¬77®ývæ5 ǬWΘ×Üg=OË+®û$f=|ö‚\Ìk÷ùšõŠ¡Ü#–åœÇü÷ž+ü3|•2™ß—3ó@¾Å)—Ãd~p™žr§VŽ"x rÉy¢ •y„T'¸ÔrYו7°ún|[y,P‘©ïéq÷@~?õ€½W?#®»ž$ÐW4šoš\EâM”Z#Cë$Ú4¥ó ]sìÌ9”„سO#žåùÿ¥DüøÛ*A yCü=”„ØóÉPÆÓɰ¼¦42¬ <虤ßv{@õ0æt{@uO73ùדISîKkqq?å¼Ô¥¸íaŽryïKwq© ä²®ëqÁ¡Ù¾Ž;ÅoìôˆêÃÇ`3ù‹_D°ˆž#þD½”%ªq^A”‚L½<¥‹Ê¾"ã‹êŸzQ6ë­ÙàÒí%'g6Q<‚Ä–~Ý6“†Þ¾)„Ù§èúUOHZ|½IY¡ue))6îE‰ÊÒ>I;zQvÓ{¹ïHÁ4trôÖ­›æji™íwô‚ôOG¿fzsñ›îïtÙ¦ëbâ)HÝ(Y?e§sP¬|éÅ´Yï•y¹"³W•Wš,|ä§nN]’;ÁZƒ™F>Í4Ê Eò†  e2wY\Á¢²#yCÔM>õ‚즷v>.o–Ê@;¤àÑ;`wZ4w ìNÜš4ÝQ„L1 ÔV¨)Ȉ!ÙŠ,»®¬›|êEÙ¬wÚ)ìjÈŸ™‚Ó û.v «Áyè{×øFe‰Š¢SDiHæGÙæ‘*H;…5ñ¡—d³ÞLåuíÙˆ‘–k¦{¼æž:À\ûq§HY‰ø÷Zª–•6€2H×5÷¤¬ ¼k-o³~jIn&øWÊG .0¸='¸9ìîë­Ð6p¿„øžoœ²¼l=픆ü”õƒÔQv[7X±n^"L½xYFÖ[A—~RÅN·(æ„ËÝ)‡çy¸ýZªzxz‰{Ýuø!?q=fRrg 'áÀ­¿ó´‰*õˆá¬\j¹¬ëÚj²Î1›²-¥Ã½QÛr~4ììÒVÓ\|¦¨¦¬P‹Ó+¢à2ÉVŸTv]›¬›|êÙMo ¶8Êy”åÖ$¥Â5 g÷Qá¶¼}}¤ÁöXüÕRV¨„[“”Ióuˆžei°½ŸVo:]zË8A®§qAaPîånU7¬ùA‹5Q•~q¢*HY¡GJE.~ÊÖ©›ßJ m´²ø—."sÙ¬÷Úf¶ïxŽ˜EÁÝ*—ßdÈ”°~<„´ytŒÅ÷ˆÈ%1 ŠâW†¬Û³QvX»Q7ùÔ‹²YoyÙ<{ö±&ßšo²O䇱˺ä:»×÷K$Ðc>#Á¯ã‘bYê fäBÊ%]Wä’g-¸ãöR.wøú†÷íþk¿ÝS±Áò;ü"ñOø~({Ê#É¢ø¡jÈž,cÙ@xu‹šºlÖ{Í"ÃÿŒYÄ)÷ºoØ¥¥ªì3®ê&ŸzQvÓ;¶6o±ÒPÇ]ì–šêÚ·•3Çòäðï¼ ~ÊhàÞîeoëžöÐ Û/'Îå·G\ÞÄ>FØj¥ àò(ð·[oËEžÇ:ROù\‰=]:eN[m³¼SKqÖt€LÒO¶8›Åe_á3S¦ÛhLƒf1÷\Ï’'óHüÃÀ”%º"ÎG”ëÁ®­çã^eqW˜ê&¿jk¹÷—Þjû3zñU”ác¤ºÀ¡$àw ´Ï¦qçwm‚º,Q_þè ØB²MIÀï@òG—ÄM]6ëý³æê2z¯ò‰Å“®öáéõz÷ËR,¹ÊôÍŸö¶|¿Ú2d‰"ëHPŠ9o$ÛÜŠUÙ@xu‹O½(›õŽͶv*æ-ü\¸zòÿЗ».w@âoïwÃVkäyPeðwQÌðéé™ c™Š–‡¿5.¯ñŽ17ýÂóí§N]â'‚'¾=aºE"5ø¾¯@r~û Wò2Ï!7±PtË  ¤’,n÷QÙ]a+ªÚ RÊ%7•ãU”ƒ´))hÕÔWÕ¶V äª]M7.ߨԳ¡R¶+wª®ñ"å¼aVAöÄ=N,ûŒÕ->ô’lÖ{ÝјôôŠK â;ÖÂ7‚é+̦6O÷Û¥ÅÇž’%ªaJ‹‚xiÊp;±l ÙS÷±øÔ«ÈìZz³?øa®ä冗ÃC}èåð%ÉËáïŠð•‹rbù‹#w–!¿û>r ¤]çšø¸\G²DGXœ¢à&É"C¨Ê^þÕM>õ¢lÖ{%Nð$­EPÅSŒ{:ƒ¢€˜†¤}D߸b‰ßÝÐ,Q‰8|R"#YÜ–¥²äY?ŸzQvÓ[k Ùnž—ä3S·¤0ršØ$PøÆ¿!ÓìÔxp6•­] §œ±€A¦D-Œi}U‚z¹ì®·l§®¬bºã\Þ\=”£Ìï¸>pgF‹;ÎÂÐÅ?•uK÷lv•­§™ýŠÑáïẢl <ºÅïÊ£å²Yï=j¢Ö¸ä\ êŒ\¨LڃȆš’ú òA|DEH–¨ÆUç¢øi~É–)€P6žFÝâS/Êf½Éå§Až¥K;‚pã@4®v;q¦øÀD}óZ¸óV” ÉAè»×UjxßU'¹Ð†rIו׼òBÝyÍ‚Ø'H?Èç:žúÆéÿ\|‹<ï!+´òg‹Ñã'ä®Uv×”u“O½‡žõ^yÍm$ÀFùg¦ø>z8V=m7£Dð¿Ò1K¾Ÿž Y¢#†.Qª ,ŽD¨ìÈCu“O½(›õ^n‚Æ^ËMИ㠫¿éà®ìbklñÍ ÞBVh t¢øÍ6’íL…²ûèX·øÔ ²›Þ)Ló¡¶,Ei:»W7ÃÓxw -äfâ­Fy.kOmYŠRp5d+òK³l -)KâS/Êf½5ÕcÓ7q|f âôŸ7imúDú¨·GáMw8öÈnÐK–¨E0½(8¸-YL¦*»Æ¯ºÉ§^”Íz«¿Ü~…¥ [M\Ódç#*¼B§Ÿ”*¼¾ÛwƒÏ‡”m‘Ö€F•(>þ†,f•½O©nð¥d7½×ö뉥ÚbûÕ)ROI¹Áêl MÇ­ŠâÓõ!Ù@^¶žvÊc”……¯²G\%£ºÉ§^.»ë-/ú‰4Æ~Xå3QìòSÆõ\¸]ó@ Q ø¼'Ž’k!$ ÔÖÑQp€Ÿ²íŠ ¥@ߨÉLüS —]6ë­ãþžè7÷Çö=ÿ¯ôûÝ"9îÖoºPÜ­wƯÛÛw+ãgÈÏÎRÓqÔI®Ô+÷®«vbxDwåt»®ä?½-îÀNøݽ3XòR¦º«.Y¢È9”ñ—²¶3ËŽœQ÷m=Æ’Ízë·]ysiwƒž®¸¶Æ3f(¶@a«'~‡ß›²DiÐuÝwN\Ö½ÇQöòS«nò©e³Þ?«÷ÍŽO-oäçN±Ï|Æ! †àÝ*@þ†N !Ÿ‡K(¨\ñ4½õZ²G»Xöš2UwÕѯã\²YïŸõíÿ®ñ?G²° LMÁAA>h[¶óš,ÛG m³÷Å7—Á Y¡S°(î Ù3nJ ¤Mù#ñ©×¥S‚KïŸõíÿ®ñïÿ®ñïÿI¹Ó›Ÿ¶y†ëɸ>â¤ÅcßíFÑÂu.Îaì‡áâåâ0ÜØÎa°Îu.®bʺJ}Oësù­…Ÿ‰ÐÝs‡›j._÷W\T õKkÁõës$ÐbÓ_YHÎW*µÄŽë$ÚP.é*¡‡2XÂ4ýáÆvž=XNÑæ)µøöür q/³–%0×. \.g¾ÏC¥àQ¯S\hC¹¤ë @oÌÍ¢›ëI¹â’yDÏ&ž(‚¿!5d…–@úœãNÑã\e¯;ØT7íR/ÈnzËíç‹-&TIÅóI !çQqa±§ù"‚³Ø£±‚d ’ ¤$¤ ? Ù1=ûË’“ûH|è%Ù¬7·÷kÅرܦb§ìMß®ìÕ=ÂD¾_Ý-üa«ä%ŠíÌ ø–$eÛíÛ•,›O{ÝÁ§^”Íz/¯ô`ÎÓ^éÁ\­¸eHÙYaWÉÏ\¿âj`îgÍHD)ŠG‡ì‰3(,ûŒ$*ª|éÙMoõžÔsß#åÂ<„©TöU$ö©+ð¯"ùøHÑ$Y¢sß#9æ$ ßÊ>b™¨ºÉ§^”Ízÿ´S½(ܵ«TRì¬Êå>ŸA7EqgQ$T[|Ï„,ÊÖÓNAòXÊ>òJ¬Hž¨‘øÔ²›Þ ¦÷Ûm´ÑÁQ<2˄ʼ>˜ß/<”¬PÕr,(~EÈâVY•œ¨|éÙMom3{÷iÞýÌ”Ã÷xŽ¥4“MœÃ=ãJ»†ÈWñqF²DËy"ŠG‡,öTöÚoPÝäS/Êf½WX›ÿåÿ™)8k~•æzE¶ûHû-ñ¨#Y¢u¦@ÞCAYl8©ìu¦@u7m¹^”Ízkä=Qˆ«ÌEÁõ¶'ó>ºZPщ¤½@±g—ø·[D’%+µdPÊ\²¸\ew„Q7ù¡©Ëf½—C¢b€m3žúŠ„>CîÍd@à4¸ÝñH~-Ê/SçBqò5(~„5dýtk”‡_£nò©e³ÞÛù×¢4.Äž$mIó¯MÇÊÖYÖ8ÿ üãG^OMÆ‘×G޼1Âqä£-d’~Ú‘9”6´èRù ¸‘vFöQ€g 횉ëM²ŠŽ¸‘Rtî@æeÛnfÙ@xu‹O½(›õÖŠÃ7Nµö™ ‰®}“õÂ]ÖæÉ> ¼®î¶¸ÝNÉÔ|΄ÒB® Ãue€bœ³Fà†z&—u]ù£®ø9CJ•õ]á-n8ÕUéS܉ï‰8C–¨(ûŸ(ºŒŠç('‹¢l <ºÅ‡^’Íz¯³¼ëŒ™PDaæ+ËQé'<A tSdáùú$ Ô#î;QÊY$œPÙ=¢¿U·ø¡©Ëf½ÓyZ€e7áV"öXˆVž ¤Ý¥žø§’0Œ²Ð AÅô†lÅ ËŽ«0¢nò›l³¼ôV~a¿=ùH€oÀŽÊÊ´œK%›‡F¸÷²%9€åS‚ù(¯K]>ÖI®Ôs¹¤«ìàæ¤ª‹¿DÀÑFKï~YB—üx”¸ž@r5Z{ÊržWO¥FÚ=Õ n¨WÎ]Wõ ¿àÖeN‰“¨N䮃¹TýÊ["˜<{"vß#ïhN%sŠšD”…¹¤²—9¥ºÉ§^Ýô^9ËnœGäÕ~A¹}^œ5Žƒ¯ôÝ@^ŸÅØ$þð¥§d‰fd›;´’Å­Ê>côPÝä%Ùíõ¥·LCnf\*J¤ðMðüNäõM¾‹tÕ{”H¥«lòðŒi–äÑÞÍëÒ€Pb^ÄG†AÉJ©|…‹RÆ’El¥Ê>cäUÝ䇦.›õV{µaäjáƒ#6—Ûa‚o.7Ãà.p PÜaCäZŒ $ .‡rÉP;/š”Žu’ m(—týY×áÖ±n„Ëê&!Qpô×Îz¾4³KóÀ*ëŽDԨſ" µ.tEzQ/DY$sRÙ+Ù“ê&ŸzQ6ëýÓ¾ývkýÁ:ƒÒ˜‚0ÁÚJ‚`  o4KZâãä¯d»’K ½‚Cß”µ”&+ÈO£nò¥WQˆ÷Ò[]×…›ÝÈ4A›á†=àËfºÁ¯ZÝø¿ùÁÉ]Šq ÎHçTö~GÕ ¾ô‚즷‚B*R¸Êk”‡«’ºž8†Ý16Ÿµv"ðZü÷ûž:>^›ÊÆÓ¤ [™d»'¿UÙ]QkQ7ùÔ‹²Yï•d‡“¡"VE™8P?5m+› µƒcñ-§é²BWD¬Š‘뜶yßóËÔ´ÝÊÒ‹1îYïµÞ³èâšvÈHáV×­ðµayW ˜ž¹Åo¾Ì¤¬P²iƒâÆ)eÝueºZ$êiZî—Þ2̧­ã…ÏLñÕŠeôí¯Ëx-ž=´rñ‘®‹²BGÄl‹2üXƒdqý…Ê^×c¨nð¥d7½µ`Âè1ï3SN„7ܰ‚\úXN·5²*(M|ä;,QŒ¯AÛ\²]yƒJ ‘5ñ©e³Þš‘ÿÏîWbÅöE<Ù®§½²}Oë)±ˆ0ky6Âàû䲘ÊP¶æO§x‹¤¬¥õ½‹Ê&’ }&>5¥lÖ[m —s5¿Sý3Sü¾cCì6‹º+Ð7¶È3ñá–‘,ÑŸˆâ÷µ‡ììt,ûXNÖMþ©Ó çùÒ[óKó/[=­Þg¦œÊ†sÁÈž<´H6ß‘øfÎSYzE¿ xÆÛuÿl”wGÝäS/Êf½y,ÐϪ¥cÀ8â繚yôÏ=œéXà±ò_>{ÅQÂ#çé lGüŽ•?˜å­c¨ <éTîM¿ŸÕ¶ò›µŸ|Ñ9(ŠŸ³„¹6ý[üÃëÝaŸ¦‡ø0K$KT5Ê¥à#e‹ûÀUv‰Ë¡U7ùÔ‹²YïŸõíÿ|_~`NI$öí³Ë“šMß%7SR[ ÓW†ä¹‰þ=eë{2fÊx#`y§FQÖå˜:¸LÖOQÓ]:Ó½fŸ™âcÅ5˜ŸhâÔ×]pÄéÔÕi–p$~so%e…ƺ¦‡œú’¬|QvSö£¨|éÙMï•L·0ÿŒdºN¹fèÂ$zKÎ@rñ‰BÉ+¤•”gS){à,Ë>"^u“O½(›õ^çݬ„yÇÅQ‹böÍÄvÒôU–ŽÿÒº·^‹?aŒ²”>_ä>¤ìDB+–=cݤºÅ§^”Íz¯Ý" µ”(Ú¢ åRHÐ;dj4i‹¢'>C=.mQ0ÕBÚ¢`j¦fd¾.@Ú-:ŸzQ6ë­6V´«"_‡(ðWÔ*%²:Ö@hîÆ ~GÌe{DOÕxúÂv/ÚpY˜{*{ù:T÷©]L¾\îp.½åÀô=[*)¸(8»8N Gìºó,n[îHß#ÏB–¨¯$,¤4$§lEr8–]#ÖEu“O½(›õ^«^<¨þ²(7ÎFX?_ÌüHëžøÈ *Ù@ê/¢ eíØ®çZbÒêáH|êEÙ¬÷ŠŸ0³ß¼‚JpNJ—³Ë/¢á +âÄGâ'ɵ•àœ”Š“Ý”-á ôšÜ‰O½(›õf)ßw=/ÙOÄÓ6mm«–T©žŠð·Ït¾3LžŸw¢Lçn÷é¦ û-c”ñ0–wÊZb]àAÈ$ý%q뎑›W]‰R•‰Íï ÁÍ ©fkò ãî&ñ‘3„²B»k”r„lñc†*è5™‹¿4-ÇKïµ9l·­ºEun G53áD¦¶! q´‹à åÐý©$à"tÊuÜćRû²P'¹'/ƒ­u×Uúð½€~Å-°‹rc´â@²_³sé^#ÝÛ/Ý}tbúœK6~…(¼(‘²ˆ²SÙ᪉ºÉ§^”Íz¯ƒÒ–3â±·-Ê‹¼±uú-Ržß*Û‘øÈ>'Y¢{Û‹RÆ’íîÔUÙ=N2ªnòCÓ2^zkíV×U×*„¦…pEÄí“g@ƒ÷D܋ۼ« #±~¡` ìrvE]S©Zj×Å…6EËîЕc’§[ë b¤©óP˜¾î²™,¥¶›6á’7× 3ü{¥¶›ë¾Ê }Ê[©íPxÒÉd’~+.Ûs‹zÀùg¦ÄøŠ„#<Ô^iS÷N|xZ¶¿ºÊÆÓ¤à>]Éò U0·®ySÝqØ~œ!»é­1©¬ó½Ÿ‰*¶Á.€mðL€­wq}S^rËñ[RSá,u°NrK:mœu•[ú|žqÓ®(—ï}žHSd¹<«Ï“#¿®Ë£}‚ïÉÄ$+¹ƒrøŠd=ýZ”}ÄVŽê_zAvÓ[®=¬JÅŸ(ÃUV— %‚CéßÅïȃKY¢5ô‹â‘![=¹ˆÊ®‘|Duƒ/½ »é­``Þ W´ÜšlK2´}O8sºIÖ"{œyðGâO¤ §,QÑRQkßwÈVϧ²kd’SÝâC/Éf½×Éô ç+îu2ýBÏž8î¶\C.Ú…ÚÊU ¯·ø§"ϹP 3~QÊ Y‹hQ6 呸¡i™/½9Øú‚# ¶À8lo3äVW¿=[&ðíÇA!ÿ£Ÿ¶‹] ƒå­Áui ž1Ø&ýäa8ô¥;΃2áz`ðôí©Ú¦·c"¸-ü„àûb:d‰®uK)Þ/CöÀ1–}Äí]ª›|êEÙ¬·PDµ1qˆ‚+#¯"c¨c 0iü¹Ÿ™(Ù4q\‘™ÀÉb­¤²×mª›|êEÙ¬·¬wª¸/\wÐåFÎD¿÷ª#²‚'>bZó{bßoRÙ@J´!J…mBÙ¢;f[ Y5=ñ©W•=´ô^K¼Æ~Ób‰GŠ"òüD²°(–x‰ïCIÈRÎ;RªïÈI¶úœÊŠ%^âC/Éf½—ÛÍ7hãžã T ¶sÜX$É‘VKNÉÅ=Ç¢4Èñ>4”šîCCäJ½rﺮ³UOï·»ƒŽ8Ze„ÓåUϧp»{Ì?˜;~-#¹ÍýRŽ`¬³Á ¸oJrͳزÔ»c¬“\hC¹¤«Ž‡¸»óðŽþ¹'®Ö)î(ef”â~Tx3<J\÷ÀJÎJÕ£—(ÞeUÜdñ„‹ÅÈ;Z¹šdÖ©£„\Òõgíº~³ût'Îäi[Q.7ào÷Šº?hú!ÞC!Sf‘ï—V‡,Ñ©0à À ’¬ß´ea©nò©×7ÒÏUö¾üÕßüÒ>þË¿Ø)¸ò‘ÿÿË_ÿÛ/~pä|ù¾È±ÿýÇòñŸ¾”ýåÿ´×O xþõ‹Ñ>?fñÔØ×é€ýøøÅŠïÿXñÏPõBí\IûèžMíóg¼(|-±þtö(î\Ÿ0=àa0# ü‹ÕßOÝ)>a®ú´õþ@ÝS·E€é?¾²Þ/a~à×ë*p{À¯¹^8Ì ä:Ü^òÈo0—`·¹—U`.éî£ÀüÀá©ÏâÀíWùE¦n? >Ð_¬üÛÖúv´]ÊæŸWîüŠ s f›¯vL¸}_ò®oàpk(~”q5‡ùy4S¼ G¹‚æFCT¸©èËRÑáV‚O¦«‡[ ¾,_%8|5“ëØšÉµ?pøØ¶š‰Ã\Es7zT¸)9s;"Ü”ô¥×RÒa~`z>ûxp+áÚÌ¿Ç1Ü»'Ë\Ýa~àtS<øz“óÜÞäÜK°`ˆô-_þ˜[§?æ»Ež{‹ÜGÛµ^¯h{ G[3þ„?Ð+kËc3a® žù-nÅW_«±8|uÛ£lÝö(û¬¹Û¾K™[c){[˜Û[ Üß;O„¹±í:‘cýĺÿÄá9¼Wý·‘©l= ðUŬ[³¾K¸æVÂ5ßã¨۸0¾›Fs—LØâúÒ@[Sq¯áj*·Æê—j¯Æêp›Ü\S€Ãí7´Í”|µÆ«n­ñÚ¤ù SƒÌ%ØöåúT„Û¸RÌ´]ãŠÃh,Óý·ylœ{kÆFëS;Ü^ÓØ¦ÀíKÜž&&¾„Ãí5yÉõš¾~dîQ€oæ®ÃÞ܆Y[£«Ã­5l –pû ¹gô%n:\Ùî#ܪðMùU…ÃüÀéI•âÀÜä}Ÿ"š¼£íE7 Á[/Úá«Û¶kë¶m/á±!¶/q½¿Ä¸·ÙpÓY~B‡Ûkj[ÇÜzÕ°uÕêU·Ú#PÖíp{`nÆ-àk9s‹tøšŒënýÖýgÚ>Rêú€Û~;×zÀá«Ñ÷{kô}ÿˆÄ]&…Ãm„¥Õ1Ð>®&ûh«¿lf0àö€_V±pøò”ÝP^CoÛÜ5€o;9YÚ€Û°Qòo$Lt\c¦7 ±l>)À¬Ãô¬D¡à62Û’ðf¨V6?àË>ÌÆà«5ß{k~9`¯;»½ÿ¹&p¿ç,w×úºýšéìkoãóº¶I0—`ùSÒ¸/$ÒÀ ô§ÿ‚~0Å'[àö ÷ÕVûnµ5öî>ÞÝÝC×R €[ [wkßu·ßš¾ÆÌ¾0­7zØêê·Jž@ Ó¶ù³^2ÐÖŽ¯m†Ü~âȾf†<¢ô·É¢¢×[zÍŽç¾æ=Äwà§)æö îMþ77ƒþÜͤßR°Û€ ¸µÿ{µ‡ù Y ÷J3/E碴¯š×‰€Û7¼¶Eà6žîùxd󌥹•p ŽmVܪ¸òŽ án1§©èõ#Çþ#ÇwS_ž·–¸¹ð 7çæz܆œ+oªn#ʹ 9€[kÞܦ„¯…A²Ô·qùØ ZÀ×°—}’ã½ânÓ“tܦ®c3‰_s[ÙÝu/ŸäÕ·]ÀíEÝ›pëUûà]¾¼Ç‘§Âm ÙéHøúeÿeí°`j0€[eÛæܺnÍß‚pŸ#¯mŽü~–Îpk²çæ´ܺÍÌ&-á¶¼ñ«&×òÆáÖmîm“ðµ’ÎNËöÓÒòæUàùžcʾ±UÞ[¸‚0^ÓñZÙ‚i[Ãý ­ñ›#|ß¶´·7pgý_öæ½Û›¯Åú¸ó/ | Àw6æw&íµ; ÞŽ2‹¯[ hû‘ûJº¼WÒ!pì/«ýº³Š„¯yÖíGž¯}ï^û½†¼Æfn¦o^YÀ­5mËp{ÑûVÄýÝV„íÞ[k~9ŸbÇ«Ë9Ü;ý½yØwŸ†¥H]l WwËKÀ×Bùªø-Ë{ôìU&|­bWù@¯Þ¼ zåíò½Ú>}|·¥…‹ÇW;h/oî÷ ®÷f®Î^ò㻸’ÍØ ÜšIÍ;¸„¯î’£_óSxdàå ºÙî;÷p5í²xîwKDzí<½§À{{ðm}çY¶½gY\÷¹Þd{ ¸C3|u¸Þ¶׿Û!Èfàf{ÞÛN2àö5mlÜhyÏŠðfÜ]·Ì™öÚ-ú§]ìã^±¿ÅöŽA`Äõ%ËkòeZÁxpû}[n¯iì¯i¼ÝàÈ*·t¸Þ: U[þPû¯@F´0¤Æë5ýV—Cf¯5l\?6.ýÖjɱˆ@[w-ÛÐ ¸u•c[-n/¸oýð5¦äÐTÀ­Š¶­ü·q±oÝðÕ ò¶Xo‹1‘I^ØíKä ‰×T¿óæìæøõ9ŽDyØ{Ë ƒÄRñz…޾m/n:l®Âü®Íùw½Íñ¶m.n¿¡n³ à¶r,Û ¸u׺Õw‡ÇÙè5‰ž/_ g+s÷Åà\oüÈû=7Ìm“–pû uwÜ}ÿ©¯}\¾^ã2OLnm鵇zn^ÀW§›{§›?Òóê–p3Èμ_@ø2fò¸ øZ=æ>YÞ}ò7 ‰±/HÆË”n™X®Îg´ý´V~ë–ÃôÏ@‘ô§³m¡ôŒâæú¿ô"êü‹ÕogNæ*ž0?PFBþ@6'yÀüo›Ž˜xfíš¾`zàô[ÄÊòÃs„<`þÅ9Ä7ܾÁ•a.áðmQ`~`ܹÂíGV?Q?Òá_ì3ÿ“²m™Ð×$ÜÞŸ'\ZïÏáVB7·É*Ááö@ɽ€0=#^| ,ÿÌØ×\ò€?ð‹Þ¯&âp&ŽÜ ·_à‘õ nMēݬ&â0Wa—–¬ß@¸ýH¿WvýH‡¹„ŽËÑUàÖ =Íßj…·Ne×óuzBi=˜0ãsýJ Ü—=ûdôeG/Ë®àþý`Òz„ù%ußW—˜8Ý‘¦¦'áèÕ–¯±µåkì´]ƒöÒà7Úb­~[ñzÅ·†Rl»q5‡Ûpµ·ÅãÝqAêM}«À×®w ô.óˆ¸}¤±)˜ë÷Ûy£~G±á ‡l¢:Ê?®ø=ŠúqŽ6Ýq£\èîpk¢HËMÔáþrÓtô§kOA¨çhûö຾½Ãmºm›z€¯¡6M§„¯±´§¹ pk^‡§Žæå0?pm4܆ۚ?áf•xB¶e•8Ì?ÓúeúL€?2§Ý¶H\oÁá«›¾uó±U·§]/ÚáöÀm y×·ß°w“ùî&Ÿ‘f„û=Ulh¬¿¾z¢­^Îô+·ŸymŸ ðeÀŽô±·ærnS7àkD>÷ùÜ¿…èJ#*à6"^Û¼øzÕç±½êskôç•UÚÚãáéA£=:|5Ø9¶;_*zÂ륢íãžyX"Ü샖{>až—ZVhÓÀ“». ¾Ì‡4uææ6înªífp{›Á–øÞª(¯¹­ånG¸5–±Ù8€¯/‘‡/À·1šÞà¿Súwö??Û6¦³éø2þÓ(Jø~ íìÃîÚ^í~¾ÉûÈf5ÐÖ÷ϳ}ßákm0²É×_ü™+ Öd[:Êìmýy¾—Ÿf³[£ò ýü®‰_ô䱉;üË­ ŠÅ×ÄËuôÚ[ú¶¤=àkæ;÷ÉõehMÏí²&W‡?0Šázòµìp¸}ý}U8ß«ÂßZxœyM”ÙÓ/‘ÛQ~½w~?@ÛðP¶1pëÃ3lGçp˜GО—´@Û’ã´°šµäp¸} š=H„¯uݱ¯ëŽW÷:ö|üØ öËÎMƒ¶hC–T|½ÅdÆþ ™f‚2ÖJâxùUüj¹ìB»ßm`\¹n3yÉk2¿Ø/èv#Dren£@Í{„Û÷ÖÉ·üˆÒzÀáö*wé8ü¡a®­nôÇ’šp›$‡_ⓤÃ\ÿíwX«~GïÅÞ^ÁùÒàØ€¹£Ï¼NÚZQˉðµ&NÓ<ᙋi$!|­ˆÿÑ-?wKè·<ú¶•˜3Ïó„ÛT{gw<áë»lÜ»-5Îìü Üt¸6[p{À“û¯¾»¼¢ü×ôi4%Ü~äØmêñöl̺ÍI€Û”Ñsc'Ü^Sß×ôýíÎëmÛûÜFÕ}c©½7–l¦<ö‰óíšÛšpkmónsëØ–ý€[Û&áVÂÖž_#û±»õ_“¯œæÖàp«¢oã àËüNÎ4Âmèó‹-ÖÐçð=ºggÚý^X´~¼_/ªÞÛ‹z}n»ð){ÛŽ×vmµ‹=’øÏ¶”6»7uZÀí%·m ðõ¡ï} õJ»O-U¸½ä½5¶ïZc¹ó&á gÞ¿!ÜMÑ–f(GÙR›¥<^–²_­› Àí x$ßz7C²XÔ2$neó]¾&áš;ìÛ”5§¶_†LöþÈ,ëi*V;p˜_ò™'I —­œ«„[K,[WÜÚÑ6¿n úÍ=O˜=O³@Ûìpçõ>áÖPëö7ç>žÌ÷x2JÞN%ükqÛØ¿Þûúfg_+àk~»÷ùíþ¡àÛ°X߀p7g{ZV:ÚZÑ‘J„¯á&[:€ÛGªÙ±Eø#ÆØÌk­¹7¾zsÝ{óË9Ø®m» ðÕ³÷prê¶«¸YÉ·´ˆûÊ·}7\ÌÍ¿Iø^wä©Óáö#ë¾ÝVßÛmgÛöÂ_u¶­±Î—àÌ»H„¯j$üÃÞv×ò˜x|:PóÚ…ð*ž>w·ò#òæä?÷è’ùŽ.ù¼ðOÊ~Vˆm½ g[„¯EX³P”¤àVŵ… n/êØ}ÙÇË—ýgN5¼î>꯯xŒ?¯x^¾Fä—=Å«ÈÚï½LÞïõ|f¼4;J¸ßq×4CøjhÙÉw¿[²îLŽžÔßëd^DœZâËïsíÑ×;šƒwæj<¼Þ11u „#̯ùÈî3 í-^›{ ðµËã!à>à¦Fx½÷S~s°è[\àÈŸ[ä<á6žö­¾– y¸|=·dureÿ#á«%o±Yçë讳h¨ííwãbIÅïר¹™ï\{×¶/Nø#Vñ¾§1Þ{¿5+Ž­ûôÔÀ¿Ú¿³z‹Ÿ†pWáðaÑÏ×ÙýP‡çýÕ¯³°Û³OOŒmØ}ïïÜ¢+n߯ïŸîØóL$¿â(ÛôÖ|º>ö²»ó·m§PìÚä”ý©p{8¶=€_Pí™äUŽz mô`1FTNÇö¾›GµLàwìùÿÕÛV\P‡òà9¶þ:\Ÿîù£Ìð¶QÌ3Êù£ž¡Æ°GEÙÁÆêú#d£6ôyÞ·]Â;ü>ÀÛûfd“óŸ÷m·8#µë¯~’¯ ¥ìþÕsÂØµÒ¢C<Í4´ ·??Ý\7‹ÑÛS³÷ÝüôÜáåÛû¾<‘–9"=¾Ý4lçMM¾Ûûæd>ûÍR‡aÛ{ö8AÛýðßkçûíÒ¶Û–áéÉ×lqeåw{ßÅÓbÚþÁ'’™¨>{ßvÂãɃœè^½#ëGÃ&ÿÛm¶ãnæÝq}ž÷mG›;B£=‘¢¥zŠ™®ßá;jÝ\~Ží}wß´À‡ç±aȱ½ïöÑŽöÐí}_~éQÆUDO1Þžº½ïç÷žü~}â\¾ã˜G5/ì7=Ù¡.Œ¾_Fñ{Õ¬˜ ìó¿3€‘¯ï®ÐOØÙÏô¼-ÃF*#lÔwtôWé3°—úÏã·~ÏÐïãïí³Š÷ñ´oü^¾¯ÎñBï³l|ß­±=ñ{Ô‰þ¯ïU9œê{V8Êã{?ã'¾?ÛCOGíÅlóVW{²¡~®öfÍïí±aŠöjÝõ±=#Ójï×ÉßÇþpù˜«¿Ø-Ñ-õ§sà}ª¿=ßç¸R<üÖ‰Õ_ñV>W­þ>ü^–>¦ñâù>þ=5žô¾7í¶i`GíÀx«ñª±}i<«9ÞU„¹ÅxXà¥ñÒâ´GOKC{æxk1ùÏ*¯Ðø^1^û¼½Æóyò÷p¼·lt5Íß·æ‹ks>ÑüÊùæô{Ö|dóUOóÕ_OÌgö£Ö|W4?b>´ñº§ùÒîji>íˆù¶{Rß57ÎOš¯›çV^óyƒ×$æûÊùOöÀ3_¡|Ú …ýIöDœioŽ·´GîÃÍ•»rö…1ó¼³î•ÃÔ±±É~+ì ¹¬dØHfaö“½õe[Ù©8+v—å´7›ì@\+íµgtò¯ÇÓÉ7ÚÒýø»tÉ_sÛo„íg·ðy߸…Ò‡[a Œ¨Õze_Mô Z‚Í÷±õKüþаq–o`ŒÝz=|!²9ëÕ^@· Áʆ¥s°áéÃÝèav[žC‚œh£áîƒX ëÆ C°££GÃÄI–eú%Y©aGC§!Xh8ªc ¢ê8ìèaª£©ãèÈaÊ0TÇ4œÕ±qrr‚—†a‚Å k`X5ðLZ2=Ãn¸.–2+¿¾ŠS\k`¼ÑÑÂì0db`½Ðä”!ƹhv1pß2 1°Ž¦¿f‚•3'ŽãàÄ!C° ýiâáö욘8ðiâ2¿ü‘&¶ëDû C»f11>aä‰×·¯‰õnhšxoN|2‹&z‚áÚa–¹OüU† ƒŠƒ‹a8<ýÁ o6°º< vÓ£aòôo2\úECˆ†ÍaIÃçé›aÄ#ìa8=C %Vö×Âðzª½³!hÝÊäe¸]4¤dØÙ¡Ðö± ¿ n¸/¿|ùwÿýÏúõmãë_ýñßÿÍ>¾Ù@ÛŸ‰.ÿßÙõ=]éãoÿîãþÊ%8þç°úÚ×—´Ï3Ÿÿ[ýÏÿG©ÿûÇßþý—õ·^ÍoKûÁÁ%ÝLºw¿XOÒ‡¤óÏÕL‚_ú׿Ĕ²þŸï]·ÅÖ¿ÿR½ÆóYsmP¶#‹áŠîXüÿB¾%çâ.¾·åÅ'üÑoúùAv<â™Ã6¦‘ IJóuOÿŸpñûq[ÿŸpñÿò­ºk­ùänlX^Òrcëž9^Òÿ`cû‘þö¾^x{µîz{fˆó㲡Äôø¯ÿê—¿þ‡ÔøŸª2ÕóÿNÉzCpA Z$4hi´†[fRQ~’&0<4r‹KŠ5cB¼yÁ`Œ ÓÃÀÙÇÄ\“‚Â!=5/µ˜¨øàõ £ endstream endobj 177 0 obj << /Type /ObjStm /N 100 /First 869 /Length 1467 /Filter /FlateDecode >> stream xÚíYMsÛ6½óWàXJ‹ÅWÇ“™ÄŽÛÚdœÌ4­'†¢¶²èJTÆý÷}KIJd‰±œŽ3ÉA°X,vß¾—² Vie‚SÉ© Œu˜>Ÿ¤Èc²JF±Æ—Sl½2IqðЬr†3 Ê9Æ–¨\Âwd4LD¯BòÊeO´*±Uò 6`N{VrªÑ².Ö™Ið3±f™”…º&˜e"E:ÂçXöNcýQŽI’ÃdÐ|Æß ¿ ‰šü„z{ØHžT?aFð9f  ÀBf‚œ‰ˆ(Š1 i ”‘Å$i‘`C1¢¢äd€ !•µZ¶' €±V–á71@f BbeÖ-§”;eaü¶Q ›Ä<Ã`€wmJ°¬ :I—DJ¬˜Äy’ÌIÜXfëà3ÒÆ6‰Ê’U„«Ø9‰ùõáF¡‡Nô"! U„“88É.Ð…S y¯œD=Ñcƒ|;¡­*$à˜ë9çœX@FçÆÀƒ(0, ¦õ;Iy þœóŽˆêu )a`1³@HoÄy畷𺠎ÌŨEü³YSœLËuQVó®.ªfZÍOÇõyÑ5ãQ]œ–Õ´ï§5t°¥¬*$¢58bÖÌŠ|Òv£ú¸˜âì¢BöÆãòZøa>9)§óÓq9ïŠö¤ÔU)öfgeUßä´ôºC¸¿¨·ú‰v[Çã‰f) Уýè f¡t „¤7+‹J:y^Ua ·úVzûòý_uuáËS¬¥´UõÑÒ%½ñƒTŸAiãÞEnâí껵6°ú(7.×_°ü¬»Ò“v¥ÉŸµãÑ&»ÏÏ»Ÿ_w@áž{Ÿí–±Ö~E˜¿Sä’¼†"üx(âÌÿLGßZ×AÃ:îE=ùåニ7êY–wé°^ÏšãLÔ»tç‹ÞBóp£ûXn䇾ËvÿÅ©ÅÄ\M𪠷kÝÝÒ ±ü¦ôЭûWRŸÞoªÏõ%øðìÃ÷;þ’'n ‡ÜãáPpCá{+ù•q(òfÑ ¢ÏâÏÅo¦ßRá†ý°»¨‡&‚|.çMzlc.ÿ3Ûº1€¢¶W½€Ç„¯&·Uch©1HúÁ¿¦ ý£)H«¿ä¥ÞïÖ†¶ºõ‡õ¥ÄdN endstream endobj 307 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 286 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_dendro.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 308 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 309 0 R/F3 310 0 R>> /ExtGState << >>/ColorSpace << /sRGB 311 0 R >>>> /Length 451 /Filter /FlateDecode >> stream xœ½SMoÛ0 ½ëWðhÊŠÔ‡¥c´lØf;´=¬iÒ5HR¬Þ°¿?ɪ CŒ =X©GRï‘$XÁ¾‹Oá;o?¿»„E-$J)!?ëŇୠü7w áA,÷ð^RƒÓhì¡·”uh ìêã{B7ZÙ5iB¥Óý`æï2@of6ý+`03€"Âê0˜9 td.›A£UûÚÕAœ_s´Ùt. ŽçYÿë·‰ïƒ2-v7›SW‚d+vœ„]h£Ÿ$™º„½Œ„:È©*ÿ½‘Ä®ß_´ªWùúéþåù¾*ï¾¶?Ú·”wB3ÐVµœÐžº$—÷(‰RÉM’L] ’%ù?ê²Òqˆƒhá‰qMž>Ö3¶LéÀ̓¶XuÍ)¾]Õ‹´eâ7CzC½ endstream endobj 313 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 287 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_dendro_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 314 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 315 0 R>> /ExtGState << >>/ColorSpace << /sRGB 316 0 R >>>> /Length 532 /Filter /FlateDecode >> stream xœ½UMoÛ0 ½ûWð˜ÆŠ”¬kƒv@€ ëb`‡¢(Öa š«ìïO²eEL‹¡F»ì€O¥¬` ?›³øõŸßÃjÓ(TJAýÞ¬>FÔµð»9¿7 Á:>Û†>4m@eÀl5ì`Œ´atî6‡ë„~ŠªeÒÉ—õÖïÐóž0†u@ã !‡5!í cXòGO„zÇ]îÑuÿLúë‡æè”cC»oÄéýnüCIÌ1z Ý \B·mNºAýEéıojÊoçç»ØÖ6çÓüúÌ]˜òç×gM19Ÿç×ךPù)¿Ô?Ç8ÏžÓ©ÆàG—¶ ·ð^7ç¬4†ø 6NGš³d†å)ÆDB…ÂڠΣv¨Â^#¡"¡BaГ(”…w|:.uL„êØ*Pzå„„„ ¥IýÑ Í5`Ó&£µç‹Ó»«ÇWK`‹û¯ý¯þR-/ [¿pV¨¶ö7=*zÿan„}ÑN­Ð(a§„ …Z‡–ÄPŠoÈZEB{ŠnQ{Q( ÇBã4ŠB*”Êõ'"­®äZD@…òæ£Ã*Ðq§i‡éZø~²Y]ιXتdôUWË?éRtMtZ¸&¡B©ºùDÄòxº+Ê›[¢)6ŠÀXTã?ÝݧÍ,G´N®ØÒü²KÄó endstream endobj 318 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 323 0 obj << /Length 652 /Filter /FlateDecode >> stream xÚ”[oÓ0Çßû)¬>9ÒâùšÄB‚mE€*¨öÂxpn[P—8ÙŸ;vXË H´Rrò÷¹ùç“`p 0x³Âÿ¸{ŀД%– Ž9(ºÕ·â‰ýÍæ¼´ÄáümG¸Ô«ö¿¬ÅKÒø ëëÝê|#H‘L1»Ú–fHp[š ”Jv%ø o°ÀÊ^H3‘Áí+ß·z4ÎLa¡z¯5eÕGT±©½’G6QL ²†©ŒWU1hìAõ·‹®ë§†cÕÇÑ—Ý;»ƒXÚ]sßiFWc.Àç¼}éíZ·e\¸Å;—¹àÕÕî‰,±( c$Ù‘¥ÏɆ¤ñAÖd‰%‹) #FùÙ> /ExtGState << >>/ColorSpace << /sRGB 328 0 R >>>> /Length 20741 /Filter /FlateDecode >> stream xœÝ½K¯-M6¿¿âaÀ%ß™5t·l$$ [òŒ¥V,Üþ¾+b­‘ûІná‘ß#"jeÆ©]••Ïúû_þ®¿ÿæ÷ùõoþaÿü.JÁ¿Fo×þïÿã÷ÿþû?ÿúç÷oÿÅ_üþú»_õe–ß÷¿ÿîKâ¿ü«¿GüWù¯»ÿ×_ÿî?ü.¿ÿã¯úû_¾ÿüͯêÓý«_ÿïSÿúý¡`ïvÿÝ럧þîOû³Ÿ÷?ãϪÿŠåÏÓÚïûߦâÿë÷úý åÏìù'”_ÅþÎï_£­?³‘üÛ_Eq¦MÊIç­Õ?ûä¤ó‚^ÚŸÕóÒ×§ÿÏuh»àì?½ðïÿ&Å«L\çù³GÈI^´^þÔ¼.è¥þY-. y_°ûŸ²ò· oZ)é뮞ú§ÏëÐ×]]íO«×]}Ý´áŠäMŒÖ?~8ÒvÁ¬fÞP÷_ô^Yòž¼/xÁ‘÷„ä}Û×üóäïFò¾«ýý)ó‡#y]0ʱ§H¼.(þßÿ¶÷å¿åâ5ØõóMþýûyþ”ç÷xþûDÏ÷©öÿïúÞ—÷†ÚO÷>t ¾Þ ñ¬¾7¯FcâR1Þ‡Ž¸qþ¬¡QA|aúwJСڋºÕüúõï•£l»Ûí»-Wýâ¼?°Ýª÷ïnï[6¶Sk‹úò«Ÿ?½§üz'6¨¶âjç”?«$ö½·3Çv WsnÊ©±·Þø[Zmö»·ú¾uÇÿ–àÄÎÉÿô?sŠúò«‡½!öJ,)[W“Sjb‹Ý‡»è>Å ”‡¦¥þÐ[¿K±Ÿ°žVø»Óýõxÿðº_jØF! ÷®ÙÃò÷¥‰%åcãêàÔžØ÷y{rl§p5ç¦<4uì­7þ–>Þ{󎷛ݰï›óêÓœzZ£žýRóÏ(¢¾üêe«bÈ—}±KÊÇÖÕäÔ’Øj?HŒíÔ5ñ¹)M{ëÍ¿eᬸ§ú2÷RÏĽy×´=]P>ß^ÚNùúsZbIùغÚ8û}ŸŸÀ¾T16¨/jbsK½„½õÖûâï_}‡íïKpžãÔ±ù¶}ø[{—¥!ÊŸé÷Ûì÷‡ò÷K=›Ô;¶®vΫöLìüSkŽíÔ5ñ¹!—^À~è¿¥®ÇŸÒõÎÞýo ζ§´î÷—ÍuþTüÜï’BÊ×—ó.ë!o¶¬–”«ƒcÿvþÙ-Çv WsnÈSSâ֛˻.¾ß÷ölû|ßœã/žm¹ºS6íK­G”Ï÷.$}¥¼Úç2°¤|l]íœåŠ»ì‹c;…«97äÒ Ø½ù·ôó§Ù¾obòÁ±¸û§¸¾¯éxuíïC”Ï÷nß@ò—za“jyµs†?NÂûŒÄØN}QŸ›rêì‡Þ|_ÞM‘ÝÐsþ ¼ûÁy߸wWeëÅrj-§ž&ÊŸéw0{œ$_¶`–”«ÉÙ¶OìþÓFŽí®æÜ”S/bo½õ¾tý}îºÞr¶ß—z¿ÆþØã9ì EÊïÝû0ûe”O[>KÊÇÖÕï„:u™Oȱú¢&¼ÌåÔ‹Ø[oþ.öYê¾ùݧÙOnÔƒ—úyïÆú><øžµ3±®R>±æKÊÇÖÕäØÊ$컀íÛ©/jâsSš:öÖ[ËùslI9û¾9í{Úû¸pשöß7‚òù^ŽŸ(¯úbV”«ƒóþGØw=·3Ç…¿sSžšöCo>cï}°Äm¼/â¼ÿ±·ùýÃ}<ßÊÚ /[”VYׇò®;=jPW§<}×ó9blPZïmnÉCÓòüÐËûô81|_Œmûê÷i,Ý ;/[3IØ\ï[ÑWH7/Àíë$ÃK1MáæŸ^cT'üRÎ )µîÖê?¾3¸ÔÃÕx¦­ÛTð]ËëºÕ|"é«Ó‰P_ WC8WP£†úšRjÜ­«VÞ‰¯äÑn88ÞµÒ¾°ïgûé±ý «ãöPò÷‘‰%u´¾8ïR#,ö”ÖiÿºSš:öÖ›o…m”›ïÅ'ß qüaÔZNíå—Ù^”?¹¶¢<)¶ù ,©®ýmpüøX?pÄØN}QŸ›rêEì­7—鯻­6“¿‹8Õ~ï6{zoa[Å6¦¤üÞ½œSSî{aEùظœw5;=°/Õž”_͹)§^Ä~èÍ¿¥;^Øï¨ÝprlGÛ§ËmÅx¿×}ùv ”Ï×—~k—o=Ž J»aq–ïh…]þ]ÐØ+vÚ›rêEì­7_÷wmÀ†sn¼îd,Û¼ÄjNl‡ßÛC‚ïð3Czü$H‰©›ÃÌ* û4ª\D|NH© p·®zÝ}r*_÷à¼ÿ±—PnsJu‹X±É?j”n®8ŶG¾ÊSclPZJüðA9õ"öÖ›¯{í×ÿ}s| ­uØ>ƒËk­~Þ¹V_ãìòeëe`IÅ_Ië‹lŒkpÌMy¿>>ŸzçØ¯Í–ùï›ÓýTðR‡KÄö-é8¢´ö€òiŸ´À’ò±uµsÞß­$‹ƒÆvꋚð(íò®c¶co½ù»L·‚µ2aN¾8 Ïî{h{œ:¶ðC)lR«æBîÂÀ’ò±q59÷2Â3aÄØNájÎ ¹ôöCoþ.¶â¾VX.ÎiX8ñÉxÿ~3þÚ' Öæ'SÉ;ŽÄ¥;-NóÓž°Õ^ÿÛ©X´Ÿ”S/bo½µæ¦ðØ'èûæ7åÔ‹Ø[o½ûÇ÷ÆfªzøîgsÝäš\|M5û(­²Ï 9mÜÄ&Uôñ&§Ø ¬}¼OŒ *ÖûžrêEì­·¿Û·2)¿oŽ+²³¦í`a3ê]ÔMKv€•ܵÀ’ò±u59~ê%Ö½1¶S_ÔÄç¦<4åi;õæßòT¼Õ|ߟ{´_êð—°ŸÛíô¤|¾jÉqô6(™ÉÄ)¾ükßÂcƒú¢&§¤œz{ë­­ñÆ.¶ØgéûæøÕíX]ìÑ5{F…íëã{ ÉßsKÊÇÖÕ ÆUÿhkÛÅcƒú¢&{¦z {ë­wß}põ}ü†¾ûä`¢—:S¦Dmf&õÅ]Bk)ïö%,©_ q ¤°PKcï0“inÊ©±·Þ¹‡¶ã~â}!Ç,›{…ãÔÁŽf QÚÃØK/ùô/˜° 0¶®&ÇžybßÅÞŽ J¹Í-yhêØ[ïü[ÞsSoÍnÁ÷ÍñƒÍ`Nâ6Ì`”ù@I»w­ ¹oÕKÊÇÖ~ŒœÖ뎞;\J17å¡ië?ôæšüníï{÷ ’âøvÛ(»7eûž¨¹?LòmüBûÇÆ>C_òäØJØá+¸Æ2ÇÄÜ”‡¦Ž½õÖ:6aÊj&ú¾9Ýï´-zÅ©…Å–ûÎ¥•É-è!ßXçˆÝZõ†V&rª¿6ÂV¿ÓO¸hš®æÜ”S/bo½µÛ¾,ìa»Ïï›3ݺÎU»#Û(?c8…=Óã åï‹BW‰aEùØ~urJOlÇ‹c;…±97å¡©co½µkæÐ·Õó˜8LšöMÚE&ÍýˆÂžiØÑ(äÃõ–Ô‰ÓUrÌŒM¬©UblPÚ½ÙÜ’‡¦müÐËáÍpÎ÷ãݾÛ>™=ó=¢¾ê>"ü[ÂÚùJcç÷â’ ßZŒe_áܤQ°K5§3¤ã>t•=Õ¿£OžXÈ€/æ¸k™®ûèuø|ù§XR·ï"Ï*dÀ¬@N"5*œRjÜ­«ÞŠåÛØ÷O’i[œãæéÎÎ:ýY¤ù¦ÎxrëLùñÓ¡°¤v˜¶“ÓNbÂa8ö Ó¶æ¦<4uì­w~E:½Š=¾"ΩúòØŠbnåáëú|Dé+BÏ¡Ë'öIU_¼S4v|±u´Í±/e›/Ž *¾ˆ=åÐKØ[ïtš6»EߟÛš‹òý Ìë›oßHÉ”n?ˆäÕ]†Ä&Ug\휊Ÿ€Ø"/‰]ô+ÆÜK/`?ôÖ3öhO÷|pŽ›~ÜÊf¤ÃZ:»(¬¥pKK^ý¨E¬¨­½spÜ6Øå®½Â5£¹!—^À~èÍßÅÜv°4ÒÝœ-¿¦Ù^Š>Ï÷W'g¨» CŽi…%µän ΄O”Øé»]=c7¬¹)§^ÄÞzãoyß+s¦½wˆ†#1š}w2°}ÅÞ®. ›ËNÔ5¤îfŽD•!CŒbßáŠmn4jÑÞGsBJm€»uÕÁ¤býóµíûæLßn˜aÀËåf¹ÓpvJ6{_j)ïX…‰íŠÝa¼ËÅ1³œ°Øákl§´²?;å¡i¯?ôÖFëÀqàïá÷Íiþ?qtŠSÏåqFøØæÄbްAùظ:8¥'–G@Ží6ZO|Êέié?ôæßÒ–í”=|†¯à`«ön4CS¶Sç“ ÞsÉÛ-–TÑâ ŽYVJ`Ͳ2clP¸sK½„½õV¤"+ì±å3&ÎãÿKÍãÔ´¸‰ê»PˆfðèÆ7·H KêèM Žoë; 17åÔ‹Ø[oúüðØç¶üûbø+ùvîy‰÷8PE>×ûŒ¼grŒzß"ƒÚ±íÇ_çÀ.ÛŒkè¥]¿&†”*9ðCá|O"ìô‰OŽmÍ^Ê}WÖzºf"‹»àÉñ'ÿö¢ø‰NWdÅÒàöžG†ôÊ}—æ¦üÄahÿÐ[ëW÷Øóäiý"§ËaHŸbtMQXc¦›%‡‡@XR>¶®&Çý*ÄV¹5×õáϤ<4må‡Þ2Ü7?CŽ®hÂà û]: ‘yu}w%³ˆòùæÁåÃ]Â’êámMŽ$……EEc·X!47å¡©co½¯(œúá‹„™áü1ïYûp™ í¤|ÚXRé?°pþhìtinÊ»œG޽õÖúåQF–Ø×¯àØæ­û–Á‚߃§QO…5fz¹äýØ dg¸yLX<Ÿ;Ÿ_ÍM9õ"öÖ›ëWõGò]#µ~‘Ñ}ýjˆë¾~uPAø"Ó×é@X[g”ƒ-´ɨ¾Wí‰×¨UÆJÍ )µîÖUv!øT›Æ¾oÌgöùÁ›[[cÌi*l73åG¡ÄŽ%åcãêàØ~KØfŸÔ»é“sSš:öÖ[!Ãm™vž¤ßœw“`atö‚ÒZc~…éï1(x–¿}’/칈…±u59™Nìö8A ꋚìòÐÔ±·Þ 1è8ÿ{lÒ÷ÍñH°ÆtŽí1cæØW 4?)¶&ÉgB—¤Zœi“ó>ô­O­€ÎMyhêØ[ï T[°eÐ^¿i,fGƒí7Ô¨§ˆòùßûHþÀHO¬¨©/wpü†ÖoqŒíìBœ›rêì‡Þú[hg*‘8 NõÈ|Y¥ªû—lß¾Da>DùÂI,©‰ɱS%±­²clP·ELòдÔz+¨{ÂJæA ߟ;U¸©FgÔóˆòùêFüågZbƒÒÛ%Îñpb—MhlP¸:Ük.§^ÄÞz+q`úʲ}uÿ¾9âÁýxÆ,»Ç¢/ª¨/¿ÚãÑB¾m“XRSçÌàxXJ`Ý'c‡Ï<榜z{ë~º‚ßyëØÎûë™çâ¥lß¾`z`ô…-Îc’cc$,(Œ-?9µöÝD›©ˆcƒ’ŸÎæ–<4­ý‡Þú¾<î x—ÇÂP©äعæ=ØÚ÷n§íý{)ó6ÂZãÙ!oî¡6¨¢«É™v ì°pŒí®æÜK/`?ôÖßâš.…VÉäØÎ¯9ÔîM›øBUQñ=;)ßúËw½©2âËê ¬›cì°ÇÜ”S/bo½õ·TØÚ[é¾/<“F=ðŒ{ŠƒýJ~É;¶ê”wlã‰í CŽ/yp<…ØÍ5ÆÞiYãÜ;NÜÔÔ±·Þù­8q;yq„½>š£»Ë‚”¾~}¥|ú»-lPÜN§¹ïKØfÛ‘Û)\͹)§^ÄÞzëwñT5_€~r*RgòàkÛP JOM™)ßzMKªèøuqlÇC,“8ö•”À¹%M{ë­ulûñÒ6CŠ7 gÉׯ§ÔýpÇ®s¥Ÿîñ£­äžXR3|ôâ`£%쀎côÓqnÊ©±·ÞiÖ³«zÔË÷ÍáF´ù«V¼hjS”Ž®»¦6Ñ[m§f¤²ˆ3Ä@ìÐA×Çú²ÆÜCáŠg$ö֛ϘÙG Åï>9ÇMœ ©ÆF™¯lwüê%½ˆqZ”xD‰…±uõƒ½°…Ókα'Æ…«1·äÔ”Ø[ï +öõ ×ääØM›Gk‰­¹óÑZ£5ÙâçZÈWQƒIiM몰Â{*î/æž $3°zscUø¡ŸsqNqjãN¾K½¥.+ŠŒI}ýèÞ¹ü(&ͱAÑÇœe»ÅÀNû±bì©øœ˜›rêEì­·Öä}[2¾?9¾®ì‰à[îÈ?»|ÏýÁžŠòÇ“˜„ ªåÕm|]%¶bÍåØ5×dÎM9õ"öÖ;½‘§«'¼‘{8s˜G>x[ ׯS:cçkÅ“òƒgžXR=v¾É±ˆda›Ÿ5v‹s¥æ¦<4uì­7ÿ–§ãÌ]ì³õ}s|óÖž ½vzšnÅ…Ó•?Ì!_~§…%UäÂÒ+˱/¯-ç–¼+EÕ±·Þ·é¸–®O¥žÇ`\Ë“Ÿö#þKâ2“CÓ0‘Aõ0S&ÇVXa}㢡›>“šÒÐñ~(œûc&iÑ-œ Ä£$ ;‘¾;V& kgÕkD/o§˜$aXQá–gû1XX³B¬Ô5aül_¡±zËÅâ nÁã4'Çn_óOR¯ØX4ÿ$‘‚Ä?‡!_(AlPuÇÕÎþJë‰ß1v$†ÇÜ”S/bo½ÃÚdHW,‹8Ãý£c_7‘’Ùa’Ÿ2»›•Ø÷…SéžOI,©ž™Á±¯°MéŒv×÷WsSš:öÖ[û°æ[á!¡ßŸ;H› ññ8>0íþü‚Â^ ÖOÉñÞ T8ÈY8o‹M³ÆžúËcnÊ©±·ÞÚ‡¿¡æIRÜgpv s=ÚXÔz.Ð'ån+ lP%“œŒcl'°íh ´±A}Q“µR½„½õ–IßÓYýÅ¿EœÇ­½/eF"û¸!#vNQ0»//$!ùò"Â’ò±u59Êï©øÜõ;öcnÊCSfã¤ÞûU±g,ûEŽÕñ°úÊÔ<‹ß°ÃñœDùp+ƒ°A•Œýš\¹f`·§ÎiìIzœ[ò¦ïŽco½ûå!äV§¤`{œŒåá^Ó‚±¢{y ¾øWßëQŠ}9qAÐL#†?FÂ{©4j‘Fs:CÚ8îCW57€®®Øµ‹³@¼~ÕÛ›(ÿé&r|… ŠlÁi¾¯¶ú®Dc×ðØjnÊ©±·ÞZ†l!Êæ$g#1Q Û³lñ+GÔmŦ‹°¤VÄ+$§ÄznQŒ=#^AsSš:öÖ›Ûû‚täÕUw"8—eßówÍ‚P¤| þþÈí¤¼!›ˆXR=6ìÉy¿ñõ œ»©îDÌMyhêØ[o½îÌ¡l±m§ûÖgC£6^ú¥W²´”7¼ÎÄ’ _ipP~BØŠ¸*–L¡Vš›rêEì­·Žß›³æœã«â|.†Ž…€PØ‚W¤›Q^ñ¹VÔV˜÷ű¿UX45ö €æ†<5mý‡Þ÷¹}¾/Î(ðÇ{4ŸQÌw°\'Pú_AÎäÍÂ¥´8"Xß.ÆØ±Œ¹¹¤^ŽýÔ›µºW?»j5š þêÆ0ìr×jpÏMVr(ã®ñ0îp 1Tsa–¨ÆÀQ³Vç„”ÚwëÊÊFÜE¨/†«ñ.A5j5 èÆ¥¾Å“g­ÃU«DÖj ÃÕÎÔ¨¡¾æ„t+,Äp·®q÷ÛÏ»ßòî÷+›yݩϼû5ïþ¼þly÷祆pºûãóî÷+ ZÚèî·wúñøR_ ¨Q®JXæoõëU)c5Uý0‰T¿©¶‡©Q¯J5Õ/W¥ iã¸]©þ°íð­>®Ü`Tpº»éRßLòñÛÀ7'‰P_ ¨A䨡¾æ„”Úwë* #uËFµÉ‹ƒEù¥ì \X4©øyÔWn$Cî›9aEùØ×fÏ8~Ê&v!â‹c¯(V¡¹!OMÛü¡wzë}õð,.äÊLzWhÑN.JžEÚ0]¾aß$Æ8uÖ’ ZŒ J^–¯pyhêØ[ïËKŠ’)QÎ.(ç…õêO楿…µÑ*ò¿XÊgÍ 0vxIÁ1‹'±fBÝ16(ý-,å³÷­io?ôÖ3¶`Wvßù÷Í©8Îo}Z¹ó©M”,ÍüØ.Í{OìÑ+ž¦kgÄ(‡cƒÂÕ˜[rè%ì­w–Šk8*ªÄ’8fÉÇÇ&šZP4³G‰¥êÛ„WDŸ+ªE‰¥ä˜C^Xæ°äTŽ‹æ†<55ì‡Þ²ÈÃÛ¸Nx’cça«ŸÇkd 1¯%ÊÃl<”oÏÙ6(yÄÙöì6íbìùèš›rêEì­7óPt±ÊÎHÚSŽïI»‡îš§½ðÿýK‹²ùÉ™üÕ–(è÷)!ÆÏG/¼zœ y ÒéÅÜúÅg»¶ßŸŸíTdËÏvï¿??ÛåþlÏü^’¸?ÛóÞ4•û³ÝûïÏÏöº?Û5>8ºæ^üàD¨óž8MýÑž×vÏe~î®›4.G‰ a»’µtÞKŽ›ó‰…aKcgÀ—æ. ú§¦­ÿÐ[ö‘•ÐN,¶âxng‘Ên‹é,81–Xlg‘[¥2Óê ¬¨‹mrz ìÆÎcƒú¢&þ Û*¦CMYh'õÎGaàÅŠGA©*~z&Mê?hM”÷ó¤|!¼“XR±œ]O3&¶!™c·LQæÜ”‡¦Ž½õ–‹}ÀZÔ”ÒœîËŠ·ïéÛž°;u%Vç™)G ³°¤šr+ƒSÝÂ+lõ]‰Æ®Jé¹)§^ÄÞzË­³UøNMâTw}µ#Œ­múM iÉY ƒXR%5Á1ß%±öY[16(\M‹4å¡©co½õ×îúûæ ¾ \ÚðÎCSµª==åKGÇ’Ê(zq /,¢ä5vFÑknÊǵíÿÔ[ÏØ†{.]Tâ¸uÜÒl,–¶Ý؈Ù颲(5ä(÷+¬¨tQ%§ÍÄÂ¥±ÓE¥¹)MÛü¡w† –ê©.p~mÍwû£lÊ¥­Ó®!· ù ,)Œ­­C Äµ•©ÄØ ´‰cÈŠË©)±·ÞÊnب_䛾ï›ãEÆÌhÄjHöËšÑh‰òç #‘•òWWVb2¬¨Ì‰§ ¶ŸX·rÅØ%R757å[•–{ë­p wVr8ñY“Å}½¸N‹0Vw“|ëàâØ Z^}°%¶5[Øâa»D‡æ¦œz{ë­÷ez!‡¥|‚³ÜŸµT¹¼TQëˆúâÛÕGÊ7*úK*Jù\œRë¥zbì(åsSš–úCo­c¨oŽRfЈ³Ý ü®%(ÍØÌÊ °ÖLT<¢Üïd`I­Èµål…õ,˜;óm47åÔ‹Ø[ï,±dyµGùq| Ï©F0ÜÂÉÔòîAÁUùx 4ÉÝÒXR= ¦‘ã•ÚëM.bìåo47åÔ‹Ø[o­cÅ-ÅW†þ¾9þéHGx©=à…n¢"@ãI¹W ,©yƒâx@I`{ø¼›¨/j2WÊ©±·Þ4.6O¨*r™ŒÇ¶²¿ËÒì¿OG­’&÷±yd[HñI!.V`ÃøÂyB4'¤Ô¸[WFMtp©QÇ– ·'?UbêØÎ* žÛKñPê¥;„#É0bxíá ëØú¨åªcësBJm€»u4øóqÈÚQ[·zæ{Ö ~?EåãµÏUVU¨„#[1|—!œo@4jìOö]cxGÅÞ³>u¥q±Ã”—ÆÅ.{¢ »=©2[nãâ”=ѤÓÞµ4JîÛ¨0NYa>œ¶QÍ i—¥Ñp·®ò F¸Âà·Bï]a,²MÍÊ1{„„sõŸ Y |¢®±¤j$îˆSÜ 2#ÜÁì»È?sSÞ÷âØ[ïÜ¿„°åLp*ÂŸŽ¿tfnÁ{QÚ‘›#Uòdzׅ%UÂßsÛë±ÙCc“Šý{KyhêØ[ï,t1>\ÁÁ|ô;Ëuxâ½SEQ]îåÃK*÷ïâ`.,öç;÷ïš›rêEì­wVÞý8Šˆ'Œ·&ÉRÚmßdzåiØHOúâ"Òys®zß¡”6GÍBÛœSe¸K¼Zºê§hhæäÁéß7gxÄÓpÓ‹QfŠ^‘‰n—g¤…Ü <%Õ£QErÊL,Â5v‹Fš›òÐÔ±·Þ´h¬ iÑ*Z Ì2Uõ„ÁW“~'ºgv–lïh&KXÿ,ÙN,SMK—Ù¬Úå•¢hdÉö¢¥Ëp·®ÚÙV¥L2²$8n¹lpæzÌð{¦ªªÜ É!GAaIEG“‹c5u„u«gŒ=#µTsSš:öÖûrë`<íÒÅYØ·< [?<ÛQ:Û=#å´X+*wéÉa ÏÏcåØã6ЯòÔ´”zgÄñú‰ˆç¸áÏâp¢nÃÃh(&ÛgŸ”3šŠØˆ­bølp bxˆõ3pŒ]>sSN½ŠâRo®VÏ_­›Ý®ÊÓ0ô±!±~dõ2«T-Ën6!u™Mª–V7}Ôë݈±sÑz.—­”¢õü7.ÛÊ:äç(õ%8îвS 6㪨ˆ/ØâxüA6¨nqÜHXo&cïè—£¹)§^00|èv†÷ Žâ'ßÃma6Ë¢ñ¾ +ú¥™e`vIßC‰,² û±€CñŽzUXÁœ’J=Ç]ºr‡8Ñæ!wˆSÝ$¸Ó‹ÆÒ?Ìp–ÉØôh¾t?ÏœØéíkO«Qo÷óŽMÚhgY~þŠ›3ÍH±äN#‡õgZ£ ÙIñbj¤â”¼R>ÐvåÈö·ŠÆÖÕ —ž“X/?c¯H…ÓÜ”S/bo½Ó*êšj"‹ÓÜ_ZpF³Üàáç qö’r„êKªF rrlÁ5Ð4v‰@dÍMyhêØ[oívÝÃâ§MîÅñU´ÂÓØ½)IaGê•!÷ÆB%Uc“3( ë}cì›ÍMyhêØ[oEÀ¡ŸÞžÑËDœ½ásñÞ€Øß€òõ{œy–ÔŒ0éäÔ‘XüI{D/ÍMyhZǽ¯r{èÝÔk–ÛÇ«òú¹ÁìifT±Ø…)ê‹;³gH^a‚6)Åˉƒ$+a½oŒ=2‚“sC.½˜ uë­÷e¡„Y´â ÔoY(x6Ðrs»kžiïrD#KªGZq¼ J`‘™¯±[$¶jnÊ©±·ÞJ:8_úÿýɱÒ8}"-|zçUKõk¢|ÑÙÈ‚ò­4Ž ª)E‘œî;a½¥dŒÝÖsS>”ŠíØ[ï|_ìÓù®ìlfXÃs9á‘äé`¦Çò}Êm 9ÞaI­H… ˜°(½«±g$SinÊ©±·ÞW}dÇ˃(Nw{÷@5Ó—Zl\²EÉûj…)Ÿ(—I¬¨ô ŠÃýÄÂC¨±Óƒ¨¹)§^QÜ?õVÒÎD­Öjqà8: wëQhtÝ¢ü™æ&Hòã+°¤NX«ÅA®°ˆÒØNáꥧ íÔk«`[ê­ß¥ªÍ‹(G”J03Êh(uæÆVÏ(¸Òä~£ùÈJyôÚ,-¨+Oœƒƒ®ÊÂfí䨠puS]b—GÇÞzë|²Q,Ö3¿oއ–÷r°ö¹S©—> §p†@¥XÊ+Êi+ÊÇö«Åq7S`=Ó8Æv cõt9õ"öÖ[ïþ‘LÎÅ©v•ÅpÓbWÑ”;Ý»Vd±«è9JݪI•,pœvkAì#Æ…wŸE†(M û¡·2xülðш™,V=k½5?eÜÇ­ÆÎÚ”·+<'¨bCŽÕXXR;Bÿ’SNb—z†ùØë£§Ø“òдœz_‚Ýå4½Ç7>mÝÓu£ˆ:(Ü»©{ëò¥û>JR+Åà˜>Âz­×{æ¯È¹)M{ëæ,SX2œœs{ô-}æžê½3ñY’» DؤJF˜;g"y˜Xñkì‘¥¢97äÒ Ø½³þÃB-·Øæ“ó`«Ž:—f4Å6ÿLQڸϖrTÔ–ÔÉm>9b·¶ùgŠÒ¢>)§^[iÊ©·¶Æ¶ñtCˆ³ JI=HV.nÊi0€Òf×;XQÓ ±¤0¶®Þ̺h]ù"4½m‰47åÒØ½á.Vªƒ'1Ü¡dI'Þ …•ð™"<€¡yÅEJ»Û+ˆ#1uVcØB*œÅ4êÐAEsBJm€»uÕÒ…–YˆøþäXâÆA ÚízÞóËKKyW5~ÇUójÖÁ7•°¾¥±K¤8inÊ©±·Þéuì8QV-]Á9h‚Áι]V%¯cÛ)ö‹Ž êòQ²!£*ÔáÛ¿tûjé²£ýâ3R/bo½e5.nc«Qn78è‚Ò<²¨±_JóP&R:C™±PrAKªåù,8e%Ö£bìšç3ÎMyhêØ[o+ŽK±+Áñ]F™ÝÊ\2Ç«.ô# «›ÛBîæ¶À’Šs@p¦ÿ<墕ήž¹Äsî©%¾îÄÞzg Á¬´V£„ 9‡ìì”c·[­ˆö{O óÇKº°Õһ眡:ý“áý%ÇYf•sSN½ˆ½õ–gU²J …8ÈQ訩U¿Ðì¼™ßÐÙFƒr/ÛXR=6ɱa‘¿ ±3¿AsSš¶ç‡ÞÚæo¥pµÅm~pÌ`ðnÅ æؘ3ŒOÍ(’¿]þà!6(>5Á)öšÖ?@1vø6cnÊ©±·Þÿÿû[¼³(\ÍŠ¥Njݱ©§Ñ£ì圢♮)÷|‹À’*ùv!Ã\ÙSX£ü?>6©/jrNÊ]¯ÀÞzç©þA¶‡Ö1r¶¿¦~ÖŽ\)?‡¯ßW.•qNK9‹4 jEñìàx‘ a—¿â{E‹7Í-95%öÖ[[cXøÑ+éûæàÜYPgà„Z·´¢Hóûòyˆå(Æ#,©EšÅAh•°­ÒØ#Ê®inÊ©±·Þ¹Íà‰S>8žäÈôNné˜úymùüð¤¼EÝžÔŠ| ä˜"ÂzÜgŒ=Ã6£¹!OM û¡·öcK%• Híó©Ò§¢PýFÌF Ïá9*dåò£XMÇÙ• ˜¯ssT¨j®f7å¡ië?ôÖû‚Zkj»8¶+™¼[þ}5j?¢ðLÓÂH9jˆT¼ä¸U.°ç޽˜›rêEì­·r*Ö=ʼ%g#€jÒû7ܰY·(ŸoE_¬Wn?‰ JeÞÄiXºú"²€RÝ¢puS j¶{W³êýCï,³_YžLul¦š!OÔýe£do…uŽHÛï´äÌj#–Ô‰g,9­vãpȱwähnÉCÓÖèÍœ€‚¤µ,8R”!gGî(/T¤¼ Ž´+*ÌZ‚…uRDX'Å@ávE|iÔ,8rG‡Iàn]³ §Òûmê\†ÅAùÛ—:øÒÙƒ9ØÛ©/¾Pþí:zpùÝãCí”­«ùm37Œ°(–«±—RqcnÊ©°z3 ¯ùg­= ¿%£{”Ùƒ³^÷³Üã¡ï$l®Çm’zEá@´ˆxKF¡‹ GmîÆ9) õ wë*ßã‰R‹¾Ç¥ºSì éñ‰Oô€¤G¡¢ïå=±ˆ%…±u59̺¨43¬”|§¦<45ì‡ÞªºÅM;ûàt¤Ú.TQØ¢l˜šGôLÛÑN¢Âš=VbIµ(û˜³{pŸöȱ3ÚJsSš²Ð]ê­S=[·¨¸'NGViÁ@Ã+ê½ÃŽ* 'ï†8XÊ›Ï8¶©ÍŒjO%§ÄVdrìz·/¦÷o—[Ó6~è;HsR¢Ëî÷ÍÁDæ›AÑ…`ÙD…_èI9ÞEaIU‚‚%…E.ƒÆŽÌû˜›rêEì­w:#F8¾?9¶-7£ÿòŸÔÎlóèÁkéŒPmC8+NOlP·ëõÈFK¬;bìt]hnÊ·ž‰Ñ~è-ß#â~öŽrlÍœØQ ´ k”]ߤÝ·äOÄXŒ 06®ŽmžpÙQ‹cƒÂÕ˜[òÐÔ±·ÞiÀgcâSÀßp•ÅÙ½Ô¡C‹¹œG”Lòu¦|a#v©qñɫɩ#°ŠÔÇØ dÀ?í÷ÉOMåŸz§“ÈîÆèÑvYœáq{‹÷4PÑ"²Qrû˜QFräî K*[T%Çâ „EèªÆÎUš›òдzóûRýó<ÆÞ‹ãS7Ëâw.0÷" _Œ…gšr–…'v«µŸ±‹ÓZb}scGÖAÌMyhÚÚ½ÓÒºñÔ–Vr6Ú$tĶtä`”"J¶ÓµS>|#"lPQ€Té!vûáIcƒÒ ÞGʫܻcýЛ¿Kƒ•ò÷ÍñüB£³jåi¶Õ üÞ5X%ïøºKji{qJO¬¿(1öTäXÌMyhêØ[oŵñ<·Õ@ëâx×ôñ ®§À=}â‹aËýIyÅÊlRªŸ)ÂX„è0ʱ§ÚÄÜK/`?ôæ3Vº:x«XrÂWÕÓ»º²4Q°NíÀj¡µžØ ÔA4ô"–;8öÕ ŒsKÞµ;›ý‡Þz÷»ÚSКD“U6°sï€çœ=¿/ᅢ+åSÞ…Q’Іð§ìĺÓ4ƧjÌMyhêØ[oí“+v{Þfàûâ4°EégÏÿDä Ï’Gu€;¾¥”û':° 0¶®>x"ŸØ–·®ÆÜ’SSbo½3;ž-R &š¢t´Eß^½ÌóÙ—(YÀgOy¼°“ÔÌš Á)3±^ò?Æ ¦¹)M{ëÕ$z„|rÜé‡ñ–øBÍ)Jß3µ€D5‰½TÍjOä,‰õÏLŒ½¢¶‘榜z{ë±Æ;m‹ƒã¹fF©>ÖãñÀ¶—Ý‘§fÑÃlR2Qej·ÀŠª:µZ„õÿÄØ%ŒjnÊ©ë¼Üzçùe°RLž_¾B9‡,4ÿàüÂÑ'Ï/}¥íð„%uµB NE¸’ƾ[!U…ÜÌrkZƽ›¾ÝÕç;8ñ|?½­„Q¾—Ѧ°£ƒ²äSO¸c§NujS(Nó&·Â6?_kìçoÍM9õ"öÖ;¿•u9žüV´¦šˆÏ™h U‘rצ(}Ïžò bE í.Ž}f„e' ŽÝ3¾œswÅ—SÓÖèÍ „f;è»6¨±àÆU_èWUW)Õ¥ G"k3D «±0®b©»_…RÚ°"hWÚwë!†óg¶ó¼³k¤–[0àÏlç‘Õýºþ†Öß?B #4X¸1ü™í\#-]Ú(ÄpþÈv>îÛIl‰ój|}|ósÛ ×Õ$ÛrâÏ‘6È­JÆfK\Wƒkš6Èy5Ä–6ÀݺÊ(±ÑexDÞ¦8Sa? 9 ª¢`8ðÖô!Ç‚),©Œ{JŽ›ˆí>…Æî‘˜¤¹)MnTrl䋎£Ú4&Ç6~ï–•ï¶)|ªbµi|„"yGç^bƒÒ¦Qœƒ~SW`Û>™J.#AUWa—S/bo½å::D©{Qr<wFhÌ´sŠÂ’³ql¢|+猛’L”Ѷø¹Qc—PÖÜ”S/bo½³n­Eî™-CåÔ‚ó ­KE¼ÄDÛ}Da3„ît’£°A)ÙNI‹þÌ{…;CsSN½ˆ½õ–á+ÚlTEáÇÒªg•áËRfÃÑzåv#šz¸¼Gjâ¸)m7ÄÁ6PXïcGW©˜›rêEì­·~—£(ã¦ß%8gg½`¼Ö a}¼/ƒÇ<È­KÃlR-¯¦sgŽÄn•+K”~EFG«oà ì‡Þ‰·>–a1ôÌ>/qν ï~•üÙ ŸÁò± ‹Y¿ŠúhÔû#˜õ¤ p·®™ÃÙà?™ÃéoëµÄ!Ïr4QðšT'¦ü  ±¤zø “c~a½ lŒÝ¢ ‡æ¦<4­ë‡ÞŠøÂóWýkó}s@‰>gFÙ{Š>g¤à5Ÿjêr¨„]j.º{ž„…¡EcwíAcnÊCSÇÞzgUú}•C&í5[&ººym—‰~oQyz 2e^8üìïƒ~Ÿgb|ÇÍñbgϹ “N†¹ô‹& ­^“F1f_åY¤§ä,àüä_pü”L þ? 8‹¶ÎOjÉñ²€3æ‚L:æÒOi¶sžÑ459?Væƒå³EÁkŒ 7ÉÑCQØ Tœ^œ¡Çfb‹qzŽoJÌM9õ"öÖ[gWÔ…²™<°Â>²‘Û`q[ÎV³Çç%ûˆßÊ™{J,©•Í Éñ½E`£uº=#ZWsSN½ˆ½õN¿Èâ&f‡_dáÞ±æ±í*ÊQl$ž¨ìV–òDÄn53zÒ>¢öF5°ûQ=dµ#OûH}RšöúCoU¦~TZ2šr?ªF:QKQíPKñ QºwjϰýN«=C cëW$§•À®ƒÔŸµgX·¦­üÐ[Û)|{öûˆ8ÈL7ï¶Dvdž|²X'‘òUÔì–¥gÕØ~urJO,šújìlú«¹)MKÿ¡7¿uೄÌQ¹y+ãÛ"‰y®Ô¸/œy¯L:w»fã–ýYˆž H3N£f Î éQ™ú³>u•ÉýÔ=!êû“ãѺ ò‘¼ }¶Ê¼X ‘UR~OlPMm—NäÚïĺs#Æ^ÚÞÄÜ”S¯¥åÔ;‹ .”P58q†{Yš×2Ê< Õ“Aù6¡!—òÎä`Ee5¸äØ›"ló7Ec7™ÝbnÊCÓ2~è-Ug KbˆãòŒZØ;×ùRCŽºAó<)Ÿ2Z;–ÔT8Çű´ya‡oM4öP8GÌMyhêØ[o8nñÖïOÎAŠfà<ˆËåÏ;ZÊ(lP QÇ£c;”g×–¨/j²JÊ©±·ÞúÔu[jvP c.mtzóœH<ðÓOˆM&KfJئ4ôqâêƒp¤Ó[¼†Æ.Jp޹)§^ÄÞzgøSaVl†?±¨¹¹ËQº C”XÐaÙ'žc_}ä9·äGÑ{ë}•ÂB“¢®bÔä ¾ÈÎ1†PºQ8îà 9 Â’š®<´R˜¯VXo›c°³hnÊ©±·ÞÙ„ÂRsŠW-ü¾9= H«È^F¤ü9hîÉ ¹¿ô%Õb§F¿"& ô»Æ ®¹)§^U½ŒRoý-=2ŽÕPƒ¯”kÔÁ‡#eNQ˜m0$GLµ°¤Fl'ÅñAëÆØ=¶“š›òÙÐϽµm)°ýÕh)ŽGµ0‚Y/f…c¨‡uczZUÈ›\XŽ%U£dr¬5‚°§c—h©¹)Mkû¡·¶Æøà ô}qذßþn#p¦OQX7 Ž@~Ь…uu9ÄÁg‘X63àØW³Î-95öCïð%ìWÈçVªÚw)} Ïg¼v•¸µ0ë,s@âö%Ô,;Ю2µõ£\A˜…~nÝöOWˆ—p7#ÄXöî¡ø»WÔ¿Qž„Oô yÒ'Jß• ¢j2Þ÷[8OòÕ¨#þRÎ i¨g¸[WU›*‹£à3qŽYæRQ,¸lmðQðÙBŽŸäG%{{T®GÁgɱ/¦°ËƒË4öŠà3ÍMyhêØ[ï«='®ö id{^°=Ã¥# Ãc6Û3ìÄ’šQ¼Kœ7ïÖ>«ï{Ä.HsS>ÕŒõ©?ôæ×ýiªÀ@qìyœzð†[¹”§Ç‘“a@%*åØÇÙW“cåTˆÝn›ÐØ ¾¨ÉsRš:öÖ›¯ wÃíï‹á!éV2¯+vý%ö#ÂfÜJq‰#Y§Éx#á|7©Q#QEsBê•ú©«BþYsGæ•8ÈÝ,‹‰Ü­áe1Iù‚1’#AXR;2¯ÄÁyJØ…¢Ö{ÅVFsSN½ˆ½õ–}©–rSµà<(Öó ÚmÀ0´¦(ù¹Y¹yÀÏ}VbƒRq¢ZFçIþäØCÝXbnÊ©WTËH½ånóìZë8ÁøÌàxß7æâšc¨°À|…*â‹$G$’°¤FÄ'‡éŽíJ·ô±{Äkn„>¦¦LoL½i‡¸‹Î~_ Ù!j|æ^b¸Bæs5¶ª×ŽD–²}T_ ]³u­F½í5>‘?KàÞrõS¸,ûŒŸ‚Ÿò¢·Ù§æ¥ÛõÌ”£¤6°AíØù‰ƒ–æÂ.ÿ.h쥴ÿ˜Û9¡×RÔ[i|•P-àûæ ÿª=Õg<ÆÐ«ï>¢à5~àUvŽ¢*ÂÕõE¼8u$¶©–ïyDalÎÝ¢ºïI쭷λõbºJ g ‰ÞA­_þz–(«W ¹íDW`EåÉE¯:Xì5vS#©˜›rêEì­w–uä·²[ïƒýƒ…p¿gä‰ä̃n¼õ¥óõ™)GmaaIÍ,~I, ÂxM9ö¸½ª³…\zû¡·v]go7ç~r쀆Ì_»œŽd#PØM`Á‘< mìqS2‹ƒÀZb7²È9öNã1ç¦\zû¡wF£Ø¡¥Mƒ?ãôšZÞXÑ(ûˆò÷sz˜qÈ„%5µRgø«!ìð?Pc­17åÔ‹Ø[ïHNÜ´U%'’ñ.ãÂ7`…òæAv òþž¦®ÉxW[ôÇ«L>HÁ‰Ú éòôFâ‚`$ž^³]8/;©Q«Âð4ge!׸[W}ÃòÔ§LBÁYúj„ Ý:¿?bËpf“g6aI]±eä wÌ ;ôE_GTìÄZÊ›j‰¯ç‡Þ²švX±†:ÊgF3’‰{ Äž¼G–ÍÂ,”£,¸°¤†l‡§ÔÄvlú‡zòò§Ž¹)MKý¡7÷‰“Ù¥*‹s¼ršQ+ ú\ª°©³Ï\ªÉéò­jŽ•qrÇrà‰µ³ÆŒ±A}Q“USš:öÖ[USªR[d‡%Œ`¶9 ü‚KöD†¾[ÎNÊ»‚’æH*2ô/ýÒ?&cD˜D£_QsSš¶öCïì 2aïV„ 8°Hæ¦JO( &¨Ž*”wÕp,©‘=ƒãýWˆõÈ »Çç_sSš¶úCo½/,Î9ÌüýÉyð=3T(”†Px¦·ïb%gQbƒêy5ËŒ®žØî¿©Æîñ›knÊ©±·ÞYG¬£ÂMUoñàx‰²Š|g$3Ze¯)Êç[ˆF–õt… ª¶¸z3Ðg%M5vaй)§^ÄÞzkÓˆ|ïL„ Ž'³LùX¬4û€ÒÆî””oÕslP‘³e ñdb']8öÌD˜èz{ë‰0•e·dޝãÑ)¸¡ç'»+fy&L>ØÙœn‚Ò‰R¯X˜’5všš57åÔ Ø½å>A?æ5Uß-8K‹»÷ê@þÜ»œ! .t–|úÆOXRSõÝ.?SŽP™c¨©¹)MùJ½õ»°$|Wrbp˜¿TUÂóâ7‚[¦ê•*ÝKòãI…%Õ•œxqêI,"¶4vSrbÌMyhêØ[ozåºG& hd…øûÌlOm¾2I†­“”yJtdŸØÿg&‰hd…,å^p¼Ì$Á\I'Ã\úeõV«çóîÄ”“$N—Ïlã*]$)üÚÊ’éºüqNµÈIJN]‰­ð·qì9Iš»†?n&öÖ›àÇ@Ùî/ÎJËèæg”YóÛ_…‡6ä0¬ ”z‰Ã~zIJŸÇŽn1·s¤–C?”¾òK&<%óKì ô¦:žã‰™,dŠ’£l¶”{œE`åðªZrÌt@ìôQ®ÞÊêuyhêØ[ï«¡ lHÊûIŽ#'*Ë-$ÈÛ‘©‹Â*ÿàù5,MJy?âl|oÕõïÍ£Z¤ÊÃÑÜKß#V”å·*õδеd6ø¾9=îŽ÷°TOó^–ì÷µôR8”å(9–T)ÄA}laÝtc§‘BsSN½ˆ½õŽRŽÏG*¥è­Ü­^ïÃXw'ø¡ö&õ~‘ÈNðd 9òPkû^cÔlªÌ9!mWÜÁ‡®2’z=j_¿ù¿i÷ô~ï]œ:U ™^ ä§DbIí(…œï»D, p{E@Žæ¦<4uì­·>€mâª~‹à´û#uЭ•¹Î ð‘zP¿‚òG?½c•­›yõÂáíÌÄ"Ic—̳Þ*’çrêEì­·œ M‰{,œ ã=Çá½ ØÒÂXnœ=RîÑ;%µ²a9I•Äz¦UŒ=Uþ0榜z{ë-ë¯Wôã|îäXY‡ºül¬à«‹’…–=\îžÄÀ’ÚáVg!Éi©§'9qìÝ[47åÔ‹Ø[ïŒQ™8u*ï'9]¢+æ"|ŽŠ©(jüyNEù£Ò,ç¹)m•Å©nж*þeQ¸ú(^ÙåÔ‹Ø[oåýx­4+¶°”÷CNsû@ƒÍǶÕ)Û¡ƒò÷³yðNÈ·I;–T‚œâ·D[<ØCc—(¯¦¹)§^ÄÞzëwA皧˸”²|`¡5K»aoQ¸w8‡Jî‹j`Iõˆ®OŽ…õSbŒÝd\‰¹)Mkù¡w–t°ª«ÑLr6S[aŸêH{¥‘­ësŒ7å/ÅÚû¹)5š‹±°Þ!ÆŽ¦Ù17åGÑ2†ýÐ[yrø0X+Pn[Ä9þ÷ÔR6G˜¥#uRdS-hóxÔgeÔÀŠÚñv‰³ÐY…Ø…’Ø{eVç†\zû¡·¼%Vɪ²ÇÁñd£¼\¨{.ýÑ}D}ñ‰¬3å,_ì“ŬV\MN/‰õ²Ô1vÉNgJ•îykjؽ¯R[,Öµ²Ô8M¼˜C:ŠAzÊluSUˆ)o(9KlP5¯>ØŽŽ'° Q,{e7Î-9ôöÖ;óýNuyä‚ãñr–CÈP‡ƒlF6Ÿ¦IÎsOÈ;jm+*LrÁA‡OaQC_cG¬]ÌMùÖoîØ[oíÇŠf.¦8̧DŽÃ\ËG[cåbŽ‚}ÈGôýTæb&Ç¢M„E®¥ÆÎ\LÍMyhê]ƒn½3ø†M…Uö89ž¼½á¿,ÊW]žƒÖá¢|—5”‚ŠÅña„µ,…'ÆõEMöNùŽì‰þCo•s££«?ÞÅñ²iK¹Ÿ ­Ô™…ÐÔj=Ì).GÁ\aƒ*3®f~£…P ëq41vÕñ+概<ÄPHùŽÃ¢FÍPô¥S§I§N†»uÍl ³ã½»ÔÞ"[ƒœ9qâùfT…åàËKùƒM±AuZ™Äñ±•;`ŒM WûÜ!§^ÄÞz³@ÌÈÖy‹’Èð$«(Þ<†çÝç  w•#g ´¸ NDÓn*Vë…8¯c¬Q«–jÍ i¨÷â>tÕ‰ëQ¡¢x›à,Ä5{ òAéÅ…ÕÑ#†¼!i‡Ø ¢ :9ÈÖgc숫¹!—^À~èýé:Y'vâcWYôbnʇ¼Ú޽õf^©‡.ybS¯ƒ±KvîÈNhžz­v”L½FK4Jý«&\%R¯ágLáüˆ©Q‹¿šRjÜ­«6Þ•Õ7_4HŠƒ6æ/e?½m Q¹lvQØØ¡ú–ä_ˆíj!£*9¥&v"cÏx¡4÷T:5uì­·v]9ÚOt¿%ÇŽMï“*JT?ØU髬̓‚v%E}æJ ,)Œ«ƒÃ¶YÌ67WÇ^QŠTsKš²]WêÉYŒ´©3’³È1ÃÂâqþüõ¨‰Rs|â ·PíؤjšøÁ4°Þþ9ÆÑñDsS~ôAtì­w‹Ö¾£ÏÅÙð>EI¶ ~ âIÒ÷øäòR݄ȣðÜAeôùÅ1£8±ˆ.ר}®¹)OM û¡· , 6¨¹ËÉqƒ,šq5«%#ˆ[¼(‡ÓQØ Z^íw]Eâ4öÖ¶%榜z{ë)ñý³è*^‘ÕN׸*ú"ãf’zÉáHdÑ 2P¼‚8”µWÔ/(µP¥ p·®² ?JÕæÉ$8Sü'ª]ÙWiV5¥k/‚ã$oÑââIj„µ79ö½¶£ø?ÇŽ´´˜òÔÔ°zçcõé; j/¶}yO+ö:×ÏáÕÂfÊŸËT†%ˆƒŠ‚Âú]±3,AsS¾.7ê§Þ™T±41ß78n¼1еYÚÒõ! >µGµ]jF±î‹c¥Ø­W«mÄ“XÏÔ±—Î417åÔ‹Ø[ï,÷ïMe‹þ–à0z{ÔQÕÍ×óª¿ÅÛÛ´”Ww+ªèo‡ÉºÄv¸º86(¿šsSN½ˆýÐ[‹;A¬·¬>âTl´ä[Ùï~ú}…ù–Û<%_ ),©OdrÊlyq€±A}ýÊàdÉCӲ譓ðŠ`žê“³K2˜„‡@yå.ëýDkDÉe+;6(êgÔ.r/[:â?£šNõnìò¥Üå>~èÍexü¨@-†–Ó¬@½æ Ô¯“t_¨Eä2¼¯ ÔÂa¡?*PkN-ÒYúC×|¬6ê×cµñ vžcá¤æc¥FNùX­™r¦³»Uû5«à”•Ø¥Àçç…«9÷R÷jZÖ½s§RJÀÝüÅÙp±ÉG±w¥ÝÄ9)¯Ho6)§gy9a§W ÖØ3* knÈ¥°z+ ¯¨•fUð‡òþ^­Ž GBö(Ò:!šu0ÿà7rÔ' äüûÞÈÿñ’W8ªþýñËÔú93h+Áõ>S.k3ÿ/ßÌÿˆY®¡ÿÙ5cíèËâ•mž¿ý¿þÏöïÿÉ¿ú÷ÿôú—þ½ÿüúÕ^2 endstream endobj 330 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 289 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_MA_count.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 331 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 332 0 R>> /ExtGState << >>/ColorSpace << /sRGB 333 0 R >>>> /Length 20415 /Filter /FlateDecode >> stream xœÝ}K¯-ÍmÝüþŠ3´>®wu#!1 @ìO@¶GÇqAÇ£ÿ~š\k‘µ·eY‚“A4¸’½ªØ½»ëÁâ£~üâ£~üúã_~üÍöç£|–‚¿FoÇ?ÿû|ü÷þñ—¿ýÛ¿úÙÇ×oÔ‡Y>οû%ñÏúâŸ~þׯÝÿúãïþá£|üãúñ‹çϯTïî—?þý®|ü,ìýs÷^?ïúÑïö¹ïçŸñ¹ê¿Q±|Þ­}œ›Š¿ÿããŸþ£[(Ÿ³ç-”·[@ãc~^÷Ç÷ÑÖçl$óã'ŠëØŸk§œt^ÐÆý9f^@:/è³~¶ž¶ ®ýY.ÞÞ7)^eâ:¯SNò¸ µÛ~$]@ò¸ —r^@ò¼`?Okå O^ÞÜѽ>÷•7òxd÷õ9×ñÈ@OäQ£ã‰€Î FiŸµ? h»àyx3 ¨SÝÖN9Éó‚»Î|"$ÏgºÆyÉó‘õy^@ò¸`”e÷« HAÏ¿í]ÿ·\¼Â»¾~…µtoñþ¼ìÅ Æ|Þ÷úã³Ö鿤{“øòKçç!Ÿ÷8'Ъ.£^Âës µ —zŸ’J=Ǻ~ýøÙsñÕ¬%{Õêåê'ãFÜÏW¾Ûg¿>®þ¹¦ë蟽…t|^+pAÔ¸Ô~sÄ­ûóÞjİ>)¥6ÀºBý6–µÕžWµÜ®ÿÁÙË©§ãÖŸ.ËCm@}ùÕ×g½S~ù("lPOÛºÚ9"=±ÕF©hÛ©/jâ}SN½ˆ=õƽŒ²?Çs}©ÖÉ÷ÉyžðýP—•FÝégì#õåWߟ½§üù•wbIyÛºš…„-øÄÙ¶S¸š}Sš:öÔ÷Òëý¹žÑÿº>o|Á¹mÆè­|Öçí¼Ÿ¦SWeýõV?ÇNù3ÕÄ’ò¶qupÚØgß#Ú…«Ñ7å©©a_ô潬çk+>rÞ ÷"Îý9o§žnϦ>ãéZ¦$)ïoí϶S¾q¯Ä’ò¶u59m [ïmCÛ&õEMî‘òÐÔ±§Þü^êõ9lèÖì÷+Çnâ¡îg,zæõq=Ôó4š(§Ÿg×îÛ³íMªí¸Ú9͉°Í†»h»i4Œ¾)§^À¾è{©÷´GX¯õy ½âl›ê3úï|ÙphÔUDù8yû{ò ﱤ¼m\œ6;?wɶÂÕì›òÐÔ±§Þ¼—gXxžF¯Ë>ÊmÝTŸ¢Ú4vÙgÔÕDyÏ6î”ÏÏÒKÊÛÆÕÁi%±ós­lÛ)\;)M{êÍ{™Ïäù­ž×oã{ β™¢Îm¯§QwwÊþåý=K+{>’ßþ$…%åmãêà”™Øá³¨Úv W³oÊCSÇžzó{yxݾÝmÓÚ÷ɹ¬£nûÚok¡MyHù;ýèÓFÊ/[–”·­«Éyf¸À.›È£í¥y>ú¦<4uì©7— ?àóÞ-ÌõÁÙ¶äó×_À…×óÚ¢üÙÙ§1Rî àÀ’ò¶qupôYá{ð¡™m;…«Ù7å¡i©ozëwÙ>^þÏ÷ɹ|°}žÝ3qõ¼ÌF]UžÝm˜äëYãµÀŠòýjq–sÂ.^£m§ô+zß”S/bO½9¿ðÎÚ8¾º›(Ÿžuȳ®ùmÓL`IyÛ¸:8ÏÊ#°ÏzxfÛNájöMyhêØSo¾cÏ“²]‡ýÀXg[ uUŸÏì帲«iþuy×LíXR+ÞÈä´–ØiïI´=ãTß”‡¦Ž=õƽ<+Ðçö¸Uø>þ…=KÒ6xpÛvÉ"¬¯Í½¤Íž¸p$––VbL[, 7?{VðKÙ§3¤ã^tåOñŒ ¥úgc3À­ëXŸ‘¢õóŒó<‹_¶n ,©¸‹à¸:uM£í¸‘è›rêEì©7?÷ç!]øy¸œ ŽHmwî|*†Ù=lz#åŸäÃÙ%åÓçaaI--'γ$ ì´åb´=µœŒ¾)M{êÍ{yžT·a½['߯œ»8eû…g70s<ï>),“н±’?”íUˆMªåÕ[›=„mvѶS_ÔÄû¦œzû¢·†áË·®wì~ÉáFÁ(_ û×ζEi¾{ÈŸÐV•Ä‚bۆɱ}°6Э©¶Ii^5å¡©cO½u/Ý—ŸÏïX4¥gÙ”Š5Œ6çgÝ¢Ðß´¹6äX¯T©1y;çÙxÎÄv›K¢m§p5û¦œz{êÍo¿ú\i¦­¤8φÊÖgeh£ÞC™ bFåß糎´Wòç¡•Ä‚BÛ¸šœË^5am2mÑ6(\¾%§¦ÄžzçT?n¼WLõΩ¾>²ßïÐÆ/»‹(½c}¥üÆGF,)o;ÞHlílm¬Q}«mRzÇl4Üõ ì©7îåöÛ1$‹á£*öpŸ×¶¾L)cÇp|ûv]81‹áã©p>ÔªÕ‰Õ'¤Ô¸SWþ KÍçá]X©§ÙN£=»Uûºž!¢l§®) ðå_¶ä7† bIyÛ¸:8ÏN#°ÅƒÑvÑ.%ú¦<4uì©·v>)µ6r÷HÎÄp›Y­=÷ÏÝ¡™m@a‡ç/}ÈoïAXR#wÁñ ±ïÛî¹{dß”‡¦Üy¦Þš—­!ü¹Ò –ýÊí9°rí<­`›ÖÊ/[«6(YÁÄ%KØçÙ^Ù¶S_Ôdí”S/bO½¹~ˆÞü6+¦Çƒól²º0Ð?õGåÙEùеLߘJî³r`ƒªyµs–í;;mf‰¶§v¦Ñ7åÔ‹ØSo þ;öw„«áä<¯o­¾³nÏgl†š‡ºº( •¾3¹ïÚTåjXœé†~a‡Ù£m§p5û¦œz{ê­w¬bò¶Ëø>9ÏÜ}©SxÿÛ)ŸnœŠeÒLyÇ”C,©©=ÍÁñ7’Ø7’míi¢oÊCSÇžzk—Ós›Öq¶½—ÜIõ`l—aËPÚwÜ=å4†KÊÛÆÕÁ±YRØi+àhÛ©còÐÔ±§Þ¼—çû³ËNe0&[{îÛ6‚öù*ÕçpRØy? Ä™òj6:a“ªÔNœgŸR[lym-¤£oÈ¥°/zkL¾}Ü+n²ý>9nÒ5Açò&Öû…åkõµžä 3±MóƒUÉ©CX¨‹Ú&…« ¾oˆSÓ:ÞôÖö«ùÄ`kVÎ/âð¸§yeíÙ㯢°Eê®äÃ?ÌI³©mùçY¯øf Øé‹]µ ꋚXß’C/aO½5Ž>Ÿù(ƱàøXTíûìÏXÒo=Jõ¥Qo§¼ÛÊ/°AÅ8FN‹±h»QŸã”·]scß”S/bO½y/—™á›MÈß'É–B—S¦Ýó©•!Êûk ¦vÊ·mÉKªÅBZh'lõ‘Bm×XH«oÊ©±§Þ:ýš¾èÕ†¿ïWŽm;ÊÞËÞœ9–Oº pBµ}"ùö5аA•W;§øzšØvû–„mƒú¢&¾†¡œz{ê­“‰¢•,­ât/Œ2µžÝ,©ö«QØèò£§¼akKlÓFW–ÖäØl$lõÙHm;¥MôºRšÖý¦·N¿¶[2ì<ûæé9Ã_;Í(NÙëYolFòuFŧH¹›ìÀŠò¶užåœæ«aýT6ÚŽCÛè›rêE쩷‰Ô­¯:É#gû1îóµvØí„·Ò<²µŠ7κS¦—Þ’ZÚ´gú!°°~ÜmO™B¢oÊ©±§Þúö¹9lÚâœg©ÏËÚhâhN¹}½ÇÖõy}ÝùóúÖؤ8ǨÀúmýæÑ7å±5ì‹Þš+«¯\‹[A¾ÎóBN³µË‡GŸ¡šOÁ °Çèn‘|¸ÍZXPhW‡/ŸaËå&l®Fß’‡¦Ž=õæ·ÿð¬s^á¾R_Sµ§=ßXûz«Ý¾r%åßçígV!Ø´KjÅj196€ ëë­h;ÖcÑ7å¡©cO½µë0 ¸qæû並n·Ûy{¶&šØ>NYܳwÊVÄ’ò¶q59Ý—ÄÂÂ,®¶{üæê›rêEì©·Þ1Ôl›ÖôއÐgB·MßÀ;dC/(½5Ï òig ªé#‡{hb§–öeŠÒûë}SN½ˆ=õÎwÌO Üšû}r¦ÏIvì }˜æß6Eé5åatë+©¡üÁ±-™°Ý·djÛ)½cÞ7å¡©cO½µ‰ãÆÍ“¼Œö¤±õŒ„ÕŽ –(¼Å÷ ’cL¬(oWÇ^'a—?iµíÔ5ñ¾!OM}QyêM¤ ^gSÓ‹ËVT—O_F<‹­ë†ÃÚÒZì.ö ñ÷NÄÔÄ"†ïv…ó¯A­†]}BJm÷¢+ŠA ÷f$rl(}Þ;n[¾¦°`®WM¤aó¦Ü\Áz`I¡m\œÖkÞ:w´ ʯfß’‡¦†}Ñ›ŸÈ3Ítl˜:>÷à¸;©Q7–:fÿiîÁBÊ_㎗òî3™°¢¼m]}a§eö!a±šRÛáD}SN½€}Ñ[S=LlcÈ\œi‹8£l1û¬[í<ËÖ¥U”¦z›K$¯p'VÔƒ@rzI¬Ð¢í® (ú†<5íåMo9T›ÉìÕ®œR’cgÏÓ7«½lŸ×žwd QxkšiòfŸK`ƒâYYp¦ÛM„îg¤¶‡œÎ¢oÊ©±§Þú]–‰ºÙDx*)Îô1ðÙ0™kÊ⯴íÕ%õÅ›m÷$¿ìõ ,)o[W;§ûˆ+lw_µí”6k¥§œz{êßËÆI\­ñ½Ã½ŸwM·Z4žu9¥/Àm ÷ ;°Iq¤N÷s?a›`¨í¦‘"ú¦œzû¢·N%7 ;%Ì{â`Óc'ºÜô`È·(˜G8ÖP~kùºzR%lÉéUX·¢,µMꋚ\=å¡©cO½õ½4Ÿ•¯f?ð÷Éqâ¡\XñL÷:&…wzøöTòáN9Â’j1Ê&Ç"ÂÂꨶ«è¢ï_×Jì©wÞËó¤ÎS|qpÿô~Fñ°Aé @œíF.a·­J¢íê›rêEì©·ÆdLkfâ:YwWo7ßéËOí/¢0nº·`Èi‡ –ÔÖLœåþxº»z´í®fß”S/bO½å4Üökf'š‘’cÕôÂÛƒ'×袼¿¹üÍÜ?ÅÀUJ\íœá³‘°žLl»§§û¦œz{ê­ýËÂ;^bäØìWàwйC8í^¢´'_=å·Ÿ‡{cî /±à¸§±ªÒÔ6)\½1‡PNM‰=õÎùeÓ?b~ជn ¦{· Vì—z=3ƼSÞµ×¢ûAj[î <3¾wb+œZª|uçê›rêEì©·î¥ËYSûÊäØÞpûÆÍÏ©*üS·(ô75(tø·Ú1¹°AÕ¼úÆ–mŒÀß8«mP¸}KÞð0Æ›ÞZÃÀkiû÷û•cÝv_&Ú÷àÑsÓv¤´Îà×ìò…±ˆØ z^íœá~ÂBeµ}ì¨Ù7åÔ‹ØSoíŶ™Ù‡7iëgù«p£l!…PRؑܶ_ 9•Â’ò¶uµs†/´„…•Hm‡ WôM9õ"öÔ;ôè¹À{!Ç-lpðÅÝ×ëS«|06Îãç ,(¶­«'¾ïkë.ZEm“ÒñçºB.M}Ñ›÷ÒüSòØ.‚syÈyÐø‚7À% Úu¬£)î™+,©­P•à¬ð€€™…Ü©m§p5û¦œz{êÍ{yö©«bî_ŽEÜ›½ í™{b®IyϾ»”{˜~`ƒRh¢8ÃÖTíwm÷MTß”S/bO½µ¯,„q'Úïƒs{R>åÞæXRCïXpºÂvœ±í®w,ú¦œz{ê­u2soŸ¿_9VÆ‹¶Ë×¹}‰ÂZÖ#4B¾b!¥6ÀºRýmwt¦x Ãý#–»¬ÓuᧇgÅò”j’º¡p$ˆ)†R5ÔHñ VçB}BJm€;u•‚¯ _R<iξÎ}IñpÛÁ“䵜)D¥sˆ8LÓ@,S8°í#ÅÃõ’âz{ê͟½›ÎŸ‚ ¼uõÅp5æ>bÑá¼{¨o~Ãqsp)ŽD¨/†«!œ+¨VC}õ é’#’áN]30½áêê˜Þà&7¾‘ª¯`Omî# ´ç®-å—Ç mëjrêlÃé$Ûnyzɾ%Më~Ó[»§ ‹q‰{Ç—wæÕΞwïºs$¸S¾µ¬ž%©÷’ËöòÜlj®Fß’‡¦u¿é­ßÑ%v½Tm|IT••—K {·’Ë©ŽM&å]Y)z mëjr|IÔ•ЗKhÔ5aæ —‡¦Ž=õÖ¤*ÜP rpp2ÙÃí3Ò쑲P§³]¹-VžÎ ;”C‰öÄÙH`E,2 ªí‰öÔ7åÔ‹ØSoyâÁ›Ó p[("DÌëBp8<ËËåƒû€ÿ&åÓó +ªGArjK,Ìõj»Eú¦<4­íMïÜ2ÿƒ†ƒƒ ÿòÙßž†̇‹Ò¶!i.÷åH`IÍkLŽ­v…õ4ÈÑöˆÄaê›òÐÔ±§Þ´6O%ÀdµA{ÞÜí‡fÝŸÃó‹‰í²X Ö!™;“ƒÿWY?‚~~bÜ%í…¯°/Ȥ“aýbÚÎÅß#¦írLÛm¿Ì{t˜Óö¸Ži{\¯Óö¸bþ"NÓvÛoÓv9¦í’Óý©kº Ì`¾ONu»*r0Óa”[ë´l‘îIƒmO*‡³ä˜ ‡X 2jûÎØ·ä¡©cO½s°åÁe1Ø’³«S7"Ø7j—( Ÿm¦¼ãhØ bÊ$g˺W`´½Â½B}S^u¨êØSo ¶E¹côQ‹3ŒTa$÷è/þÊ¥q÷”Ã<+lWC39È7¬ÙÈÔ”¥F™Ô7å¡©cO½uÔÞaQ.ú¬ƒSuҰ˪ͩk‹Âq¸›‘B¾<ÖAXREŸøÁñS`/sÕ6(\¾%M{ê­c¡îΰq6¶ÌÑÇÛ_€gçÜoQ˜ ¸x¡|!™±¤Vä¦YT…î)«¶gä¦Pß”S/bO½µ{ò¬M/»'r¸{º¬~û²îµÐÙ6R^•Ÿ©^I»§ª¹çæ ,©“ÅÁ¸*¬»üEÛá\}SN½ˆ=õÎcP‹'¨n0þ>9› xÊV76e¯(lZtƒäÕÝo…%5"£qr|sA,Ìðj»çÆ„}CžšzzÔSo&.¼ìat,r¾_ÏÞòöM¬#<ïÂí _H`.î Wò½|c’RŽqüå¬ûԪ骈u )Urà‹ÂrÚžâ¿ûƒú>9jªo.ÍSß2«‡!’ îaŠ!Ç’IXRUŽL§Ý‰Å0¥¶‹f¡è›òдÝoz3jÞó…K1|õ—‘ Û×¾XK¯­4Æ&õw^8ñˆáï¸p¾$Q«±bQŸRàN]ÿ4Ì7²‡ZvI4ÇO“+ò¸7ÿ-ƒÈ¥Ù£Ö”wd-#6(… ˆS|r¶`aÀ¶KœD«oÊ«²ÊÌñ¦·LAÅ¿vsDãŠ>96M ~7ˆE|´Ü„äͽڅ ªí¸Ú9ç8a‡ÏÌ.æÇO@D¦Š½Žs á"ì8ï@}B:#­]3-a)~>/Ç“älÙ úÁ4ø"´"Ê×ötÉŸéÊVïÄ&%Çqü7,²uªíŽ'ê›rêEì©7Ûb£õ9Ø’AÓSrh8­fÜ=[é–Ôc¿…#‘ƒ-4‰ÃpÊVs°eŸRàN]ß²+Í0\YŒFf8Zn˜¶ñeŠÒøsµ”gö¤‘Ô Ãµ8×VÂ7°¨í†ë;5ÛN½ˆ=õ–]È¢=K×Tɹavï°˜ÎBÖoQ2«¯™ræ{%6(9nŠÓÚµàùW[¶FØè›rêEì©·üfŠ[ж[ؾOŽoð-< Ã3Çvá,p‹ò=ϳ~^+åÝu–Ô•Á±ý–°×mï3`£÷”‡¦e¼é'Ñëå NØR[ vý/¶”r¦)€ á°¥ÔúñfK©yš,lØJîòñfK9l-Ò+N¢×û÷21G•-×åà à—%u€¯ÍÆÑ 3bìô¹FÊ'’ÓKjçIŠ… ‹ò`j{åɾ)§^ÄžzgÊ…ânK“;î‘dÄ3‡..í$æÙ½®ðeò„B—¤ÈåB‰pdJ†¹Ì‡ Il5¼˜Ô'¥RÏq‡®<]ð@Óót .Ì^‘¸'9v×VЬ"ËÛ:–ÎåÚ¯3—"óê¶Ð»&Êûë ND”o?ÖԎTɱ½–° é—ØöФ@ê›òÐÔ±§Þú*<¸¯e.¸àL?“{(÷5öÀó:Ðz¦× $_>Ä K*rÁ»sa=3i´Ý#ìO}Sš:öÔ[‰{,ö™YÈœ‰x\¤µ5ZUœ))Qãr¤µ¶Ëm–¸úÂxÄ"LVm÷È+¯¾)§^ÄžzçJ¥À«5<ãÈéÊ·¸`u[X·ô"J«‰{¥¼«hó<:ÕÂoOx¿ ëa£íþê›rêEì©w&ºÚŒ\^‘èj·ÈÞö‘UܨÌ(Žïó:s7ø Kj)ÅÈ©%±È!©¶3Ǥú¦<4­åMoYNª?ÂâŽÃß'6ÃZUÂvfHpœ˜çÞ)÷çXR5³E“ÇdaḨ¶K$jSß%Ö %±§Þy²x#hx«d 9Ë7£Ó}éº1§Ö)J'‹6üJ)5FKjÊ®spl#+ìð­«Ú‘ˆD}Sš:öÔ[F?Ã÷äËYÉ9p¶óþ;rèlä7…æXÊ‘>_Ø¡ªã(¢„äÍ6@ ë Œ¢íHp}SN½ˆ=õÖ8V"@ã95Šò쩚/QkZÄÖàåºîÄ6¸¹J\M“7Óu‡qütÔ™\SZÊCÓÚßôΠ÷ÁÒD+‚ÞæP€–ÙåÍâóÌ^kˆòþ”@‡r|–Ô¿br<Ñ"±ôqcÛ;~EõMyhêØSoíR<¤Á32—µ8ËÏóÚTZ;Õi¬ã·2;5kýQ¾‘ •Ø­œª]W“3äýÁ¡ÆcØöз}SN½ˆ=õ–«PQé–«syævr&ª«%Z¢`5o \rySFgÇFr¨W“cNÌñ†Û&%‹<‹Á¸<4uì©·Öc(ó{ì¸ÄÁ®©w)6ÖDõÕÖÕ‡M]>e§p,©Üq‰ƒ]“°ØQ©íÜq©oÊ›,I×zÓ[¿ËíãžÐ±~ 9·‡¢4z9ªHáEJssß)¯S'ÚÖÕ7O3M×…ýÛ…«Ñ7åÒØ½•›)™ì}WnÞ!—³†B¥îh¶‰¶b£—(væ¦>R¾|g.,©þâLw¯+Qµ=ßB}SN½ˆ=õÎ(¥†œûK‰Èñˆ_£<åìt·²Ît´SµìÈ¿.Ê+ÂÊ5´‰<8îèF,<Ôvz,¨oÈSS/qê}ü.ˆQ=r2|-s?”l¬‰Ç_tbæÏv¥ÜÏÖ mãjr.„/k]K´ *~—žrjJì©÷ŸDØBßxÿî,) Ž_lÔ¢´µœÉ2ÚÞª„åòŽh5©,) ŽC%Ôv–Pß”Oeµpì©wæ‚pä²%8x1ñFz69œŠ2¸˜Ë–^;OùT¾2ÇNåSaˆäÔžXºÒŒp*ãdª¾)MkÓ[ÃðЯÐh\MŽ­åŠ¥g-Ñ3n°ì¬òYéÙò¥ßűA)Ó8ž +°H-¡¶Wzé9º|è—˜ëMïc+ “]»s+É\F˜Âú&ŽÑÚ%*¶’3åÈÌ.lP-Mäf½Õëer£íÔÔ7åÔ‹ØSoÝËR(*»Î KÈij³Åî½á”³ÂÓÝ~‚+å,¥NlPrgøbWXäßWÛYvE}SN½ˆ=õμÜîaÖcY2ºŸ[zåêÔZ¢°´pÃtÈýÌ4°¤z Ãâ4J…u£^´Ý¢ðú†\zû¢w~/fØ#*SŠãwloqeUX“®!J_€ $÷#õÀ’Q™RϾØî.´j»Ë}*ú¦œz{ê­\pÎÆWäµK΂b!ÖÁv}í‚ÓÒ‡ÔÈÏòOÄ¥CjqŸ@XÏ•mG.…è›rêEì©7Ný4£÷0z‹áÆëÛÏZxÞëÛEHø!§Ÿ JêR‘£w2žž…s³¶Z £·ú„4Ô3Ü©«üY¥ãŽ4–•µ€·\Òz ¤AòP˺d#¡˜•2{I¥±LŽ¥¢Öw!Mm“ú¢&÷•òд¬7½3žºÑ]@ä 4ÜÚ8ôÔ1žúäå?½-;fÊoDlKêHRœZëÕãíÖõMyhZ˛޲‚ù˜ìEhÍEXÌ02[~*…™¬nžâWòæ™Ó„+‚ƒa‡{gªí¡]}ôM9õöEoí‘tÍŠ×Ó:)Î홬8ÃëÛŽôm ¾¸×dÙt—7O<),©+î<9¶¾%vn¹Ø6( ÃÖ·ä¡i+oz§ÜžÍÌ qă´3– ¥ Ó"kõjiaåG{Ê‘ÄPXR”nO Òî­šmgúªƒMMë|Ó[ÖIŽj#*¹&g¯ÈïÒPÛr^ò‘Å}rü¥ü–GÍ^'¥…ˆ8ÝlÂzP´Ý¢’«ú¦œz{êM·‰†%´g£ú~aıé£]Â5ó='e@„(5ǶG,ËÔ7åÔ‹ØSoùu-¤÷•Á÷+çÆPR`¿Jv…ãé ÅÖomÃï–Ø Z^}ÃxÞ‰Ej{k}SN½ˆ=õÖ,RüÂ5#‚F$` ¶…¬y'²D鼃¦—7X%ˆ%•qüÄ0°Ã#dÔöˆõM9õ"öÔ›áŠa¯`~úŽççÝ´_x.½íá$üe«Ëø€8‘ .å œ§ÿV«]ñêÒPïÁ½èšYܯF I„Ày°|”mñÁåÍ…ÅÌ6’O쿉%uš§Ü‰e ÉPj¢4éJ_Ä@jêØSo}"4j¶(+@Nwõ¢bÍ-œ^ãcáP“ÞKªÅà “¥jÕv–²Uß”‡¦u¼é­{Á¤Z|¿ú}rühJUUŠçÃñŠ+C”´»KʙјXR+rh•#ÖwaÑv쎣oÊ©±§Þ: j0]_ZÌçFÄ@„azlA¼·ê,tØ£(ÇúNXR—óÇLßÂnäNfÛ;s+7YÖ\š:öÔ;‚úK¬¯r-MŸ®û>ܹü¹ÙÎ:Fí#ÐŽT7ˆC'-báyzÞ^_Ð"¾¤üR¯—c ¸~ rcë1üŠƒê¢c!™9¬®ÃŠ¤àž±åÀìrOLXRY\[/†X/ymgqmõM9õ"öÔ›¿GG±?ìú>ÛÌ~7ü—ïn+ˆ„?4±PŠÇL‰H),†§>ÎG/µù„Õ'¤Ô¸S××¼a—{íœyÃ.¯é¹»6’Fû‡I*NÿVÊá¾ ,©ð Jaë(¢í)ýè›ò®:´÷~Ó[§ wDD²ª´8 óέ¨^w~.H¯Ú"þÃRÄ—”£F*±¢ª&‡à sž°.›l;Ò)FßK/`_ô–¹± Q¿oþONõ-Á¥è“Ó/Q2–™ò†ìwÄ’*‘¸29Œ»ãJÎÉØ6(Æ)Jþ:5uì©·âÉ.÷«5J‰Ó©Ùjà p»#p2j~¤¸B~û“VTR`É)=±E‡„÷-ʯVß%ޝÀ¾è1‹+j½~Ÿ”xPíÚ¡(ë‹Â³òµvùÄO,©žO:8æO!,BöÔv‹¡ê»©5-õMo-½ZX–˜ÿPxëW/Ù΄/†¦(Ù¡fKùDd8±¤®\LMEÓZ!ú¦<4uì©·~—‚xã¡ò&Áq*£ü$‚Û- Ï®¢( å yˆ‰%5²ð9X޶£’xôM9õ"öÔ;câ첌] ާbò3 `Xª}NJïô¸SŽõа¤®ÜØ§ÝÂÚ[³§Ú&õÅ/—õ¸÷<5m÷›ÞzÇnøo Eœ/Ò[∠Y.š&ö4çNyC¾bƒRvQq<Ò5°5~‹ÊX+»¨úîð¡^ˆ’}Ñ[VºW¤9‡ùÔá‘q3×:Jú¢Mfï”3ÃbäbïUmËnÒq8}íÄbI¦¶3^Y}O•çs¼ö›Þ™‚zàFKcq¶^—–º=­!J¶Î^S^}\6¨È휅îá™RW¶¹=Ô÷T•¼Ñ…}Õ[ßËŠ"âÚÚ¯xkª;º×(7gÔ~)7g®ï|v.¿GäXR#¿€àxˆK¹6|ë¾³û¦<4-×›Þº—¢ˆñ[Áñà=ûÆøº,f¡X¢ô}2™ÿB†‹²KjÇ×%ŽÛýëv¿h{Å×¥¾)§^Äžz+,°ÀìÑ”£èà˜am—(nu° _hÜàÒ@yÃá3±A)æ@,#…õuÑv¤Â‹¾)§^ÄžzgΕ‹_³\?neéxœ_ïêOŠþ‘©§ªÌÍ'ÝzbIíÌÔœ2ëÆh{Eü–ú†<55ì‹Þ:ÊžXÓø³ÿ^4#'…eBè¢t8ÍU¾Ë¯Èõ]OŠ1þâ\·´M,€ïmƒÒ1yÛ)ŸÚŒëMïcÞç‰fÍyœ……n¼š›—¨˜÷[Ê›²Þ¯ë¤Â‡Ô–.Ìså©ÏÙ6)Í/óN9õ"öÔ›÷bI ñW¾cÉy£&Öåæü´LJS_^ÂÅPŒ{¦P«iƒGúiÜ©«ìÛ¬ââÁvß'çR&qO@w!uëÁ\P6o¤¤»TNe•Ä’Úafg)'ºc=wp´½¢Â‘ú¦œz-å‡á}Ãû}Þç0¼Ïax¿Ãû†÷9 ï÷axŸÃð>‡áý;†áv¹k«y}rïžœEÐæJ QãÙ#"´2Y“ä°ñ›TÑÕà4ÄrÛËͶAùÕì›rêEì‹Þ™Å§ e#û>9¨äöPfOîÛ7w£"øk‡?×h¨JySýÔÙ“šáÏ•œV‹Ó µõ*¢oÊCÓVÞôfr¨Ì¦Ê–JÚÏ*§çZG¢ãé&òL‚"_‡8þŽq óCzÅë—( {¾pùÂîXR#òuˆÓ‘’žØŽÒ~l»gé¿“|K½ˆ=õÖ>¼#æp©üëÁ1çç«Ëµ¡#!ºvÖ^Î<ä¹Àˆ JÖzqPøMØ}6Û¹gß”S/bO½;/ ‚¯´ó‚³»ïw;VUf;*^Í5-·Œì¦¼aDlPa¹mÈðëqRÄú)ÊRÛ¤´§Ÿóµ¤±¯zË\¸·c™Ë \æÂv´¸Ì¢^–¹”oìÓ‰ÝÚYc™;ãXó"Ñ6¨Xæ^)§¦ÄžzçrŠ‹˜;k\-œO,, N½Œè¥â´QfôÆ)äf+Õbi˜œ^[Uü’QÚ[þÞì›òД%JSï?D‚³ AAx:gûÚDñVx2Yzÿ`ÂÓÉ8÷NyCr b›R)Hœ‰ÂâÄ"ÞDmgú¦œz{ê-óNõN±«g¢œ²çx6jÃ`sWQ0Áø-äYˆ%5òðœä¶û®Um÷ØÕªoÊ©±§ÞJu|Gš¥:¾#ÊüèV'ŽªÄät¬6În)o0žKªG˜lrÌà8¢È€G 9_}CžšöEo¹Ùx4?w?ß'g"¹×­x1OîEg‘%#º…ÞòÀ5W¡²Ô *Rƒä0óìÚEÛ=rØ7å¡©W‘?õÖеÂÉãirnÏ ÎZ;nvd-ž%JÃKm)gÄ‚º"ÁÚÁi3° " í+¬©oÉCSÇžz§÷éÀNNnÉaécú –F.§Û@e4*åŒ[%6(¹ Ôˆ©õÅkÄÛ²$óŽ4üq!¥6Àº±áp•PaTq`C¿‘áà‚}ýFöƒ+íï7+TQŽêÂ’š™`íRíÕî¨n5z¶.QÑ7åÔ‹ØSo­º*§ƒ³ü€´ÓÑh¹kÜC]]Ö]‰l]N'&bIÍXG%Ç\ã„õJ ÑöƒcôMyhêØSoÜË((¹ŒÒ ߯Ë ]˜øö6«à(]a®Ì(0PA(äCé‚óg{ja={R´½”^*ú¦¼*îʱ§ÞL7‚à"ÛºE‘׉gQ³ð#oO »ð€°¾Š‹PŠ·‡8hÕ/%㯈[‹¼zö›+м¢OJ©p§®òÍî°®•£?8æš³øYU¸¶ØikøQ-Ïór_ù6¨ª«Á©7îØê>j»†ˆú–z {ꛬ úœ¢#…Þ¬ˆªÙU”6Y™hÅ(&ÕØû¤jnÉn¼ØžVˆXÙn:|»´%k:€»îÔ‹ØSo…Ƹ³¦Õ™?³8Ó­WýrÓRõœ'­Ã¥´Fv!ãØ^”òg[d bEðgNŽù$ ëNÑvfõMyhZê›ÞüDþÿ®^ë‰XWq‡›üb=HØ*C4áÏZ‘7÷×XãHŽÕ°¢ºŒ<§Ö͍äÞEáµbß”‡¦µ¾éÍYdp}ÓÂ]N/bÔEƒ•í¯â–ŽïýÙvÔžò!‡4Ç¥yõÂ-›Ë›°0Yªí4iªoÊ©±§Þ2;"ñí3„«ÐDrì¥ßH“[!¥6ÀºfÑŒ·Z,ɱ‡ ‡*ÕZÙ÷{-«þµXʲU›”j±ˆƒz*ÂÂ`ßïµXÔ7å×Y‹åEïŒî£i'&Áñ$„aW¸hžN­ëãpõ±=w¼ |⤀ة3‰‘W_8ÁØWb»×±l1„7E²oÊc pì©·o »•„1Ä#ϼ5Ì$†¥%öÔ[^BHø™¹iŹᮠ{+«ZVØyª—^åðJyWh(ÍA¥«m\Ý#ü³ÖÜå¯h®Fß’SSbO½iëòè™Óa‹ 8^ùÁ[ºdeÝ"·Jí£ÌÑÞÇ)«ˆtØÚÇ©§prìͪF´ íˆÝ—6rôªïź¯­Ì„Cù)·²dл1Á,T2UxŸ~ú[¥’÷Ò´ÜIåÚY”øÖW´Ñv®Õ7åÔ‹ØSod5¥øŽbÝÁñ󣦴m,ÆÍ”øQ¬›Î#”Ó—Ø JzöÑÐ nJ{I ¶]³øû9õ"öÔ[»” ™Ðýàòûäx$ßI ýÿ]H¢ðìP«Žò µêˆåmëjrÌóFXσm;; òдÌ7½y/Õ½¤Ü­…Áïâ,OÚUYpo¹Re1¾¥SlãÐÉÆåžÐ)°¤¦N±ƒƒóa‡ï Ôöˆ]ƒú¦œz{ênòn?ÝäiŒ¯ž‘aÅ~{>—ÓM~ȵrÑ‘nòó(e'œÜä{??wõ)7yšéá&ŸºÊ§±Ã«feÂàxuÁ‡- ’ÓI‘òÑñÙ5ØÙŽäžP*°AEeBr0l [Pym‡·QôM9õ"öÔ;gs«¯YqFœ ŸNìyJÛÜKJ³ˆi'yÇûDl×Û%WŠäØd",,Üj»‡+…ú¦<4uì©·6òHJoKQ~îÉqKÜÁBf8zó­˜gÑårø‹›”Ò‹“51èê^³íH§}C.½€}Ñ[.ÿp ©KqÁÙ¸¸ynÖºåô7¦(ï¯À EòŒ[Ý®¥¶uõB ß]µvÆõEM¼oÊ©WÔñI½u¨xctéw98–½Õ Ý+¼ÕžÅê»"³å1ì;6(Eɉãd»‘mSßK/`_ôÎìuŽO¬ÏœKa’ ëWZ?î) †ƒ /¹òÕ%lP;œêÅYðü'vEøæ;åÔk)ì;õN§•Îèÿ;œVȹáÂ#ù‰Ì£ó…éøRÐËD°Í—÷<)¥¢Ç“nÖ˧GÛM+ûè›rêEì©·¾7ÏšßÄT®Mr¿R½†Q»E2P_œLÍÕDòæ;Â’j1y‹ƒØaᩦ¶«&—蛞lÔ‹q3§Þ™³§ÒQçB·²˜Ø¯[.7N»è> ÃׇƒñÄó ¬¨X¶·Ÿ„À¶Ôv ×ú†<55ì‹Þ2HvÅaó\èà°‚=tfsy9òl/;å;bƒŠ ?äLì˼2lûÈ;þ#/M+‰=õ–ÓŠ'‡6ƒ„.‘CÿÔâƒ{£ªGm“Â;]•‹ÔåÕ'aI¥jrzM,J«íš†ÙwUFUjê¡K§Þú^<Úéi~!gxM©¨<4Pú5b@iXWÊÝË/°¤zØÄaúbrv²íµWÕwSNÏ«&öÔ[ã*êX´½œïÈAÚB91™:\Þª(5,np3Tª%–T‹‘"9¯(luVµ]#•ú¦<4-ëMïpZ1«bƘ€F¼ˆG92ŽÄMµGŒ ò^+ƤD\ þƘ”ˆFq$—"4ü:ô™t2Ì¡_nL.ÌÿwÉ…5ÀDÒ*[£Zr ,ïÊ“–røp KjÆo•œ¶‹`µ=rTgßC£>5uì©wfÒ.(¶9P¯¨…€ãð…S2+ ? |t¬HNyÃÞŽXQ%’ð‘saH%ö ʶA}Që[òKÖÇžzk5Œo©õ¿OŠ ?›´´þ• º»(¬X§¯•$G½.aIõØ*'§­Äú›mç7¤¾)M{êÑ'‹yU2úd!·ŠýÀ —× 5êê¢Â¶VRŽHŽ ‡%«LNÙ‰õh˜h;ãnÔ7å¡iÙozk¹´ ©r} Ž­ -Eœå½’îíkí²3r§`ß¹Uw½›T­qõ¨! ‹\¢j{(sBôM9õöEo~/ų¼TW&‡ 4Ý·0’kúbî%ù¦ÍCî ºÀ’:’o’Ãä›Ä²z2Û>ª+³oÊ©W$î¼ÞB*Ö§ôý~ål¬ºl¦/é†yÖQ±”W··›TÍ5šs¼``‹»µ¨í¢¯+ú†\zû¢wf´øy<p¼pNØÊDQ;¯ J 'p ; ÊÝé,°Aµ¼úÂ9½#¶£ÌÛî*±}SN½ˆ=õÖ !ceÅü"ÎFU5d/ê¾ãÄVy8‘ç‡Â’Z1¿$Çë¾ëÉ\¢íã˜ú¦<4uì©w®†oœWÌ«áå~¼z«{ñåÕ[1ô‚ÒúÖ~kÉz –T†d‹ã.kõ@éh;C²Õ7åÔ‹ØSï¼—Î|8y/§¶KCå%[Þ:³Ö÷Âì kù=K*2¿œvöòÌnjûŠÌoê[òдÝoz+ñŒZD)‹ƒèòé®>~l¹º†(|Ÿ<Ü‚|U¤3VT‹(åäÔ;±Õ£Õv(eõMyhZï7½å¬Z´ÐRö'q¼UG ¸Q7ªÙõ)Ê-"µ$%wï¦À’ê‘ý)9„ClSNŸ¢¾¨ÉºSš:öÔ[ó>,€¥Et£8Ū«jíy!ë†\‚=*^]Å0\ÞµYa¡knmÝ(NU¡kÃð²Gl»ÆA‡ú¦œz{ê»Gf©SíUq.?t]ØR?”ÇàVÿAÅ~p¦ÛyaIeÝä”’XÚRÛ€§¾!OMKyÓ[®l¨o†Ú÷Éq§«n¥zÃa˨½Eù{0P‰MòKU˜K*rx§ÀñØÇ·†4žì«oÊ©±§Þò°‘Åk*܉w²±@„Žb‹ï­Už†Q§™W%GŽVa»~Eyˆƒý–°¾–‹¶c­}SN½ˆ=õÖÉÄV<¼*‰ƒj>ãR’y[[‡D‘?ÆOÆA+*+‰ƒj>¢ؒڎ¤7Ñ7å;b¶ï7½ºÏ¬l¿OÎöº'ÁòêrjOQ诸g壨ô÷^d;•]69æ£&ìt5µ=£Ö…ú¦<45ì‹Þ:ˆŒ¼š÷wä†l8z¼±ñcYf™Œ*ê^•·¤Ü+¶+jƼ/ìZÂdÀcÛ#æ}õ ¹ôöEo}ûvÜ¢0´ƒcY}œ¼p§#¨/ŽtLuùFž`bƒª3¾æÆ¬zw`mîÑ6(\¾%‡^žzkÞŸòëa¶‰à 2„%ýÁ¡ÆÂOå…/`Ë‹èÆlœ£~PUÙ&Nm‰…¤Ú.ñŽ©oÊCS‹H½µßÇqâö½Û÷Éñ·ÔöÕfgÛþ–eOrçNqø r8Ë K*wŠÉi#±˜@Õvk¡ú¦<4uì©÷ŸDô¼ vgíRÒʃsaˆ°óô†NÝ£*Hi0ª5äéÚ‰MªŽ¸Ú9Hê$,ÎOÔvlp¢oÊ©°/z3¡ r¹=¬3"1¼a‹"ªOiAÄU„ŸªãÕ¡Íĉ¸Ž“Œçâ¥æ¥VAØ¥ì“ÒPïÁ½èª$jíY]6­ o壣ñm±ž*ô% ; d0•œ5ánöæRÛºšœzÖòŒhÔ5YwÈSSþè­Y…çžq¿j Ž-E÷¥µ…øn÷³&¥‘~¶_p 6)íÏÄqÇÀŸ&Õöˆ`õM9õ"öÔûXA O7£ƒ³±‚dÌNã ²‰Òš°_)¿–»ëI)U€8îºXŸ&£í©Ô7åÔ‹ØSoy{úö«!åð÷+çB¹›QÂݬÔpüpvOyš§×I)¤WÏ` lA¶ W£oÉ©±§ÞéþÕ0+EJ;r*ÒÒáì¿T¤¬ƒo@©™Ò¾’ï@XR%SÚ $:`Í$¬¢ÙURHŽoè;ä8ƒöÔ;smkS#×¶ö2𓟴 4wxçZ]ž•o9å7º”< Äq£K`ÝèmÏÈ·«¾)§^ÄžzË;«8[5Ñ Wn3꙯^·¦wVÙæy³Sޕʣ̤ª¼=ƒãEMë)£íHÉ}SN½ˆ=õÎpÚJÓßá´ÆBÏI†I—«›M¡WQ²9Ü;åp–TT3gûA»°QtEÛ ¾¨‰ŸcP½„=õ¦çêå5V+”)ÖÈhöÈ6LæÝc62n€°¾öl0θ`™ND•Ã$\±'«V‹*mªOH© p§®üܼVv‹8øŽüX6¾Ü†í( /H¢Dy/:$ò8EGB2°ˆƒ1DXx ©íõM9õöEï Rpje8pp.$e÷üÕF¹Iþv“ûKO§¡£t¥§O 6(¥\§ú®IØ‚›l»dNöM9õ"öÔ[ÓãfiD9z“_ííËZVßyf¤g6ÓW émŸ‚p ÒÅ;¥Ül5ý»Ù'¥RÏq‡®:nŠ ˆ¤ÁñÃ×áó1«fÀ÷Ÿ”C[Mù‚I—Ø J^½±ùè·°îr<Õ6)^WʲM{êÍEcõl)G¸[jò‚°€¦f§”g¸“§ÌÍìÕG˜Ôx Lú†òL¯Ì@ÍV3ܩɳ¤Ô¸S×Üïø¤È‘œ ûÊ…2Vt¾wyD«ÂRïð îÃÂ%;„8^1&°^ž9ÚŽêÍÑ7åÔ‹ØSï ˜/8hJSœ›éÐ~ÀþÓ–(Y|x2îò¦3ô»ž”2¢ŠãibëîFÑv$8Œ¾)§^ÄžzËëc(©ú¥,C±ñž)`ª"LAf¥:DaI»” « \V‰%µ´ƒ=8u$v¢ô Ûžm¨¾)MëxÓ[vˆ¢ÊˆJ@*Î…‰EõÛÖVH )–2êe¨°¤vž’ƒ|ÄÂ.„°±í•!nE~Çm¦^Äžz§êޱ߯œ ¹œ;l6R,Ô…þ¶ª¼öÌ‚+lP‘,Ÿdˆ¶É·•¾¶‡ï«÷MùTÖRÇžzËÛóVú'2€Ãs Ëù×aªpG.M6užþ%äMs‹bÛ¸:8mëɦŠÚ&…«£®Õ.§¦m¼é­MÖV̺lÉ1;bÙQãrúJšÑï²AÏ<ò¡—Ä%¤8Øé–µ=ê}S¾• Õ±§Þ ©óZzgH »2¤Î7tgHûúJºå‘g8R·åsg¡qÄ!hŽ­fHû„”Ú¨bM©ëˆ´¸b:¬‰Ó=m+²·º³<*Ø| § ¹/)oH A,©îmâTÔI ãÔv\£oÊ©±§ÞZÌ{E®Q®°Cˆs£6»×ï2Êk³{U`RØÇyEâû¤XRWØ!ÄñÜOÝnáVÛ[^Ñ7äÒ Ø½u¨—„»ÇÁµ8 JY†o •) ÔŽpX]Ù‰7ŽGI,©×âxQãÀúš=Únqp­¾)§^ÄžzÛ½TóÌú×÷åã”_ü°PÌvkzIÿæãã§óñ/ÿ©??ûÕ¿üíßþÕÏ>¾~ûÃÌqíãüû·_ÿüã/ÿÛÓãǯþéÃ×É%þºáé+i÷ŒüÕ÷ÇŸýEûó_ýúÇý•7üûf¾Åàò|h-Ò|kqäÙgGy`C!ÏG‚çñóŸ~˜ÉÃàù÷O?ÿëßñ+Õ_ÿ¨ÞË/t÷e¾ëñûúÍŸ(Õïùúó¦Üì“L¹å ôl|“4ùóËÿ§nsV¬ðÌüM ›ASâf1ÉC3CÈeuÜNY9É”÷>O9É”*ÊI¦üÿÒË?èacßäõ[TÅ ²þÁÈÛ—Dþáïþj¯Èþ‡"ÝF±äøC‘–Zó9×÷öK…­êï—_ÆbÏžA{§gkh#­õü_~WÏD/GÓqôX»'Z¨nç°~~ó¿þgûû?ûåßÿùz§¿óÏÿú³# endstream endobj 335 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 338 0 obj << /Length 333 /Filter /FlateDecode >> stream xÚ¥‘=OÃ0†÷üŠ“Á®¿?VE°!E,”!MÝ6Rš”6ü|.qB UÕ[:¿wg¿²3؃DŽÝX9F¸’ÔÒYjµ†r—|$¨œ4ÃŽ39´¦scaö´ãîÛäçÔ#“)9s½Ë“Ù¥¥Þ2ù¸vÔ2ÒZÊ•†|oé‚iV`à‘Z¥¯™si[—EÆÓ¦µ}ÝvÇ(Ã&‡“n;ŠC¨‹®j›ã¶ÚÇÊ–†.Ãø™ Ÿ†ÐÄκ­W¤ìëÛ¢ÙŒE³ŠâXmšjÁ¤*‹¦ 4{ÏŸo’}È@fœyªùÈV‘íI^c«.ØNžädz‰V0Iµàõ—\¥í¹úë T”'¨˜D¨Òü…Š­+Pq﵇…W&Ÿ9~î¿8ÏæÂƒ§ÞÓ?Ñ[ª¬b4•BF.ÄŸøÜm¶M endstream endobj 319 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_volcano_1.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 343 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 344 0 R/F6 345 0 R>> /ExtGState << >>/ColorSpace << /sRGB 346 0 R >>>> /Length 119839 /Filter /FlateDecode >> stream xœä½ËÎ$;¶?OÑOÐæ%yÛJ lÀž…‚WÇÒBP °gá×w1¾ ™}FcŸ{áñ¢ÿΈ¨ £²2É`\ó÷#ÿøÏ?þ·?þ§ÿ÷ÿýH?SŸ§–ë¿ÿý?þø÷?þëÿÝ?þÏÿý¿ùñç?þ‘?ÈôãþûŠüoÿ០ÿÿý7vüø?þøÿËôãý#ÿøwŸÿùÓýü·§þãÇ¿±€µÿLýG™ógª?Öø™û\òϲþoŠøÏñÿñã?¯~®R~Ü÷WH?[=_!ýö0xÍåg™?~ý‘kýùá#ü_þø}àY?G¿>øúÀ?Ës}ðþ@{~¦"ù|ÒúYsÐÇóó©‡ð¢¯çç|àEϹý,ý|€ðý‰×¯Èû¹êÏv LøúF5oAÏ7|} ÏŸ-]|>ð¤ös]w•ðþÀSÎëž¼$îÏÏrÝ€}>?ûuOÞßø3Uj×=|¢´ŸÏ}×_ŸH?K<Þçï?ýFüóÏç?üöäž÷¯óõ{ðOóÿ?ôäÙ~¶|~1Âç'-¥ü\ëzj_èéç3®>ïåÿå×¢ülízL×ka:|ÓõZ˜ÎçÞð{q>ñO¼¹÷Ÿã˜ðõÒçák×7|}àÉ?G½>øúÀX>ø¼Y¯…%ƃoº^ Óñà›®×â|c<÷çžè½8ŸÀs>¡÷ŸHñÞ÷ÓøW,²‘ßoÇ9ŸuÏ0°\˜ù³·€Vþ@ëg^賊 AƧ×^JMÿ¬¼óðбõibj9¼=; ?)IÌMº% Þ[î?ÿø7|/¿Åî;ñã³Güœ ?Ïq+ñµ…h?óüQ?·9ðyVø(Ør}Ÿ+Q?[É05>JÄçÑéæ«{Ó¨ÄG9'¨”|·¬û«þøñyHŸ=nßþõB|nÇLñ2±>@ŸöD3ÿ¬ÍÔüs.ó LB´ýsŠïóM³G >Ê9!i‚ï%ëÿï<³Ÿ§`«-xÓÀz0ã ¨m¹ÒÖ ´PŠ§èƒ™óй‘×Ðgl|š˜ùóÉæý¡ŸïòYíòÚ¯ð¯ƒ(i¿å }Æþì¹üy¯Ùb¢¼™D-?Ÿf>5>jÄg%!_þH“4*€?!Àž“T‹·ùnY)þç{ß}"p÷?ïê¹ûŸ7ùu÷?ˆá»ÿyÍŠï¾ß}!pɇûËQÏÝ眠Rðݲþýì3HÂ3¼j|U!>ëñÚÀço¬ïõÇgŠØÄˆ§ç£aSk¼èä#£ÆGø !¾Ï7.5>“1'¨oóݲ~ñNu¬Zõçâ¯JÄgkƯÃ%¬o€K_Æ»þyÆ[3õóR/óˆQù¢Q¦ùÊ^p4jzŠ©¯Ì·¬|(?¨³>Éâc'J!qÆ’Œï²õ1?›ºâ6’@Œ*ñ±ù|¶+ñÕ½LhÔªí_s‚JiÀwËúŪŸb”ýdµE½˜½Žž–­èaUŸ) õ‚î_Ôôþ3·Ã cãÓÄÌý\‰÷Õé±áÓ˜[tJJÞ[î/žÐ¶×‰½9.›DÄ\[åh|ÞžÏ~²þiš:~öb>1*?JDjæëû„¨Qàºs‚jñ6ß-+ŸP~¸nU÷×…x~Ö»¦f<ì« LÕÔù3óˆQù0Ⳋ ó•½qkԸǜ Rðݲ~±lÆá,c›ùõB¬ÐÚƒicÕ*I€ôªajÁŸÒ´Â>xŽÛ4_ìW5îúí1•Ò€ï–õï?”{yO÷f(Dlj Î5ØîÒ¾Ý÷f˜ö½5ïÅD›!³M|Øî8ª7CÍI|/Y¿Ú +v©¹´Vnj¡Jñ0ôYß÷Sw8…Rìc™@ŒÊñYýÅ ¾F €Ï A}^â•ò– ùçó¼Ž5e«å:b”­åéÀ}¬•ðˆQïcMÚ3ñ¥ý-4j÷±TJ¾[Ö¯OpÛ2î¯:û>†sÚÙ)aØO|²¤È¤âË@Œz}ÕÏá}eó=ûì©Q¸¾*©”|·¬_<”%vÙϳ”qX=ˆÏ!wœ:X]âñy 1úÑW’ù PíbĪD¾¾7ÚµÕhNP)ÍàjvdýbÿKasYißõ_/Ä ú×ç‘™[õß'N< ôej ã ù üªDÌÚø>ÀÖ†0*®J{NR! ùnYÿþ¯ºMøeVòoÇ>é¬}2ØoÎÓ« Я±p]|0ªx@”G|Û>³4**~e™jñÊó–KÍgܵèéZ)-AÐé±8öÚ~Àå¯gSic›ï‘"¦­’ˆ±õ8ñ½iÔqm•ešJiÀwËJña¢Ú›%Å7âódO˜³ö†96°O÷öDŸ_¼!V.Éw>=D|¾Ügi ßGŒÏjÀQ„ø˜“TH¾—¬T´>ŸÂä>EÄ~ P!ñg/”e&=<ËÔoø`T>^ü8'¨”&ø^²ò—ª{ãØûXÁÞsŸ_s(±]níú ý[C%µÅ;H>¥ø”±õgëæ«ûÓ¨ðG9A¥4à»eõ{Òq[Š­hDìCÒÂ9"¬ê`VÒ§“3릭rÅV´„ƒñ6}¯Æ!‰£À»ÏÃ̦Ršà{Éjñ㩜ðöÝ,ày½öKº'J(~<üØfñ Ùà’p’û¼ÂâëñDpÔ$~5•ÒßKÖ/¶Ã¶_áPT–ŽŽ­jÕƒ9,^Ï8GŽGŽ<$mêÀf™háÖSm±à¦·àÛÊÊÔ¨xtLÓTо[Ö/–„‚×3J¿.ÄC½fÁR“bIkSÀŸ°C–ÇÔ'Žä#£ò£D|vPñ•Ð\8j±uˆsêCoóݲzIXp]¬¡%GùŽUo îZ¶w„ï9_2Üq~í^ Ĩ:¹Q“ùÊöìkÔøM[2Õâm¾[Ö/ÊÑØ ð¯ 1e…Å3%­%”?wS{,Âä#0¼w‘Šùú^„5j×:¯9AµxX(¬TrJøÊz—sOˆ±Ï`=ß{­÷Ó¿¯eê#mjóèrëDÍækÛ% Q Žs‚jñj~ËJñ{¬58Xüº3ÌÍ}k¡p|†ûÆøê\J¦ÂK¾)ŸÖy"z¨Šäë¡DrÔîužs‚JiÀwËzÞœ½õðQ·#MÏlåÓ»€û=©|xô&4åzxˆØùpâ¨ç„Ä9uB¢xØG¬_Ö34—dË4=ïÞc›€¤Z‘—©‹>ø ¤d#6VZÍ«œF €w¥wS) ønYmXŸp´.ñ'–Ý‚]ºÖ})M^§6PyjkÜ‘ËÒ¨×ùjßëd>ü¨5íhåúÉç4ß-ëWfˇ~ó$³åƒe §ÇxúÏ•}àË[«©®QðùIuê4¢<æëT>ø uŸ1øÆõu‰‡Óê‘õ«‡r?Ós!øëF¬xŸ§÷'îÿ>eà¯Ê³ýããù ”ã݈¹÷Tò!Þˆ£ЯºL¥4à»eýâW­ñ´c#øõBôX½ ÖÂ'lž;©zOk6›Úq^Ÿé‰DôýTНʼnƒ£6鉚TJ¾[V.ô5<)ôøu!ƾý`ai]aµjKÅ/ÝÔê*ùØìwÛÒ@¾rŽ-«šjñryË ñ×ÜÓ…9ï”u« `á­ÿ(§kaYªR]sJX¹³¡ÙÅi¨È5gLD1™7|ø:Ë9§‰A¥HÁøø‹kíý#œ3ÍÑ'ÔRãð™°Ho‹m íŠ7` íéÉ|­BTY¾qKqúíK€¢Oª’¦òL}dýBÄúM}öpÞå–Cå‚Þ™Ýðþ¼0 ò>Ÿfäû2â:j„ƒ£Ð ™jñò|ËúmÀI¸omR<•Äé¸òT’B@&¥GˆmqœâPµ1ÄÖÅÈWâüËQ‹Ü²š³ðtLñr}ËúÕr¹°°ñ"ή{1€®þÙag“=››ø^DS; ãà#0üw™Íû2_xš5j\.[6•Ò€ï–õ‹_AŒÛna%tB›éñÌVœõs(¡© àÜ—©]ÏÞ <:D-æ«¡5½šÃ'˜ÚMµxµ¼eýê]C®_b…qèÁZ™¶ÕSÐWm¦vaÀ×m–=ç: JöKŽzë·æ%^©oY©„Øé² …D>ñ¥KA‡‹ÿ>,Ø^ …¹ŠO@¾ …f•™Ìq5*A¥›JiÀwËÊ=V¯m±.R,ýÓÓ²´úÛŸH±¦ÚN›¦ŒÊ.¼œ£‹oßÒ¬Q\F9R“Žç£¿euä]“}ÈüD÷$Î [éŒhŠÔP­ÅTÞ4ðùöñÛ-MI|[Œ®Qè\·Lµx)½eåÝoÒâu÷‰Xq»Bû97/ß}žrAPÜÁ7¤ãëî©õ㜎ãà¦Q}¬Óœ 6iò£½e¥øÁNy«[¿.D˜éç„¢„Ûr:„jÉoÒº+^`ò ÈÒê„[¹øÒÖç4jRæ•Ò€ï–ÕÏ~ÂM[~ö¹ŸÃÜñ æxöå׫Örº©EïL[0*Ÿ}" ·p$G³”Bè0'©¯ô·¬V¿iáÎ/Ôè'¢Ù¬~kÛÜŸr©ß«_ê÷ê•%êwðIýÖÅåµ¶>~ăú}dýJÉy¨(v)9DÌðT-FÅYžñHÕ+'×>ˆ™ 7Ëd»&Öùò>âiÔì`AÎ *¥ ¾—¬6Tì»6ÃKõëBh•ÚC!JˆaQ8уÔN­Rg˜)‰oh•êUW©T‹—Ò[V¸nNP0£+¼ý„[7Š àg ‰:?¦ÆF'>õ &b»®ÉW£–+(8æ, ¦x >²~¡bbuÙï—"ÂK²"fUÔ PMá’°#ª©Jø²4 . ±óŽÈq³ÕQµšQµo/ ·¬N0àS™ñˆáRnÐLJÄ¡ÑOƒÈ~ÂSK—Ég@!kD„¿’|=laC:ðʈqµ(yó ,D£qtBùÜÖŽÚôøjÎ@Hšà{ÉúUDï°RF‰È!ôSÁXÀ¬àì09ÀX0ók6Qªø¶ËniTò> S-^©oYÏ;E/Sö;ETh†™gHêÊ(Óœ¦V„,‚@w¡Žƒ€Q˜~E…K wª™jñ`j>²~eé]Ì„ñ!ˆˆ.Ÿ;e.d¾]¦fÜÆà;@q„K…ߦWóÕð§rÔ´;w!$M¥µåÈú•]¤`'à)â F¨#R2Ÿ½>?M§rJëh#R/æ3í:î8™?Ã|-NµÙyÉ9AmÚ6ß-««ÉÛÞ¯Df1–øÙXŒ¡8Ê–º5¼Ïß´¥z›øBoÓ¨MÙyšÔé8Èõ–Õâ?Ü*{±`ëh` —Âb&fF¾€“ð?‹IÙóѨgG朤ÎëÀñ’Õ Û¤ªIa›'’¢*æi4§ O—zÓ0éé/Ý|Ôl6`±îËœæëñÐ9ùX¤ëciÀwËê­0Ã+‹¬à¬+Û/Ê-T:W.S«,ÊÏ0ájD~ÌHÕùIšT‹—Ÿ·¬_­h¬2œ\X`jzœµ ñXXž—³6£°X2L~ÝÇÀtÖ†(ýEcÒ”Ÿ"€­Gm\âåü–Õï C>³S ‰@0ý£î áw ô¦f‡ÿ 8&y†ØâË lÈsyÔâà.ÎISy3¬ß¹Þ¨×åH,­&ñÇýê§ŸžJ³N^â;À1ë0qùæK4Ü,ǰð«2 nK|/Y¿Ðý¦26óó‡ˆÏ«:a÷ÛÚýÜÀhäeÊBìäý&¾d;¤QöD|yž5j–§Bs‚Ji‚ï%ëÛìˆØ,E¿.D,GshÙL·Ä¨Ò严]ö !ÚþÁÄiXÕÅ4'¨”|·¬_é~ÕÅ9~]ˆÛ¥˜ÕÞ«öàãC'zÃ$ñm85@Œ@¦Ó=Fö¨M~ZÍ ªÅ+í-+³)²jÊuhéDì`paóúY Wu,+]ßUVíM}">‘|ƒ—n?©ˆoÇ3L @§ÌnªÅKå-+ÍE§îcM¿×«Ü–½S¯²å»^eýºêUÝ*ƒ×­“W½Ê½Ô«^å _—êUNm„®WIºëUöç7¹û.¡üþö]và€ÆC’»æsÌŽå!ÝÒ¼¿Ë'Ò©½¹5ŒS{ó)ïïBzQ¸iðÞrÿå»ÔþûwIåþ.­ßߥõß¿KÐOåÐr—Úÿ.;þ|—íŠ8ß…Ñÿ×w º¿K_¿Éý¯ï»°6ªfýz!>:ó)õy(Oq)>ý§ôÔ¦9Þ7Ÿî¶ÕN¹§Š¯G4³JMí¶œ“ÔGæÿÍwËê-tâÞ=>lL–-w`{'ï„âàÃøÊŠ$iÀ¨î¯¬·¬¿r´øŒFE: µŽvæÉ ËÄ·u„i&óÀ¨üèdaˆ)>ëÔÍ*4Å_ÅTо[Ö¿lí/›s~mÎãµ9¿lÎãµ9ç׿Üþ²9Ï׿\_›sýËæ\_›ó»L¶Ýî×*;~Û²‹ùõˆŸ©™è¯b~¤zÝÏõ^ó_Åü¶ùÚJ¿6ÒÛŠ‹ù‘ï–õ;ÏÈ å^ øD„Å„^Š“…Ã<€Ë3B*¢ÉWTï øQóE^žFmÖ„9g ŽxåyËêLÖ0(Y'^"&†` ÿ,÷{Ñ_tâí¦.l~à3 ì!" ÏÃΰ”=j±Én¨4LÊ–¦ðü}dýªì"³÷F)ÄdšÚäŠvêœ,'TÔGæö^¯R*Ë%b¯G€ÏÍ £Ôœ]ÉoÅ|·¬ßyF1Öœ³ÝVŠs¨sçr +t6•iÚKJ›F•!ŽÑmË|‘تQ;«9Ëc¬G|/Y¿Š©4®¸TBÅâô¬+n<Õ+0ä"28$ØNð5ÄœÇÝDîWø=†~5µ°ûQ<ì‹GÖ/~Õ!wãlŠi,S–]sä‰:YSuš“½(O6u©pM;Å(‹]#F@Íbã~ Ðù*ÜÌ,øþ\â¡´ø‘õ«_5ñâ6"flÐA¼b¥ à ¸’©- Àä3O¶\­˜/'iÔf‘s‚JiÀwËúUõæœè]%"3| ±k„Îö$|Ó05‡“|Òõ®v¼Ö+‰¥N8*>Ìu©]Ò€ï%ëW5á˜m8\nЃJHLQYÊCÀÐf@" ‚/.‹½Lʧ’ˆ\Ì×U–eˆv½‘m^âåò–Õ~4Vy6™™ð¦cWXð£%|(¥nÖÍ×4Ý­¨ i¾‘-5ùÑS-­¬Žî¦kMq[F0ôšÊk¸péTÜV“°Æ1’ž¿Y.@'.7`KæküÚ© àM©ËÔ*7 ⽎¬/7à^ŸÝ×â˜Ãð ÐöE‡N’©ŽcÏÉÀp0õÎò1¸¥ã®˜’‡Íñt´zÉúÅ’U(‹&ǃX‘/oä †‘ Ù·w+™Z±·‚ÏÍ-B4–aòJZµÉÜ¢9AÍ ½éÏ[VçÞWl>Ź÷D¬(±À"1Û5Õ‘´íº§§iÇÙ,¬X²ê”ECP%²0£{ÔêݯÉ󗺥ß-ëß_Ñ#´]f@ˆ¨d¿NÈö ¾  q;»ÌÀršÍçÊ/,3p)‹ñ‡õ„'.ÓŸ~‰—ò[Öã0bl…Ìjœ‚a*ŽÌµ ¢˜Z• »ò” ©m^Ûez<êp çl‰Ãâ–õ6 qyAæ1ªTùd½Ï«B #Q¿…n¾ž t§JQæ•a3ž+»fx¡a2Îx.ñÊ|Ëú¯ÀTú÷“—ØjlLÆÆé¤%<ä.ÄLª©ŒþVÊ "`ü`3ŸJ±ŒiríAV.MÉÒßKÖï‰ÀU\‘ˆéôÙþm±È`”MµmŽ 8fa…¼>âëQìòXí’cݘꛒ¥ß-ëw…oaÝè§ðmEÙ»(|©ÖÈðF`ó´/‰u¯HÅ™™|ìH"|Aâ‹R¿uèjNP) ønYÿþ¯Še‡Þý_/ÄçëS‹îçmd`øqꤻFQÚFG¿í³I¶Ñ]b;É6ú9&kÔ.ߨæuÊúá{ÉúÕ$Ãèsj1âEêÐPѱ>t I¦2Øôaà'³ÒÓ€_]¨rÿ|Õ£?+œ³°V@®â{ÉúÕ»J³fò»JDGpV†ÊŠùê§Qq¨¼«Ì×ìý’ßUækÂJ¬-byÔv•SÓŽ²,MWvX;£*ƒöùêLŒ¦'mmß3”^nßó$†SlЋ6+nß*(ô¸žÄ0ß`rKõcÇoÊíû©–|·¬v—°‹WvË%"PSm *šUvœˆ]*ÌùÃ|²?Ê&§Ï_WÙö88EØa=’†|·¬§|s{]ˆI¢zº |A [šMõi+Ÿ£—z!\¾çÕš<ªzÍÙõó?æ»eýn¡Ç{NÇ–=Jù1lø©ža>ÄRsÔiÍ9[÷°‘2bX¬ç²výë…@¡—nÍœqí—šž†v,ò+¦ H/oeï\¼†B/ ;…^†¥[j.YW‰G¿UâÕ*ŽJüYPŽJLÃûQ‰7Õ©À›ïÖo•8´Y©ÄQ6¼:—î>©Ä ÞZðKÖc£°-ò×…@–RVa íîpÛ(–œ¦ùl°xüžómFôá‘Ýô8eé¶Q(‡©Tóå—Ýô‹%@h ¢Q1«ÐVd{®!€ï9û\®È!eŸË'xÜPÓˆ4ÍZŸF €æŒšLµxi¾eÅ/…‚;P”â ñl1P!!º}µ¨@ 4¯XEEz â#P%þA|Ä_¼;µÈ–§9Aµx›ï–õ«z&€ÓFAĈä¡9`…ˆ£9oç²ûO3uAI€~š@‘’øzthâ¨ý4.7Ô/ñRzËênfTT§¾0 ¬‰ß"¢„èÍ©/Ï2u*2½:ÿŸèh?ðÐÝW4*Z8Ù‚ …ï®ÞW·¬§x «ÈžRú¬¿–*­=(ažȽÒMÊYýª³iÕ|=¬uµûŒÑåÊJËÒt–’9²þý%áô\/¿7aÿQ´xwš!Rp/Þ º ûæ3PÞMØC+_h¥õQsÍ êé»Þß²~“+9»®Ïç‘"Ë¥òÑ衬¦x$À7äô8!Y˱3â‹ßS£ï ]Û¼^ÒØÛ[Ö¯ê |NÌ%·«âp :ëYÞ…’Ãùµ‹[\½?}¿aâ#`ÿÚA âpð!o„£>WÅá˜óaÅaЇŠÃGÖ/~Õ¬tà9^PƒF.cð¯Ðü’ìäš–æU¿=Wµüé$x"_”é>>VžæE•s‚jñJ~Ëú×ðÞö{Q}…‘ÎWéüKé|…‘ÖWiW`è ï}…‘>¯0Òç/a¤Ï+Œt­ßävf;C{Ô+ÆÊvGØ$ð*}zÅtTw}·»{ÌLÊv¨áìù‚"Ù© Œg6•Ò€ï–õ«üš½ñ¯ä#fÄ^înׂŒ ›í0ÀXŸ½â±"| ½‚ˆ!gäÞÍQp/ÕTH¾—¬ßåV3ا&-õìÜê0ôOú•òuŒ/ÉTgOC•f§ÊåÓ 0¼«Ž`Õ¨í2Lµxe¾euáVÂ.éÍB±È(«OEz›®/§,ÄLj‚ˆ ¶Ò4*e"½BYš»ÞîÙ-h¦*p¶~‰—ó[Ö¯Vý} —+þ ™\ìMµÐu/ô`\õwn-©P–ÈGÀÿ ȃ¯°CŒZ¬ qÎBÇ&ÅKí-ëQ Ï•4úë…8EàG4!„Ë“€â’©:ø $U¶nf×'<Ì3{T§¢jNPÕF—©;Áõo/5 e±«#|‰xöŸ¨7‹6S³ ¶¶ó›¦Ïw'’‰|êáKDYæ+t‰±ž÷‰ðå·Ï%^YoY¿Xj&j` ìb H¤ËM$‰v×RiÝ@ìu³‰ïÉÁ–,úTó5Æ@>­ªÓÔ©&áO}Ëʬ©&[3æbîZ6w™à®LPUÑj~P¢] #7ŸUјj~ðÙȇX)Ž >Ú’¸©Má›ï–õ/ªÈ³þÌÜnU„9(åÊ»z©"}½‚™Û­Š<úô f.·*²3è*RæïªHÐO0sùMî¯^°‡Ö—K Dc½ˆÅPݪÔH|Áö &µ(ÄÊf'ò–ˆzŽÎJµ°wÜLbÎÊ® O3ß-ëwG 7ø\ΦÏ’.5"›evÔW›‡ëdà\žÍG Û|hDîæ‹¶×5ÉO¨9AµxØ<²ž`.¼sÝÖ{Fõ–0¹± êN²Å´õžVà).a>ÁÑÆCú“ùŠ!œ]£ŽuU?z²©”|·¬Qß¶û™wˆzÃÿÄBšðn¤bÅÕ©¶ ®¨êH>ÅõŒÈÍ|™¹P1jöÊ93ó¨(^noY¿ QoX‹ŠZˆXH £Q-"n‘÷œ`:ÇDÎÇ=ÖÒ\µZ)¾8kÔîé*ïSª–|·¬_$pSó÷Q€q\IAŽÚOqS}X) ü:à0|8ˆ2Å7"ýŒ£àV)Y Z¼2ß²ò¡d·‘nõˆÏÒªÆ$ƒ Äb"ê< f•¢ý¤^d•o~ªùžK ‡›.µ“’&ø^²~¡/¹…ÒtõìS1&)U¢8Å Õ;fU@¤}s´ ¥(öè9‰laÝШǀ’ä}šÃÒ(xèÈjŸÌCõÈ>"Pk”FáÇsRd»©A„à3PüÑÅ<±*>+Ë'îPfÎIjV±S”¼;²:j—æÛÓÌE÷©_[SJ×¶¤s|Ó.–Â&8‹ùÜÍ\ˆÈÕ|jæB÷ãÕK±™jñr}Ëêm–µ ªCª­FÓ-‹Û):1m½wŸËvº»mÍ£QùQn—}˜Ï fªéNÃÔÓÊt¼e¥^UÔƒÙ]B¬ÈҪ꡵ó·e*»«)?8Gí:66_sï…¤±³»š* ޤQü ÔG!]â•ç-«‹O·Š‹ŒJëEuNu(»’ÊRqà3P¬¹Û(Ä—cËå¨ÙrRÖl*–F¶#ë_j/Ps¹0ã¹k/\š> û!ºOÁ{²äÇûåäœ"ncé8ÆRŸ"ÞIÁ{Ë}jˆ±¶ž‹Õúd %­P¹ŒÍ²Nîڄй8øp² ÙøªñuŒêSU;F­iiwYÿ«š‹UýüÚÇ1_Êå˜—ÃÆŽùrûâû¸ýðùöíìse»cUÓ«šnß©ŽU­í-ë¿ ñ¥–85#z¿Lãå({§~@sµòcâŸt|HXEk5"ÑõÏÕ~á(•±.­±Ö·¬vá2Öš-y„ˆóü„- Gý›Ú\–€ÉüP§VßÜ ¸®‹ƒŽµN¥wzTÛ4'¨ÍõnË[VÛb:â›æ*Ä å°cÕ‰xâÕñúM_×À êDU9ð:¾ G>ñEÙEÚæª9A¥4à»eýýÙÏ¿?ûcÞaæ÷³_öë+Œæ•™ýû³ÿÜÏþÊ׳Ïâ¡çÙ_¯üëö–õ«“ݧNºXaË\ ©ˆîßœÜg¥º¢ir¿ûtµas²©Qeû¢ó©›¡ŠS¹O§èSDñJyËzªçØ~ñë öñui±‰N<®'ë «YóUµD>Ë4[ˆ¢æÅöÄ)ÝC ¨|·¬§ô,ß—h&bdUŸè‹E˜¹¹œÍ3›Ššà;ÀIZaÂJ43"džl7éÒœ%š×#¾—¬_¼S i»Uav1ÃïüÀ_ýDÎln¨ŽÌlêT",rðȵ=uèlÍ|q®Õ¨årm?ÓTJ¾[VQ0A@©€F ‘-UäUl»ÝÓbêRë*Z»FåGÙ˪=拊cµëØ3¬x§diÀwËJñ£HüŽ€a„ºaœE=ù ¬áà×­Ý!ÕÔ¯+ù$wØ3 ì'âqØÀ¾ `¸EK¦Z¼ÍwËʳLäJZºû1Ã0õÙIJލù6=È•ü˜Z\6Ï9ÉUæPn0Å|9|™YÑË©6’M¥4™ ³¬ÇìÎì³cv§ ³;o)â·’€·ÙUÛ•Û`T£Uð\fw´[gUÅvÌî©7óÈjñ_{ZÓ0ÿ¯á>1Ö‡ÊÔOÒÇ£=%f²mŠT¼ˆ@éG–*Ak–*éÖq˜…ŽÖ4iGÖ©†õº—/Cržk­‡Ú“Š®œ|š\¾U|ŠªÃ éÇâË,£ü¼©ÖL¥4à»e=Ê5—âW—ÞQF›/eä P•ÊHf­Aj&Ý™UÔNÖQFs¯Ùúdfó ¼íšÍwËêó‰Ô®ó +Z¡SiÛ-Ö³g]‡ŽÚL-:å­rÅ]~Âɇ„ŽÚÝ\”s’š0ÛÖ[V§,°øŠšKv>G3X†ÛÆ^Êwª{/eê~w FÑ)ÆRW\ÁŒ(–DÏË£º²æìŒ#g¡˜Qß²~e0x¢×Ò{2ûY…±ÉuÊž«[ÏB(?´ò(CiYi'­Ø˜¿2Nõ³|/*ÓT‹‡VlGÖ¯¶CP:Û¡–)˜xfµ‡ÛÏvÈס!‹>GU :yÅŒ€™æÜUÓÇn#Õiª–f°_ò‘õûjCå”…€ám¢1Ùð"êBÌkIÛFd TO§mCKÚ)?¾LÁ§fÚ± 9Au‰¾Þ²~1¨¥çƤÌÁÂ(ºl¿íÉ8|œºUO˜Ô”†éåˆÁª'4Ž•Æ4.Gx9[š#—pn<²~õ®2hZ«ª(4a>€öéø®²Nڜҳ¹êœ~C,6€,³eó¨Å«êË25KSTލQÿì¤"gáA|þ“É>šèÈd_µ¬Êd*s¥Àg ¿*ÃŒˆ„¹Ògç\ûª Cê£ ¸•·¬®B=müýu!‚:‡*u‡ouÛÖç” G‹’>¶­ Ñiú¥ª Ú­º5*ÃÒtšš¬Ç¸Ë$­¸R>Y/:7ÿ¤Üë­’©EåU Rp«§„wÕe¾Á²,³ ¸% Žxi½eµî·è€³îGÄxô÷Ép?¶F¸Âý–3)±ÙN¸C'îÇðîQÛî×M¥4á~GÖ/–„Ç+pÓa\ktX" Qõk<Œ·eêÀ{>ع1WÊ÷<3_yš/JGjÔæŒœÔGåˆÐ÷ÈúUËÀ3‹Wˆ¥CÌåš®÷³yî~Ð(==n×ïßÎ"êV|â¨ÎÒœ8â¥ü–õïÿªx1·GG!¢›Q²ä06ÁN€Þ‰Ïº!j8CÄGÀý⳸/­½zsTôNì9Iµx›ï–õ+/©ÃÍ&Ö§éþïòméª %o½ À,AObC™¿ o½ˆyj\L¦+G¹9ÎùÍÛ¼ÄËå-ëwe…°'g¯ªDÌlã{cEÒÚÈòPMµ_`æ È.bѶ4ÍWXÏ¥vZì’’&ø^²~ñ«¢kÉ>`¹£JÄ»s‹ËÝŸ–ª¥åƒØ§C|¦ûk¨øÂn¨Q‡ëwNm/uXðݲþ¾}+ Ùˆ•®öæO»¶oyb¦ÚŸvíØ+]€<1Þ¾›Óg|ò×ÝÆH9ìõÚ¾ÛxËJç¦}¾rnÚ+\cÅ`64Ü—¬!çfxÿ‰ØGã*>õ“Ê~wñE:Fur»æì¬ÎÅÚÁ›ï–õ/Aoôì_˜­nž ·m«;Ao<€]Aoõæ¼'‘F]NÐÛ¸ƒÞÖ«ÀúK€õN–¿ÉmMŠíf§ÝäNtD†WB“Ž.€/òSLͰæƒ@v-+#ò4_R»Ö.@ž¶%Ä/Ï·¬_9Y›Dµðˆx¤hÁ’0öøO/ ±×¬&>Õ&+"Jä…¯PcÂçcHž¦Ršà{Ézügð¬dh$6‡á0±ä*@çàej† yÒK ÛŒˆˆ}_¢¡IJײøOBÒ |>²~µçòÀ¢Ôò¤TMšåñP""˜‡+©G&ÄJcæ«:\)µ¼êp5“ùr4±å¨YGNÍ™ÙâVÖÍô–õDÎð îvpDô)§?‚gWGŸâÒlT"Y&MóP a¶%_:1 w ¨Í]Û[Ö“wÅ*nFË#gÝ´•f•Ÿ´;Å…¡Œ½]yW9_yWÚ‡œw5¦ùЃ£vïCUûZYsó-ëÿÿj¶vTûoª†!„\£´[íK-†a£½2©Ô¦äŠeUÖyL3@”l¾ˆùШŽÑœ Z¼ÍwËúÕáŠÖpŠK§×>ë ÀéŸhŸ¦z|Sž•ƒÈÙ|ƒ†Æ™èÄÿqÄCA€#ëWjøB6ÒHÎæÁ%Ù˜…úÏy ä1µ`ѧ)ê8Óú‰fëy ÐîW„8â¥ç-ë ý£D öËB¾8ÕŠ|6hcÅð‚~ÅÒªµ[ 81ú ò2_çEÇYÀÚ4Õâåõ–Õ[rÃñäq3´»_~®}]Å%úÉBLÄÁLà8€.GnŦUÆUz¢øUeù‰2,Mð½dux¦ä W§-ø‰ú?…U°Ð–¡ à‹®ZWŽ\"~5h#E/”«4•Fçº~bxÿ’ÛFûdýΊ†E·[Ñ€ØÑŒMõ·Š÷W¼§=™:€ >T…¨\½;ŸåâQ«r´4'¨u®þ–Õ©˜Q ¦nᯠ¯Ô\J n8O/q„ÎÊnÑI+*䟀êVÖD”héK¾²ÏÙµ¸[ç „¤ ¾—¬_ùðcòTAš5ñSó•“¥ëEÕuªkã“Ï@¶ Gýë•£wR¿ÈÜÒL…4ä»eýjŸšØ²÷)"Ð §2§6ÛÊ3üU3 ;C7â1Ÿì}*a¯ߣ/SÜkê£~_²~ñ«.¨§ÁóRIІT^Ï£ðÒŸ¿“–]Þ e È'À ž¢tó¡A5G= ž9gã3Kñöéä–õ_JŒíe+R—µ‹ˆå1™[ÂpÖ—’j7u*ÔxÔ B1•ð$óÅéN£:Â^s‚ÚUÂUÿެ_EŽn+Õn¼êÈQ"P±h[‚v—=,åIWïmI!5Lbâ3NähŽÚ%HºXagö¨+q·uæ2ß-ëß§Þ ™¿YÑÒ| ¹,]ë4¯>hÊ+Ytþ–(ú²¢¡‡úU€&½ ÐüÖ¶›t  Þ[î¯ÌP¾2‹š  Qy¼ú¨D¤°‹%àW¦ðA×  8 „ˆLSðez¢bÔ,{¤æ•Òd†Y¿v’ÿ“ymwNgÍ÷º“_wò½îŒ6¯í¹óÚîœÎõ{Nçºs:7ßïymñ–ëP÷ÈI@ÜÙWÔT€º2 Ö•µkù9êÙU-® ¨ug@M…¯/'K]P”F™SGV‡§²[[µAq©ÊnÕ#Ý}f¥›5[Ñl4ldY¬0BcP=UÇøb ¥è ¦QOã±$W@î–FeϬ_½SƒöZ‡±=V #raÍŽáÞ‰ýò’÷,ÄÌ2u ÖƒÜ_¶x²ž­ôº_c·ëµLS-¢ÔŽ¬ß¿SSNºƒØ­rݸ·žJé~(OãÞÚ®·fæ  “î4î}¦ùâ±Ó¨~(5'¨nÜûÌ·¬}`v””F#о›‹|Íjì €÷´=BÐM¾\é:Ë'Ròuf•²ËÓ<á|ÅÔáî.Ï[Öïöòýlª×y)Â"æ„u.Š:-w=ªïÙ¦ÉGÀÿ„‘FC¾xÃ4ªß?Í *¥ß-ëW§ž¶î…þ `¤ÍNQžÎá«ñ}œÑ¬þ‰‹FaÙápé86«Œ:+iÔ³ÐsNR —ý‘Õ faty“‚YN°Ž8Pn;{ %y˜ê|®V`Ty^é~[Wn|4j?íÏÛŸK¼¼Þ²¾ÃFò>eüïŸ}X’Å S]-eæ È'‚–Ó)¾Ž>,Eâ/B(>{¸$óݲ~Wêöe]<ˆ…8yT,ȳIh²`Å¥‚l> ìJ_¬Ë|«Q‹“Èe+ÎÇÒ€ï–õ ‹7Êöãï3+eåÚîJVƯÎÂbv1¼t¡c¥,öåH¥¬×JÙ™ ž<ª;œkNP‡‹=oYíK|#—œ`év q)GÉ‹’èé¦F§0ñŽÛ6¢Ú›FדkeÛoÚƼīå-ë÷Žew;(ñ¥õj² ØÇ¶i= ± øNã)zf‹ùÐoÉz?$ÈPg(ñ½Šï%ëW½wÏMÍ‰Ñ GˆFÛÕïæ£B_Çá×]Fbž ùŠ ö,TЦùz 9j·Í•s‚Ji:mµGÖ¯ …vÚ\(´3E]Üa”åUwþ:(¾›óh.JÄÃ’k æ- U€ÔÏaj’GÁ#«³ 3Jò=6g>dŸT‘ìaÜ­U—¿”Líèà>.o.DŠG|a¬Ò¨.o®9A¥4à»eõžÆœ§æ=-ëÞK²nZ©dG]¦V•äC(<‹37ïi,n<§ù"—C£0ËÚjµ4…ñšGÖ¯Þ)C[.TìjÄY_ÉGkavÔ?càbïÅ|¼zDyÌ×âðÅQ›]ƒÕTÓ%\óGVç"1È”ÁPü:æ`[ÈWÒŽiËÔ…à3Ýa´‘=À`æU<ªÛqiÎÆêæ foYÿþ’sŠ|×’õT«{Žê€Ú÷/—­ä ³RŽª£¦Go>órkc`/‚º5¶»ãxnÒ)yo¹¿Kaá©è¤°0–xª–xŸ\ìÖ ˆÇÔ¦TË4 Œ;…«÷hæëJa™ø„²+öãüÏØµÛ]¸ò[Ÿo×wyæý]žùûwy^Ò¯zCeüþ]z¾¿Kz•QL)£˜úý]zþMî/ò¢ãQIIÝø„ˆâÒ=âŽ6Ð#S`÷J.ñ¼£{—Èž%Ÿ€¤"±Ì­]QV|(‰£ˆÇ±N¤¢eø^²þ‹Wz±.Ì(÷O\ÆýûGóOtÿ¨£Ü4ÿÄu^„bkì.Äç&Ý?qðÞrÿë«úy7`J¿—5îïÒòý]Zþý»ÝÒ¯qC5ýþ]ús¾KXý]lÅôw!ý4az~“Û‘›ÏQ.åKÄŒäzf˜£/0SETLöQe†'º71çd® (þ(#¨Z7_x5ªšTJ¾[V‹ÏH›”$>,Ü{ž\l/UldÆ| EX1ûã’a†÷£CìCExyÔvgå4S‹z Gô‘Õ5¨1H@q]„ G6Q8MQu·=ÒX¢dóU5ñ£õ %î<²FÀuO.–|‰WÚ[VßýÉÄwŸ‚:ïஉ‘ðîg#oïp6ŸS씚KFSS_µÙ¶Ã9› Q/óݲž’m6òÿºƒñÅ/Ú‚ÞÞ‚S>Ðý*É×»¦#Êé,=5jsžì£Ýȳ§x¥¼eý*ðf-Î|åi<­‰Ã{ ÃÀÓȆPLE!hðàäiñ¼»m4!]ÌÓb²ÁÉÓšII“˜§udý*@”æ=V¶?¤¹ó‡,ËçÛéÊö]¿yY.& >ÉÅf§3^Å‘ÊÕÁÐçgžÃÒt¾GVg×Љ-®ÃÍ:F¦•–e&Nq5¡€×„ÍÍéOiUÎj‡M|ŒfL Ð_ÇÜ;… 4à{ÉúÅÙ8¡LÑzœu0û°ž²¶`JO8èÅ^—Â\cz ?x ))J8Ä[âx¯±‹“¢47锋¼·Üߦã]^Ž‚S#w4Цc2Ûý}çÚ´m^«ÐœÖrYoŒ(ù]çÓÆþÄy qÄC1Å#ëwvnx7Z²†¶Œê14ÃÁνÈÎÝ…˜Y0%“FÕEK5_Ù/±F-zÅ5'¨”&ø^²òe¬z,f‘ï(H(EÇî‡é¼šÐv¹õ9R[Ü~òðyý r7)õa8'¨oóݲ~÷P"­h?”tóaÝÁʲbÝaÐéòºÓSÃê+>1ªJ H—Ns£HZw²G¼ÔÞ²ß^”î*´áBâŒTÓÒp)_ÕÔ¡ÌÍGà˜¦†ò;V7ßÐÐHCH¦6ÐYý-ë_Nó9ýå¨wŽd¸Žzõ}¤ýõ^¿üÛ‘"*Ë0æèèú¸S3_ õ²JOUÂpQÉ•- ønYODÚyšãX/‚Ø-D©±Mz»W o½,ñ 8¹aF Ã|0ìñ¨Ýõ¦Âóûs‰—ç[V»Åx$ÖÝ7bßu”cyJêÂcª :ŠÑq9ó²#=äDiæë,ÚÈò”ºûC'ï•- ønY¿Ò <ÄÓip‡èˆº‘³sŽƒÓPWØ’€˜n~‰K×È1¢dóÅõ2»câbNP-⫬Þâ2¼ÖªL„êwŒzÁ5 àf´¦©C]ðP/¸ÊÛOê‡(²88êp1?ÎIªÅÛ|·¬_¹šiSGÐ*+܃ GZ‘QBn ÐÊßMmXnÀG [3=+l<½xÔv¹S5Õâ¡ñ‘Õ 2{œZõLwÌEi·#³Àcéøô¬jjViÜ\ $ª8_x,ñõ¥òª®ÃÇ—ºhqÂ'ø^²~}Òø¸{ƒUñûx0QÎ=Ç¢5O±÷ëÔT)ø]yƒ|0*?ˆÖŒ¢Ú݈pˆ|íyÅ?°îw­|·¬ÿÏÈÿçË©üíe3#H¨yÙdOÊ‚µ ûŒ†È´lN!”ž=X;_¹Ú^6bƒV1_hqµI;Òœ5ðÙ^œ1éŒú…O-ÖcÙ80‡!.#lªbÔîÒ0µËÈ—‡áCfWˆË|ÌÇÚw÷h§¯éjG8Ÿ·¬ßÕ«e^÷ãzµˆÚªI‰W#ãÇÄÑæ‘.Bû {ÁŸâP œt‚bã8–©µ¸£ç,Ü–Æ0ß-ëWeZh}ÑéĈŽÊd¼`}Èd™L-’¿Ï H¶nö;€93´9yTŒÓœ‰•YXú†ð#«CÌCÄÝOCí-ÃßÀ ñ|ꢮ+šy(jN3t[WµU5]:åWûݳxÔ~ÛS†©¯ô·¬vxð(³†örÕõ ÿ^¿_0øò1bWS›Ì ½èÒp¢žÖuqÐÖ¨MŽælLYNç»e=%Ïb1éÏÕÌ»ûÈLÅY\s ‡ßtvÇ0_ ‚£ö+üFÜÕÒ€ï–õsc¤îú-tÁñ²Ež ÛuéȽ™ÚäÉí”›Ò”ÁñóEöÉ Ý•§*a!÷ŠÖ-oY¿Ò¼Y^q„)¼úH¢ä“S+83‹Ö ŒnéâPn:=’Í|™6XZ#ÆI˜Z¦Z¼ÒÞ²Ú •žWT‡3r4jÔÔH^+™¡²©h[J>ês@DDA’qõŠêÀœ¤Rðݲž’´XN‘"FøÆJ£öûð'VŠ }£&óPºå’Ç©.óEí|Z®"Êíh–|·¬¿Ò=eñ‰XE4'˜åÅݺ`N´© ä3Pœ-:–•Õ©~©yT·.М RðݲºYBŠ{?&XwÁZHcYÀ“,ÆÒ€¬LžÄw’Ìú±%â ¿:6”%@¶„bªÅKù-ëß_W—®Ä(Áƒø¨dËg?*Àš* ¨¦g.Ó°©KÊÓæ3À(A!âF,bØ%Ÿ§”'c4'¨ö#×ç-«´=à”n&¥›“"s¨ëÖ)ÝÌÚoБYm|¥ (®ÁêxmŠ†ê—ŸÒÍì€ÒÍ,}Ýæ[Ö¯ÊSvèoÊõ7b ÷(ì,èÏúLÊõgƒ{P—Š‹£Y.ì.?,…ês<žU\üx¬\ÉÒ<¬vwdýBKhXkNÙ/#¸ŸŸÂ^Ýæ {_éÐÞT7óã¨8ÔöçyÄ×£lÑ< yÓ¸†©MVÐçyËúůJgfuL›û×)hÚ÷ÄïVÑ´ïñ¯ú@mõA! ðÈþè Më1_Žß­ª ~Õ¢F›JiÀwËê¼È0ŽW·!"þc?Æÿm7LÀm¶,S‘¢O>®Ôsi™O 7{Àoºº©oóݲ~Wµlü¸­®Ëªkì³Ý†Ö]_ÌFVÜS³N¤['`««ñÅfz¬®Ë!ÔÉÒÀêzËúUÚÖƒÛͦ™1QN.È'êöô&@*E65ê*ˆÏ@ñG'\í1_Ù‹»F-Ú?4'¨”|·¬_üªˆMB(è¯ ‘i¥˜XL–#žpWÈÕÔ©n€ØMúÔ¨ühwˆ:ùXÈAUŠuèîÂ=.ñryËj³eg-V·Ö&¦VÏC1Ö5TH,3ø'“ýÓ¼L7²]tÞ?§Ú€Œ31êmºam=–ÿ´]ê%ë¶äF¿ø¥„h4×pë(l¹ÄKUÔ`cS‹JYl¾¢.ÜŒ("B/ÄaVµÊÌ£9+@Ü*a:²2Œ-!Ìg•_7âSÁyÇžÄêÂØQ·uzUMøà­nöóøÓÄldžx{,–»;yOs“nIƒ÷–ûèÇ@-]Kø&=4Ò·(ãX‹ês 1ÑS|bT…(Ž_a<µËI«9;[>Q<ÇY¿ÒYµ¨féÇDl×pftfœa+ÒÃY¶L+ðæ3À­\ˆ±×=ñÅ‹²NdŒ[ ³úü¦vUXÚ|·¬_Uƒ‰zF]¶!¢ˆá@ù;:âÍÓlIm¡ß“€›ƒõ“|-º´sÔæ–ÜœTJ¾[Ö¯R°ÙÆ…ÁËBDî0³‘`ƶér"¬ÇÔG$D|pcŸÇÐNß]‡°7! ‚õã–˦Z¼Üß²ž`®$#ø¯bÀ6Ãu=âècW4ÔòC¾ zè™@Q4ªl3v1ˆ¯1Õ!y‘—mÆ{‚¤ß-«UÔ»O—jæˆ)£™aÐ4.)4%Ôªèæ+Ž]v4è’2Ži1;ÊØþ_µè{.ñò|ËêJ€ÆeÉI%ð$úfNy¨P¬hìXM-ÎÛ,úéAZ ‡:ÄÕµ8j?=HY‡xÒÌÀs½eõ‘9ñNÒxˆè]Nÿí©‹ãSjŠW«™:ØûHc›ê1]«øzØk8j?ݺ†0– JGÖ}Ù²ñg=êÎÿ:ˆ•—Y©g$ÚÌi½ìM[ÃÔ¡hk2`ùÉá_­9º“|= ØsTÔ YU¨¥K¼ÔÞ²ÚÎ\ÐܽŠò† Q5]…hSÈ»LuÌý¬ 0ÝG§Z2_Øô5j³ÆÀ9A-ÊLmé-«uçÌ@ç"Ý93fZ[ ]}§åV·ƒÔ¦pÔWjU£JÍ¢ô˱9²G=e¨«ü #_â!ÒáÈêU43ŠÛ."P¯›hÐÐƒŽ‰ÇëÝZ¦:PUÀ GèËuó ö®E€¶–.„¤ ¾—¬¾û̃ήÓC¢!TèÏaÀ[ªB7x†«ù äøŽ»ÿTóE©eÚœ¡ð¸kç²4éÝGV*VãÇÿñÇøñìm|ÿù_~¤ÿëéÇ¿ûC¥V"Öá+¯°èïùñãþرƒ[9·R¢!1Pþ $d ´âÁÍ%»ÿïÿñÏ8ÿÓÿmÿ££²Âé÷þØÿã¿þñßýãÿüßÿ›þ#¿ûïÖ‘þö?~ü'rÿÛ-öú¼l÷ß-vÚO‡ÅÞß?ÿøÏäX°ÿŽÝØX– &ÀÿòÇ?¼:ž`’òFÇò¨õðþ@{ö“ÑÊ­mef“ÇCçl]ä)"ºÈ9GiCÑ ÞxýböIˆÞ¢¬ÏwŒQ àõUóƒð#}UÀ×ZA°®>xà‰ƒ§¤t ÛŸ}WEt‘ñ”ŠÌGøúª)2=|/Þ(m¿<þÀëG?6ã¯Wá# ÷ýtkÀrü¬OfÌê¼–nQEÛâF]'»·>p]th}xjôDÄxÕ 1i!y.ùî6OÖƒp$m ”à‰r|pªÎB -¢ȃë¬Ã…áÏKž¨[瑾|ΚdÊý%ßÖ˜8“µ®Ê…†? åŠ#Z‹ºa+Ðæ&ºŸæsÐ%-N‹äÑ5kŸ)yâ€ñNüæ 2€ç’ïë êϯ¯búÄ)bòù‰N —‚)j¬:âàÔD òU¾äÉWõ—j)*¤ÉWéúEhü¾¡IV5ÂY½“ƾîq€ê•×:É$Ñ¢\+ypœ¡ð³"Ã-xž¨¹ƒñWäÁ\¤… ä¹äcU®|­Ô¿.Dœ7{ SW‹`·ŽHI{–Žª»¤"ä’|ϵ¼ÇGø¨ â{¶QV£>2ÙjNP-Þæ»euâôçkKµ© /dJFHL…þ¬Ý7rD:i\@]—ÓõéÙ›lOäiQlã55Â\¤Að\ò}‘+=¹b%wŒÆ3Þ”v‰gòš?ÿçá¼ëo.òø:Ù&±aE!ožÄ:{¼äF˜ ´É•²¶—|_˜ÈðB<ªÜG8Ê?ލÏß"õfDáþæ¼DMAäÁµ'„Ñ®Ü[§-bPȣ룙l8©ì?ÔÇÆñw€À\¤Að\ò}¥Ádh ó¡1 ÛL<hì[¯¹”~6$À[¢píþP„STÓO´çxÉ‹æmò´ŠlË÷•“¯ÆâÃÞ‘„£þˆ0=v yåµ|I´èJ\''=Ü"<-ªçc<\óYøÌEZÈ@žK¾¯Çzܳé. =6õÖYkî) ßÚa¹"Áž%ÚÜz2yp}Š˜.•<5z<`<\Óê°OØ I&DŸ[>»Ò{Ø+–#M{H GT +AF±¦Ák=E•ðvÿLòðÚa4ùi!=âþæà5×À’D“Lhdù^˜'rï³qEç8œSŸ(³ÌSì£_]g\Rqú­WÇ9ŒzŸãÈxÎÆ,Œ³± ûl| ‹ï’õ˜Ícóè®B²áÆÎ=6¤aׯkÝÈ,Z<àáµ{vNI<5¢_0^Uô)çªô­B¦”^òÙÍ‚cNw%ÉüȤU¨³¡ÅLm¼¦=FÔ–Á‚ú`wbB 3궤,“VŒ‡k¹¨§h!y.ùŽƒ7LZå´2 ÷uëÖ êsbÇ27öîÜ)]«êeáFÜñÝo-Õ ÉZº!ƒ–nË÷U nË(ø:ãV¢Xÿ^ò—W›±>¬®¶—ÉÊp\Ÿ^ò#¶I4)ae™Cãe7’Ç\ A†ÂèIË÷U±³Ûó` g.HËæ¤Ë×z?šh±M€‡×ɰ‚ÙÈ6ž°Ñ9®ù~ŒBØ2!zÙò}n»—¹îJn€G¤èGñIÁ;¾$óš*É~²4½ˆ×Î96œšx¢€Çk2r.Ð$Sj/ù¾úíZœoóÔo ðø}jD@Ñ›éH‹JuäÑõùWœ[!O ×R…aÊ<·|§¯J< z—‡1Ë{Í cØ“x-åwˆÖ¹©Žç\'®‡d¨}öá©‘h‹ñª³p1i!y.ùœª¼0ÃP¦2à+áçàÇöq/ùv¼D Ç/ytœLþ÷ì‰<[*y€qÍ5ð颅 ä¹ä;*FÜÇÇÁz=VL¤ne˜Úâ-ƒƒâÔxi…ð e<¼>y™Ïx³¹f㵎YK4È<·|Çž“b­Î¶ç@ÛÆòÄak÷q~v ®iÏC´ØÉƒëâkÀa›%O4RãxY~fÎdÏ%Ÿ¢;+WEÁBìhÒ™pOôjŠòª‹Lbm_Š]Ä'À†6 ú>良G*Gír#iNR! ù.YyÃãt‡ò× ï\žøažˆ¯Þå43¯ÿÄ3¦h•7¹÷s|#qÃë#žøé9^rîæ 2€ç’ÏAXkЫõëÀ± ̰ŽÂ³…ªÇk6ËñzͰ¶’×öš®‹$³qAÀx¸ÖvVD ÈsÉ÷Ý6#ÒÙ¦pÖÂ6…Z‘ئ¯ur΢… I]Ÿ*s=Ê©>]<•5æPvS4ÈžK>/䟻؋ÓX#eÖm$«°b,^sÎM´ðè:ÛŠ1âü‰ï»y"U‹ã%g¯`.Ð x.ù¾Ší±¬e‡‹F™{žÇU~×R­“hgý±ÎuvŒP uúéä©“ñó³òšOe¢… ä¹äû¢oHÔ)x"Eï—á± ([Тn0ªà: ~Q(´¨ @ž¸~Ü(—pÔÏIïqëfÌEdÏ%Ÿ`SH’ÿ V;8*aÍ+‹×T­?AÒB!®O$SÓ7Ï3åIZ¼¦Ep;1'{½§%žK¾/Ô8l¨Mau†wáרnüYÈkØ×¶/«»wmÙƤE9eòèZ!ø€ã9#OTÕáxUÎÎdÏ%ß7¥ÍCÃiMaæB„mrŸ“~C^ŠT“æš‘{ÿÛç!R£E•ø4…™ žä{ÂÍQ=š“THC¾KV/tÛ-ûÈìN¸1±î³±îèÃÐX?K$®iû,I¤ÁÖÞ˜* ïó°Æ 8gñÔ0ëb¼*k;çª4C¦œ_ò}áLá-+*#D¸î3ÛŠ’uÛv•&Fã5§ˆÖòàºèe¸tñdæÄÆk*ð_!›2mžK¾“ _£™[¨ h/œbԱ̣𚦼:E‹ª,š¯Êñø¹úøÖÕ'Ï[G`½H>¥F{Ó&±‚ØíÅkªtSÄ)m$òø:ù”6bÓyŠx’,/‹×\äf%L‚ç–ÏÊŒ€Ãï0Rb†" Û [ıá!C´J#åStmžá´Ä“hÛ‘²9νdÑ$SZ/ùüT”‡¡^¿ŒÂë'1N?×üµqjC¹šA§®Ou+Á©‘§¢R{ŒW×UCo,Ñ$¢°-ß7Kè _P–_¤q}€^£]!§pÿòwgòL®¨ä#eË"¤*åqÔ$Ë€æ•Ҁ‡¥5Í> 7+A Ã9G>k‹Àá ¬N2a{'5|!âÐå+"’þÄIµÉ]®9I…4ä»dýBqŒèé'+¤ÂðȬO÷D¯Ã5߈'‰‰CäѵÊÈw xjdª`¼zç¤!Z¦ Î—|.†w,¹à¾Ø`h˜PÚ®ðšO:VìRt™èÁurÞBõ´vòÔÕÁxõÎ]´<—|_„-ΰ¡–}hûuàºÛ™Û&ñ&´ÏJ›ˆˆ ¬‡\вþ„ šøÂ—ÂAóô7D›2î¶—/ŸË•_9/-‚ëèÿhHòduõ[ ߉¨áUŸ€üÊviY3ŽËžœf3®æL ˆÜÒï’õ‹ÐË•Ws"’ábá‰óÃ.ÊqëWsÛˆ5L(>®æ&DÔC pÔ®}Ws’ iÈwÉê­F¯Shö´ †½US¿·ÀBõu¤¯V”(xm×¥rO±ñ ƒZê¼–Iw‰–h¿@EËwj/¾¸¿nxªäÕèj*Î!» ´ˆ} ®O}F„¡ýrm|y9ÞY0hAÍ,ßWe¬>:]?–OxbM÷σšvrÇ5•£½!€¶ÞÚÔrãI‰ 8ò<Ñã=H“Ly¼äûâ¤êÿsz‹mÀw¨XØ‚`§«ÎÁ…M¯FIöµÄ£kÙ‰éž.txhÓs©OAâ¹äû®~ßoW_Î2“ø.Ë…8¨Ç2"Võq±”Ø<#^<¼öÒ NU<Áo8W?vÜáÌý¬#Sª/ù^V°nç2àÁ¾3B¡è~X¼¾¬`ƒ®¼mé—E¬Ë$O8~òįÂñšË˜«]–/ð\ò}e£*0d+YÖ­BÕEê ¨FÝCõ~FIŠ. ¯“ú N‰<´nÅx¸ÖZÙå‹ê@zÉ÷UÖ‘,Üb ÏxÖ¤‹vGKFQ%ÒúvÇG×ù¸k#¾ª%ò´©º8×üívÔh!y.ù™R;Ä<ÙnÊüg½Üå³Â<°íqQ"ײÛ%Ñ¢Ò y&¿ë?ÎxÂÉÏñ@À¹@“L´áUÇÈ1tnc™_Ã=¢¶àhÚÑá…¡ÅŸk‰‹È£k5 x„¢Äc¼aås‘2ç’÷8vÍ“dixF(ë=ºŸeMëÇɰ±““±(äÑõùf5îhëâAú$Æ;¹•˜+`Ê<·|ß½Ñå>&FÖ Äoôªç^¶kCÙ_õz£×yƒGùíîäáQXotËï7šyüE<—|¶üîðæx)Àh"–ã=d¢Ó®¹'<ƒð +5xxÝn×uÀ5x"<1Q{¼ÇñR“a:¨½™PzÍòDW™ ~Ýð(l“äÌ5ø”¹ÖèK@“¦:Å£ëSÙ°:,§Ñ_€Ì5ø ”¹s‘28ÌÇò}O8ÂB«hIÀ#JÆnÓ+q­ÆkjŸ=•´ˆ–#®»CÂG×Wò´}ç9^“’sÀsÉG_g´%~\úƒpä¬gë§°Û¯Çë§+Æ#-Ï’×^[ ïêBÁóDQŒ÷¸âæ"M2mžK¾¯B@`Ãçé‰ð³G‘PõDÓê>u¡¬°³Xgû"¯«t!Â…eÑ3ŒSãh`®ÂÒ=ȹ™å%ŸÃÛ²ñßZ–a¯FÌff þYxÍçùY¢5Æl¦¥ëO¾µª £‡1›hŒ˜Íb/b6ÙB!‹ç’ï ßÚbj.ïpŽlêŸ ê! gø _ç@¾!ž¸ÆxÚ?ÆÙÉаLއkî-¦LÁsË÷U¬4γKCeªÀi¯„i°2®¹Êî —€g ÁÃëê —t¢^ÉS¶NÂñŠ –s.Ð$S^/ù¾òÂ?±Ÿ '… UÇ8®™Fù $^¡OM î´€$,té€Lh/aùN›„ºL:"ëS”?„á¥Çäu¬´‰Fþ†H’E^'Š×(tž͈0^uÓ#ÌEZÈž[>ïýp`T7ÃwÅ  g-Šˆ¦[âÙúÖ¢Òy‘ļ¶Ä€9{£É7އk­•Y´Ê¶>^ò}ç†@¾“Àbמˉ¶Õ] çÈé¨:Ã…o¡›ZÂJJ>EÆùBª<áÂßUv9ªÍášTJ¾[Ö¯:Ä¿±PáÊÅ·GtÚº¶·å@‚U s‹¬\̱]ªò‹`˜›àl6mdÕçá\™‹9d‚ùÊò}uô­‘“ÇüI• Ó Ãw3C¼¦rVªhq$®m*$œ¸TžQ5Þ9æa.Ð C>]25âí"×´GÐð¯ Ê^)¢l:ù:©,»Ú!R³ƒkâKRSÈ×–Ê"~F ³ÿX¦&&eß%ëU 2Œ7Ü8…èQ©)E"Ê>ì¡£úè0QÕQ°£Îã0·ü8ˆ¼Ì‡vÕ-?4'©/¯·¬>„-„%¯G[nŽÞŸ™×|Æ$ŒêAàñõ©€Í°gñtª9óúÏ£n€ÀsÉ÷ÅÆ8µH?Úf¸AEAÛ§Ð/÷Ù"àÑVÉŠ1  e.Ú#Ÿk•¬ÈZÄ'yà—Ãx—Ïnñ¼}vS õ|ÉwJ œì”@b<Þ£I/6 <ùNÖÊ¢E©ŒG¦+\ÓU‘W¯Î7iÓ Pm]ó(®ðìÝ£p<\ÓøÖªhi›ç’ï÷ôÔú •@A­«tÓIOuLåUºéNO >g£¾B%žˆµ»J7õ+=5¿ª‚ŠªÒM#½eýâÅg¤…K\q®RÕþOîÞ]ç’eióÏS̨îW2 !Ñ!Ð:” І^ŸS™Õ=ݛΌTV~Y•k­îºä%ÒBÞ¿áñôŠî ×ã>üswwîFG ”ª­Ï ;è|¢TíëÓIîÒõ; —%{>¹š×4>¶‚H. c–Êäê‡léþÛëWM^͸ٕ2ýz}|Tr¥^šO]ŸeSqbut}7Ýr:%'êʉ‘äBAÊh*NìöøÜ7ãQ¯øqõŠìüÔõýNõöz§Jº†º’³k$gKÙ/Kº~ŠþþöW|û¨"èïT­¯wªÞßþšO]Ÿêg¿mÅß”KýtOé½$¤À­—[ÛñR¿Ä’`¡CñðŒþzxF¿Ô+é©ë[ý¾_ê—q=û+^È"n<ûëþÂMNÚêZÌThwõ#¤¬¥)“úÆ…6”»týPÿ/FNÇTº–Do«s… šnÑ…téŽt5éc-@ÄÎAÚu¢Fp!ò¾Pe ÙY¹hÈ*‹§o2.½\ÅOÞ¥&³×OÐí\Xè9m,ó7æµ0-Ëâ#/"5µ}U"mf,ÊX!Çó@EÎUuÕdúºõû`ËL=‰è¦¢˜ßþ åXÎä¬Ä°dVæ´µ<+0Nµ“›·d\‡d,N‡ã5NÀ\M>%™K¿HFéfîôkh¤Ow<‘ŒÒÙæ5kñÆùÎ(£vòëÝ¡ F2Í 0Úüd}‹Ó§]¿Oµy²A½ˆ Ò9Ò*`€ç¥³mOÇdÚú6›-‚è¶þ«&¢üP§íâšà×ÿ°ï1UŽW£H£ÍEžé@™K¿oþbÁ~üÜô¬ŠF³êÃSΔrû‹Ék\Cgvò7z –¾¡LaÏèl‡¿˜¼ÂŒî–ú}Xã°õ~ˆ80âÄQqâÅãº'Î"'[2j'Cœ8Œc€Z‰ã]ï‡ÍE^bœ8Ð`]¿çÉsžP”û䉪–~WMåºÉ2Ú'î¹)Žú”1•¹»œ½àu(RRs’+õrêú)̹=yXœ}¤Á;ù´ „qaŸFüŽ*Ûµ+Ç»ü˜†ÅJ™)£ÂöewŸÂ?~ë­Ÿ£’$Ä;Pp2"jv ³,e#¢-Mid4B†ÙÛ“ËÞ‚€ð–•ݸrWä-K§Åð×ïCí$ü03&Iç3˶`ôs<±#<—èAÙ›ðÆ§†%ü†‘ü^íiQì¬aC¢Í›@âI­´*~r#æ7€{@O[ÙªÅýe Í%Ü­x@J’ŒÚ:åLbÐjX DÎìSŽÍÕÜsÜÌ›¥G]?‡xm€0M¾:_çžm°°Åð¯Ga›«nÙâ]b=íô@žX¼°‹Þ›ã¡­Õyˆ sé÷ákÜï‡j«EéÖfÙíkÌqOlÓP›§xÃÜA»Ê•DÚpì)SΪÇñŠÒî9xÐ2—~~˜€VÚ: €Fœ^…iÙÎG)±­³ÀOû?J¿0À1q@á—dÂÍñÐÖY ŠW™®‹¢/®Ÿk̳¿Ÿ^@|ÕêB”Á6g@@Gµ“ v¬•£=ê§Ù‰¥-ʃwãxhÓ4’x•içm=ô»`‰[–(˘˜ìzÖP"'Y‰øæX2&¡.çâöG9¹øŸnKÿ?Á<”ƒ1‘£:¢Œæ$ÚPîÒUê#-Ö·5uØu€ 2Y³“ÐD#;×2{%׉AÂÍM(M9ÛÂ4ªïoš“\!Æ­öÔõyþ°’!O«ïUEbÜU$Æ»ŠÄ¸«Hô»ŠD× f૊D»«H´w‰vW‘hw ŽÊº¿Î¯pI’¶Sn‹Ä:_Ÿlsç-ôJŒÞÀn.ŽÇ¿›¦)Ò‹-Q¸ÂõÉ6wèŃW8×Ï/DUðQ?AëJ±¶p"mŽÉá_‹àªÖdÚKÆ ÙŒ:WÊT¯ìÞÙ–¿nÇ5:¡P˜ë÷ÙÝÓ–ûyÙ±•v‹„Üä>(·»‡ÜÆú׳åyÑ‘—?NSÏV)$îÇiÞOå.]ÿŽ»çå/)·¿ÄÀ©Âf<ùÎâºÍ8ü%ùí/I·¿$Ýþ’ôö—¤Û_’nI–¿ä/þª¹0÷‡»Jtœ2©¹z¹Ý‡\øªÈHÓ_\K“œˆÜüO·™sÎrÃõþÔæÚPîÒõïüªãíÄ«ùúU×íÄ[o'Þºx5_¿êhï_u]¿jkׯÚÚëWmíþU×S×O©«ÛîAÕ×N€H%»t{5PP/O¶¹&®*P9M†íéGŠÌ½%RŽÌ`Åž<Ùæm©gÒÔa°‹ëÇÕÞÙm:¨»èYxoV:eN´ÁëU¼M”ÔY¢­ÈÐÃÚ!Ó ¸ãuuÇ\àAÈ\úyúcÏLÌú Ú\ÃÐxŽ›Àâ(gaûÌ0 Ň¼Å¨Ý6Ô^Wú#è\)ƒä®¡ï„ž'ÌEžt:2—~ß_³â>5]+\Æûyx ×Ï qxhá±WGŠÃC=g˜+:âyx Wê¥öÔ5`™, /;èi¶Äd5I©(ý"c¹cžñ\‰:PæÒ a=@G•Ì> ÷D’BW M#jº%—(#ã”àEç.™Ä²j­_ ðœ+1R:åþÐï“Á²É¡d@Ï·ÀŽB ³°£q ì(ÀÚ"ºíÀŽ"DÌÄíbáæ¼ØæY¿+q‹ÔõÃÓÆ’’MÉÙ¤-–še(ׇ•Co*ËW‚‡w2“É«|Sþ½Ôz™ÌßgW/¡Éäl/¯yxÒéÈ\ú}rï Kgìøa@ Õ\:¨l ìøµÙ–s¼‹gË7eОŽ/±ÏÝ -=¿Ùf¸J[;:¥ñÐ+ì>[Îph§·t.\CA7`Âé\|0¬†s-ÝbA™‰Ð‘-—Šš<ƒz4.©bR·šŸÐRáWåkâô‰É,Q:oIñšÌ*´ùÇúŒÚÉ£;úà#¼ /^ÌE^fyŒºúýöŽˆêý:fåû–ŸQäzí)æú©=%Y*öÜÁ¡[3ÛÜöÈi)¬À|Ò¨9™¬d^]ðž;¼ tȬöêúý Ym/ Y ÃÆÛ"‡oöý.QN±ú40L½K°åˆSŠo YŽèÂy¿e+)ÎE2ÑŠÿsÓÓüG]ž…ƒö’ÙæEÈJÅð`°:K´÷AÚâ”±Ø Žçqœ <è™K?GÇÁƒÉ`§OŒ¡yNzfÁÅÙÙæZÙŠxæì¤ŒÚZ£>¿É¦ Ê~b¼¨*й@CÈÜú}xYšÒ|¶ŽûL²_(ˆàxnDð¤s™©¹ib;ÉpºZyJÈð`eã¡Í…huQÊ\ú¹์˜# X_ìîÉèȘ›ÊEßvpFR ¼¨ûŽ˜s:'Ê *ãEÄæ"O:ÁŽéú=÷ÂêX°aXˆtv§k´wºF»Ó5Ú®áuSc§¼Ò5Ê®QÞéåN×(wºFì#/¡¼Mšûj×k"ÙY#/á‘`QþŽ‘på%Œk+¿G)Gž—pÛ¦Óxêúmc´U! ¤·'líDà\tÛ#úZoÓI‡@ŒÝ9ž6F£Ó’Ì´¸ÆE'[wwPZâI§´ú}Ú»ìP?7½Ýd˜NkÌ’›‡n/€˜ƒpsȨ]= 1x£KÆRå9^õ 5æªÄ!ÃApô‡~Ê $ßÊs«€²·r¼$Q¸½7ñ*mR¹ª]}+`7 ·;»Çhk+8¶rÄic+wýég¢TS&€Ê‹í*ˆu™æÓÞ‘?ƒtµ)^g‰ž’ÔNjFF|ç¤ÌY3+ÇC›Ÿ¬4ñLÊ\ú¹Á'+Œ‡4 Õ“§·%Ø!)OÀç#ÂzŽ¥QÐêl{ÓiSq:/bx0yÒ)í‡~áñ¯f'_‚G‡ÅÁš?Û v,µÐ ùÁKun·ÂH”1é,¨P*= uøÝ‚s’+õJyêúaAŒÖjÅ`Ä(††—ÞŽZ1¹,hKf1b¬ùBÓ6áu(ƒÿ©G·@=¸Ò¤Ã$Ò…ë÷)gÖ•â°X ¦‚Sv³¼Qf°{hëjâuZ|ö‚vq ¬?}P¦Úiã¡­[V¯ÐúÓÇC?Z ”è¼üK1o(…À3Øp“eÂÔ̶™ (‰¼Í»Ùp·à3çtÉ’±@kŽ—#ʹÀ“NGæÒϤ¤çŸ›‚úÐ>¾*+"¨^P× !qÀ[-ÚÙnM5dª2þqÀÛ~kÂoOé…èú9X3‚övhÓRU‹sH<·ð쇚cgÝâé^>²ÚQ^tÙ”©›K2î×Z’ ƒ g P—ÂõãSa÷ðVdë ]ϲ²­Ü,¢Qvæñ†Žmx$ä¢C™BdZ9œþýRÆ 1/kâ\àI§Rú¹}ÛJò,m)³­„Èv‡O¡ø¯Íû®á»WøS;y6w÷ &Ã*~6ÞUá¯*hmP‡ªª€®ß´€Äš E„:6‘s ™¶ù¥Nrïü¾a‰[Îæ%9eùŸv$O—³Q£:Š‹æ$7±ŠÃ(O]¿»P-Lày8¿â¯ê}Œ®ïø«zÇÈ”;þªÈø@¸RÁÃz—ßñWùŽ¿Êwô Gµ7'sÍ,¸9½ñ¤Û‘ô÷ájzÐypÛØÀk,Û„¼y´yp#:=•ënêÏÍœ ¼Lê¹~û–9Àésüê¬hq`ÕÑY˜ÞA[>xòµi¨ò—ȵÁÔ˜ƒ@3X’æÎ^àýzè÷oS㿘j î=yP0h ¾Þ†›Ó f[åéîø2ÛÐVÈëgï¤ ÚŽ/ºYéÈ431a<´ùDÖ&žé@™K¿O†8<íŽúÔØÿpÄßls]m]<ù~`,‰íöeÐ0 $<ýj8@B'\”\?0„w™)¤í´sÌãýûÒµ¶NK¾wñÄd{ÞN€ÂÃÍ`x§Ïi'Å©ˆãù ‰se‚B§’ú=Þª3¶{в¿æMçóìpb|ÖÁ“×.ûûQuÆ&m±zþN•ï[y¼à5Ö©ë¡ß§D­Ìñù¹é±T]Ûηӌ ÝÏάÊXbæDU¡üïŒ2‚¨4R½]D˜‹<è™K¿ޱN#ÀÂØ*?4Ì#>-öøäú 3G /ˆðö´›£}‰F*GÈÇsÎU™âúyÐŒ‚ÊÍx™Xµ+LK§|«ß†g}æh+ñq1Ú(j4´¨Ú%äµAÀÏÕ¢R*‡¹~é€[V|rܪ¾®°+wžv¸e´n9qíB¶SÜ2Ç‹„îŹÅ㢑B|é÷/á|<“`’~‚.¼|ã Âå%š§çu-4Ó—¦¶C-‘†72NÃñ1Sp¶›`‘"4ì ³•Ý|VÒŶPM¼Å!U,ާ”ÑØÖ¸eV×Tžs'€mâú}ªmš74¶‘6ÃÙÉêlVOÜ~“S¨ø§k†º žERít­ ‘÷ÂB6‘[N,±Û0yÒ 8®ýñæÉ?xEÀ£ÄÎ0?ŠÅ&Ô¬Él˾HO«Y´1ÿt”Aúôpx…¡ÙÅ“Ny<ôs(á†4k·i8v°v²w•·Q}cy¸ *u,Œ·%³7íá6 ià2gßmy‹xÐ 2—~Ÿ¼Š£É^84üc LÄU1³­+å¯0ƒ~8´ó£j`±ìO…î¦ñ²gŒª !Á–³d.ý>y„ÒÍt;Ò–:w&¨§—ZÞ=Ýî¤àñ Ç2h{ºÓ¹R¦Ù±— èžn‡¹È“N¹>ôû„uµä ø º°fGËBP1t£ ]%³&B2O/=©¯’¬EÎʘ!„㹑…sí:åõÐïë¾ÔÛ5 zfíKQ“»²}íKàÙÞCµ‘º2jHTˆšÄs¡¨ÉÂgQ“S•Koý|¥ ¼Îm¢qÛö„¡2 @l«'•*Þ&=€%ÐÎþwÓVV¬ÏÐçÏ0éBÝ]:@æÒï¯?mcGlÑÏMo[]G¡±q&>Qªô—èŠ:¼ÌŠ8ˆ¤B;"©Pü'í­ˆTŽç†HΕI•d¼¼õsÐñŽk\ÒîÈtaÖ j ·ˆÑQ³³ ê²;"¥ÊP;‚ê…°i†ªoއ6Ÿ4DDÕM(séççh„…¿;€Å*˜¶£ãÈló/K< f@í*³šÓ)IÆÎޝxô[WîÒRzè÷áîÌ g=Ò“ Óbxª¯l_÷ð,“—2hc$@DÄ༅ô2Å:#df Ê|èçoô²0Êío4’‡.6þRc[oj"½,¶2lOÂ]“d1ÇRcûŸa´Ä!N5=ô‹'¨ï'h‹Ü8¿ªU.ëx‚*Ûz‚¶x@´»¯U a2‚Lcòɨlë âu¢ÎôÐN¤Â’ DP =Ïw·­^Ò V° d(ÁÀL®“µÄkòÉSí¡¤@ÒÝðC Óå^(lËMÛѹôû;¾ñ¦½2ŠëQ\ßÅõÎ(®wFqygç;£ØüËááko`ÚvÉ^ÅEŔΧƒ²K€P5¼ÌxD@å<áóé l¢%@D¸=[ÀB;@Ä|¡ÔöpPN{ÏÍxé„zÙ;†zÖ•»Û2›l¾¶ «á S qé“(žmrû-‹:PæÒï•÷Ûó3ï÷lŸÔÀ¯~Wä=þà)ï÷È(b€ÁX5°Zäýþ> {Þ/‘°<ï÷ð°ÚC?£dáåå±#2˜¨K\Ïöe`óÈO:å/R$£¶¾»J§ÜÈ’IVìã%,„lKS:@æÒÏ[(eZý°…R«„^·‹l·Ã #º¶€–p—õ$ôúäxü;˜·½Žè™©ñÐë‰4upèõîãñ;F”‰À~Eï¤" –_¼ a¡yò1«0æU˜hŠGÌr>|@ß¼ÙæwÌøË* séç)ݾ“½= dòü{*gáBcÙ÷tK$ÍКx…qŽF:gÉX…JŽwW¿p¡SÎý¾ŒÛªXý™½§@¿aä³w m=ËC<{¯)£võë}±•`4ÉLKQÇxS¿/çšLyŸ[2—~~kædrèMd.  ƒ R~„ ¬’^ƒ3¶—IOË)‚Ì4tM#VóM:˜Ì­ßßï|ÙªóLSîdšòN¦)w2M¾“iòÛVîdštG£¦w2Mº“iÒL“ãljÀõù d_-®¨uÅ• ˆ_QO×ÒuASñZäWÔž#}Ïdßh*ðtEíù¡ß'›Y2ûqDÑ$ÔwšŒbí…Q4ð…/7^ÀoŽ(šÖ$³‰RQ4°µ¡À÷†-i¼ä1«˜ ¼ÉèDѸ~nHìóíFåîfi_“mˆªx–Aµe¾iÄ”BÅ£nõrÖxÙÍ7˜ ¼L¸·1úý-¤Û§•ït{ãO¬ñzYVXùÞH·ýõ²üAºýdµLΉ7¹1_è`0é°Xüc4 uŒÆ65AvZµ5ògvòÓðê*Èa2ÀU6ÚÔ˜yÔ+ð àú}x?,OçÏM#­á÷w1¬Tà´¢ShË;1ųÌ:ʨÍPAÒoGÆÏ‹´p.£©ƒÉÜú}°T†w1äÌiÇÛïÓ:¶Ø¦Ýu_…ÚV¶s´…Cj4« 4s¥Æñªƒwa.ò*ƒ¹PŒÍõû¶/ñþ¸%Wœ Qü ­}i‹§À#œÚSãxÚ—ŒFh:‘Bj M·e?K'„¦»~Ÿr_³Êîümát·[Ðø*Âñó Ó=ÅSÎwNj{G™S2ÏÉñý“s—‰¾0çC?®›^••BôYe7Wænö¼2Øæ ~ …üØý&e¼­£¬rtU2™ù²(Æ“ÜûòlˆrÂn/ý©ÿi_?ä¨O]ŸÏá¿Qð· •åÙRÒ¥þ¼#zç;³eÞ™-åÙòÎlYóR¿Þ™-õÙRï/|ͧ®Oõ§ªiEÇŒ‡gÁ«Qy‚«ÏoÝ>Êy¥õgõ²¡\ l¬xxzÒ¨bÚŠ‡gÜY:3*kmsDf‹Ó§Ì”¡ {edSd¶ìÅ£[5(S”¡82jg‡2e¹ŠBd¯`¼ÈlÁ\ä™”¹ôsä÷UzðtáÅ€@Ó›©²­Ž$^ÀPU;ËÉOÚÂ(“,£¶ñZ© 6Ì^ahóNýÜt ¨¼ì¦cÐ ÅZ‘âúŽ‹³&/SÍLǨï²z´³›Ž"£8ŽÀ‡ ê~kÍâuÁõ•‡~nÂbj—›°oP¦Q›fÂBPÅŒpµ"*@& ißMX@×ÿ}¤Œ…æq¼¤àbÎ…²÷›Kâ*ý>ùǤÿ÷禷.Y¿ÏëÍŒ8»·ýl¤Äo—ÞôS&³¨ÊZlÇ¥<è•:}¼¿l^± ʸŒ‘Ö‰8ëµ&á“*¯ër¶¶ñ«Ú~‹dpáÂxqÃ\ä™”¹ôûº8•ÇòsÓ¸B–Æ|â¤D.Ìdn;J:Ã07f´“;k³]¬k“̰3î`hˆ –~Æy|&É\úùÕhJ µ& Pîqî…,}cæ‚«,Î<·/‹ƒê ùFÕí©¨&€”ÙÙÖ%z‰'jyè÷)C '—È?½í;ci ‹T¶ù=§-ÞbÖòÏÆ]" 4ÊAe0^”HÂ\ä ¬žý>=m0G ìVõHd¶õÂ`ØœÙæorLÇàÙ·L´xÓé2(ƒ‚’/ªM2‹n3P:I ûxÜbØé¢d"èi¦Ì¹é=æÉ‡sU• ª¹ÂÆŒÚÙÿn[JÕ ¼d"‚-0hsyÉD["]Âõû(kç9ež¶_o»;T¶v¶yN¨Y<+îHµ³ÿݲÌôV%ƒ|CŒ¹ˆ˜ <è Z֮߷**±ò´TWfˆF¶e„gä€3ßâ•0²í%[œ.S26Ç˲ p®ÌP=ÂÖχ~&×YØF%âÙ±Pü¶±Nö±^`TøÓÊb5Æ…zKEs]×O°>§˜e§ü„f«°vbrðÊM¶ylÏM<«òF´‡o—¢s– š1^wÀ ÌžtBˆë[Ä·]`ÄÅ6…##¬ß(!–=›%ÄráfO ¶q@£rG³cÍL:,Ò1yÒ©´‡~Ÿüôe0Ðî'èÌŒ2xˆ²åÂ#”ý%@^mF†)´“_^D×B™j0Fm¾,ð Û :ÕòÐïys¯^À;¶Ûõ#¯èªàØm_†‡Ýn+„\ޱávýfå.˜¤únjJ·­aä§®\O+Ïå•ç¢7@îžonh$Ïv‡<‡µ»ä9{G»:ä9œñcPæ”a.mº áhÉ…:PæÒ/À¦—ƒPƒFÙ™»˜•_ý ˆt± t´%µ³çÅ#½«©6Wµ‡ãÕûEA=·¥d.ýÜñ‹Ëí®j’FÊ#A¼m•'h·»ª êm§‘$ÓhÍPš¤h¦NCneÙk=Ô…HPxà¡R+]¿Hž½×I#Šx«üÌRB ¯³le#:"£µ«Ú¼î4ê(xÝ“³\Tœ+_I‹…ˆˆàõ¿ê” yhû”-¡ãþd¶gâáM¶uÛ¨â-Öïè[íqÇA—!KQãxžÎ͹À“Ne<ôÓŽÜtä£u“vî;Ä6€Úmöœ»ƒñ¤aÇJrGœ?E´(cŒ+-¹z.=µFcÌI.´¡Ü¥«g7«rL¿5i+ݶ ’r )3ÆYõìêCžUk¦ Úeº dº]Ñ1^÷ë;æ"Ït Ì¥ßßUªóµ\%ë]’±¾K2Ö»$c½K2?.E‘Ã(ɘÍwYÎe ÓSW× ’ý‡Þõä©JDÉfµË–ÙZÐæ;œ«xfï ÛÍÓ2ëÚí$CQáxÕQ•7ʰR:ený¾ezd"þ…²kG¤™ÂЦã¬l£çÑ©G âæÉC¨² ðxTÄ%úna[–£.Þd‘ÝUú}ò´ÃÝ«'|Û:ÍÉpj´P9*¥Î&À“qð‚îy¤®!|lÝå£pƒƒ,ÞoÖxè÷ Q óÝ¥Ìs<àû3œò ¨Æ¶8’x–,K´§#SŠžpF¨rÓxÃñ„1xÒ©¬‡~ŸØP‹°;Ž7ÒÏq¼˜ Jh¡V¢îÊVÕi!`]6|¶“¹}¬¥ƒ2çîW8Ú:dñ ƒÙÖxèÇsŒ­ïÇ’Òdé½R÷ª- {U¯3É`v+³l¸h˪`tµÔÈkN¢_Û¿þÂwNÉ\ú}òN·S9aÂþ,ƒ09Ó´>H«›m>¨ØŒ¡ßãQÆÚ#•A›Ö@O¶ñF +Û\ä%¡ùׇ~à9-´]øœ G¤øµíÜ6}S}Šg×LÊ Ý=°J4pó»…Û·¡ñšVa.ð¤#?’÷—ߥ§ƒáy¢CûQµ<¤úУv¼=ƒôN„qX9Ú \]-F2Õ‚Ë1^õÀuÌEÞÒºú}3¸<Á¾ŒËà>qy øf\ž`_Æå ðÍX¿¾—'À7§$™K¿O—'ŒfÇŸ°m’Úˆjwü‰qá?ÕJšƒÈo9õ¿[‚? L#´6çä*Ä\à-¢Ô1{»ûx¼ªo o=m q=Ãõ¼¥À^S1É+ÔG|´eE-“²²ö|5³Pö–n,>Þ‡Õxš ˆùǤ-'nX ð¶cÀ°@áíÂ’É(T˜… !æ;“d ƒ…ã9> çO:åôÐï¯?mÛ áGô‰Ó;u{qfMF Fµâq“j·(Oi\„W¤/ ?qz«–`ÅQ«goqNt@ˆÝŠ~X2ÌÁÒ‡»§@[ý¡sO0 .$t¬Å¶^ñ&ÜX“ñis¼p;;i—Lg=µØÖ¤ˆ'Ðáú…·sâߪè8@çɆ­½‡Ø™„¬ }:×¢$'"ëO­@;”ëV•£‚·³4çš6’»týä]C~»‚º@[=Öe™œÇO„ZõmyÍŠx¹u¹¨}g å«#d™íWZQæ3u€Ì¥ß§õ£YFe®Z?@/{w·­ /|4¶¹~Ô$žì7匣Mó?éEÏmENXáxhó4·§x•Å#Ú|è÷áJ•ÌþxÔÔcŠz?ÄP´àyJPZe$ OÆ|éÃå@¤x¢­£D<åŽÊK£‚к4¶s3/¦&wéú/^¾*ý¾ÙsÿA/ËýgP³½ hv¬¯ì†ŠÎÛ•£=÷,L†‡¦`çÀzÍâ™”¹ôûž›f1-wnš½(OÌàF”EæX$Ê1#Ùg”Ñ…žÙë*œŠˆþ“ƒ¸~q¥^îO]¿E<¡ˆÅôˆ'óföǦä³Ý=›…‡±´²¶·€¨•gStÉ’Á²)ÈÚá^‘ìKªtBí9×ï“ÅY„Õk0à[Lª„×Í*|,sƒmî–­Š‡ÊzA»:Œ8èÂiˆ°ÀÏÁ¶¬TI<èPèáú¹ 37‚¯ýÜôê ža¹ÆôVYI;S\ëÖõ2jgÿ;¯ Bƒ>áx]{.ç:@æÒÏ/´LÎ÷¸oÐ8²3©°¾›m]T;é!›(ãíŒFák\߸ˬÅÍ6}.¸†lú„Ì¥ß߱ܕw¹ã+‹©ÞYLõÅTï,¦rg1•wS¾³˜ò•üÚr$¿jNð­úÔõS²Ÿ“—…=Íb(k„=¼ºkhÉÕ!£vòò@‰mU2e&XˆÀqæo0»Õ‡~Ÿø~‹æ)­¶ÐC§LEÖ€lžµn•ÔɳËeЮžµ¾ˆ˜¹–dìöÈñ<ì†s§Ô”µúEv;’=ÄOÅPÑ,%6 è[Ž¡6 û=j’ Ú~´}Â_*eª]0^õs æ"Ït Ì¥Ÿ#Xf w)žè z¡`&îãv/FÉ¢ÅL+* zYQiÈx›yö¤íDF;q¼êaë‹.\ k·‡~Ÿ\(ßJ¼TÒv·ž™å\·¹Akb›1”sÅRÚ³dÐv¼T§s’ŒÝ¹9žßÇ9xÒ)§‡~ÞÎ’íéTCù¾Ç¹M8ˆâiR@nÏæ"NW;‚²D×B^ &¸((Ëæ"O:ÕòÐï_ã]˜ÃÎ3&éLÏ- P’ù§‘a—Ü]U]g)ê°Mµ½Â­Ó¹Q¦š¯ãU÷Ã..L¡âØ]¿whçx†vÚÙ!B;WìZM>Öí\QaŒrŠòÏÐN+ß¡íílïÐÎ6/õR~êuQ·ÊŸ m·<«´Û©K/._Ùqû_p†nÉlþ`*´º…e6$cTÏ£³8W"®JZ’¹ôã^*aüŸpv˜EîÀz8|J#¸K-çÒ‰þ`ÜÎ]Íä@T¿\°Ã°Ç%gù‘Õ“'5'¹•ß”É]º†y?]wó,Š”XÊqÈ›mÞPw ¦8º`’A¶û}nò]S“½õþëÎR±è$/3uõüÞ^Î3qÂo’íÔz†’›*Õ®ìΟ¶ôHÖ)FdzO:ۓ˦óI|ì¤[¨ÏM>õ¢ì­7·²RtÆ« .¸zf3ªÿ>¢œL§ý›2DHRö=o«áä|KósY§tGVÕ™tY MhìÀˆÒÜäS/ÊÞz±LûòwWxï0 ØkS¶Eóµe Ü4Ÿ@Äü}>‰Ë’ê:ª\=zCÙëÇn:°øÜ仦&{ëýÁ„z@ŠVŸgÏqãlTe ÄÉD®Ëæs~AKð f'É:¥3ºz–•š¥l²…HcƒÒ³d«ùÔ‹²·ÞzvQñ® Eze§—dÛâ¡~U5¦({W’až8ß žº,©¡(ëç,<’µ¼!»ËÅäs[Ï¥é9?ôÖgi8}^¿‹÷ØwÛfÀïÕïßeЀ|Öò£¬Sþ»°‡ß-dõ½³ráõ»`nñ©eo½?¼‡¨™bÏ: yê±j×õUlø=÷²˜RZ#~ßBÅ?™ÃeE5a¹zNê‚d ãÂÇv Ÿ›|×ôÈ>ôþòós'ÛXî+jsÞœÊ]¡Ø·œª¨êéØÁ7—%å¥À®žÔ%[¶wãØ¤ôÖÚúD¾kšúKo=»†KvfÏ#> zVµñN Z²l›oŠÒg™-øÝp¤%ë”’FÔcÐÿ”=ºž3Æ&¥ÏÒrð©eo½?<»ÃRåϪÏÀ#ï—iXfÒ¡NÖÌojOQ8£XÅç¯caqYRQ%V=v)tY8›4vŠÕÜäS/ÊÞzyvm³?{~[¾VYO?Ëý¡Ží(™³ðü^6”Öª–"¾E(¹,©æo¡zÌ¥è²Õ®Ì» Æç&ŸzQöÖ[Ïnų—TÞÇ{ìzá2VhïP»‹ÒÓ8Jð-%ÎeIyöœ§ÑÎG&{¨¼56©Æ·êüª'Ýdo½¿¬»û|se;¶ÌÕc¿Š½îg¶‚ÓÖÌ¢´W×|[†\Ö©”ý¯­g¼Ëü*{¸ÿUsƒ/½ ûÐûÃÙ_صÏ^=§„c!Â>Zð³^ûlIå:j•uŠû¬÷Ø^)Yì£;öYÍ->õ¢ì­÷·}–wÁOª§Žä2€ ;Wû–yWå¶óŒøçdÞ\VTsJõXIS—µ|%»z:§æ&ŸzAö¡7ÞYÞcÎ3ÀZâWÏï›ï@çÙlå—Û¶ }¼C9ßîW.ë“1½Ç2ã\Ö*ÀûØF]÷/ç7_áûKïï÷Î\îî=UÚœ»_¶;¯Û~üN¬»£ø¸WJ–TQ¸‘÷X^¤ËZÖíÅ2}nò©eo½¿<»ç´&ˆxï1¯ù¡ö³s>=0]EÔ?¹²å|ó’¹,©æ‡ÑsV6ÉšÁÚÇ£¸æ&ß55Ù[ï/û¬-§5ÛaýçÙs’dÏâûûT˜­À÷¡Ö¥õ¤õœõ&'É^o´Þ3lq–lÇ)Œcwa ûÜäS¯Ü­÷‡ß{[͘ó{ù½Ž=Ó@*·…˜Švƒ=Dùµ¿žƒË’ò{ÝÕ“RÈòÞÆ±ý^çs“ôÒ›ç T[<O̰«ga}«°4Ü*ö¥§Ñô'×¾)e»«Ç²]¶Ù‰Rc7‰ÒÜäS/ÊÞzë³$¬v†|ýs÷˜Q"#òßö泎­¤²™ Jºó-ÌeI9ÊöÕslä’µ#“íXÛ>7ù®©ÉÞz‡Ýk`MÐ~¨ž‰=ͬQö á9X[”ž±>‚oD.KjÄ~ÈžŽý²–väc{R’ÏM>õêÚKCo}«i§¯êëDÃ9Ó¬rû¯N;Ô¢´NÔªžC­)Y§¤ß{¦=N’°Êql‡ê÷¹É§^&ûÔûËúh5Rν±h}ôž SÇ] áæZ’(ý†kßo©&ëSÀ¼Ç°í\6Ã’À±³Á|nò©eo½õâ^“ÝÑï=Y6šs Ê6ѱߜ•Ù1X2^*ç/ƒ©‘,)wú_=µºl2ç¾ÆNîú÷ù®©ÉÞzÇ»¥ï¦ø»ÅÞ,¹ß]Z¢ô»Ìüê7°uSZÅÔ“p·(Xƒ7î66)ý.­ŸzQöÖ;>ËÆ}tnÿ,÷U¾½'w0ù›}jü€òϲ‚_-%\²¤šŠ¹\=¹„lÕ—‹(ÿ,=ø®i./½¿ìÁU;‘Ût¼gÁ"ÕaÛ0K[÷=6¬4«œgÊer›{¬´˜ËÚ…ØÇnÂCð¹É¯²}´ýÒûËš2-ª9Y|ëÏÝ“qÊ2¸ÚCÍmoNm¢®õÎù[«Oh½ilýu§õªÜë´YñîI™É¹?q3¢ì­·žÝ®ù¦ö….}NœÀxó,yÏÞò.JóqÅ3¾!®¹,©$¼‡«ÇlSv·^56)ýâ|3{½5Mó¥÷—g·Ÿ Öy>C¤Ëm9Ô„…™+k+¢Ü:¾‚?a¥¡,©#ROÕê™àw,-Æ®±‹pnò©eo½ãü˜1Þl~~äïøIÏ9­ø»pNtëñ® þ™ó­JšË’r¼•«'­5\ÛQW|nò]Ó´^zë³TØ}Zœ…½gá ¸ñ+ÙYØÂ¼Ia>³b;ߢ<\Ö©=é![qÖåØ5Μ›|êEÙ[ïëÝ¢U¡Ç»_l†%0aW#Þ­(jƒ‘óýÝá3¶‡Æ¾Þ­sRâ3ÖpŽ.-Þ­ϘÍí|jºôŒ…Þ_ÖÇŠÓ—_õžŠJ=^½CmXOûåÖû|«Ä䲤¼ëÕCÏTÁ ÔGŒíXö>7ù®iN/½ÃoAÛm­î·`wë OEÇ';ÕR<ÿõÖÄï8EQÖ)ÕYPqÊ&ìÖ;)ÏÐçN: Œëi¹õþfûM´×M·ý&Úó*VÞ2q®(]”n™|O×Ò)D²¢Zܯ½‡wd¾g¼?—.ÊW åüÐ4¥—Þß|nç ÍÃmÞÑ3`)8ïl6( ³°Qþ{—à[’‰Ë:•⯭NJ뺬ñò±½ÏM>õ¢ì­÷—ß›ç©*øXïi°¸Ü,®ÓwŒë|þ½¼ÉZ[†Æ–U=¹„l1—Æ.îÓÜ仦&{ë­=ÄÀ~le–›=þ¨íæ¸-pZQÖ„O—üu^]—%UU©Ç{,ÀeÍŽéc»ÅÔç&ŸzQöÖ›ŸefùXtÆŽžsNž¨ ~n'¿¿›ã5DÙ|'½¿žh[—uJglõX,eí&Þ56©R“¾ƒO½({ëý-%aýʃž‰HŸc{LÅ-1E”V”µƒoQû.ëTÖ{Èžô°¶lYJåž‹|ê•d‰ ½¿Ky'Rܰz¼•¼-Ü’¦¾s…o¾Käì+YR3<“ì:½ÓËÆÓ;=l—g’w²–B/ÊÞzŒ9âÝd„=—w*þÂ3~A»nºbŽœo0Q.K*ݧ€Üã4Y»3uMêŠ9r~‚íßýÐûÛºËÕ…ÀWÏÄšfìºþÝî'†ß+LKÁŸÐ²NéÄ X³$kåv}ì"|Ÿ›ü®•Ïdo½¿üÞÈNÙãBÕSìÞ±‡Þèûßæ§ÝÞƒB’%•=.4zÒ Ys@úØÉãB57ù®iZ/½¿½ß²Qÿܾ¨ »G¡w‚]EùM2€—%ÕãÁìÊ’mX©8v‹ç&¿û­q¿ôÖÙ8ãö´ü®=|¯h3n8¡ì-Jo!­Ì §Ÿ’BÖ©'é+qŸ!;e[Ý[”ÖÚœi[+do½uf ]e8tFô,ÞŠi«‚…½dQ56ƒO "dƒÊK{B/!Û‰—tƆæ_zAö¡wÄ« z\ªß¿öFçeÜý#q†(ÝBz >WÊ’š~ãVÏÀÊÛåY5»l“×õúég¥Ývô½õÖïÂȳ®zlWý.¼¥ÛÑoð×Õq— èb²N B= ßm×=ľw·øïâã7EäöòÒ[ŸÅ*#œo²ê\Êžm1Ÿ«xL, ©ˆ’ýA1yÃf(5dI-ßµÔcAÿ.ku@|ì)¼RŸ›|êEÙ[ïx_øLx_ZÄï¬-+wÉQDùžºƒo|WìϪÛOsèáÛ\è [1v˜ÌíÙukšêKo}–ލªë¾À¿/´ë>0Ÿõ¸/¬òëº/È”ƒzÜ*vÕµCÖï ÙoþD^÷ êUdÏ ½?úÆ YÂ7‹BÇ*FB¦ÿj‰ÒËH·ÌβzïˆFõž2$k§¢±Ié%ø®i/½cÍ3;õcͳÛúmm)FqÍ+K”ßÄ{ð;> eI]k{¸nQvà´É±GÄÁqî¡ÓhZ!{ë1ë7‘î˜uëɸ뛓íPŒYoMÔ#J#+f}tÉ:•î˜uö0fýÈ&C!ÖØ ä˜K=—¦ŒY½?œNRm7\SÔÓ±¦$ËSœwÖiGkŠÖ)òËrYRç=¶.P–qÜûŠóæÜà‡¦Gö¡w¬±)b'±B7fªL_½wRÜæ ÙRð³Þ–6ƒšaò‹¥ìÀ›È±‡ª,ùÜà‡¦¹½ôþ¶¦˜MrÜþvöl|óOùÛëå6®|”R‘¬S—¿½#¦¸¯í:Ö%Jߣˆ¹‹0˜þöÐûc<öˆžâþÊœ¬YŒ–œ8ó 7“¯¥ÌZ˜°ýÉ5‚jŽN¢žŠÈª¢¬æW¥$Êã‘Zð©eo½Ã~¶¸û-·Ÿ­ËC4GÓ`ëK]”v8Þž/Úé]"Ub·¦-p”­æåÓØÕ inò‡ò7MöÖûó;XâNªÜ+OÙ€iÔfÄP¥õçì â{%K*î¤Ñ“VÈâΩ±ãNª¹ÁMÓzéqXŠý–ý>)f'<îæ³Óžâ1‹VeÉùnOáé‘öí Ëí)+KÖv멱Ié{*+ø¾ö­üÒûZKa ÐY=U±Å þ"ÆÏ"ÊŸÿü,ïS-A•¸3gyˆöÙ,ëÞ,¢|-Η^}è町=üíÕgÀ›¯ÙqN¡UkÇÝŒþ-YÝrÈ’ºüíÞCŸyáý¢hlR—oÌù®iš/½¿Ø¹¬ ÁÙWŠöCï9˜(„PžQ&”îqŒ‹n8‘3‚zÍ›R¤“zÞ&Ê"Sc¥›R-Á§^”½õþã¾ íu_€>v–Uîû +ܪÁûÂ¼ï ²ÑÆ}kï‚·áüâq_hñÉ{ ¾ßvék}Ãn¡Ø%õ4x׆N` ó,Ê=93ø §(Ê.©fì ìÉ5d Î!»ø9Es“ïšæúÒû›ÚÞÛˆ¹ÆöÙ›7Ü65Eù}¡ß®š.ëT¹î §§ÁþDYÄÔjìvG«|êÕd÷ ½¯ø3¬9âTÙ³°ÆuŒWqóÊS”ΫEU$ëTŽZ…Ç»íͰÃrìvZÎM>õ¢ì­÷·5¥á½¾Öö,XP6¬~ ャKÉ׿Þñ]¡­j›*ñ×Ìí5déï䨗?”s“O½({ë¿aƹ{Çù1ã¾Ð±«1®‹yÑŒûÊq~L)øCÊÙ.wü5{]ÉXäc;#vÌ໦¥¾ôÖš² ]"_w…§p8³­å/‰Ò|sß#ùw¿©ûtKíKÈXë“¢¬Sœ6[u¾ô:{†ÞÄXAåoªgz”Päo.qtßµûÅ:v†ù›Ëýiz—Ç8޲ÈÏÔØ‘¿©¹É÷GÚûBïþ™ßïuÏùà=Þƒó¦÷‚;……Í“rÿL >¢‡%ë”c>°'!²ºxúØ dq>s‹O½({ëýчûÇáƒu¯ã7£?Ž÷æ ]÷úãbhèå×å}[W¤ofé×å=Æ.sþ¸ÑoMKzéþ™E«Úð»øÂÉ»á½oôdzd )­ôs¿á=£,©qXÞ“SÈš«ÍÇžnÕÜ仦\ÝBïˆq¬xSe«TÏÔéacMáÉ¢oQ[&ù†Ší²¤¼êåÕSFÈš ÌÇöÚ—>7ù®i/½ùYÏhÝcߣçܶÆD |$ýò:MŒ¥ÜXã/EZ™¬S:M¨»ûðóå¹miìê±ïš›|?Éšì­wœ…y}…¹N¬ˆ“q`׊×ï³0£ÊxVfTY™A”²zPXx¹®¶sìzïïütÜßó Ù[ïØ·šc®üÜ=ÝV±ð¼-#d«­bÎD<‘´ê´zAö¡÷e÷ûÒÏݳ±3V<Å»fCÈö\©sp)ÁïÊ¢œ99-2Ü™³3{Èz £NJ`G0nˆ1t©…ì­÷7N€Þ­è±}1‹’aUXŠ(Ù&ê ~FôT•ŒTŠŒ²Í¸£²Ï²Û üYçÜàK/È>ôþ¯É“Çe#ÉðÛV1 þ=â.]±§u:_Ѥuåvz-ñ•™"3Æîaéò(Ø6oMS~éý-ª3Ò$b ØC/X†­Š^°¹Eùž:‚oIÛ.ëTŠ(ëIˆX(zñ0·(ýâÌ$Y=ôJІ½¿<»<9ÔÈÝnÊ:¥§[ç`žt²(·öÌàE¢öTÜmï)5d‹NÜ=‹Ò{µà»¦¥¾ôŽ3³9VøT³Aˆ{Áó#-÷U”ß®Sð«Çà® jDûyý•çÇc—ˆöãÜ仦ôO„ÞñY˜‘ªZ êòC¹ Á‡Ë›™Û1Ê}SÚß-e«~Åuí ü][Èš‘ÒÇn^Ds“ïšÒÿz‡‹1¿ÂΊžX¹rEÕL¿ëGt¯Áß8‰GDÎÔØ¾JЊ×]1Ã9ÅØ5ž_Î]õürïç- ôŽõ‘Þòë£,ê8ý.ìÝ“ñ[”V‹rY¢çü–ñYj½?‹ÎPñYj½µ7Ù@G.ïÏr|Í’µí ç]¹,š›|ÿ,m¼ôþ×û,Ž)×åÓðÕ]xtãWGœâ ÏnÖe§P––þÚ{Π’…ƒTc;  ÏM¾kj²·Þá /2O÷°g1×”Öú÷–(ÝÌ”ÇAËå²Aå¸ûå¡çm²º®%Êc!rð§Ð{~é¾ÅžžŸÅ{ì ´sÕ+þôÜNí ä{¦Ãª7•ã¯éèéÞ­ö¸w²}»®ÏZeùïé¥÷e+ ú@[³{÷ ï㈠º¯¸ÏüŠUŸ²¤Ö}“cmÙ\ï{‹±gÜä²v€ÞnMÓzé}ù¯™Guù¯™WBäKút˜ÿÙE¹ÿ:? £¬Ž úãÖâMó— oœyÖ[¹•‡ÍØKjJ¼éÐû²°FB [ã¢ñ†p7Þ°kp§ö¨ý¤½yûNŸßåQÇ_³'õ­z{Z¥÷…‘¨=ßš¦þÒ;>Kf¦\öϞϜ0Úh˜ÖÇÂS ³®zuÙ jœÖiñ=d»ð!ééÉÅo†ø’¹„ì­÷ûKÙïýe?öýþØ÷ûûþ³šÀ~ìûå}ÿxsbßO}?ý±ï§Ç¾o²·Þì/¥=÷‹‡ò5Þb¥|ðX*ß#È÷ýc§›*í¹¿Ø½éÚ_R½÷—TßûKª¡eo½¿ûšru?…z`Zˆ ͰÑ”£®ð[‡dIU÷SDOJ![iDZK`d$aµ¶qkzdzëÝ*Ø»6jÖxá‰àv<‰ƒÎx¦"Ê÷‹|sEºlƒ%zß™sì©E²¶OMÊïé#ø®i-/½¿áÆ)iö&3aÉXöÍ›ôå–Þ|¿ó·T K‹÷¤²ëÕRd{ß8cái“¦¦Œ, ½?úšGX=Œ{ΰŽÒ9§¨+~Ãùf4¹îHÕ˯*±il¥9ÇØ-ì$œ»ÉNÒGÈÞzù½‡°z{Ä»r…(WÔ 0V½,'#a)£ºô jD°²§`w¥lÁÎ;…jRÃÀˆŸºB/ÊÞz³/j„/‡xRe…E;)ê“ÈB·§©¿Á¾HÙûÒOS“™§¹Åx¿¬±ÑExí<)ÇŠñ~¡÷·ß›y[;°`Úòý 5]•isNéK”~Af‘ežùc/UIÍ{ÊYƒ›ô±Kd€pnò]Ó²_z{¿O…Ø4·Ê{ˆ»ïÈ3±E¬83«å)~A,ÃÔûMªÆj0‘áÈ÷;#Ã1—{nçB¡¬)do½¿aRÒž¬\^õô+;Ónâ@Øbtû…&Æ÷ ü…ÜC–T‹(6öT`-S¶ ͉±}5bÆË >õ¢ì­wø,åÉŸ%£©2öžäwÆûݼ|–+ø[gÒ<ƒjqß:­óMkdM1vUáhŸ›üð²·—Þ'F¯æÖ>ÛuW`t?ý¯Œî§ÿÕã÷¦NãŒï£W ï ª[…£‡1xDhš%Æ.ñ= Yþg¹5-ã¥÷u§bÆFøÊ奠ÔOÍÏÿ+øò¯6e/‘*ñ׃+ Ù¢ £¶D=ü¯Åq¸¦Ë>ôþ†{º‘ »kôL`wàÉäç% Ÿd£îŠõPö¢’ò’ÙƒLÉf|K;GŽç&ŸzÇ!1¶ji1£-i}ôžJ+ƒÑ5Èï¨]”Þ|Vš#¾b!ëT ŒŒî¸\” Æ&¥u‚yîµÌ¶ce¤ÐûK޵c@ ÷t:FT†?fa/>7×¹}[{–g% ddÀ5ÃÃæ™s†,âV5vĵjnò›êÈ>ô¾üqxRØØ3èãxXÿúåþ¸âücy™.T {À ßdáÅÒØõ>'îü¥\óÚ_z_ñ)Dˆ½âSèëäyŸÑ*ŒO©¢4oé´ãð_gPÕk}EOj![`Ýó ³k=³Ìzº5Mí¥÷¿š½ùC| Ñá—Ÿ± cOqÊšˆ=ÍŒ¸+¢Üº‚OÔÊ’òÒôWOÍ!wŽ•ç6Ð|×´æ—ÞßbO%½+”ïöÀž•`Í´NQÒ–º ‹ìš!›E½ã“°§¦öŠÆlÍMl×´¦—ÞqÀ‰Þ¹}?ÌDø*´áñ‡a!fãÂaØÀã'oŸ²¤Âw§ž†xNÊÂ7§±Ãw§¹É§^”½õþë¿wT9O,?wOWE¬é~ÎSѪuQØÙ«ì¡Æ¯²œšlÕ©PïwôœCšd«ªeѦ¬÷[s“ïš–ôÒû㊷âˆ]ªÈw$¦Çf”Þª¾Dé–TZð‰ÜOYR)0=¼‡ñ…‘N[c“Òs¾sð]ÓÜ^z« Ƽáñ†ÌwnÄTâÞƒoA;Uxш´±öÐóÔjPõ^©ØÃ ¯<Ï2 R;Q`kï·¦´Â‡ÞW‘Ÿ½î«în7z؉ö:Di>ž|ÌO#¨8é«>sÉb}ר±þknò§Î ³¾ô\j¾£>_Å^Ú±ï/fAÑßÑE¹ç©?{ÆÖ j¸×9zJYâ•$ÕåžñÉY±f¦[ÓÒ_z_˜#Ž òóìa®óêXg•YxWVfâó«¬uêÆaôMÙÀ™¢ô»0×\˜##do½?î!ˆÙŸ)ödEWÜd&ÐÏ7j¶0Û}U_Éߨ†MYR%Pf¼'ÕÍð5._Ë"‡s¦à»¦&{ëýÑ.džv9âçw€–8zÏ›(·ËEµ†sëí!»„ ³ã4ÎÆGWò÷±¯X:ÎM¾kÊ|Ðûz—Îú?wOS ã™aBÁ…õTzð³âc¿üáçF‹·-ˆƒOï¡âÓ­)±žBï×ÙݎѳûÄÙÏî³Þg÷)›ŸÝïuMö>É¿Îîç%’¬Ùö}l÷"øÜäß§õ§Þ/;Mø ïYô—r…-eD-•äèªWœ¼g÷‘ʯ8ù†ºÁIb{ÄØõŽ!cIh™éé¥÷—5eéGvCõXèoFà›½»8 î.J¶”‘ƒ¿aq ì–ýÁ+AoÙ',††² §sŽÜn¨¹ÉBûYí¥7ŸG€öœHç®Z¬ì1À®’¬Lɡޫ,YÚ5)œ»á3‹?lvÉ’Jú,êI¬rÙSO5ùØ ðט[|è%Ù[ïoqÓ›>qÙK=Ñ‹7‹V¢0Ïp5àD¶«ÐpwP㮚Âx†9CVoÝÝn¢¹É/ZÝè ½#ΉQX9p:Ø3}D<ˆŠÈ$V&q[s—ÿ—¶fæÍqSW6Ø]-Ñ«Z3F7mQúžZ >õ¢ì­÷…ßÛvºj›d?§Å”Ö6)¢ä_P=F`cyÖ›Já ˜øNûÒê1v‰=ÎM>õªÂ• ½ÿúš¢ú¬@¶ú¹{Š,-öÛ’¼ö+¨k_p>êÆJv C‹Vì«ÇVzÊ&ƒmÖØIùL>7ù®iì>öŒ!P.v7Ѥðæ1Z·#N;wQzvW þPÔmgÕ£©üÙeDUÙM—÷É#úšî]y†^”½õþ†ÿñûÙ¯­ÜøìÖS…Ï~|ø­ÂKk )?;öà۫벤ÊÏÎâ³›l†ï‘cçŸÝæÎÂg§¦ÌM½¿Ýué×-Î ´Ýbo&^"QÁ™y¿Ž~5æÉÒUSP5PgÙSƒ–ñFëV=DùgéäÇØ·Ðû³öŠaŠüRlù#†yüÃ<ž‘ñëŽ1kÄ0Ï~ǘ•|ǘ•W 3ù[Þ_z‡ÿ°ðïÃX¼*³­ó¼ò”îUÀ܆‚?…×D fR%þz02g„¬gf4¯æûÓ•}A½¢¦X±ÿzÞXF6̈¸,öpgÏ8g,³óýÞ}­÷ DóŠšÛäWœ†(KjD\–÷Ô²¾³ÛØ=â²87ù®©ÉÞzÿ <ƒþG  OcQœYûžgª[RêÁw¼‚z¡ ÷‡DOj!Ûu’'fI¿¬:Åù¡ij/½#6šu®¼ÕÁØäcÄÞLXúXot^(·5øŒ´£ló‰eÛ²vvª›”Û$Sð©©£@„Þßö3X :ùçîŽè¶“Ú¡è5ÝC”öE(þ*e—ðP[`H™U›U[!›·ªæX®e`rnñ¡—do½¿Õø ¶óŒÏM\u¢òŽ´ñ¹™ñêõ`ÐX“ªv´²7É+›Û{XSpùmþòŠW67cTÈwMYó2ôþ²VùÝïŠ5'Š,oؼ;nb0QÚ ÛrþΪ¤TWPéFˆgcÍù-0ÖœðwtK¾kÊXóÐûËZ•…`ì˜aY(ǹé¸ä ¸ÀmŠò5º¿"NŒ²¤.Ì0ïa$n¦õªÇØfç&ß5Íû¥·ò«Ö6áW¨gù¼)GÚÏ›r¨é0»r¬?dA1Ù¡Ï©H‡è9YÍ’5L&;П47ù®©ÉÞzÿcßÿˆ±/÷ù§ûü£ê8ÿ0+K1öåcßß矾1öícßÞçãûùÇdo½¿¼‡WlVŽå{'{T˱ãªe3D¹/©ßT’ êòÞ6T÷fV…!"m¯e3Dé=4ÄöíÈÝez¼«qmÛqW#5í Œ´!Xåç¸üT`Êá_è´•'«Ò,óÎ8ö•wÖ”?[WèEÙ[ï+ö¸Óíã´d$VdF+}MQº+Y¦så]!»;î™dÛ+ñæ­Š2ÜS”NÇĽÉ3ô¢ì­÷·Šüÿ5¥¬u[ºqR+ˆ Ûþ^!™Èù ˆ[”%5±Í{ò YFpì¸E\+#¨iž/½£Þφ®=ÎîÇÒâDmü~ÚN–löç·cÈqYPÛŸ0 8ìâ²iá´Œ±Aý“ÖÄ^‚OM){ëýÍ·Ãú™)b™Ø3ˆëG‹"ó¾’(·àoáQyS)vvzçj Ù¢¸+Fv®ˆeRµÎzUUã ½¿åñùÐE=¸wü¦Ìž<ñ-3¾qF WÖÓÈ_a$—w–èI-dy'áØqgÑÜà‡¦©½ôÖ9`ã ZüL£f£$!Z' ßå.ê:w8¿ ~’²EÑ”~¦ñž¼C6ëÌ¢¸ÌˆAä9‘1ŠÔ4ï—Þßî˜Ý÷NâRuÜ4™í™¼)^XÁÏBí9¨v£ªíȰ—,#¾’l¿—µ(¹çÒ4¯—ÞáÿJÌC~O¬ëE”Tb¢âÍR4@ì Š@\[ÓEå‘Vìal•üÿ=Æî‘ûÀ¹ÉwMic ½c?¤ FõAÕÓà…ÊìSM_úòØŠü¥o«” jD•,áÀÑ>DÜ´Úcì•Ö†<ÈDöÈ)do½#…("9bPò¼µçY–ßí5ìªÄýÌ27•ã¯;Ö8Z‰+².œ˜þÎퟜH"´š…ÞZ'†ÐØÍÏïš›|×4¥—ÞáÇŸ°…ì¨iǬõá•È/$¬í˜ZnEº,3ÖÜí91Ecûi=´¼e>0+/Ì6Æ?ÏukÊZì¡÷wŸÕÞ¶_f3gþ¾ŸÌ¸Ÿ8FŠñÝöûÌ6^ñ×B´˜÷Ýç¶+òmÜ}ÆIÄdo½Ã~Æj…;°+TÒºG+¾iÖETfç}Ÿ²¤æDÀVS"BPâçËG:‚?½©ª(YcûŠ—CŸî¦c׈5nŠÉœéÖ´´—ÞqÎcõ‡ñšì::"¥™ž²(}Óc¿ànCY§JÄñ3bœ™ÖÌ0'ÊBÊ¢ô›3Î{?*SôöÒ[ñqEuŠÏî=SÙ7¾lk¬Þ=ñÖ°æ’ß…×k²¤†âÙ½§›d;²+šb²ó£¹É/²ê˜ì­·ÎyÛÑ|¢î­P ¯<ü¾jù¡õ×u_-p˜9?«’é1fŠÚ±¯‹ÞKŽX8bì+/Ü«=ÌqkZÓKïë<Á{ߊóDŠçr8¾â‚X£Cçý¨}1ÝÁ¨¾ŸÂU k/#GvÙËÇ.aûŠ!nØL!{ëýÍ÷°ˆœïwËb<—žo‹)/zþIù»5ƒoïŽË:UòóÝÚª"ÃYézo÷ÁÉLÛ”ãm‚ìCï/>_VÍZŽs»½Fk(°òκ*ríÈ_®Â±YØgYR‘…«â1TaÞµcG®æ&ŸzM¯oÙblÇÙÂùðªß¥“<¬'\3ÿÐ’(·SMçŸ'·æ\T‰ˆ ʤwtÅØ=êw-­9¬ßňpÚ³BïÀÙf–cØ'Yž_¯ aÌ™¢ô„©^žGf%0g‹·€Ï#{˜³Å}‰õ<©_öÜÉ»?BöÖûË™«B>ðœÐc˜LˆÍÈíÈÈvŸS”âZ ~‡G€²Ÿ2¼zÑS‹d…ׄ±o<'Ìí|×”Ïzè÷ÿ ë±ï ìi°”Tcï°¢©½‡‡Òo ™h53d›gÔ„vìa^íB–-uUÖ˅þƒïšÖüÒ;pz³¬¸Ö³ôM'ÄkMDŠœHHPŠ i%øŒk¡,©(MìAMCÉýJ6ö”&ÎM>õ¢ì­·îfv¹®5ò~ÕcÑsc:hÍuêþtòkäý»Y|ó¾¸,©ÈûžóÝJVOö^ÍM¾kZóKïoçúüŠg÷ž‰Ûÿ¤eûLÝ¢v|ð•³Ù r¬¦ÝÑó\–ñê[xd+ð?±C/È>ô޳0q7Kø;„ÄIÌSF.õ ‰òXü,;£îH•ðw4|ò¾$[Püc“rËõt¾ôZòh‡Þø;úþæ}õ¿ÒÖ®9/Ǻ‰V\VÔpzPóU²]¡¬ß~ÕÅ`†$ëbèÜŸ^z‡€–‘¸t:mÙ…•ÔðÉv¥ÏÂ]u]¨1^‹Œ‘äW-2â1[‰8F´^1‹¶Ö³'[ ½ªPoCï+þö×zÅ?²¶4ãßH¬)>QW%î\½ÅÎEYî%ûFYâî2®Ýuÿ0ö]P]ò³ªŸŒùÒûu6šžó¯ž¥X²Éø»ç—uçi§á|}–¼‰#kìÇÙh +,×ÙhD¬/ç&ßOC³¼ôŽûV*:Ûü<{N-ÁMT{Ψøû û–ê¥â†Å“Ò¹à•”‰••iSGÈÚùÆÇ¾NRû:ÿ¸^]y­¡·>KJ@nc’@‰3rGpu ‰Øõ{ ~G mB©y9‰oÀÙâhwSÔãl_„}¬Ú~û¥÷·xÖè¼j|N¼-¼AUÆšòÄ:EI·Ñ‚ß @Ù†ýbß5>Ù“¶díYî›”Þ­šƒïš¦ýÒûn§²¯²/°2=ÊØÅÒ¥õ‘ï ÷`Ù5æMÝ•;˜ÏÛB¶jåúXd·ü© ñÖ^zĘ!6fÔcÏä÷ ›%ã½-C±G¼7qbÈ'† eÊúH š6B–]=øÔ‹²·ÞßbŠý–ÿˆ‡[W<ܶ¦ª¿âá<×—ãV»©+òžnE ×{‡c<ÜŽØÆÃíñ늀ëù¥÷7Û9}ÎŽSæ=ƒXŒÛîi¿gë¢ü-ÁoÊ;ÆÙÐØúkFü×!YË(›”Þ﹃_TC”UæCï3ò9,ù|½Ç*’^9Ù1¤H]¾çÓBÙ©=x Ê{ʾý,³Ý~˜)êÈo·¦e¿ôlåáÖõŸgφŚVŒ†ÚNôxýLÏ"mðÿv§›’GC=çä¦ºÐ©ÆØÕqÍM~ñ¼§õÒû²{UƒŸ»g݉çdV¬dE…+jŸëîä3³C–TÜò"o¡ªRâlÉÛ5wåë^ÅJ‹\óýÁ˜çÐ;Υĸ\q.¥Õµ_ðêiïëU…–Ÿ`QI)dIU‘ˆÆš6â6Ô»7ùÔ‹²·Þý¯Œ‘ï~WÂ$+Dp-‚eš·ð ;Nè•<Á\h‘ŽÔö¡;̾O¢E¦,J'ŒÚœ/½š¬6¡÷Gœ2žéÃæ]‰¬5zá­>så«n¾#ÿ÷TŠSŸ÷”.Y;×'MJß)c±ˆEMKéý-Kw8í³YïhB­AîF¹RŒ5ô8›ª;CÇ>¼GÈ’êngPO³»rT.Ì-Æn^ÕNs“Ÿµ6ŒõÒû:3à/RŠ3eæ¯ëÌPò}fðú@žÈ÷)aÌ›J‘ùÂ3Cm![”—@T‰+/ÈôƧ^”½õ–: q½ Ã% ™¼ÝŸÓÞzRZ#„ê „@ÆÒ¿­ÊYÙÿšÈ«³…l•šXÊî£æÜUÄé1ÙÿFÞ»ëÊÖìÜaù÷û \÷Kj8°8Ù¡eÀV ×÷šcœ}$§ý öH.V±»ç¬ /ƒÙî¿Ë«TNGÊ«\9¯²–œW)onäUÖW¿¶ù®0‹¿V•Ù«_Ûº¯¼Juy‰¼ÊwYÿ°;Îr—qÅ8Ë]zlé%1Î[ìçtâ¾Ç*˃û {:µÔ‰žÞ—éŽÐÝ@'áØ;cd³³01´ïtÝ—Ýß­‡hÌÇ×ÇCÄfØ6ØM7¬²EùŠ7BÞDÝîøF}bofžx7n1uklRî!¯!/ð\ùÿÂîßDƉÏ2qÃW·+äNÉërEyüj†¼á<6Ýë]Œ=¾Él©º]ÞRžÎV|–ÚBî–¶úa÷w{ûâ“Ú}o'‡‘Þé±á77¢–‚÷CÆÄy?<7S~:«îµ]Ò5¯mÓØ¤Ü{pCN»Ž°éÂî”[Ål“À˜9¬LEŸQÖ”\b QZ½ÕoŒHú3t—÷Œu¡m¡Ë¶S]ßT/®¹)wKkû°;Õ-ò›zðÆ®'ðÃ2v xzĘk8Ø³à„®S-¼x¬[œ3tÙ!‰c÷Øå¶‘J »º²nÃîÿÞq¬›üxÂÀÝnGt{€Û‹”{‘ZÈ'zÉP—T‹[9UèÕè1vuÍMyª5½Ûa÷wµ_Üm…Óq|æšE$ã oD­¢Ü·qBÞµ½´Vö¦±}?lþlK×ûÇ×*Ê÷Ãéòãµæ|/Âîïr¶&îû#ð»'ò¨«çä<ÔÂí•„ê\üìY%äxSµ;4¶þšu„§„.ºmhl£R.‘ä²+P÷{ŒýÿÞSèMKxÓ‘í•WXçL¡åØ‘¾žôoy˜Ú *¼&âKº@ÄÒØá5ÑÜ”Ó.êf»S â -ÕÈ€#Ü'Ä™±š“âü]§[3Õ’ç‹‘#]ã;¢LI52#ä´‹ºÙîÀØc¾¯ãåtùÔéRu¼B¼‡ù{8á¯ò8ÕºKm M¬"^wvè6¼‡»Å{8¼ú¯‡]MX;awêQÁÛJêQÎb‡Z"#³GEå‘ùãreuǛ踲úk"ÒëPßÕÇ~õ¨ 7X=*Šë¾ìþÒLjU½Üð1‚³‘CÖÙ½€~À#Ê}Œ3ä§9ê:U)H§½&];Í?)7íD¶‘Î »<ævë7,C­éúóæ<7ŸS„HÚQ¯<›(Ýý­²ŸòŒ-ê:•<DÇuŸÊüácƒú-±“-å°KºÙîïÎØêFù4“¹ž©–ô¨›!«…› ÜyÉ£¦‘}ŒÔ­8VzrX]ÙÙeÅØÓkB¢v­li+v·.œQNì‡ »mo-<Þ–œLÊ×»òfYuÒ%ec»WÙ}à®[UqzŽ(D7—‡¥­|ØýÍïÍ;w¾ÇE¸4|²y;8¨Òßî³Ô“KÿÄ_èÖÐmê ¶â¯É)-tžÜªœtÇw¯ª[æ“MKKû°û_ÚÙ·AV Eœ‹.ОUÐ5œYòãxŠ(gv.u=W×O5ΩKºVEÑ46)ù™#´Z¶´®»¿Ëa~p¹j 5r:N)è…õK]D³ŸL]PZçœÉѱKº¤ZTX;§¶Ð­ÀIãØ5pÔ87ånimvñ¦Šèó‰[uFÆ­êɸìþÎ?Έߊޱ›Q{Ö !¢ð¹î¥÷põwy|Ú ªF¦ƒ÷¾+t‹êîç2ê[ê%äÅ£‘ëÃîâ=ôg7=áód<ƒšúSø³›ð êë”0Ó[éÏnâ<îXéÚ³écû³ësSî–¶ùawøØ!ðDÍ ½µ<‡vV:aÿâŽR"/”»JÁþ×Fè’q†uN+¡ÛUÏÍc;<­•-åù7ìþòÌ0 “XïlpóÅÑ…=zÏ¥3ì!_@$¤®S5êkŒÃ^-ÔíÀ/åØÑ•VsSN»¨›íþ.–݇µÃGøƒ…ÑGðõä¸üå¾ÌÔŒ´sˆÐFßåzuVHs;ú-mõÃî8ïÈýräløÖ¼úñ``…ó‰ZórBND ê:¶ÅŠ¿^¬ã˜¡;áwª`v¿\Ѩau³Ý© x7ü?ü,“µBÞ•Ërú«¨äÿL=¼øYæ*õèr1XKÉ\ü,;ü?{†Ü-eqØýeÿä GV ªþ2ü;9d¥Š’GgÝzÇ *u§wNÒeÏxŽýêN¿T¼j¶´Î»¿«&zoZwYñϘ*³ˆè8ŽÇï§Òò!Ôú¨|ùXw…VC—ñÖ¦^ô+< ìY«ê–ºÙn=»~”á= ÄatnÊstÏÞäž½äÃa^4ûÄOç6­¿&§ÜÐíX½¦ú‹Ï”å:Bî––ûa÷—ù¨ 87 æ ëßmÈŠ_ѵ…ù”÷çà㺤 sØv#:ÂC;arnǤ¥õ~Øý]ìþ®Ö…õ$+j]›A$òðüHãôX°¿Y)ãâ(ã÷ z>í”q +Æn ƹ›°Áhi)vG]žrÕjžcÕ‘9ö•7‡+J;sì+NïDè+¨îèà°ÚE9ö7ÆŽ>𻩒†–¶þa÷kÊ´tŸ>Ž?»Áyž¿i-ú@?‚i}bI™mË“$ÿ¥žøuƒêñׯA_é"ÇPcG¢æ¦œvA÷e÷—uZŽhûóæ°N‹(VªÓJ]ªð4Ò/#\×)¯x½ª[V‘lvŒÝ2F_Û!_ò ¨N«ÇØßôé¡}ßð{±¿3»> ÞYà›b%]ÑzÒ•»bò¡=‚}íjlù½È©=î$èýŒ±sohÌír·Ôt³Ý‘¯ûàÚ ¿³8Çîõ¬¿ÏÈ“¤òkòƒÊ|Ìé—¼6ƒtIù%qÚ]Àil¿³øÜ”»¥m|Øý_Ûï>ÿ ¿ûüÿñ»·ÂïÞþ~÷—åe|~–]ògi#U‘Ågi¯¨Á~á¿&´X~–¾óg9=–Ó??Ëéù³ôýa÷7µ.ˆ˜¶­:ÑÄ9^¥Þ€ b¯ ð|¡šArd›I×)G#Çpq]×î;>¶ß‡|nÊiu³Ýÿij;ü¾º¨Ýü{—W¯7Åã÷.=ÿÂãæ_W÷íàÔ•ïÕòï-KüÞ«eKM7Ûý/»8uÜÛŸŸe÷üYÚÉŸ¥ÏÏÒNþ,ûÝ‘o~–Qòg9+e\Äg9+[oºÙîÀ$)¬k¿îcd]Óâi‘U(ô'5QžotB~U­ÉL†Ñ4vºùد‡n^k¢üî9Cî–öþawä)Ó;²ãŒÍ±Î}ê¼½Q~j^!¿ŠCcyÆ Y†Þ˜5ÆŒpâÅϨ'#äni-vëŒÍþõ–ö“9 y`çž…ìö«þ¥<5?kÏ*â<«”º^Ï <Û3qž téžêAêÙžW¨¤&wKéÕ »ãw!öÌßeUã úéoÜÙ¨"I•ûG•EÕoˆ®{Uë“n×äôt‹kBá?M”~—:Cî–²+qØ0 ¹.Îð§à©é-ßêýcûõ~ž­<Ƴò­®· ztÅð›Û½¡ÛTÀ#¼mÌcdM9ŸHV„ÝßùÏû˜Dýacæ-¢ëÇ%ÿYm!o¨ö\S£v®?$‡õ‡¬waý!«[Rý!+`XHKYvç?+¼ÿ½KäGœ©žLeÆ/õäg©Æ°Ð#VCw{öæˆkÊ Ý„ÿº+ü¥|Øœ–Öóawê…€óÀ‰b;‘bBD.‚OŒØ/ž‘Y…ƒÀº""ÑΜÖTW”³\«¢®¬bo«•ò «ËÃRfІÝ_<»Ë‚7OïGù+Ä©¶¯m€­Ùj¼ì`H 7ñcx€’J™ë’*î¯Îãs n½æ1娠ðט[r·Ôt³ÝßÕ>¾ó‘óHÜšNü³¨8PvBª «~Ë'’Ã]RïH;æ–Ðm¯Ì‡ð9iî¦ìZZʇÝ_úúÙÅc…¯ŸˆIx;+PX¯×DùêsBÞ…dv[¦¼š¡«7Å*Ò5D¤©±Iy®Ã yA'Ç+´Ð°[瀅a×ûß‘ÓX_½ ²¡Ÿ ŸIyí„Ü`]\T ¯‚8èFÝzЭc×U˜[rZJÝl÷—Ï.ÎÐ#ÖªÃF®UÀë^¬î¢üÙ­!'ŽÍ†+û®ŒX«X_wZè.T½VÕæµ´V—Ë.è¾ìŽ˜;W;¾ÜPÆTA-àåM;õš¢|_o!_BÙæŽCì©Íw|¿z\pWXÞ6÷¾ÖvQ7Ûýq÷‰XhÜ1fºûx7rÝI?î>ŸÇgºûD,48-Ý}c’î¤wÊÝÒV>ìN5)DsŽ\ÔŠ¢¿°îw"õNQŠ}°ÇìDÜ¥ÎÐ]êM›Þ–Šgp7éÚy46)Ͼ9!ïB ÜíÃîÀ`“ú1ˆ³­Ó*,§Y¼ÄwöÜûšò!ÔÂZƒZ½ˆH”ìb¨ìÃcÏ@/jº°CbηËvÇûBü<¯Bj8é(Cï k´n¼ìEÈS33&ˆÕV¶ÆÖ™‹œZC·«v–õ]^;˹»²…ôW?ìŽÏÂ÷«/ÿ,D¥ggyÚÊ{!?Ù\ï·yªk=ó=J j"éJÝJ+E·,m”> ?kM«u³Ýq~ä2åN’³‰A qæN²³AÊ;äͱYn¦Š'ñTy‚ìÑbìṓš{(w’ž.Ân½ûô-œ¨±ßÂ5™Ø…HŠ}“9‰~¾ÀÒ¦üâõ0e—¿ºG÷?¬‚Svè6džFÇRåþrnÊÝÒ²?ìN8Âì´½–‰ IìŠÁgˆøpE”ûìvȉ4O]Ç÷ßÅ9¥‡îF5AÕ Ê=|E€ÇÉ–ê7½1¶÷ÿeGOæ` âRñþ‡g¬yï =c¬r+ìU\WÔ /­sj—®½Gc“Ò¯¸zÈÝÒÚ?ì¬ vlª½)ê-R=Æ=t/šÝ`•ñËaDv!3å5í«+˯ÐíˆäpìùåU÷ÇÖÂ.êf»#þZˆo=ø þŠt™¯ÎŠf·—8³b¡àý$êΜAõȺu޲ã™[š2ç›ß57ånikvÇï2‰b3ýw™áå8DŒ¢ƒOøŒ¼Ý&ÿ,³Õ¿¸eªb ±Óæý“êfËŒ±{Ä-97å´‹ºÙî/öà}p²­¾‹c¥Öž§¤§ëîŹEuWy<’¢BWTꮢî{†.ú¹kìè÷®¹)§]Ð}ÙýÏÕ„ÿ=~EÕ„ïWM¸ª¼£&|¿jÂû¿âqû}]^þüÓØsÇqW‰çœ ðd|¯5Ü<¨ñî7ä~&k+¨âøŽŸ«n—®í"Wc“ÒsN\È~e—ëf»¿Ä"ó*ØŸ7çàdËS‹ðº(­>Ì&85«B`eª%ï«§zè6áG2S áKÞ”Y2Ý»Ð?ìN´|ú9E~9œ˜TØO£‹ò=«„ü*ßh¶ ¢~*8õ†®å®øØ)Kf{,zfKëý°û»ûq§<«ŪȋMÔµsåÇ ¥ûÂì!@¾+ªT&R슨OIÝN;üóGqjb’¦85QÙØõrE'Ô—Ýá—̳iî—)g¢bóåoÂxsetï!_ò!ÎÔ¼s§6Ýõ,¯>¶QòÄ–r·´Í»–¶×‹þdN~ŽvöÈh¢ÁbGâ町¤Ê«úâçC™ø8DLNø9DU^-[ZׇÝQ]‰îµÑä,|–…õ± ¨wQ)†ëò)TÀu3Uâ³°Om_<ÎsTwÍþË'> û3Ÿ&»\7Û±ÖÕäÇf"úSØg‚~ì.Êý)7ä1ê’êøKNS_xÖå±Ú‡ˆ ñ—¨ì×Àê}>ìþb­ßM¾]õìÇÓº»Îr'pw弦ÇÚM>C·•:a:çñ¶I×`›|ìî>*ÍM¹[jºÙî„MÅìëè _""uºG¤õlU”žGbG§ž=‰SOÊkF§ºË§žÑÜSbìg®|äSÂ.êf»¿ÃÈ=˜n¶û›óµ¹{°ËäŸ si„f†S‡!OˆnZ<ËåÙÔuÊ£›äð@ä˰›#=êtpEù0CÞÔU^¬¢±õ×ú¬=t»Ð•çåkd¹[ÊÚÆ°;î[ÂZ~ßn|UìÉË õ†Ž,6vböL)¡KªG¥·sZ Ýæ1ª+J¿Kí!wK[ù°›ç¼ýç?þõoþ˜÷àùïßþ)þÝ_åÏ¿úKÑ0<´?HÉüßÿùó¯ÿz¶²çHÿ?# Š¡ê3—( u­Rµ6ƒºûÿ¿~ú_ÿü?Ï?­euYLöãÿüïþï¿þ‡ÿð¿ýÏÿ㟿ýFóÿvDý/ ðןÿ“úÿÓcûý=>äÿÛËó¸íö5üù¿þª–|ó¿øè‡ Îþ&ýïÿú×þI[Ãc®9èü×NÚþbZl~†Ñí´gk²¿Ø¹¿ÿ‚ùIþ Ó_´ºmUÐ_Îc¼G}³  úì ó'+LCÑ'ÿbT$©é/@ç¿ø½![º¸þ´ýÅ@ïBÿd ³Ý Yøþ ó_àQŽ¿Ð£ßNÙõòotþ‹´ÿ Ðé/þÁ·ã?÷ÌþÝÛÑ Áôû—ã?©ÿ_ëݘx°üá@¦_öY¿ÓO2ÉkïpèùÞ ˜ï¯EÖa2½þ|KÒà-ð?àKÀ—@ w$ðŸz'FA|‹&ƒLŸiÛ‘Ëå ógþ½øÞüNÎ1Ê1õ ÓûàŸ‰¯G2¿ÿߎôxúýør¤o¿+|7ÒàÙ÷?à«ðÜ«Ëó{¿^ÇÕŸ]o”ÿObXáW]ÖPzX…ØCü> ཚÏF.©bJDqPbg<þèýžµ/F?µ9%•y¦—lhžÕ8.óÅhZm­ Ç´`ÿÓë’°„ªjWHI­#"õHtÇsÆ“çI=4ç¨MækNHݼG/Ûú ÆZ}Žæ»©Z0ðOÈ}·‹·W5<ŒßKÒñ, ÒÁ’1Є›zÅn µ(³YsR k¨—lýÎýó{ŽV´üóbðøßìwk8ãÝN¯ÎWÒkp‹Ôs¢ÂÅÃèrLû!ÏôQ[¤;aNJa õ’­ßxÚ­?å¤2 ŒêÉgõ!.Û‡„<á{Hú8ÊôH¬(¡£V×C{Ž:=ןsR*óL/Ùú%PO{^߸L£ ¦gÚ7ÌŠ“ß½„_m¯KÍ1!=Qgé ô<ÛÎ>ÏK¸žg.—Ê<ó4Õû#ÜgÖ)`\ïÑ<˜ˆoëõHyú¶ÈHj°êÒÑ#ÙâaÝ2ª­xµø¨%Ð1g‘+屆zÉÖïÒA_ì±ãÆýæ¼W1Õßç„B‹¿ë‡¤–º#=;î_b´âz öcÔ—/ÌI©Ì3½dkl ¿«Ïô¤2–³žúw\–ð,ß¿¿óòŒ‡ñ{µ–´> õ@LOÆãv„Þ´dŽ:=W€sRêæ=zÙÖo#Ø‚‹û—Ȱzž‡àžüäl[2ˆ¿q¥iÅ¥ûY¤¢¸g Œ~3½_âñ®`T ž*Ö ‘Ò$µEz "ŠCFG@zô;`ÔápήWct×K¶~Wp~_KPûI ÔÖoóÏ­¡¢ÒIȨßS„¤õ 9PD$‘ÑàWƒ^ƒ[ £6¯ÔäœÒèe[¿K¶Â‘ÎsáÁèr”nûÊ3ç íS¿ëž¤nˆYð`T( W‘ãŽQk¤À¾œýº5ÔK¶F/¸gB®M1ØËçc&Ó¬AB;ÊïŽ!içcwG"ZüéÃhÈ•^Ó¢ÿŒÚbKÀœMÆ®—l}µCžY1擲Á"ˆ_âñ¨ðV8R%’Zu…ô@ ÇÓtFñv|ÏΫ:@àO'~“ʼRß¶~q¢‡ú´ }ÔßÍ€vüN» f2£@¤*©}é8z&ƒñ$ìCï÷˜øDèJØz&9§¤2Ïô’­|ж]FOüª¿#à–Û§xqÏ»ZHèåý=ýPúTqT鑨º.Fm®gCµxÙç¤Tæ™^²õ» Žƒ³ø…GWâ¡N{y7àð['áÞÿëR«Ç•Uw—mvH¯[m!G¡SîÜ.5k¤—l ·ú°³¡£‰Á¶/Å,îXˆv!¡‰úré~¢2Òáct{ ©×ð+ÿ؉ðŽÍ)©Y#½dëw÷©ßóÀ.ž8@j‘¶õ×Ú(SÚVj»£ŠéÉ,j’>ûÍ–‰c¡ zËÀ¾8ê T1Ì)©Y#½dëw‰vøÝFÔ$»ƒ¬ÞÏCÙPjAxð¯¸t>ožô@Ô¨£(]¿¹òÊ í s»ÖP/Ùåµç´¼›YÉöØ5Éj#áyu×¥‡çÊÝá›ÏáT—õûõDÈAK†)¨7,.ÁQAüÌåRXC½d+ýÕJ¹gS•¨®­ƒ¸ùzÍ3½°¿U«ÿ—ÔÚK„Wõã©â¥^µ¢ŽZ³Ñœ”Ê<ÓK¶~rQ,b0ìZ ë¶Þ"Ã\íͽ |§¶´ÙêA=s-†ߤg ÖÕ1®5'¥°†zÉÖHÞÃÖTç ž*±­ñMÆ=¡GÊn7{U)®'¢ÂâÐãJïÙ1FºEܸ#×îÒ¥Óè}Ûú]»_C§áÂü$FW”äw³š„Q°¦m tû]÷$5¶ô@´h«#Fo®gx3µFOÌI©Ìëím«V¿eáãá•Î8¸ ÿM7+¨ÍwB׿ߙ%µÞ‰Ò¡mŠ «;–^7ŒŽÚ}›âœ”.FÅM/Ùú%ZŽ#Ñ„ ú‰;œg#áÏqéæøÔDÔxÒ6n¥'í¬zìÚë¡´9%:·­ß4Ù´² Óä¶£#çÇ$Oáo³D•ß_„õd®l—®ÇéhîJwF®Wm£â¨Õ]霓R™gzÉÖï\,ËÜù#Òêq¨ó6[àXø| .—Ú±ô@ôÜÞµ ‰Äñ FC± FmQ+‡9)í¼cìû¶5•؉èt7˜Â (¼c +È ™ß‡K'Ãï߀CóÄŸ‚Q—ëĵ0j‰¨æ,Âå€yu½mýâôQësÃYÃ÷42êU-Gi!þ—ø=‚ø›vúâR»ÜIÄð=Œn{õ¬Fí¾§qNJa õ’­±Rþî 87ÿ$†]{mmú}úÑ‘d8û‰†%ÛÒ˜%=ÏÓ#=Û«œQëY—F]žÁ9)•yõ¼mUÄÝÁ¹åÃฬ_£Å˜ÄZ ìýö†H:ŸÇ[z ¶üãb,ô…„ÞBnFõŠ?ÍI)¬¡^²õ‹%áÞϽÛË¡/áq q>ôsv/áÈ~K´Ò—ð`Ô‘pìh1 þYzÊâ¨Í9Mkm*Ž…t™(¬[H¦' ¾6Ì;ƒ„NDpíT`•)= TI v‡š¶ù°%ý$t$«Ç¥2÷Q·5Î~ )/á^c#Ûgc#eÈ áU—žç($=5n³ >Ã)½g#-„Öî}\º¦aû7·5õ Zv`–ËPŒ‡çºÕFàYÎ7<Û”Zwé‰pøm0&p9¡ÈrŽˆæœ“RXC½dë7 ²gÖhAƒi“Áû‚DšNB™5çºÔp¥'¢\_e‡yÒG“Þã»>ÄßhÀ\.…5ÔK¶ê:8žÓÑìH0à‚«ík•ÁÕ¾/˜È¾3I õ\z ŒV @pRõù™sR k¨—lýι P‰%Œ ¨ÞbîEöjÜ„–„~]ja-é‰HØèé?]zýÂ|x¨M@e¹tÓõË¡në ÷.{ˆÄXÄÙ?î²æäÙCd¸u’Z[sé‰(É=ÝÓczýè~ 8—š5ÒK¶~ãbY<ÆT]ÜŰr g¬…]b?ñƵâ6~žzHIÍÕ#=5þôaX›kéu+zæ¨]7GÍI)¬¡^²õ•ÚQ7ÏÎq°‡s]³Nä+!¿*;…!-—[´ËujJÛg µ u—£k’J1—Ã.éf»ùYš9Šg…’ÏfµøžÍÜÏ l®_Æ>.5ˆgéˆPg<ПÔ3à5ê¸lš“R™gzÉÖor ·/ª—˜®Ø¿gŒ'£á9_.ºš·îÒkÎ|ê]zöU"àŒ^\1ŽZ\M™&•y¦—lÏ”[øçÅ`í&Ü¡)ûð„ŒéRCV—žˆ– VÍ#N„ô¡ÕC£¾œÍˆf²Ebæs¿m xÅ%)²¦Á8‘KÜ´ºôMB Q.Ý9º*¢†Žªá@6%후®{)† kŠn†nkB¶¶8GƒŽìq˜ZeÐÓ#%^U\Û%í|ènO„gýwþ^E²8F­‘JŽ9)-Ü¥è8w[¿sÖýü»JôíκaܘÛb±ÙɹK"Ù/i·cLu`ÌËQõ§Ïmû¢`Ÿû:rå%¡/ðI¢Ÿ›zÉV]A-1—µE?™ƒÂ§]Íi6Š6 /e³x”äHÅ”nKå^úkrj Ý¢Ž=¢&sSî–šn¶[ŸÅ2r¦½T?‰Á¾XžDÅÙ¿<‡p»›óº´>„ô@”øÕŒ1€†½ÁÞF¡`ÎsŒ‚ÖP/Ûš`Çͦ“PÇÛsÜ›Hš,æË-Äï$ô›âRCZ–ˆ•bÔãzÄè%*%0'¥2¯ž·­É™qŸ(;3®•”À™ñŒ½äÌ…„;3–KÏΔˆ‘`È™Çx÷Q»GÁ9'¥2OÎŒë£þ|Ø¢Ðï'süa~’âA·bÉô"X³.—Hº¤Ò‹à{˜©Ëc§sû‹BKM7Û­Ïb¿êë³ãŸåÎlëªïÏbM.]>ló.©ôYœS[èÒVŽýú,6·VZÊ!ìþÎä‘85\ÓŽáUàû%á»æréæ .…U8ªþtYŒHm,Wºüã‚3Ò®®IŸ¡½ÝÖ8³´öq%c3D°Ó•lô+YÉW²5\ODº’­‘®d%_ÉF]ÉPáW²ÖÒ•Ìm}Á”Ýå*ó*I⚈ää›î F¾)ûñÜâz§>GàéÌÜ8KzÏ=«iTJ™(Ý¥•ù¦g½mý&ßÔª+€ þóblà·ûçfªA/x¬øCR»/IO„²É@É!õ m\£6|9'¥°†zÉV9n-•0yiœ±á•|¼ÝðÃË`N^š§üó¸´=É4ÒQ"|áméÒ££&/ æ”ÖP/Ùú]Y²ÍJ´yƒéZmóìgy(ýu¼´x·¤›'JbÍ|/Á(êâ‡õ`·“ВжKC}¬ñp[9¼¼Ëã2øc!%¢÷EB•æRZríÑãO'Ê¿—ëUE»ðbzÂæ¤ÖT5/v[¿CN}ÔWÜÄ`¿ˆe9º,`j.,#¼= éaLœý¡7ql¨3ªÖu)¬™ºk¸­éô6n:½'õ„%/å¦3ùž'öÑÒyþ.×±ã&F;®·lÕä¨Ë×TÎI©ÌkçmëwؾGÝOb0éÕ=Ó6eu¤žÓÛ¥*Ò›(ÚÆ¨3Jº1'¥2Ïô’­:ûÍçw×I t)æ‘ÞhöPöó^ƒÀ)ÍÒï%=ÏñRz zÔ¾‹QŠë.´FuØhÍI©Ì+åm«Ì_Ï)x[ —Ÿ`œ‚¿¡0‚¿á‚p›®Kïs7žÛ[ňq¬áô¶µLæ¨Û;*sNIaõ’­_"gàèÉe¼¢bgÀá”õ{8ÇzýÞâY–õ{L²)‰HÉec³@Ÿzýª~'ÕÇD^|»[ST¿ç¶¦ú…×>EFEçéÂ=÷¬0ü÷Rzû])ñ«ëkŸrF¹ÒãN„QÓ>…9)uóÊ}ÛÕ€Ù(‘„y¢²­™Ó½¢³›Ã½F™fçÁ áTz9VÒ(QÒlMzOqkT::õíR³FzÉÖ¸8tÜ¡‹_À`oÔît"ŒÔ—/a2„'Þ—V"jü韀üçjTîÁž.…5E8µnë7 ²aQ£-÷Ï‹q°tþýÐÐû9Ç´BÂýpË¥“ =5D¿ ôú¦Þ±÷œ£‚ÐÚ=»KÍé%[“×·Ý^k»ñV XeàF¨â¹ŒGé×ã}>.­¼×éD‰¸ÆxnØMzÉѨ Ük=%…5Ô˶&0˰n€¹•ðÃÎÉ„Þ]8Ïñ;ºë8žìIÆF†ô6N uGfæÜ:O<ÖP/ÙªýÄœC‚Ù ÆEÅ€!´Lô}­æ-ÓT}~wIÍwE=ÞÞ"˜)–‹6|T#´õ ꑺy^¶Um†ÝD’§WÂ:ö¾<¹Û~yz×2¼dÉ-oÝuI…§78Ï™[ºðäjìðôjnÊÝÒÚ>ìNö«zŘwÝbODoÀ F'TQ'îuq=Éq­¸aÌtç¿5Ý÷o@°”îRXC½dë7鄿“Ãæóóblà»c=ì(輋ïÉÔ½ŽÜ-b÷L„ƒÈãÙ$ºôúAɘ jsJjÖH/Ùú‰ÖÁèt0NMhÝs.@¤tI…Çqj"ªŠ ÁèHü€šˆrÔæ tœ“ÒA|ÓK¶~]Ľ–j1Ä@SnqK¸`÷ñŒqSŠ"nêXžQ㌧ñ7õ,ù]£NÕbhNJežé%[¿(â7Õ”eŒíÀ$O…jKh)tÀ–ŠI7“ÇöND}“ óØH¯ì·ã}Þ0‰¤CnŽñ¶õýPög‰z?”- d†á;s¢!´™A©žÃ2]h#ñyn@ÈØÁ,ʾ?ʾ“Å·¾m}›ïžÞ¤pÓ·?{úögÿøö£ã°ôDôþñí[;aÕ¤ÔøMÝÓ«9)Õ·mˆ¿õô>¡€já ýRdà/¶ ?!@Qþ® °;šÇVÒñÜ¥"~)2ðS¿G_ŠsR k¨—lM6å8°!G+âô“G«A•ť•5ƒe8Ñ¢ãDd kÝ+‰9«ò­f—^¶5ÌGÝý‡—ñö,‰ßÏ;ÑîòX‘ÜŒn˜L ¡¹-Ô1r³10j$ž Ñ%GMð_˜“m0e^-o[Ãü±V‰U`l´o+–ôFü–§V`æ‚Ùß'VRkË(=©Ïú±Ÿ‘í©»}‹gø¨Í38'¤´zÙÖoN €œµÚ»ŸÄ°Ö ÂD  Ò@¦\ö'Ú]jP[Òëºyë@ÑS²,õËQÐÑz—Ê<‚æ¹­ßÜáÖóHò'1€c±-ÿÀ‘êtH(#ä÷›—Ôw¤"®È(hg½‚»F„+ÎI)¬¡^²õ‹_CF4Ô Xè5ò@z›fŠ%µL"é]&dÊWãŒçY§°&8jôÑàœ”Ê<ÓK¶¾÷)»r¾÷©¾Ó–wkÚï ¾LRßšvÚ–”MO 3Ÿæç)aæSBo[¿D=v“ucLúŒ¬róIŽŠå¯Ô’5W’´³ò½\U’‡á]—a§¶ªQGêàksJ óŽàÝÖïÂäM é Z£8œÈ±jUj´&¥ÖsTz‹~½z§ƒ†@U?“8G¡Àœ”Âê%[S¶/Ê’:z"U” —çQËË$~Í¥v™—ÞåÕË7*0 2ÿ WT€KR*9G¤BI¸Óõ’­ß¬”÷YwVó^€dX?:ÛJ óâÙ‡„oßӥ抒ˆøubðl2Ì 5‹Z¿sBêæ±M£Ûú].@õZÂ^v´”¯ ah0œðË"Äë®'Â_ªÉ 圮g[ºF5»ۥÙêìpå¶~}Í¿#¥…0$²v[¿[)QMÔ‡¯”À§ð–œ´•A²ÀŒ¨Ì©.ÝÜ“Kqâï¯ç t¿û¨ €sR k¨—l ”lâ?©f÷ 1=”–/8?Ñèa)zlÏ=¥µ0jû葨þL’aéYÏZrÝb³õº5Ð˶~^\¬ÚPNd Ñá6/ðHÓSx²Iè x»¤Çb\Ô#Nd @„ziâ¨ñ£rNJaMx±Ûª‹Ž½f©¡2æ[¬åbóßhþž·-Ij/½ô@D+e2Ì€%oµ”qó1'¥°†zÉVÅ®eÄOçrÆEöee ù~(g)°ºÔŠ¡„ê½ÈØxb¡‡+ŽêXšb´Æô^¶Ê|ÔÏZ\ð'³¨§ê±Äø'•ùZØd=)Áxˆ=©G£êOÁ(Gzã µäeú˜ç½Úœ’ʼrÞ¶Ê|a»ìä`¶ûì&Y·ku¡ƒùpópéz~séhÑéMŒÚ]ÏÚÁiÔêˆzœ“R™WûÛÖïJó¹LµüK^ZßšõLÐwÚ##ßxGF@*üq¢EF‘ýB²Q}Ôýw!Éø¨šÿ®·­ß8ζ¹j@8mú" *:›m³ éÙ$V‚'h¢™MÙÒ«ò9ÜEaÙÇön:³¤IϽC8>êõ¸5ÔK¶~ïŒö6­Á¸Ç¯|;»C÷§;tgw(õD¸ßZpáæ•Wh¢Æåu†ßZa\ê%[ÿxsqPA:³£ôŠA”^¤3/5x-¯—ÇF=,âì‰H(½èÄ2Šô¥·Ï”Þ¾fô’­Q‰Ð-ÉÔÃkblô”¸ö37¸¸æ!áÞ°áÒNt¾=‘z4o ú4×k 5"ìyx­¡“x}»^²õë‹ÃS³Ü^/ÊÃ9þ¦Xéé»aÀñšò±r\fE\/ÊÊž'ꉨ¯rò1à[Ò‹yWzm• à/õwjdŸGýÇÓH-é‰B?/Ækå¹j?w€aÄ.$̨fO—¤õ¹øKOD‹?½†Ëõô§žá@iTG‰ÒœÒèe[¿ÿU‡’Iâ«ká\œŠ2³ ÄÛ¹8s,™zÞâí\ìˆ{èò¦_µß_µû5XzÉÖïʈå¢-0Ð--²K ®—Kâo¼rîéRëÄ-½ùFncªoºéŒâ£F+uÎ9u˜Ìo[¿¹2œàp”.1&•-F¡ÂŠnUó3ì‡ ÆË5îu=#òˆÁè¨Ðì1B¨å}Hè£ÖêRXC½dë¿êƒñ?,vÈJ ŸtÜcñJ¤‚ýî[×ñDÆïï)©u¸‘ˆšbôæz(]æ¨QØÌ9!uó½lëëØ²¯îœáøižØqÌ +7”'bÊ E©MÍ_Æí‰˜bì2pCuzyÜPGwN¹¡(…yÔK¶~óP^õœ’GŒCœ+{â;IQY#èÆkG{I+›P1Åí*@ãÿRoêu%£áº¡ˆ ç$ØïUß©ó¶õèF+cXÃoHdàŒ3ÍŸ´l|ˆÓH˜QÓJ'$µ#šô@ Gù#Ã6@éu»qÔî7$ÎI)¬¡^²õŸÉaž¯/ÙËý¨ˆ½žÒ^~TIµE¬HS <ß|s÷vüšx¾~îÞçÏë¨ý²õ»Ë ^oñË`³èöD–ýFëG´›ƒ„.ƒµºô>‹Œô@ ÏÁqFë®g%€µ+:¬9)•y­¿mDþmAÿ„jÆùÍ ôÊî"á.ÃæRë`!=5®½÷àîzÚШÕTÎI)¬¡^²5Ê(šEO–ÌÃÊ%âÖãsÒzê MT—K·åôRoX)¥Æ(Ýõ S£6㜔Ê<ÓK¶~†©öœÎò¥â¤Qîº}’ð(^u©UIo2B7# ƒ¸Ø®W• îX?Ú¾×qig-îo[¿qzÛƒj_Üç †ÌÍçX \Ǹ•„û\·K §Iz"d?[(›ÞF FÝQ1„9)…5ÔK¶~™\2óß{x¢ú°ÜF/ƒÄoS $‹¶íz"tŃ}X ÇKþC )ûaóÌABÉ­¸¥GÐ#13ĺš0‹¢Yk fÏAB1qäȲ7CïÒ˶~óPZ)6œ¥?‰1-ÃÜRqý’ÐQ°L—v«‰‚–_…£ú©QÁ>éu”hbÔœ•Ù³íº5ÔK¶~ãõ»¶Ü-ïá µFÈ *dÇ$ág‘æR‹ÝPωºÌ 1§ëÙ‰Z£Îhá„9!¥5S²në7û_a`ãF|ò ëäÍOWØ<$äßâÔp…ÁµœÙFï®×å Cg£ä »Í¥2¯÷·­Ÿ¼z>"x'ÊIþsNã—KY¾‚3Qßå$Õ€`£&ÂEÉ÷©&ÊI¨—l}õã ÐxáKC>e_$üÒÖ\:é%ð(ˆ`F3ZK8ˆ¾fd4yg±±4R£Æ}Ûú'* ´R’1qü°<í9•QIC,.íæÐ˜ºVŽÁQÝ=nîÖ>\«ã`íCë$´|ÌíRXC½dëwÉgåÝÒ oi8‘0䘚‚¶n—"÷Ö[Â-™Z"£—·ö“[¶Ï–†s¸Ö4ùÜÖ/~ÕkÙ²ãFŸMcL´y¾–‘:þr­ lFÕµd^I­(MzF`TÝOÁxÀ_ ÷dTW Âï§Ó¥2¯Í·­zÿ,éulÕ8‰qìHÿd‹b(<þ·‘ðïô¸tZõ@ì¨'c!£wpíÛGõ¨§æ¤Ö,Õ½º­á»–å­=Œ1í0fÝØ,§iWdé5òÎíãÒË´)Ó»LTšá\ìöáÎÞóI¯F!O¾ývÝ<ê%[#éà”¬r1žÅg[ÍÁ±ÀÈscÈhÎǯB©E2¥'BŽ2Õ=$òqT±Ù.…5ÔK¶¦§“sçœq dÛ˜gÕH7åΩD€RË.”žˆÕ\è£G„2O—Ó¨‘;Ç9é:€5Ð˶~á°/ç)ˆ1Ÿ»ÜCàì·Pà‡³ŸŽÞe*y­qö+× ?»Ša™fÒ³|NÚ=ÇsRÚyöÛûmk$Ê ‡ÈŒ®t é0„ ¼éê‹ ©%3.Ô×J­ªZ§ îj†o * ^>[nº¹Hè–V£%çbG“sß¶Æ%€Z)™ùË¥ú~Þ”;ý Ø, qOL„Îâ¥:Q_h4(;®g}È4jju6 äU‡[C½dkd9¢½`SœDÊlMh.D€”ÏHÒ›Öç†Òõ\j¥'B§Q2º¥mSÏŠ4ªøSÌI)¬¡^²5“á¯Ñ(Þr@ƒÎéÔͶA¡+ë+E¨VpËÝõ¦Êç"Œ6jgH¯_€æ™À}ºÔ¬‘^²59¨B-Å97P‹'!^N.pKxmà"lƒ#»J²mý^±Õ»ô#*€Q¿àMÀ^·†zÉÖ¨­[ö¬ ™†EèÌ §Q  =¥³¸T®Ò²9ûQÂöNÕw4ÍI)¬éBv[ã„ Ü–u¡ÿ2u9víÙ<7ºå°1‘êku=^.lŒ'r°¤÷K”ªQA¤“¤‹˜ñs½m‡uÉ'NÈ@1œt²¨Ïº!}Oó¦ëgÅp'J¼ºbÔ#½§7bר ü5¹.•yt¿¸­//æ´?ÎðE€½$”PQÎôsv ¸L•”-=#¦Û$`/¡7ˆ‰QgÀebNIaÞI9ÓÕùíä½N$òãØËÌ;ô8d"ÿ%á™Ë¥í:ût¢;€ª3Js½†Œ=ŒÚüzÍ9›òù`^io[〼Se·Y°1-Üš[Ý”ynµ‚Ó¥×ê¨wY´”zhÑ®ë5+Yà¨M8tš“R™×îÛÖï<~o9Ëîh?‰1 ð)2´,Â…Ðçž$ü‚R]zžç]z F8gÀ€7šz(ôâ¨=ú,`ή> s¸^²õËtf !,ßh ø\5ß?1<ñ¥:†ç0/¥JXÖÊ9ªþŒR\¯Z˜™£Ö»Æœ”ʼRÞ¶~‡€Q,渣|ú1 ©±çÚ±£?4zÆSÚØá¶19ª¦:´\sŽ×vÎI)¬¡^²õË|àÃŽ ?‰Á.$…¥È°Ôû’pÏpt/±o^z R÷c¤.$ѽÄFÍÝKlNJa õ²­ ®ˆbžx†cë#À‰6#¾õïOÜÍ¥ƒËf½Nبz(±8žåzDÝǨ “¿©Ihsk¨—lMÙ&—ÀB?‰QƒàBj›øEÏ®½\º…¸œü"g”.½'ÅìjT~Fë.•ylšî¶†ù‹Œ8b6ø`ÛÈ%&B@#!ó‘ö͸ NSe9‘ ¡Y…Wüùä¨ *aðKÑÏX]/ÙúM29<‹ qT cΫp†(j` /ÄQ¸8%‡÷Sˆ£¤â¨s 5”ºDåØ8ª¹!KÝ—Ýq±i#±’7ssW¬YÛpdW.ÈY±’£(‡@ k¸žÊAG¬äË+ ¼ì¦-5!”aNJa õ’­ß%þÀ[µ¼‰qœô­ÚY´~`QìãRëM*=5NìÝŽ®cK¯3ú°ÕO;ÁM—NÒ &î¶~FƒXÙðÄ¿jÝ$´>K¥ÃNtW3ýpTwƒ NÇbÁÔM¯aÕ¥2 Rnëwñ`æ«Æ²ÉlÖh.ä8Þ] Þ¾îŒ”Â7¯ë‰(ž7%é¡M(Átúy%éèê,k}¹ÞRÊGï$ôI™AÔÜê%[¿{(î²ÍJ0ÏtBg³MŸ´îÒÍ0{¸€pç͘ØXÒ{“ªQAø•¹¸Ô¬‘^²5EîÍÓâ—#×WôîóÎÁƒô`°~»žˆ×x`3Ï%½Ç%Ñ4*÷v—6b3Ïõ¶5èˆÄŸ­L!Ûüq9À¬D.ŠÄŸU]ªV<3úò”Hœq"ï“Ó­Rˆ£‚ð3ãq©ÌcË'·5¡“¢¬·ùk¾,mÑîfµ®…}ž ½æ³»Ø•Ô1óñò§ùVõQGøÐŠîÞ5™g·Ódkên¤@ÁObÔ ÝT…uE~-»!¿–ÝúŸÔÝè…±ð¬²Uz0pÔ?¤îFKÖH/Ùú¼Ò¶¨Ãà‚1ýÖÐüù¡w‘Ðwºš¤Ïº¤Gbäµ» *á]—åRÑ)r ÷ƒ\—Ölíú¶U"K\ž‰ 6(|@¶Zþþ 9vh9‡’öç\$=)› ›d.׳\KꙘš“RXC½dë?ƒ•0>±TJ€‘ØÕ"°ÖË (©àSJä5Îðì©Ì~ÉPá0K-ßX*”ª~¯·­ïLÌõp1 z* `F†‚yÃ[H*óÏMÄÛbàw0X*S M”–,žëmëÛ»<Ã…Œ¾ýi%]r–îH.‡+•R8Ywúö1jvÁzÓrX8êŒO:Ù˜¹… 6ÃÉkTAkâˆ_¢³lJ{¢ÎáæíiÔ—Ööê±óê¾süOwôÁ1=6#À¨©Uæ”tëÂÑÞ¶ÆvˆÄŸÅ‹KÎ_;“âÁÄÞx* wl—.vÓäÚ ¢Dœ©2}º^x–ùÞ€MàDÆ:õ’­=‹é0?/W~¸š˜ „¶fž $䩎‚´³]O„gÝ£3iÌôâÚ¶öëÚfsJºèÀçmëwál4·-Öëñ‰57kJû”>^Ëø[^„a1êãRK”Þ!8©bJdƒ{¥^„5F#ç¤ÖP/Ùú½gøPAÕàw@NõÆ µõ\mg¦ÕÆ °§¼ŒÁQÝÙ<vV}”y3@쵇ßan—Âê%[ÃÛ…"[EeÈèxÒ ‚yìEAð‰«$òˆ˜‘6—ë-6¥õó¥¹^•ƒ!çÔÿQfö…y¥½m}ï'Sæ'ü.oé› ¶ÃóÎìÿØBúLÛÇ:ûI‰Ìþ–$Ú…wèÛajXò±¹¤ RaÞødt\=KJŒØ•)dŠHîÆ4²T¸%M¯1ÛáÄŸFúõ* +“ÄôöqNJe^=o[#gïœ|;tÆlàðûßôôêvø¼vË¥‹¾\Óá)à‹w&Ã-4=Þÿ0jºbNI;ûHŽõ¶•æ½ùß!Ò Ø^º6 â¬G˜‘(ì” Ÿ=A¹7 ÉÀ&A½ Hö£Þr|u9gÍ€íÔK¶¾ÍžÊAÂŒ>Ÿ`âgÀÄ |Þ¤0zŽD__æ›S,>öãhò/En(ÿÊLª/Óô’­QõuÒws1ØÕ)Ì¡mJãÕ ƒ€ø,®ÒsB»9txÞì(½\8ÕÂŒsº;?¥nkìæxžVÀê!“îŽèÖG}PO„gŸ…b=œ(WQŽ@4g”£JO(G4)f”c%ó˜á¶ÊükA0;Ðü$ÆÄ² xÕ…`xy¾ ‘•âR¬ лZ¤NÔY€Q‡ë!:ÂQSìär¯Y%™WÇÛÖ¸›o@²W¿›ƒq™–ÜÝÝ¡ƒÕ gÓZ.5ü}é‰Prwl:›jñ£Óî‰6§¤“ñ¿5ß¶~ç,í†z¢dtÔ[¡Ê“ïÇ2ÏMBî6\Z™Ú:¯-΂b°Ÿ òNwóQ#ŒsBêæµõ¶5‚™Ó`Fûv>†+ì)$Yxvö!¡óÑ.íD¡-É’+bà¦eíè©û>ÚkMýÛçv½dë?Xôß(Pèå¸7–Ì<¹$&[÷ÕóÒŸª©îÒ*àôíDä¥;£ ×G-ÑóÒ«µK2¯·­ßÜOßwŸ”Ÿ`<->ª šóKˆù€žnݥתӊ § \?ýOÁhGzOxhhTºõÜâR™×ÎÛÖx§žÓëïTÃ;èiBg>–Ý”°›ª#©ÕqJD‰ÒÁÎz$¦ÐV¼SG£‚ð¨Ls©Y#½dëgü$ÕÓU/Üóø ëé‡6!~²#dB=ÅOf„¯?¹Íõ¶êéz'‘ã'[õtˆŸÜö¶5ÜÚ×òþ[¸µÁ8L¤©©^´îjÒÓS­i?®'¢¥œ ürËõ*¶sŒZÃc9!¥5U¸ÜÖ/[É,ž"~^Œ…«‚Ëjú¢¢' w—.¦Ç³ÂÕÙDŠLzö¿Æž±÷&á¡–êÒAÌá>Þ¶ê~"XIýRÎ8ȪŸ8ñà7à‡ÁY.ÝV3@=^¡¿Ù½kN×ë¨Ð_\óKdÕÏîRåŒÍù¶õ»í*è÷“vp}–›aË­È—U¨Jµ¸€ 0†Aíwê‰ØÞñ“Œ…õz”ШËËÉ9'¥›¬¦—lMÙ¦="P×læZ| V7ww¬š[ ¸tX‡zCñ¦©"ÊC‡KµkOk>ê̯ÐK[sk¨—l%áXÎì€cYµiÕ½…A¾íM¨Ý¥d%=±I8ƒÙâ͆»ê¸éšR7¯ì·­ß- ¸³îp¡8qR g_$ÜJ½@Û¥HM¡žòTv8†Á¨Õõ "µøãË9)•yµ¾m};Œê*êhr¯£åY ¢‚Èg´–PQ¥çÈïv·¾%AA**ˆ|F+ UzÉÖÈBöµ¤,ähصђ«+ yU8¶‹{H Å*iU F/®WÔ€dU£ÑÌÍëåmëwYÈËj·wñú0øb Ïã×܆ž|"ðÉ&>.µ`»ô@ÄÓ¥Ko#Q£îH#Äœ’ʼÒß¶¾“8­þ0'qn<™¶¹­8z$tÈA?cðmºÞ`áÊRhXÑŽëM¥ž úȳ0'¥*/ÙçmëwKB˧/u¼‘HÈ¿8%ŒEÂCÚÍ¥ËÂÔ[ì_´ã”F®ç¥CõúVNq©Ì+ãmküRXPVõ_êâ\ƒÕc3ñ³žHç@:ÝaZYw½ÁÞH+bEp3eïz`£‚Ð/5¢—‚YÓ}÷p[¿´¶Âå9=I’Œ¥FîÓdŸš¨eî@fÔ²biI­ŒZz ¦{¢È°ÌÒ³ï]£R㜔Âê%[¿C:E\aEî ü×Tùå'Ç *l×—t²7]¯é”»4]ä¸á5äväóèÐä3Ý•ó÷¼mýæì×Xjì]s+“…éiež1h%£øÚ%IRëÓ(=Õ3ûÉ`£¤ÁFI£ú¨% ò1gR(ZÉÜù¶õ{KU¢Jlße¦í{Þ´}Ïw¼‡Rmße¦í»¿ã=è~ãÛwÍHNÞUBÛwÝiûÞímk ˜ V7#`bK†¹R‡râæv-‡&EŸÀGq©…3¥¢¦¹1÷ã•^¿pÁN&|:¦ù äd²FzÉÖ/ËM GÇA]ÅOѲ8åm¬$ü–|\j}¥'¢„3oØ5‡½ÑvXy­’ð[òt)¬¡^²õ›¥F]@÷gÇÒ‘;–^v,]$äâBÇÒ›ÑmGîXêIÊbÔܱtN5aŒ¨céœÉ¼ZÞ¶~w(ûýÂvÍ¥a£ÙóóœÇC°4ì÷LÂÏŸË¥ÇWÔQsiØÃ(* {ôÌ9¨QKàö`NJaMQi˜Ûú%¼¦zþ¼'ÞVlÑ›å#ꇑ§IÈàv]O„w–€Î.½'|y5*÷¨T—N¦yÌþ¶õDK~XM°ÖÕè!î&¦ÿ“é¶: x,Ú'©Eû¤"îOÎ P·þ‰O!Ž÷'ÎI©Ì3½dë7æ·EZìÏ‹±»ÛîLO«™ÒØÚÉûv†7„P·{"J|Ô©'Bz¨ö ¿gùGÝÕ¥••Å£¼mýæX ˆÜ¬WA“Æ P_Ø#ê%¡ÍYö ÈâzF`Tm6ÃVÒÛ¤7 ǘ£‚ðÃFsig–ýmo[ãXŽ•}Gàk?=«¨¹pG¯öêku°’b#£ˆ“spÀ¨Åõ¶²W#¡mé.—ʼZÞ¶~w…ѧ=' gÎ!?„Ý{jrJXåÛq©J‚qÐ’S"RêɼݵD™æ,ò¬âÒÁ:·5Ò Ñ9Ý÷?€"Þqý²Zß^.UêÄ,NÔ(B£n׳bZ¢õð[-™W÷ÛÖoVJœt­AÅOb؃ýàý.Ðs¢ÿ.ŽËSðùx½ÀDhŠaz‹Éξ&ˆa8CÐ#ÎŽèK+%æ¤Tæµò¶UçOÃT]Õ cÉhÿp‘ÒÜ„þ?& ½¼µºÔj-¤¢Fa,EÐ]Õ’ízóQKÆbNJa õ’­½²,K\MÄq™Þì*9–&À± ‡@FPªé9á@!•ßñ @æ¦Ø ®OòçsNJ¯]s¾mý.­Iµ¹rEžA[§N®\™Ÿ•+5W®,ב+Wî½¥—*WæGå J?T¹2\/Ùú™ç]×gžw¸YwnéçÁ¸ÈóN-ý¨'¢Ê#ëyëáf5Ô•ÈËS#_ÏË»Ñå“zÉÖo.:À)Þjé áqÚ8J;Ix袹t0•MÕTûìó¸ÞR.Ę$ zhË!!_*Þò!ÞrÓQ=Ä@=­]m‹ªš<´þ#“Væ‡Þù¶5AËþ#AË^A£>0¯]Ш5Bë>ø÷ äí–âDû„–­JA¢tí>jÄÆÉì\‚4 Qšð nk<<øZz÷‡_\Á³ìÄ CÍñZ !½….ØRœ(‘Ñ^èhe2VµkTzxàheE(AÀöÛÖï#Yï3¦ùG ò‚³@Þ-.í—ÏÓ>7‰%½8íŸÏÓ> OyÚ_#Õ©¯÷i_n“u…blZl¿s;þz._ry%¡tªNa$¢ÄŸn W×sô-Ö¼½:ŽÜÕ®ë%[¿qª­çB·¶Tgl8Çözà†­á¼uwY{ÿdD•ëÒc.Oê‰ÐG%c¡? ô¦gŸ5ò¿=sR k¨—lMè¥ð%,¿AsíÌå†âùÖÊ›é;µ°–¤V£B= ïLŒR\¯â’ƒQ«_8'¤n^)o[S29\yÓ}‚- p×*HÆEé$ôHÀ‹É”‹;]è×20Ž’*àßlC£‚ÐòV¶KaÞQR…ÛúÅ’àÕ?õ]œdž+UÚXF‡êpšßµX¥Ciò£QßÅIÅîLÐëg⨠ð§‡MÜn'Q/Ù'„À<õRŒÃ.”8°u¸€& x«eÒΘØ9‰hq8BLl.×C,G$YÎI©êÞæzÛú]ôÜkó†öÝl½±:܇DrùK·û¥Ã–4ê‰P.?h–H=K…Ó¨S)öš“ÒÊŽ×c¾mÕ’€Æ=iÏû&Ú_hOEgŒ¼çnô’ÜÜîK*öÜà<û¦t±§jìØs57ån©éf»õY6}”ÚGq‘D§j¤zõJB1Ç{\jWré‰Ð>JS¬¡‡P2Ê&LÝ]‰èÉï@xw½´ÊÃ=9uoFY¹n õ’­ß½SÇò‡¼%³wÎç>;Pµn/¿s—øõœP&1 …ÐcÎ7FmÑ’sBJk —mýæW]ô‡{Θ‡ý’•’è)£ì°‰7sÆn¸óÿˆ¡Ü¯“³ÂlÔœ3–’Èhô’­ßýª¿ßßÕ§F,Œ…jYŸ'ºÚ!¡ïÿIÑzNÔ(mhí4\o©¬ãuå¢U] k¨—lýîW¥§÷³íë˜Ðö‚ |ÌŽùl{17l®'Âý¯—15¥×/›%þ­¨íEÍm/Ö|ۚž*0úIŒª–ÄJ@ª(‚)‘t-—^Â}ª½py¥ £_A+ahÔ”tŒ9%]ÂJ8o[¿y(÷óJïé°θÈý}ÇŸŽØ=ßq~ÿk.5 é‰è‘õñ0@r gÅ„u8,ç¤ÖP/ÙÞ¹ŽËbôcÓf \^å\$ô¢´&é1h+ê9áù`ƒMïAÛ”ß9%…5Ð˶~—]‹¬Ç¢wJ >HooX¨n#¡ÇÉ•Í#‡ÒQ"¬æþŠ—ƒªQAè¦Ð¦KÍé%[¿y(Í‹pª‡ŸœA‡ÊèO»x+Ô´ç„Ü%{¹Ôžé‰ð.‚`´Ö†^‘—¥r«ŒîRXSÔ’Ûmýïã"Nߟ5è'1,Úe!St3E?È:IÈyªKÕ†{L'z$׊Á–ÆÇ:ÙÒ=«<¹¶)“ò$ó²á¶ÆòÁ¤‹Š+Š\ˆ¨:šÃƬTC4VJÙª NXßÅu³ÈEz%¡¸¦LÎYŠ+õ²­ß²s$§¥8 ö!s9c¾… q;ÊíÖ⺤R Ð9(¤.;pìpZjnïlÐ^AÆ6þÞiù{9z¶ƒé›ü¢Šõ%nð5¢/±*e¶yì%5\é‰(hyV!=+ÍÓ¨Ó/휓RXC½d«ŽÖºa¶(t£+3ºZsõ…GioŠžŒîR+‚‘ˆaN0ªÙÃà0XÊŠá¾?`NJ ñ[x¼t[¿»´¡¬£D¢3tS17,d`µ8á#ì ² ÖMD‰Dd`õ%½ÇåÖ4*íoðÈÒù…)ö'sx>æOÓýØ»zÒO1'°’~4 ¤R)éÇ9vú¦.ïÇ;ÝŸ97å畤{^I¼HÞÏ6úH¸]8ã 5·!Ö°Œ¸…„Í5­‚Òeé€ÔsBxvdldAo!I£.‡t㜔Âê%[¿Ä$xç ‹AþU›é#np;ª!CÎMD‹\‹¾T›®ÐÒ4jÎ^lWš¬‘^²õ|í|‚¯Í–¶€²Ò ŠzßJ_›|íÌ- fðµUžè-k&óê}Ûu ºQCsn‚¬æ+¬¨,©…DNΠ´ÚÂM lÍŸg´ãzh÷ÉQk.5cPOæµó¶õ»ì–aÅùʃ ã«ÒÒÙ&BÅ·6VäkP$m–_J½FÛîM0Z“»pbÔÔ£sJ*ó„ÿ~|Ô¯ú.ªüðçÅ8lоìU±HèéGg/º,øDgÆ|¹BÁˆ¢ÆÒ¼lÑFÍE6g5Ö(†L¶FmNÇ#æ÷á 2ƒuF„§šgôGu颳˜!ážÝa>Œ8'ï9âÈ©U ª‰Xeóˆ^ç¶~>óø)»§‡1ìñ{Gèmá’ð8;£óÛ¶”1Ií´#=Ýñd ÐzÍNµy žsR k¨—lýn¡GÞFŸã ÈK—‚aôý‹~ý¹¸‡oÒ-í³K¼ñ³`ýüœú £Ã_ÔtCýþ ã_”{¯ú £Ã_<#Ù}ëzÝnÐñÎj6×8ïÌèø?§¡óFù_þ¢¥~æ=ÿ Ðö7§Q÷Þã¨_gÜ­“þÂèøëFFõFÇ_'_wŒ~£ã_Ô‹{ ¿0:üÅ_Ù\×òã“ù™„,µýþÂX•ȹÎÇCír©i?ȹ4êNbë¶Ipù¾¨ÔUéÛuÎ ¤¸îõÕúØ^pæ×†vA7Úmsd­V‚±;0cãêà½lÛ3óÝÜbÖz!6\nï?uAuÂa:ǶÕÔµ}5Çö“š_rØÝh÷ wï¼m kÚt»“/*l9áõ~©ãÛœ–¼dÔýç--t¹A*P×(ÛþÚ9?›oê&ƒùÇØÉ»ðÚ”»¥W7ÚýÂ÷Ûlþ±øÏwäŒûq¶Û¢ìë]ð¹eÒÿ^ÚÍ"wy¹Ë;uAy°)p&+uo,ÈÇöx“_r·ôêF»_<ï}±ýjjz"νèM׫éºçñÁ€º¶ÙGãòfϬÑ`P„>!çzð]·„”ý5® 9ì‚n´ßìÏk¦uçûÉÙöRÞ:²tËÊs¶CH"ÖÍYï¡òb9uÐu )–ÎY·P ºé¢íql£þ„%××9ì‚n´[Ì}Ëôΰ …äÜÃÀ¡N9|¾÷_ö6“ý—¾ëç"çP³R×)ÿ¥'Wéf›D·ÿ\øÆymÈÝÒ\?ì~ñî wÞgÖ—‘3ø†5›I§ýÙª3Êlëw•£|pξºƒs#«ÌÈi·›u›½a»y¡¯Ýøö^» íþëßa5$Íš&]wι9ã‡:Òt—†j ì Þ:T—ãË‚.¨I^àp'ê^@'{Їç׆Ü-½ºÑîÏÛž‹ö‰õœÛ4¶Ì Âz¨Ó1zÞØ9([î¤èò~ß\ê‚*ZAÀ¹GA×½}|ìì­dxmÈat£ÝøfçM/àÿŽ›¹çÍ ç̽.n5(Û£dû˜!7hYè’ªÄeœš¤k­?8¶mym“ËÒ£û°›óO±iF}kɱ´»Úš5øöAŠßJ­’·ãq]Pê^+N*ÒµP1ÇV[^r·4•»ß|‡Å&ÌFü çôÛúû<ðq©e/b)¤øeýܰ˭Ù+uA5&r9ç&-¹nµmÆ®}ðkC» íæ3¼©5wö_uÎõ”ê ÑýP³ÜY¿oRüîË<Ÿ)ºNuV'8§Ý u›}B»±ì˯}9n×Õ}Úµ=µpâù~r¶m@.¾•­Ý ½7´¶'“¥ÜJJ¨ë×vrl}†.ÖnŒÖv\›rØÝh÷›õð†b‹aª|GÎ:eS‡ÚíRÃ>·‘HÙï|} .¿ c\ÔdÕªs®+Ýu}õ‰×ÚÝ$‡]Ðv¿Ù—ÞóÚy#´ëœ~~åb½»uâbÖÚ ߯S³cœóþý,ÙÐuª1òèœÛóÄumáØ•ÁG¿6ä° ºÑn¾»7ßõ¼ }ãݧÛ7ÙÙ¥ß(ÝŸ øÝ—*y±SRçæøR»3çTn§‹Í0uiìÊs±_rØÝh÷»½ÜžœÜ¿#çö˜;‚n/Vš¾ìÅ÷k5ɇҡ;èYXükç”$],»ræõkCî––ôa÷›w÷f6ž7bgß»_ÎM¸ó[··Ñ~åTHñ™Œ%¹!˜®S•‰3ƒwiฒ4vñÂh^»˜ÃÁ-½Î“h÷‹ç½n€à®Ë˜«Èéæ»Ñ„»6×KÝݶ—ׯMÝ’¯³B¸.(¯°wNµtï¢éc{?n¿6ä° ºÑn®õ´‹¾o[öw·Ùk˜íåH昦:)¾»µIÞmÝÎãF×LÊmR—.ÖFŒÖÎæÛ¤$» íƽȓÑöÓ·qÛ…߯y'äÛà;#߯ Þ èº§ƒõôÁÛQ¥ÛïA‹cwFsüÚË›Q?ìÖ¾tÛêG”Sq–=àn[ÕJ"õØiBnø(ÔuŠX§äLÎWØÅî0Ñ(ÆkC» íæ½$îc3âHâ¨A•úë9±ùy4s×|åÅl…®S™«8ð@×< »°ë™_rØÝh·ž ö ³ús)öV5{mÓr[¤Ü3Ô$¿ÎL×å'ÒÀÁ=ÛïÔ«Æîž›Ékw>‰2¥í~3×ßHØÙŽìû³ËñÍÓ™o\¶óÎÇFqÇ5–äËVkß´•ʱ¹óÀN`wévû•0v×»Žkw¾ë+K7Úýfm/6ŒÅÚ"Ç—Únx )ÿ«äýB©ST#ž„sª-êн8‰>v%Š¡_rØÝh÷›çmç–”˜ú8Ûi|66Mº šÞç¤.ÝÊ-vv]>h¾r9Zšú‡Ýœ«|òoÖ§|w {Kó­"³x½m‚fŸP¢SãÄžIU~³Î)v èû&1vÑ7»Ü©‘dt£ÝZCŠýà#ùRlwPl®žðRš½URœÓ–üf¸.¨Ê¾sнZÐ-¶õÂØÅMxmÈat£ÝaÏe¶ì¥=v„ö'Ûúg)Ÿ%†ä†D]PM«µsj‘.Nq»z¤Š×†Ü-­åÃnù‹Ù ¤„À™æsÃq±´ë¯k½{9Iží&LWTÒ_ã&ë”®M“»9â¯mrÚeº»q/'Ümó2øœc|l;Vç»ïÛý¤Œò¥³±¦ü‡‚Ÿõè’Jòè:çÜ„éÞYlplP÷¯íÚ.wKóa7îeeÞ-Ì8ÇÞ+Õ½¿ôùÝ‹ývƒ=fŠÕ-¸¼Ú÷]PÚycGêÚ[ñ +üÚÃ.èF»ù½d[ùóÊçN29Ä™ïg8I¹µJ^íp ]§²þºÛ, ¯lªš™0vÑ~׆Œí~mÈat£ÝÜËõûêw=÷rà܈EYîn=e«EŸ0ΤW¾xæì[Te­À9g#ê–»xpìâþ_^r·ôêF»å?ƒëwè|½0mÚ~ Ñ5¤þ¥AŠç“Y$ï¹[¢ºüHà4:C°ºÂÛ–)îüê–vA7Ú­}isŸî÷“dqŸfÇGøÎ›ü7µI^é-§gslþ5|çøQá;‡w¾s)áÚgúÎGù°[ïF§¿Gœ›’;lstCÀç­È‰ß1$*]ùýl]×)ÿÀ¹é9®{‹ú}ìªS® yg*ÆÕv¿™ëovÛÝí!–CÎÅA(£27à|ù†x ÊæãÆl‚+ïŒÏ^]PͽCâœ/Ÿºõú9vuï¯ ¹[zu£Ýx†Ý*@ÓÝ~N¾U¿‡Ú–ávÜ}ÚÕ3÷\¥[±)åË¢ÃÐ5ÊÆæ_ƒsÐM·b˜cõ',ÙEr·ôêF»ßøì’Eì›çV‘Ó¯WáœÃìÛv*ƒ—Ü}…žtøˆA¬‹^¿b´ë4½H.·fAÔ%<àäëE¢®%ˆqìì~o^rØeº»ßå‰-‹ð¬+ÎDZÅ$%D¤Jðc7É;ã[(œ•”eúN¤`MdoWޮݙ‚µB=[´›ßáf–ø1j¤{ã[AqbÔ•”Ǩ·äÙS[‹¨;¶Ç¨_ØÒ-6™`ì¢Ø)®mrYZö‡ÝïjàN•d­|†3ìh0±Ò£´d“â wâ«”›7—ºN¥âÝÃjÝl'ÆÎ|†~mÈa—ïd÷»z•aïWåÙœÅd„bIºpO®MÊcÎ]òÁð]ꢦ²ã†géŽs >öp$&^òê žv¿Ë§¶5ªªñÌbsbðF…Ê¿>$/woI]§ªž`¶aF“nbeÖN¤|N¯ä¸]‰qTÙýÎ?Žj·&ÿ²Ô³}£iÖ¶È¥òc¡Œ.An¥%Ô­|^MþLi3D½:aKx<Öl€ê`¬ÚôÍï»9WU;2ß2ôïÈivkŒL%‹Ûª|ÞVÎÃÿ•wV@]]wp1ûFœã¤¢îíAâc{¯u¿6änéÕvkÿS>îœF ü×ÖÍ“¯{ ëb ËuIé^Ä)Iºå&Trìâ™D¼6äniIv¿‹¹eó»{…k} ¯÷¥Î9{T;Ä:äíñüŸ¿Í3܇të–ÝçFè ÛÝcåÿ׆Ü-ÍåÃî7ßac_iÑ?u·ÙIKæ… »ÆX·—C4›BųS¤˜YK޼›6h nkA˜óÚûžÉ‘²ûocâx=Ý·1-‚\ji[Ù!+ûš°m jp]KÐuªë”ꜚ¥‹coõbÉúÑÒš?ìæ~÷ºoí ö}äØ3¯ó5':”S¬y<œ9$o–ÝF䯋Å9³#u‹Eµ0vñ³¯ ¹[zu£Ý¼—t}Ôyû>œb‰3û™}_Š'ô­ëuÉ/Zë•ÇHެ ›/Z"ÇÎBdĵ)‡¥Ðvë\Œõsé\\l¿Ô‡iË4 'Z#v).\´Q 9ühÅ¿æË×´ÃÙ :Ãõ=T‹7§än) 3d÷ßFõcúzXy²ÌmdØöÏ …5„³ãêô N˦àjÝD)öMŽÅ¯©k±mŽ­Ø7¯ yåªqu£Ý Õ ™äÀ²Ÿl (‘ò/’ã.÷Î̱ù×à¤à>s3ë)ø@QViõ•§Ý¼ÍÇ|³,š”ßhSþL¤|^š’/»eè:UT/·‘ˆÚ¤kp›Ûäùµ!×:Ñ>ì~s¦º»Ö[fò9ÖS*ÝǨ>¹Ì‚úžâãk¦ü¾–® ª¹Æ9ͪÀ¡Û ªc7žSýÚÃ.èF»ƒ9ž<…MÎ"6Õ­:ßö;.ó„oýΨA‡Ü²â© jªBÉ9¹Jw{jlR|â©Hî–"©Qv¿ó—¢.,m÷€ƒS:vñQÚEêcO_­ Á·Ù#Ŭ#r*cÑtS,í™Þ~m“Ó.Ó}Øýf_jùª–Ùñ9·Jè®;¶ïÄzx·#z&3[x òbÞ2è‚êîa$§ùjmn›3Œ±›çóÚ9ÇpÁß̰h71âúm1✳ tá4»$Ü8s÷#n^<Ú¬„Þ%]§#%ô 8;bÄÙµ)‡]Ðv¿yw;ɧŒUlȯkè*ôûvå$Ûörù”ûø >å­¿§TéÞ#Dð)â~ºOyìhi©vs6™;Œ&çXýÇœVnÑÍãѤìÙ 6/ÃÂÂ9ùênžG‡þºÛyˆ–„™ê»øY„׆|²¾óêF»?°º?—€;9"6C~`3de9a1Ë)¢1\]GbØœ¨» Ø VLp'‰ä ÜÉ--õÃîs sª„ï£,«œ”uë‹<_Ë+™<Ÿ rÏõÒ¯€±Ã}%Žºö†qláûðÚ5Ü©ëF»ÿÎh™ÏçÝo],ó›DáÏd8öŸäzÂõñtçóy_øìð¼ëXÏ› Lô¼Ó]Ðv¼»·ký÷“3§ÆÛ÷Ëâõ¶×;ÒÈ 7isF*çç½Xe~‡âï´Óó^ w¼“Ö>ìþ…‘’æçw8Ãs™“)ÿKx.Ðu*ÍÏï°=žËz<—õ빬ŸDKvÿšSêþ¼—Ôão3¿ÝHŸïØxÌ)©GËëþ|ÇæcNÉ+ÞK^Ÿ÷’ÞKão,»Ý :•ÎÜñ^j÷B }ÝK}|!WW(¼åó^Ún ù¨ ÷¹ßKvÿ£ÝË_Ía¶´Ž2½«9ëªfc=î™wæõ&ƒ²5uÜtÊÍÇ@]PÓ+bÅ95ÙÔ×_˱‡ûsymÈÝÒ«í~‰™ásÐwäL–R#|œk±3ž22ÜÝKº 4ã‰SB^Ag- §jzP¢‰2í1¥í~sÖM–ù•dœŒ’¾dH‘É\O…’àFˆªä…Uƒ¥8•¶rƒÀY KݦÅÜŸ6HyÔ?IžX°“ì–ïi:C¾—d'+ÞòXÔ &R<½îAÎMlLÔuÊ[f8§z(ä[cWE±o ¹¥í~‡å\³®s¶a¦ýå¶.˜L}a>ý©{’/÷IH€ðd¸ÜŸ¥±+ó<üÚÃ.èF»_b ßmc 'çt¦¦ÞüÒNTæ›_Ú…ö’-¿´3¥öf”B”WÖ9§2}ãêVsÔcì³Qﵫá›À®jIÑîw1T̤å~bÖÐ` éµqw‰~â¸íaë‹'dpOÐ"•ô×ÝrZ–nq83Ïâ÷Ì”¼Ñ»*€3›µBõæµBÈü(ö¶"æ3­îÇøØ¼Éi¹g,©L¢š7ô!§NÇörͪ±«¯á¼6ä“… W7ÚÍ{qÔKú^È1ÿÉ–¶5X1ˆ*Ù®|­Ò%_æy†î¢øë(‹kÄYŒÊR΋åHP^ sdò$CsÊå ü‚î0§Æ\CüÚƒkÌØÔ}ÚýfNɬSáwHŽw“(!aÒ?Ïqª¬¯ÁƒF} ^TÓt!¦¥­Ne}&“øòÚgÂÀ®õa÷GíZ>‰ñ…EÆè3(7‡>…âù|ô9@tAeG¯ ÇܼÔMwªãØÉ‘ymÈaeÇú°û]íÈÀ]V_ÀžÜF_ÉI­+_ŠÅM\> bxGPIhÕIˆüÔMœ€W!Åo’îLwŸìV,4™­Ž—äd Ô!Ï`’ò<ƒ&9ê\ª'ã,ŽíwŽ:š%]$ùaìñ/±¡@’`Òv¿é±Ð¼Î|ùù‹uè¨ìDž÷¾g$`ö2Æ7‘tù`—Œ«ëwäÜP×­7U‚cW÷„ðÚ7Ö¿üa÷»üŠ+zàüUÃ0B 2€½Ù)îÝK‘|³‚p.—ªÂT§0Y¼òrK;àüáÚŽóTf$²ÈnaùO«1 n9Ø-¦»œÝ À( )_C¶ävJ¢.¨BÜ2çd"h]Ýì•n…”¯!ƒ·+{]ÑØýÝ_¾ñ¾Ÿœ‹^·lŸ±ˆ^—:)zïgvùJ¶£™DÆÅŒ]r¬ouû=Žpì.„šÅ=ΕO\ÝhwØÿØ®wíì`‘¢@[åú·OÈŽ ;žáº¤îؾÿAÜbH·0"Ø;)ßÿlÉëßq^“ÝÊÆj;¸—Û\‘«íšÄ‚x% ZC¼Ð#Xqq"Ò1Oƒªì'eéK¬H„ymÜ—âÚ&—¥7w>Ú-|Ã{žž9æ™>ƒ¨‘6 ÂUIy 2¹|f¯ÞxRf*„{œ23nLºæ™æØŽ'ç׆ÜÛ8Ü ¿h7ïe[a£Ökq†á(m‹„‹ÜŽDŠÖQìÊ=ÍzìHq½&'Û×—éÖXEck½æµMN»L÷a÷¯øÂªOé=Ùníh‹û¢ô#JžlûÑ“mù×"ó+øócO¶ù«'Û|ôd[žl›Ø¦ÈuJÂ6çk@âCaâµ°M‘YU<1Üu çk¤ âØ;0cNŽ Š{¤õa“<§t£Ý:“NG?ý~r6<6ŽUyq“)Î58 B´$é:娘›;õ1¤ë'3xµé3åµ!¬2ãÃ,~Wl8ˆöýâŠ}?ßGÈ=&©·c?ηÑëf{Ã2kvxçµsx]7Úý·b–Ÿq¾þˆóû…¸Å·ÃåŠ[ÌH}ÆùÚ#ÎWq¾ú+ÎWq¾öˆóuÆùþâóîVÿ[š¯qäâþ°ßõ‡:kØur®Œ²ù.(äùPTó5Nœ³NQ× Ó8võj^Ûä²ôè>ìþ{ÏûWŒzµÇó~Ĩë¯u}ĨW{<ï_1êžÏ{>ž÷üõ¼g|Þ=Øýæ¼P­µU"6§s2Ý•gJL#‹”G`šä@ Ì¼á¾96ÿb°k@x´.Rô…Ì"¹[Zò‡ÝÂæ$ k™º#5<Ú›zÝPï&Åó (Dñ4·Ï›c‡ÓÌ Xê¢Æå¾â"y'þ%áe·êæ*¼U7ζT²sÿµZ¡ãÅâeç“‹Õçò‹ãçºN…ºù˹N ×Í*Z•”ý5®™¼2ªt£Ýã;¼M>ò+vÒ·°m¶óüŠÖžßáæLÊ"ÚÇþ§|ì,¾úÙ>ö?é×þ'…ýt£Ý«/špô޾¶R£ÿÇAñ8xЉ×õ6%_v€îòätUé ûbc4Ýýwâµ!ïLWßëÃn¼»ýþŽœÛøüLÊx¿—Mác‘ºïLiü>®¼ñÛ)[”wpsμ[BêÞügÛó£ýÚþj{~Ø­óÂD®T÷óÂD.U6VÃú¹ññduñ=žf€úuåª Ê¢š²ã Û“Î%]?‹ìþ<‹$¶'-Mv™îÃnÕ\³O kP“l‡†m‡Ú‰Oÿ}¸\ü·Ò=‡jMûkç¤.ÝÛwÉÇV‡'¡ì÷-MýÃnŰŠïk¾#Çzˆ­I§(öÁp2ú>xÛ/Û©‘}ŠÒ.JœÒ¤ëù˜í#_׆Ü-½ºÑnù=ØÈ³¹ßŽÍŠ392žz´u©Ö™mC-Ëš}²¨ê™äF‰7ݪƶ¯]½îõa÷;ÿ㲄5`»ob¶Ü#–õßì6 -Ø1À¬“‚q.([ÀŠåÝ œÓ8ÝÌA<;tƒÂµ3ãá ëÃîwq ýwaÄΫOQF€KLRÜëà}î$ŠíJU#îdE–nab.úÔ€Y’$ÏD”ÛùÃnÌõÕúŽùâäl[ø§;‡OYúb™ {¨V|Ko»:t7›ð±’šœëxmÈÝÒ«í~ƒSŸ °Ë¿Cç4ƒ˜Ìž¥,yÿ*XSrO¸(MTU…R%´zY-ÿò|ì¢ ¥Ì<ªÐö–n´ûWîdûÈסrZ¹“ãWîäxfä>N¨íWîäì1§µÿFó*3å´–GîäìvËwŽ„?¾ä4_¥€°mþíZHù ·$ÏlNت¨ªJ^ç rÍ +Y )ß t—ËRT…Èîw±änÕ;[±d"I"–l¸ì‰­ <¢Ú%Ÿ¶vVz¥Ä±=–lœ2¤[Yæ27)%WÉÝRc.ý&}«’ò@Á¶üH§ùÒHq…ÃN™(sg[ôαéÍE™<‚6Ø-MmðvÀŠ*\]JÁŽ@íÃî¿á/ÍŽç$OdøK“û‘@}øKõ•º®{G×Ãt}Á_jP©Š ŒGN½ËÝR}Á>6}çý¨ƒ˜\ΙK¶ÀK[)ú R’|^[© ʳ¶œxTèvs8alÏÚòkC»¶Uv ï®ož¤¾#§Yùwµo¡±+ýܤìzZ¶%Ââ;kMTÕ*âÎ+fjìW‘\%wKùÚlý¦ŽíBM¾ÂÝØ‚y *➎ȹÉÕ⯬ý\‘ÊŠ¿²³K×vš»xþ=¯]Ø MéF»•@T·íû3p]·#‚pü\/á‡Ü»"ì©¢žâ y: :ÎÚ#?ׯ]‰ÓÖ•Ÿû°ûWíÍúÕŸ8ÖÀ­G ÜúU·5póQ7Ÿ_œX×5pýW \ÔÀG Ü >ÿcŸÂ}s¨ï*qŸÒB­P‚B}׳‚¯Dªô¯} "Jا( êcŸ"Ts×v¿ÌófGßO>šŒm£9*ïÕänSrô²õfG <ÛxÒ{=²ts|åk{“vA7Úýî¬ÛqêR¾î'¯óAãN¸¶MŠk;ÊÞÑt%%ézw÷„¨ßÎ’î`SιIqmÏUr·4¯»Cß`à%¿vû1ë°û4Iñ^j“É”ó‘Z9µO©lä…}JU5ÇîqŸ’Væ#_DvkîŠIù)Mujk¯»Ø{xZwÍ5KžÙófÖH%ý5›¯'é"3ãñ8zÖæ| Ùeº»Cï œ/–ûÁÙ¶>(cïîÒ=[×C7Þf™BÕ׉@eæTÌ×Eº•X[Êæãº¥Œ>· ºÑnåÚLôGΞkƒãg2¿nEv©åˆìMŠ>áÑ]~ð¶ë’ÊŽzMŽ¥‚S×¢f;ùûËkC»L÷a÷›ùq°Ûžc= æx¢…(2q²}&ÈÂÉšñv•|ÙŒWˆ…ùÏOˆÎAbz?Ï©±Õq•×N¼‡¥5Øý3>µ) Mø‘‰4d©Á¸uz…/pÍZ˜}qì?ãÜ[-›é ¼‹d¢/0TnÌìrYšö‡Ýô#už‡øîNozÀìVäYe"Îqþîžã†¡ çïÕì4ëï.8V…B]«BáØÝۧÙ]¹Ã™]Ýh·z_pçËÜØÄå“yA³_{aïçí‰Ì@{Æ²ŽŸ˜;ãì³7™›tѦ=3bÐ…1²änijvë^à!iËïM³é ¿yØ[ÑŸ{¼³NnÉ‹ã¸6QM;•ÂüfA2ÖÁSµŽ$æ7—àËn´›s}&†ý\äL«v3` ä­Ê}2ý\«²¯ô•£!*tA e}zóë‹" ]«°àØÝçG^òLl¥«í9¢v·C= €¼QP…cÏr¡B§’òßnKž¹2–!*ô&Çû‹#Ÿ•½Ç+)~ûˆÔ-»L÷a÷›zgƒ>ÍÂ\#'ßÏ`Pj6ÐÏiÙFÑ'¼šä–gBÝÆÎeü•ÄÉÝu“aªaì$Ì5\›r·4÷»ÿVÞÐjŸ>Zåkf+ä|ä+ÌG¾æxäkvï>õÈ$ŠX&5ž}>ó5Û#_³?ò51¶½»‰‘Éú×Ä>¬ÍÞw´ˆ8—]™9.ÜÝ.˜ /6{C·pàîVôàDùK_;ÔôeÎçWî–^Ýh÷G «¹¿‡ƒû«K>(FŒ3uÖÝy òMÜ´ÖD)j Îù¥îõåûØŠðÚ»¥W7Úýv/uNÙÖß¶©Â9˲–9ÿΫ³Ð.Âánÿø,y¶¶¦+*ë¯Ù–cKתS8vqär^Ûä´Ëtv¿ÃhîîæþŽœNŒfà[€kL?ïö¦F8Áî)ÝÂó‰#Éž_æ–®!…rì1šÑ‘“†t£ÝÂhÆ—ÌÚrr&Q™¹cÌ—ân‘ëog~Ê@ÆT–.¨áFä Š¹óW»UÌ-ì&¹ÐŽÒí‚n´ûã;<Ï„øóßá2HöExÈüñBîqï¾ÃáØµâÔ¿á9ã7>?¾CÈÝÒš?ì~sŽë¬=ÏáË*ö*âL¶MK™ÏqcI¾Øð@ €¸ð Åf:t¥Ø´6­ªQ^;Ó•?ØZv¿ùQë}ìïÈñ$dÀ týê=}vp_{åÙMÀ••Ý¡®¾/öÛpÎPŠ•åbzÈXYŸ¬ |Ðý€öÙ±|Ã2¾¥!]ï·±ÝýJo%~™•et£Ýÿ€1þíïPNþ½ð­²›Ø>+aâ‹5{Ñý‚Ç·ºt ãá‘D÷@¾qIctF\»:Bºê-v ïu ‹ïØ$ú gÐbi[`@=¿Ùg}{tjž1%NÒ­æfÄØ•xœ~íÊ.{°4»ßàå‹¿S*Ÿaà™èœ¥ J·ì¬ec™Hð­(+_ÒuÊ;]€Sƒ½ºÙ‰0væ3ôkC» í˜½HÔRßD¤fU[‰°š0ýØûCúŒ\%ÇŽ/{"óâØüëå}¡{S³ÇÅg˜²än)™‡Ææ·µ ñÉë4ÀÙhŸÐv+MR¼Þɦ|[–ñfyॖê4œƒ5zæ>‚i’òµ(Kî–bo »ßùR2>äKå$oþ$Ö›/•Þ“ Ô%WKU=³›ïúÈŠáö¼+MY·¬/n²Ë;BÊîwxbhÇ:~çT¶NÖBP°’â·R¶äåÖpPT‚8™±ðâ1Û# ~íÌöq­H7ÚýfÏÕm¼MH¾Å øú¨¾¥å{M¡ˆ`«MÝŚѦ˜B +¬H‹ÙSÜ7 _C¸¯²Ô³Èîw¹§Ér“ÝŸ |²ÛútÛ'ëÂÙyßD¹¡<[F¨[çØž ah }'WIîØÁŸ‹kß »*Ñßd7smê]ôje8çxÕfhëlÆRI1{æàÕQŽÜoôRǶ¿ÍZ [ìÎ1va>_»04¿«t£ÝÂOÀ! X0øòü8y2l ')¾3½J>-}¤rs*‡ü=à§LéfV‰¡ƒÝVþzÞ’j éF»ßÅøvš|3ëô‘'‡žlOžRÏH7³º=ùÖuA }µÎAÊ =TScw}µ…= ÚŒ–¦üa÷»œŽiõ;U}£ÁaðÜ^3¶Aï¤<®X$Ÿl?€îÈ XçMŽÕjS·Ò‰Ú ÇÆìœÓ‘8;»t£Ýïò5™ùÅyœÁ€" ll‹Ÿ ¦g+1=#É®ÝΣe®Û~dV™üY8l¡p¡LéF»ÿÆ:;c¾øåX£c®u …Ôcõ€þªÒ5•éÎ`¾xAâäÐØCùâ¸ö`¾x+Òvk®Â6Û÷»Í{!=ÖÞÍåbPþîvɧ÷Nꢄ”.N*Òõ\§½HñÝ­Er·¡1Ùý&ç¿2‘Ès;+»Tâ\¡êÆ›àØ> ñ²[sJµ=FÓœR:슷E©‚ Þ3—¢ àQͱù×xwUº‰Á.´â,ZsV—vA7ÚÞÇ|gç%î´È0‚ Ū®²É‚âséKòmYÛÐÝÄ`ÞpJuÝ4Ymˆ$÷pn)Cr·JÙ­Xm²_Š˜Gâœ_úD¬l·x=´™ýÏXg¼Ü‰råp¢@×)V¾¯Â>f×C›ÙE$ 7¸BMñ”\‘ùa÷߈·_8ãÓ18óNÇ|àtŒNÇø…ÓÑ8–—%éþÕ³`?ä#NÇ NG°|ýÊØÔ!ÖSÀ×¼T¸— ë) ά_¹vä XO¼„ñ‘7 ¹°žÖ‡Ýü¶ ñ«=· ÀzTGöŸÝÙÔŸ-Î:5@‚€ªÊ­rNêÒ-¼º·ueÝ¢ƒþG¤íþa÷Kìl+PI;Û8kªíqTK›Wà9$/6k å@%y@µŽ%1l®î›”ï*9n—vKc¿9/°‚¹ùóæ©LE»ú¹/R_'$ÞÜÒmĬšB p{¹tMcW¡âzYtoÑÒ´>ì~ U©ù·8ø±Q&q·îð…nRœçQؾ½¼Ãu–Б”KM¢.€516(®ž\jF´”ÉKc¿ñËáÄWŠß78HiŽß xßÂðp·À`ŒTÑ_ãˆÒ»t»Cž,R¼oô c?Ï%Ýh÷;Z,LõéEx8s¨±Ü¶£ÁÆÞßóÁBb¢œéNæ}û{î´µÀ¡“ËR&ÅY°uÉÝR|#²ûoáðŒõ¹6ÕÐOç6* 8<¡â(%É}mª=®Dc}®M©Äµ©=ÖpïåkS{¬F©|ØMd¶ñË-pæŒ?0~|&5È—¾¦ähN]§²"` ®Mº•£x”’óo’gî0Ó’ÝÚÃVÇþøŽœÆà)ú¢.{ßPT³”]•wÙT¾¨YTÀYt²ì%ÝÂ$nû4ù:ٵɮâA߀YœDcRöœpÎ'¾:#®'̲ûmp–8XüCr¿×«ëg r®w×u͵´ÜÖ¥¼£!·í‚n´ûfFjÏÜ u{Š 3ãT¿ 3ƒhÂ̸rGɸºN B¹CuJ@]Ë{Ëâ”_=-dÕ˜³Tç‡ÝÊ-'Ž­òäÑ/×<5íÊÿÊÙ­Á”bľéÍm›»3p{Nܤ±ψ}-EλìÖ¾”"íK±6±v¶HRߤ¸óÀšËäÙ$ÝN4¤­})8ìG„ †¤±ŸýˆŠän)û-Íç‚#7{IÓÙlÀHÀª¹å7Ç:¹±AÒ-ÌÝ›úkpr’n5&Æ®Ú{$¢)¡;&,þ‚ìVݎܽx|¡Ãeaû´Œ/À¬CȬþÛaË„ÂNPKÔTÆDå$Ä’5{cQ²†ä”ªÊœ$ϾÝêv+){ Ìwä,6F7=‹ßà%#‰µ”ôz,ŽÍ¿îx3ºtw΀lúºf–¼òËÅ®\v¿ÃŽD ©-ìH,cÃÓk®·H™ï)%Ù&¬Z¤;x]Õ²à ÁŠH“cƒâw ÅœÑR% ùدÎ>8­t}QŒåñ-À“'R~ö™’7FVÕY¾­ô“1EKº~bùpö !¶ÂJG¢NmÍÚ@cÒ±ð²[–ÿ´1Y?›];¥úî˪iÆ®‡µèƒçvÏñj›[·ƒ±»êz2O…Wî–æùa÷K­¡ù3§1ŸY “Ò ÅѪ’_ç–낪z†à{Ð-öŒ0vÑ3ĵ ƒ¢{H7Úý—ÅçšïÈñ6÷YLö~•NÊgÒ,y£7ž¼>³9‹6ªºÐ ïÙû†%¹[ŠM§ì~ç§™V#{IXFTIt"ßþ{ˆú5Rܧ,¹a:RûÑKÂzì!d?Ì ÞE„_1fƒl+¢f£îÓî7Ï{2›¶ µÁe„ÒYД» áåäÝIÓix|¨“sá}a#Q_“|ÃpÍ»9W†ËÄ97+¹pm®V'ä˪:A6«Õ bpuʪDÅy…©Û,+¹zj±ê±[ºrßi]Ýh·Î>¬•¨~öÁ~ìÖâwÛÔKa™ó¹qzGýòªsèz zÓ_³ÆcH·ò\5}#Ìsk<Šì‚n´;`ãÃMËçlËøFÖr·lp„܈J|{È7;dí©*ÜN`¶&]Ûirìæ1^òÁEt´»_öÚi·JqéÛªVÅØ=ùåÌÕhÐÒ;)~[§Æˆr W6Ö¸TöµS4æ(6¡F車Íån)6|²[{X$Ž9N8ÅÁk›‚ãÛ&å»Ò.¹u ¥.¨¬ìhç “>QàÁg:uC ÕY¢¥e|Øý7ü\íW ¦?ê7Ç£~süªßúÍþ¨ßl¿b0íQ¿Y¹ýõWýf}Ôo¶GýfÓ3 'û™>}5àv®»„«>i ‰õI;G¯CÑã0“ÿõôÊÕàƒè)ú ˆ½$Dàv¦öa÷;Ÿ|¶:?Ï™prô†aèÕp²1Go/ɧeÝuæè 9zÈèkSºÕÒ@ÜE¸C­I—¼3i¤Í»é«LDÚ\Ìgœçõ ž¨ô$DÅyûòQ—¼{·QÞÀÀ¤:…¦±½~íÆ[X ¸Ùý÷ú/¬Ïïð£ÿÂŽßaÝŸßaÝ_ÏÊéX5½>¿Ãÿ…ýÞåö‹z÷ó›&½»à.Ûò~q˜”çsdÉo§U×u*ôܶ!y³YM>>ÍÙHù,½$‡]•a>Ùý"g+T(Öç\5.Dp~{ðiNßa 'øÊU=¹•“õ9WÝŠØPK™~±w‘µ”WîµÖW7Úý&ßp0›~²O88… }Ù|"Û«‘²op¼îÊo6ו? œ´¥‹bfŒXyé׆Ü-MûÃî7çætÊ#‡~,D á$í¤ø."d†…eé:Uô׈ Œ"ÝÎfªÓ/èþ·¥ÿyy8“e÷¯^Pî3ôT°386A@2L¤|¿;%ßl†ru7OÝgâœë÷XqO ^Pá\À¾u5ZŠnŲ;Ü F}­p>´8 \Ù çŒLŠ÷B<Cëê:v.Oøäx=à‘´¬±‹û.ymÈÝäèÅ.»ß|‡ÅöÀ[ئÆ)Ésw×¥¾í”}+·(Òåv<¦®Q66ÿúrlgÝl;+Œ½#¯M9,]Ì–Ýïê©Ns¬v>V1¡°õ| ‰ÞÆÐþÅ+ÏÌ…½ùLôOGµwúQ´Oí8¨~íÂŽ °Ýd÷ËuÖ~¾PWÔóãÄ‚L|DÞ )ÌoÉ…LÖD©#9™uE5œv<ë1Ôa3ÇÓP–n´û]ª'öð8 q˜ëWDH´‡mDV>;xðˆÃ\E©;¨8 ýÂs=4v{ t/ÉÝÒš>ì–æéŹª2QâbvTv“ùwÊ&E’0®¼3Jyu;ëu=‹Ñ9§ê€º8hYè8•u·#GKóø°›¸j›u‹ôG’4³MT‹F‘èía¦ÈÊl¸5-¿“XŽITS÷ÁÌzè5¥k}À9¶ú„óÚ&§]¦û°û¦ ðˆMŽ5/ŸÛ+mÅ;ÉIòlGÓ%U[ weD§†ÆÎîÓçµM.KîÃnåêÃsÏÚ}r*«p§ÕÕ±±ê Eo)*é†ù…û¤®SÞ­Ö9™åW×л9v.)®YÁ›uŸv¿[Cº½Þ Ó9Ûp`P}Ñ-* øy¯‘ÊŒCu›v•®S^#•Ya´ u梱kD æªQdzaF»&àæÕ¿#è9‰áÈb³RM¤Üº)y±GÞAÊê8µJt™2Sk-¾Z m³v¹~Ø­œð‚¹Z9áà\w"Kµ¯¥eRôaãµ­EºNeý57×Cº}¤°ã}¦°ëÞEvA7ÚýbNY=v+Ö9ÛòuаÁ³ÞIÑß Ô˜fÞs¶çè‘bÕq.ªK¡î-ƒWtúÚÑnÒv‡ü®Ê«GNæÏ Ü©Œ@k#Åï¸UÙ¾ôÙ¥»ÄÙʧlê^GsçØ ¸OYKr·Ýye÷›}Êò<¸ís)|4?éòŽ&tåQ'¾qˆLqµî¢ªÐüÃb$‚„Û+ú7S‡½…¥€d—Ý£_Dw|,rÆ}cX05Ã÷¬€ý   ª{E97ûÙuÛÍ¿àØÍó3xmÈ›Ìöa÷›ç]-éãºb¾ŸÊM{4‡“DÊÏìCrt,ôr¸ácî…E°sS׋ÂZ(?óœ™*9ìrè;Ù­Xö[)y,ô`FL±sìrDQÎ(À²¾òÅóz? $'n¬p·çâ_åÿ*¿â_åáiŸ)RéWü«>â_ëÿZ¿â_ëÿªóÃîw8GËb ‰þçLoJ~spÌÿs»’y7† f—%G³Ì RðYeaË®›¶e‡ØØFy gI»ÑXd÷ß‹w–ÏçÝö#ÞYãóö¸ŠwÖÂØŽO—gèïxgyÄ;Ëçó%ZšÇ‡Ý¿ÞÝÿý±wêÛ¯ºÆYã½”GMDùU×Xu³F*ýªkl)ÞËzÔ5®_uëQ×ØÒ‡Ý{¹<õ¹§Éw¯È}E¶è\v”­Çsq¹z\mQÊtPmÉïØ¾E¡?ôÇ;¹×´¨bÓÇ&þ={Ë ÿ¾+wb³ßþº7†Ê| ÓvOîK¯îä.”uâܹеŒŽ­ºF^r·ôêF»Õ? ©³YµŠL¦µ#ÍÂÆa¢LŠñ_"!Úãa[¹©*QS¥[½z&Å=6R³µ†<³V?ìVÜb!_]q ÞW‹[ðŠ8É$Å]Ôl’oÆøêÕÔ÷Ø9ˆèLæ¯Ð·ªk?Ç>‘9Zšú‡ÝÊkCudR^8·–¥²§M±¼6ô¼)òk¢3L1¿fRÁŸ¨$¿&¾ö[Ë]CsâØUu0¸6ä…ÛÚ?ì~W[× j% 6Cçžv¿«–23T/p9Û@»’ý®Û½ AÑ(î~ú¼X¦tA-E‚À™Öì–üÓŠÆž1T*9n×´”—h÷»x±¼úß‘3mísÇó°­'²´»¨2S‹m«t›÷dR%¢¼h§ ÷\»+NŽkwvÃAMêJvsï>؇ˆ½x¦ï¾NêÁœ,š;{›éG½ËÌân~!¨,RªL%Ç °¨k%W[½xxmÈái¯n´[q*|u¬}Ñ#`XW<¥DŠ¿*0¡ÖPSæ”GÑ*¿LL¨¨ã@‚Nöà¾gy4É¿¼6>ìf?¼mëÓmó9%íPÃLÎì8“!ü7ÇAœ™0¢WޝÅtIGþçÌŽÔÍ×Cű³×äòÚ&—¥G÷a÷;¬Á듼E2ßOζ½¾uwPœ%f“ÜÀ|©ëT@â¾M;l£•$ç«› º Hrì¢n´ûcÿSÏ£ì×jôS+7(ßÿ É·G"’¨*dp¼ ý”Qàƒ~ÊEY®è§ ô,ìxPæ+»ßõfYH ß!r=ðâTŒ¶EÊ¿Ã.yµàYçáY%¡n¹à<Ö¥[¹H&ÿxý;,’Ã.èF»ùœXç¯ÄmÊWd ïAœäÝKIrïAÜfô9-EªcÒ¤k™Ðƒ˜‘*õ ~x™rû°[ù4ÈiYê”ü×<°$’Eœ%Áž´+1côÊ3Ïc½ˆªêfꜼ¥[î»Ì±‹¿ë¼¶ÉeéÑ}ØÍo«3ën¨ß QNí(ˆÔ°e']¶Æú`e‘è«YTø'‘Ê÷’nõ΋ÏÅhlåx—±±l#æ¹íÑàñêÊAÂo¶¬&üZF»Ü(W„}mì'D¸v}]h´Zý¾‡ÌNVþ½$†ôj–]¦û°[XÈ+g¬–œÉ\èe´ÕŠB½AØ+î¬,]?F8úe½Œ¨ÛÙz½[²ð–§Åp_’n´û]î$zä5½èíGw{¹Î>y‘âvN┯› I]P)ž}ªí³çvÝ´Y,œ)ž}z‘Üì¢n´›{é»eøÙɹ;æÓó¶X½íñÔÿPØ×3rlÃU4ùÏþA;y§¦ŸvÅ©Iºãk8öðÓ.¯ ¹[zu£ÝªÝ_–1Æ\ršå—Ö†( }{¨&A†ã9œP”¬Ä)[º…ݲP)âù‰…µ%ÈO„¥W7Úý·â¯;ýŠûŒ+Éam™^ªXINq]ê#FFvz®[ýî&BÜ'Äv…Šâ>;ZZê‡ÝšSðw¶Ï)à ‡<€<¥MŠs ·«—ɺ®SI^ÍjwÞªt·É1Ùü,W$/k^Œì~Y³‡ÌNáÉqÇ×·ùSJðÖö¸ÇKIòɼBû4ŽÍ¿îv¾v“Þ¨•”g‹LÉ;“§#»ßå½ë.ñ|í†Kl )ahªCg©â 5®ëTRf96 H¸¤/¦kì€ ÖÜ—B1 —²û?åÌv%Çþ—ƒN w’>Ž_gÞ4Ê£IKòrë,© *«¿8‰‰}ÓÎFejìÄßÔ¯ØßâÚ•˜Ø'»ßåÊ¢?© 8Ó2X‘1 ŸúØåÈ£=|"Äs)‘òŠò‡U·t wCØ4ùóNDpãŽgºîÃn®7‹»«1݈X5%–Õo°2H}¡Ùí޽庤ªì~‡Å”wõÅI‘ ÌíW¬im¤ŽÎHïÒÝÄV Ùrà”ú¢#èyX)÷ðNÉÝÒR?ì~wž®<óÇÅ!Œ€± #°Iñ û ¹ DÀO‘JÊtàÏ7©{?Öê[3£ø.•"yõŸg~Ø-_ þ~ ±¸“òúQ͉‚D$­l]/mÉ¡¹pHCmòÔ_³ZyHw°`É4Á³NÒ(÷€¥i|Øýn 9tëÄæ4?;Sv3ì¦t§lP\CÎìy¶¥º¢€Íáœ{û®Û ec7z¬üÚ&×.Ó}ØýâÝÅ«Cáƒ"ÇÊ»§÷ç:ïϬOÆ:éÆG{åýêz_0f·“cøÔ½5¸>¶Wûúµ!/|ìW7Úýf®²øéY½šÎ€À–C1c6½¹Ç$ågÀJÎÝ©/ê:•1"çøä=Áîúë›m”σYrDz7+ïd·r š¡1˜˱þ¡¶¡XÝüëd+uÈÏÎv&…<ÛyùÙ ”µ'Îͱ†®õrìâyÀ¼¶ÉeéÑ}Øý.]Õ-ÃÉ7,Þ @²lž `gU"Œñ"¥9õ¨[}“‹cqøØºe¼û¨[†¥è×,»ßÍUkÝð¹jª¨ËA,ÿú¡v&ÅÙ§/—[Šº¤ #W“’t­y.ÇÎŒ\ùµ!wKSú°ûÍ\•.´Õqq®§Ý$ì“åâ8ug†@ïFVkÿp–2˜f—–¤ ªê«pΉªQ·Ø)°,n*§WÉÝÒ«íþ¬ÛY‹ý=ܯ|C›Ý@)÷r6É33@jPhœ“ŠtÑñ7±J¹ O§¿“[zýJÑî¿Q·¼¥±Æçt˜Ï^ã“/–k|²c±Æ‡r«ê¡.j|¶#4’s»ºx}вlÔ-Ç"e}Ñ Ù"®í~—‰í¼çxߤøa‡ (#$, áñc×È)ÝʤiϨD—@ÁI sº'4…9=§¯0ç£oÁlv¿‹ßtœ@U;„Ž†Ý¼wø•± ˜›”ûúºäx‚ÐõvïŠãœÒ¤Û-öƒ±»bC^‹>v´; Ù­:¨d~GîÈÉV±Yq¶qtɤ|G3%Ï,̬K”£×N åÛ›YfR~²käKSÿ°[~e0~GŽ7:[6[ã<ÍìHÕÐ×f‡,vèâá„nžà éÎvHáéƒO88íáXKqV™—Ç¿[>×XÇ:u¬óWë|Ô±ŽGkÿUÇÚu¬-`2€ú\Còc v¿Ìűg(nŽ}p8Ð ÍÚQw¹7GO±å®ëõCU*¨ŸÜƒº¬dý…j+íÚ.ïì-‹Ä:Ùý®f ÉE¬gZ e@e©ÊnEÔ´¾rL¸ÐuÊQ[]g@&D³÷5b¡gb”_y'šùÕvËÏY€G¢Ú¡‚l3¤ +Ôž!ŠáX͈°”Lé:>äÖ3'v¶½ÇÖ^Ž×.lKqXÝšÐ÷ÏëÀYÜø`ud«®JŠþt\„gkÒÌ…˜ÊgMÈI@½Ó}•Ï€°÷h)›wý&&œ,w ˜÷ÃŽsö„ï;'ƒì˜÷˜p]~qó\×)¯¼§*vÛ™ 륓âŠÓ—ä°«9œkÓØý;lõÑUwKœ<«»E·¯ãÐø¡P»è•´îº›¶ ÝEº‹•Œ]ÚÅÕ¥‹|ÍÉnuUu·hZR³ì‚n´ûñ²‰åÂý89(÷MÌ,éÈï¤x²@J7@Ò-ôƒ9bzaÂë5RÙÐUcWÍW‰éí¹Ê.Ó}Øýñ\æÙ}䥯G^z ëïrÜX奷¬ßºN•_yé=ä¥ß¾¸ÿâ#/r½/íÃîÐã³÷PC¬–ÏL5ü0L´uúÚB`ùi•åSºNyF'8HgðÃì®±CFg§ç(iÄÝvó¹,Ç2¿ç÷PÛ ¥L¹žl„KÝëýpf•<{/EЧ8rƽ%êZ½>ÇV=?¯mrÚeº»åëG¦¹÷.ó¦ôðBùÖur_‘ÙÙÐõ\mGÍuN-ÒUõÕ Å¯k„Ê.·¾7Ùuk~ý?üŸ_·.íüó}¥¯ÿûôõüq³¸QP¿¾¿@·tþåëëŸÿ8ŒÎ¯ÏDÏAm¨|†Â§`CÛ_¹Ü}ãÿøÏü ô¾þûùßLÍöã¿þÓ×ûãßüëüwÿôõç¿bqÿž¥ç:À_ÿúÿöؾÎñßc{:›5·ýü ùë¿þq\ éëßûèVËþýÂõ ÿåö;-Å\« èÿb$¾â_}ÿ¢ßJOÜÃ7鋘Ðí/æqé/Œc­ÿèøåÞ«þÂèðÏçè¿ì°$ Þ»ÑñÎ^Qwftü‹–-HÆ¿0:þ…!¦ê/Œ¶¿¸E/ºw£ã¯3nG1ý…Ññ/ìUÖ_ðUׯóóÈküýŒŽQ濫¿0:üÅ_Ù¥³y|3H˜8VNºœãU?g†Cmë× )s@_D—W³º ¦»ÄICº¨ÎÀØRôk{õ,MãÃn†Zú9ä)· 9†É:n"õ¡Îì~Ùòç7]¡e88µ?‡ÐCM7gRßüÈ~„¸´¢½…‡Z|؃£H^ÎYÅuA…b8pкèÔ±C[\NØeº»¹½»ùúçê‰Û;ç f’ìý‚uc“¢ã½vÉovŒë:•ô×—ã¸OÕ¬[Sc¥ÁãÚÃ.èF»_B*ý¼1³ ¶œÎÈÒ™~(´™”»ƒ—äã¶àymƒ¤]ÃN7ÑnÛqÊYŸåâÜ"‘Ûü¬p–žfhs¾\~ÏW®ë”c“îqºãšÌ±ú–œkS» í¡–vyY)à,Äp×µè\½‘òo+K>î¬E]§²þzâ^²ëŽÍ>Ÿ½‘òPË’v%G›oûUÈáì#’Ãý‹³½ûFÞÙ¼äv`3ŠkÖ™%(¿Å8®ëT !‡óõlúÍ.ûÙØF¹CxKnvQ7Úý.ŦÛoZÙ2Æ8g_‰bõb¿²Íãs‘â<ߺäÅöÃÐ-ÜÁVý5¾jt9jöUçácŵ6Éa)t£ÝjïYííišàÀ‹zßÝìqˆFŠnúûîf–Yãݤw·slþõ´Õ“8u6!M󾻡I´]›òÊ|]v?܃w'ùpÛž/+{êÁ¡†§€ îA—~§9‹Êx@ŽU£Q78dPÁ=èòÄ7d®»_§\\OÅ"ö¬4(/>×FW[ú9†»•`;åv_ÔÕýí%ÇS·]_ÇnÇÎkC» í©þvÊé‚Sv.B.k)—BµëyCŒâ,q¬£Üü ÔµäÜg2Ötu'‹ïØÓÝ”¼6ä°k2Ö$»ß©°W-ÓÏT਴`m·”ÝIñ”„=6R~òp]QE%”ÙÖö‘¤; âc«X˜×†|r=Ò‡Ý 9ó/0%„œyãnë¢ñß9Êöôm“ò9¬KžÍfº¤<%$pJ“.R>0¶§„øµM.KKû°ûeª?Þ†<ÁYô _ÅFw»uÏwFñÝÝ[òÛÙÝuAM5:gØBw°ZéŽ=Ôè×쎙‹t£ÝïRŸ¦ÍÜYg*pOT°î‡¯“âoìB³‚c‡:š¨é³8’R”ÅÇ,õkCî–"©Av úqÃ3Úýβù­ÛÞ¼Z.O^¤87®&ù­·u]§|1ΩOØ®{âÍÇ6*¤ ¸Üì¢n´û¿s± ¯ÁY!é;BbÈT‡»ü†»]ש,èë6} ®­[k¯ yç—סÝÔï;o­!¸žù%›ý6ÙNei‘ò5¤Ižm÷eº¤†ÅSŠt äcwàÚwKKù°[­53Vkú~³ ‚~Ú¹§8Ô9£Åß.UÉïVßuòDp–æ™.~Œ~'\›òÊÂÕv‡ç’ø}}GÎd‹ÛÚøÝß.?¾æmëåÙN¯“-n‹»þ\0{gév¶¸M™”Ï+Íå²4绵ÇθÞö=v†=öŽÁû‡$ŸZHñ^ö’<[¼ØtI o%š+n{«úÒØMýÚ&—¥h¼(»uæËîù~rÐê~Â熴ÇDŠûæ4$_÷k¥®SI™¤×elbrwZÝc?‡zä¼¥í~±‹OL¥™‘3X8vbsZQ™Å>Œ²_>Žd—[Ü„º ”f&N^Òm¨»c˃Ïk›\–æõa7}òÙü¢ÛÓ=Á9‹y¹ÔñTsî.˜î9ªE´ ¯÷ ¢®QS§|qNztç={sì©S>®M¹[zu£Ýoʯ}JY°à,‹ê‹„œ7æüd‹”ýÎüHßT×u* V#m•R׺gsìäk0¯ 9ì‚n´[óc¶•„éÇäLû’¿¤ëÕMŠs ×Bó:Œäº¤†ÒSz<í̬±»§óÚ»¥¥ØýæÜ^-Æt_ëïÀY‰q»ÝýÝÜ1¾»Ç©w{w‹yßÉU96ÿö­Ä»Ù|l£¸ëº±1ï& Kð+»ãtD))} í®{xL…Ý OÓ(ãtrX¡‘¼ ÷RÉÁQÄ©…º×÷¶86(Ÿy‹äni-v¿‹Q7ìڣƎ™+.ö E«ñ°92  ÏܷÿÇæ_/ù¨ÛéeÇJ?µÖ¦ärY Ÿ“ì~‘n^¬l(Ýj¦ïÀÉ×Ó|ñéò¥€’w~e£î,†ÃI¹ápR×(Ûþœ›9BÝt³¯9¶Qö×vmÊa)t£Ýï|Nþöâ>'pP09à¯öP£b\›òÎèêF»¹—»ð=7÷©»Ÿ+#GÔ2ãb«€Ål¤x†KYò +亠¦GNÉ–1±éÇj]còæµ!‡]Ðvk_Úm„%m‡ßÖÐä¹Q7ë«‘r¯kvùN#@óĈÁÒ_ƒS²t;‹Rè]ѹ–-EÃfÙÍokÙJtÛ¨}GŽçOóãOΟÛV¢*_T2/žÉ×M]¥.©Ð´Í9×èìSc‡÷×Öû›]÷a÷›¹þ&=ÞøçzpÖõ ›Jvæ[dæîAŠyU£HŽ|肚Ê&NÞÒ½hl1 «ùÊp¯ ¹[zu£Ý<ëÞ> g‡_x/ÎÙvÖ½YaùÖP[A²ë˃üNe®ëTÑJ”ì¬{" ÐÛÀbll£xÖ½³äfu£Ýï|çÅvÔl¥AŽ=‡5ÍOµoìZ¶³Ý*žÝömC¾¹ïEÔŒ38yK× i8öÐ 4é#=Zš÷‡ÝšSR{úÏÀ™œµºücë¢Eÿ« ֺܿüg ‚ÿÌ9ðíýc¥=ýg¸vç©–æòa÷›ïм_?{¶ ÇpQ"ÞÙRfRô Ï9䶸Q—Tö]”8ú º†N±“·àµ!wKËþ°ûY8§û Å -ÊçŠ-Ê 1K—[¹u ÀÝÐKC‹räÃrlåËòÚ=¶(§n´;”ÐY~7Ë÷ɱ#W3¿ý²–ç§Ìm’º×ëæ÷§<›GÂtI$““¯Ç‚ºv\ãØYe“¸¶Éi—é>ì~sŽ›\›ZdLËøÞ¾[-¤¸·-[òÛUÏuA-Aë9' é"cOAëáÚ»¥i|Ø­=WÁéhk~´Z°NÛão‰”ï%¦ä›‘ç1DMe©:§VéZ•>ÇÖ ÄkCî–¢õ«ìeÃà©=ÏÀiÏvQˆ¯°´7“â¹±-É‘Ù]PS¾@çà¼Ë(yÖØCP¸ö ¯––þa·rñVx|Á9€¢ÄÞrR{äîíëttùu:º®S)dÊc¯<]wLv+³”û^—ä•ï'êÙe÷;¿æy¿ç$<}à°›s½¾Åj¾ÇžHñ¾ó¿Â$(âàŒP{|b¬ÜO¤þ O€rØÝh·=ÃHV½Îï;rª¡ðXÑ4D Ûa»Òëzp~ò”¯tAyÃXçdvŽÎ–¨lÖžIý Kîµ3Q°¯]Ðv‡6^ýÞ_ås»‰Û¹Ò}¾·såÃ'lg$ʧyò¡ jªÁ#8Ã{ßÔK¡Ùõ{ħx¯ 9ìì¹&»•û^,Úâ~pÔ+Ýò5ðþ·NŠ_ËÍ}ÝŒ¯ÝJ@è‚ YàL« ‚îd…wë¤ømÍ-9ìšìß%»åÃé¶*N·•“>Td™çŒn”{Ã;9·=릮SY>p}8 ¯¤±ÓÇS$‡]‰«¢ìæ÷¬‹ð½€ƒw¾ÚÁßúÙ…ïÅú…é{ºõ¯Ðí¡–}9Ù;©ïø= Wž/¸vvŒøð­E»y/æà‹÷ì1Œ*Újý>ã½4sµû½Î繞÷Ž¿¥E[û|Þ ®‰­\‡t£Ýïb`Zƒy*±<xt¥lR¾É # i‹šªÂÇšŒQ×½ s“ò5¸ÊÓ»L÷a·öFð…³#|JçÛÇ!uI§ÁV$߬1ÄÙq‡óÝWäàìØJ<;2™gG\ÛÏŽ°gGÙ­œd3îóœ³íµD~s·¼ä7wîó:3U®¼3¿yH5A~óyŠÔæëj¬Ó§¯‹×†¼2ûuÔ»_BýüÜÅë~“ Ú O ½q+)~+kKnN+ê‚òºßÀÉÓuóMUçØÙë~ymÊÝÒì~3×Û™oÉÖwä\à¯ë?ü¹…¼¬ô]JAq>>FQnKçñÚw"Î]Ýh7Î39Lƒ|çä˜ÿ;gûQÌ7~Ÿq³\μärï=|uAÉwNŽù¿©k¾qŽ-ß9¯ 9ìÊì6~ÅÍ*qĘHN³ÚH)Èýz*º<8æ;¥ÜüªÔUåÁqN)Ò-Dßn›Ô#žYSI7Úýf?‘9ŸrÝ"g2´ÒQ±ná†RHÙû_—μӭJ”Ö-qò–®5ãØ]¾s\r· ÙýÑ“¼NCè7}EŒž“"#ŒÖi£çÊ•§ ¹ÆÆ9;×[Ñ]‘{bÞn¯ÓÀµ)wK¯n´û=¾Â®^cDN³¬»¶AáÑ6£â}Sn÷E]PþÕN6Ѷ&Ž]<žÌk—VîºÑî×íXnñ›hl^ ¸HIØDF=žwâ߬7QËÅ)Â&7îÏ{ú7Û¼žwÌhiÉvÿzwkû|wÕÚê¾_*´¶r¹¿»jm…±÷²Ck«l)ráÝ}¶¶r¹ÿÆjmåcÿÓó)Ðw.Îñ¹ÔŸKMŸÏ¥¦hë‘âÌ«çÒj|.kÅç™WÏe­ø$Zý°ûfï°XŸ!9Ùú,±±Ø3š–NWô §¡àSn=‚© JÏœlϺy³ÕÞª¤ì¯íÚ”›]Ôv‡ý£eZv_œü5Ë^2 žjnw…šÚ•#••u2,G¥-ד]{±C6Ð’¼3Û¢­»u/7c;ÓïêT*Új¼¬ä̺€¢u©J>™·‘·¨ò ò'Ö”.*1v@ĵ!‡]Ðvë^€†²²ßKE¥Ýÿ²;KèQHùsÙ’_÷´ë‚J޼#‘€’}칕AcצÜ-e'¬±ÿú>¥2'zð Ž9­N´ÚüËÎø’9{/{g(†+ÝAƒ¡3€0 \×úqìég%^ò³·v¿Ãý:…wiùœBζœ,K KÛvšVhs{Æ$ç¶~+Ôuj)ãœÉ>Õüb¹j앇kO¶ŒZIºÑî¿þ¼k¶¯½H ß‘sƒ2‡Z¶:„Yô0êÞIݶ§†Ü"ÔÝÄa3?q-tÞËò±ú–¬"¹[zu£Ýëá²Î õ0׸¾Ž×ßñܧhµÆ ˜ëcõûا8ZÖÃ2âzÈ 9­‡EŠÔv¿ËÝÈTà¯uà@ái±ÖÑìç=PaŽv¹w© j:ª‡88á\] þqì¡7® ¹[ZÓ‡Ý!ï%3ù;r  c[ÝáÜ–ýÔ-d çyXF䃸!£ˆšî=xýÉæåÙ5¶î…×Ì„‚¥è »ßÅÆ–cz}?9Óp:ªc‚Ý,‚Fб±™$/oš‘Êš¥ júšt3PIZnWÇ?s»LvÓO<87fÌ?â,tp,ïëçí¤ƒªÄ•oG¢ª‘âÛKŽa‰Rw^Ò$ú§ã)MÇIJ ºÑîw}P¦ÍUmJÁÙ6“CZ@ÝÔÿ[Þ—ôê’×í߯¸Ëæ‚pÎÖ‚d@€Û$à…¤Õ% ¼”-Ê6üï}+ãœ8QÕ¯‡÷uS¤E¿FDÜÈŒ¯†¬ÌN\1È-L8ä«Sn•ÔuÊO_à,â×tË´îû5ö ØÁ67å° ºÑnæûœœjx:ЭÖúcWµÆÆÜ•­³s•n´›9­Ýª}»c¹‹spÂN aµÃÃ#DsÚ~ òeuÇÐuŠH·ä´óôRל[õ‰œòNô±:vó· Cñƒ!ç@#\Ô6ÿÂU¨3ᛘžéÇzuÈQÙ]PÞtÕ9ÑÌuO+TÛ›®úÜÃ.èF»¹?Ëæ+;0ï³ì(·ì»xëOó±gR’Ÿ6)®[ùeè<邳l3Ýi­1öTëEÌM9,…n´û<Á]3±uyu’åpà:ž´_¿ÎÉ‘jx Ç=‚îòÕtÝîáõ-(®‹LŒ=„"¹)ÌK˜åa÷+5Ö“xtŽkãœeAøÖªeÎÔBŠß…½$7œoê:å¸6àLæî8¹”{xÖç†Ü½xG7Úýº¯Vï­$vEˆÚ–-Ÿró,Uú”!/DÆ›=R!2€þ ­Dßú’¯ß¨x†¦ÜûBÝh÷¿7ÿøÛ9• Äø„i>ªïÖfG®tÛéLó0Ï33ñiÎ]TÈEîÊ”.0Ë1ö Ó<Ï·€iKx-»U{Ó€òÕÝÇSmi…)0üÝ:ÀAþnŠgÊË@N0v<ûLk-KÝ“ïc7ÿ>qnÈÕΰ<ìþkJf¾OxwGÒ{Xc\̨Û{¹¯CoeèD)N™ñž%¾ãÌóÐ0K´´Ì‡Ý¯ä0lX>Ÿà÷;çJðì$–Ͻôq‚FÛúÉïqù<é~Ôu*%ÿëa¸×ºé¡rl£¾†%«H» íþQ÷»ÎçýNòÃ^0`a/±;MJ’ûýN5ÞÝz÷ÃÎDÌÜï<âýÎãy¿³ü°Ôv¿r¦Ê†k_ÕS œæ•Vöµìæ³I›½4sHÞˆÞ›ª¨ªžRàÖ Ýb¾„ꨳ‰oUrØÝh÷+¾¬Ân¯Y9™à ‚hÚF}ˤøKÒ”¼YoAè:•åÙ¶ž·íºÄq¯˜×¥âuã}gQë&»_ËYGôw ÏàÄšæñ•yx•0•SÑse™#²¼Cz–ÜÀ/¨kTÞª€vNÚ®›~ÇÎŽ/À¹)wKÓ~Ø}ÇáIÃ1âÅÙžÓsù¿º¯£ n~9Èáwƒ®Sõ–Ósåj.Ýn]º0vwçîìvìêüfÊîW|Y½=ÏœÂ,GÔeË_n}ã¨?˪Πî$~)ó¼Å)ª Àê³ü\5Uc<§änéÑv¿ðìæÍN~ÈëwN¹Îf5‘o´Òk¤ÎóU¬6ˆrËX‡.©Ì“sÎWÖu”x®ó¹MN»L÷f÷Èeƹ¾8Gàû°gü~ìÇ· rÿö4e² aœßN ~&X1·hãœgÈã)àn÷kçÙnøPŒë“S¬ÝýVÌæj8•O¨? rC‰¦.¨ìq}qR’îÇð±“cIrnÈÝÒ£íVMJ²Ó6cà|Œ0¬ª¥[>G6[K%EëÖvù<å.Ôec›—Á95¹î<Û(÷ÉÝRô¥•Ýü-'¸}Più[ÀɶéND_fëØ¤Ìºlˆº[]%uA%Ï gÊ0t—¡ cl£øËSq9ì‚îÍî×â_Ã"˜E{%pØÆÞÆÚìFŠ{¥ž$?½®ëTÑ^)¡¯HvÝëvLÛ( OÉat£Ý¯ìÒ4÷ëïwÎDWÞlëø“Ë"eßõ|~"åŲѠë~‰sNŽ©ëV«‘ÃØU5t˜rØÝh÷‹yEë`Ÿ r¦#l„Ž]þú/®oá–|Пғ¨á}2ÄÉSºÝÑ7 )Ï+’»¥›’Ýô_ "¹/fíºÜkX>µá+0B.ü…5-rÄÛ¡ëÑwúbB<~H×ð8¶ð87äni»_ÃéöÄdÖh:gYääZvò‰xµLs,ù ¤KŽÚè:•‡ÿõáœGØuv¤í(•>7ä° ºÑn®»Õ¶Q^SáœSqQÓk&.ÙæèC¶ÎÛf”òΆE%‹òšŠ¢Ôúµ¤kÁ"Ží5>7ä•èEG7Úýʺ»ˆÄ·’ãc-ô2|¬ŠŠ9¼õ…”¯Kò̼–6E ¢ÚNnÒíV©…±»Pí1w· %·4·‡Ýªß<¢Ížª@hÂ#º>Šƒ½œKxDAjïêHœ¼¥ëõqìÅÊSj"ªÏèÑR`ÉîWü ›™ ‰±[ç ŸðzTÒY²|#åw%KžÏ#lºJúëiuµµK÷”BúØM™¬˜»Y–ÌæY®ö‡Ý¯|C×â-8¾!èËq†QAÌùÀW’<³SØH¢†²ŸS¦t­º˜cwÕÈbn€¨¹¥e>ìþ93gÏæÙ>Ê8gÛÁâülT<›Sngoêâ$¾…ë95³él¾Nå'ÏæËñNy6‡Üsyf{Ø­¼êf'‹¦¼êé¶ÛêÞ Àbÿ£“bn@Í’£îº“9ÙM½ì$€Œrdp—¤±³ÿÎ 9ì‚n´û5¬˜n™³ìÇ Î6ÿ^6¯C³Ú´¹IѶ6$v ÍÌÜUBf2o“tk¢ç&ÅÝq®’Ã.èF»_xvW·ìõ¢^xøgeæûk¶2¢K\»uyL’O‹ U¢¼!NäÈúÎAD•æÔØY1yÌ ¹[zt£Ý/äU,€œ[x-1^yQ´Ýð,F&Eß b\ð®,ÝÁˆ×Ô_ƒß`±³Sï;EtÄÝ$wKá”ÝßÈ«ÞíG9úLr>“ü¨™‚\5Qª™ HB¡þ+ÔLM[Q<Ž:5S3¬8®íþÞØVÏ¡aþàû*Û.ØXYØXÈ€ÏæfgÌå”íçNœ»ë^ìcåçÎ!¹[ ýÙ|¿sÐ_]¥*Ðí¾Ñ_[Ä.Ð-Èi B]d "¾À,ìîcå;Œ,yb†70üd÷+ë.0¾Î®î=r¦õwn…ŠT·•pzå²ÜgʇU[@ÔPGZç¤,]ëıÕ[ˆsCî–¦ü°[˜Éâb^›Ng÷®aøq¨ /“ïÊ®’·³S£.¨&Älpªí¥¡k±gŽ­Ø4ç†vA7ÚÍs§íHæp¿—8Ûü°Íj5šaÞà¾Ðïu9€«Ë¯Âæéº¢è÷"§g"Gohì®þ,˜»³?ËÒv Ów[\¹Š3ºíœa1(à•€¹]$ï†ï]§RˆhþÏñ@÷„²|ìvCݒîNÏ„ìu˜@xÞÆ¦â2l àÇ3Ë2àyɧá¨Cש¤ÚÅñÜIêZ^%ÇVÞ%ç†v5bÓËîWòû,2s}϶÷ 窃™Å÷¥éPÜ—2²ú¾ÔÒK°=ºNq¥'':è^ß´íce]ØkfoÙÝh·r¤PUUCïSãlÃ78á£÷i%Å3ÜÞ.߉ý”QÁª •ý”y·ó~¾u‰÷8!æönÐYÞƒ›Ý|“¡=žè÷;9öì’a_±žHÝö¢²â#ql’IºI÷@7ùØChU˜òÄ­=ìæ}±³³ÅÌÞ#'›ÇÕâ³¢”!e×®¿åÕP;³ã!—·¡ ýc1nƱC„sSî–Ýh·ðå§]×¥Þ¬sp7}|¾›>ÝT')÷ŸUí¶3£½;ecÓ÷<9ŒD,Û(÷Ÿ%ÉÝÒRv¿Ösè Ntß?’sQÅ@. ˆvÅðýãõ%J.¿BÚÝuIu­*à´³¤®9¶ÎˆœòEÜ t ’Ýʱïµ{œ2~¥Ô/ã‰Ó]Ôlo·ˆ ΕãÌ ]PŠŠ“¶t§a î²›`ð‹lXzt£Ý/¬õqy9eßïœm5%X¯7Ùšùú;¬ŸÍ®,;ΤH±£;9†EÝãûó±ÝËèsCÞ‰Ut£ÝÂwú÷ñ[¾ûb{ÿ7æã;çÚÔ ?à²á× ÖHq½ëYòâ}ëZ¤ŠV^ô­Ùu'z¿%ï[Ç•½ M» {³ûµ3tF9fà,Ô4Ó{¬‡3`-ס]Sb-gyœã:±–‘c6;ý;x,07åf—΀²[{Mø_†| [9«ûdkž]”ù8QaÐ"àí9òe_Oè‚J:¹/~ávs]Ö‘—Y¤ºF +ÃÒœv«65ÛźFq–ù›±§ªV·˜÷ŒÜ……½wé:ÅŒr‘̱ËÚÃÇú~bnÊat£ÝÚ×£/Ú}údûg ó£çZY¤|_ß\ÎÈœé*N·UA úäÝn!YŒÝÕsCî–Öò°[ûz`šŽäûzˆ‡€ØlÓ¾X¬-É®AÄwÙ}÷ /a“cØìðÍ.‹°Áw»d|»”›ß—º „ LŽEبkØ¿[ØÀœrØÝh·jRª}šjR*<½¨I±}û°šDEɦŸž”wžor¥Œ7p®SÇrݱ-´ßؽ£„š”*¹ÙEÝh7Ÿ±Ó5 ï‘“ ácÙ>Ñ£Í,h|nóõÎéj•¨ëTbªsÐqÙoA]pI¤ø5êUr·ýe÷+>îužhkJò~çlûRNËbmféõnÅ_’9ç´Õ©¨Òý¯*¤—t“ÕWaì¤ú+Ì 9ìBÜ ÚýÚÞˆ^gõg}¢&¾ÛÈ‘O¤9Œyø>œeDP»Pí·ÀV•CÛªä…])VT¨N‚/«'דq³9Hñ:±×D—]Ðv¿RqTnXËà/¹³=ÜÁRö¦l޵l+”Ov4=º Öòd×у— ]`)wŽksC» íÖ»uvåÕ}$â,‹´¢­!Ò:Hy$¬HÞÌ— ]§Š¾ U}¡÷ð½:-)ŽŽ µTdWaÙýZžØrÿõ{äLžžÐ÷½Ò$Åw߬Œ=ør]RÁîœR¥ÛÙ»!MR<‹´ìrYZêÃî×zŠ-‹3±Ï9ƒ‘õ L [ýR&Ïe”wó£bw¢£W¢&ºg­!ÝfñŒÝÀÜñˆ•¥í~-ÆoÖRŒŸ}®-:’Q…ƒÚÇDÊת)yµÓ«÷QJ÷R4œ¼¥ëy +‘òµªIî–æý°ûÅýÅþ˜—CÎàŽ§mÅsR"åûŸ)ù4\‘ÁÝPÉ›ûpà£"zÈ@kz–0wã³KË|Ø­µjÑ_û`¶4ÛdûeɲÒNÚô"yg~@뢚W?‹“«t+ër× ³:(wKÑ]v¿öìGp Ã0O ò±-ë˜x©ÛŸ¯ºÉF){бœSŠt»Å‹0vW< sCî––ò°;äi䛟†œã0?³ùa*‘=ÿ²ã¾Ø^»€1D?sj•®ùa8¶ü4œr·´Ö‡ÝòkÒß¡<1úiìj¡‹ï Þ½¥˜}q? :MvéVâØŽUì¯.Ýqá9öPV«÷jù-ø ±[’Ý—Ù¾Å}¹¿h)ÅÞaOüþg!Åuboɧy  ªèm™î](ÒͶÄØªÞçܙ٠D\(»C?<ਪO!8Ûö²èÒ„h4ûá©O!;€6]Éé‘îűWºOéZG“ÐOù3»œv¡J´û5¼¶S‹—…hCÓø©y,'|mÉs›A•å­h¨Ñ\®{Å;«m”{§äƒµ˜m=ìfüµ”§]| §²[îuªD<÷Jmé·xï<Íy\~šó¸.¨¢,çÔ"Ý|ÖŽ}àÜ»¥G7Úý#p1ŠçÚˆ³¶Òñ ”àMIrÇÅX=Rùî/½NÆ%æàî[†}÷—R®~åa÷£‚Fø--Ô €ºýÈjÜ~Ë~ü–°lNŽrø-º‡Â‰š+ZZËÃ>ï˲&÷ô%ŸÔh÷57÷›Ó 9üÔÐuêq_Öù»n>9N;ë—cnÈat£ÝÂƗı•&¿6Ý vè#³|w¡®ëÜa Τþh¤BŸçä%]ëƱÕsCî–²\רü#ûe #—UÁÀ5Oå¶½O¤|§Þ$¯ÌÃiýùf¨(ânqÝë0}l£ÜW“%wKsyØ­VÅ#û™´bŸg5B@¾Ëuê…÷bùæIšÕuI ï™#NiÒµlDŽÝ…3¹!wKK{ØýZ¾ÂµÓ^gO÷~çœÁíÍùdœ®dªFºRªäÙjÐMW”GúÀ1œmêCÁNìæ_ÌmrÚeº7»_óÉÇPå{O#2 :›;)?‹É;+öŽTÕi ÝvÑÙj :\4¶ð¼9÷¤gq6éF»å DÍ{ çkÔxäøVò ÜHÅ8<åþVæ¬÷l{lLovêÈ@gLÔêíçQ€'rs=ìþÆw«õçw+‡Z–ÓÏ5|ƒçÓ7xŒøÝÊ9~¥Z{|ƒçŽß­Òâw«´çw«¨–…ºÑnæ_{oä‘3“¡À#—¬Âºóž-Fî¼ÇøBUQ“®QûŽ8gY…õ`žgK>¶Q_Ãxt¼y†LØrD÷íLŽe¯7»ú9÷ÊKÚ·sðZ’WzË{¥s°8¥H×ι[ç`Î ¹[zt£Ý¸/èMañÚ÷;çtÉ@Oó%òž‰gï©ù&Zvè°¡è°sΗÈ{j,ë’±Xq„3Š÷ÔX±‹u£Ý÷ßbÙEþ »é·”ØÃèÛoÜûƒì)ä÷ÄŽ!9^‡4âuÂ^%\Ç4nAòÃná6`m›ÌCDk¶#Áš¼mG‚5y‡\,ùf†5°ÅY»Ål8ç ã{àk?4öâïäšÜG´¨S²[û<ÆlÔ/‚±&ûŠ3ÖdÖ1Ö¤~3t HkJ¢¦b¾É{OéÂk½=Öô@¬€|2Ö4çÃnþ–ΫÎûÒ‰£U¬Þ([®Ò´˜ãj¤xíz–˜Ö…û—Ô96­KöTí,]‹S-_«jDó’vA7Ú­}Þ¶ßGü\qf‹;»b`ÄÃ=B™¸,ð÷m×åÊÌøkËÒíÖÕ cwõfòßš²Ëtov¿ÖÇ9Ñc»éôÓ@g²Îª¿ÚëLʽËSr{³ÕÕlŽíÞ ã¤êºìLfcÏchs«s,Mõa7÷;Õ2b¦|-ÎYÀZ´Œîjq±–I¹wyJÞÙ·a¥Heýõ0Ïu›Òí¬ G¥œûZ*këv•]Ðvÿ(l´xÉ糡5e¢jÑÇÌÖÄöWXS–ä‹3Ô&J‘{qR–®!ªpì©úGÌ=Y KY;™5ö—Ÿ·¦=1ò=ræÉäœÓz.Y‡ik6Šg"TzùöÎPKÔB¿sž;tOïb[]’97änéÑvë=ì±z¿s€ šðZ„àì–r¾»ys¾w–®S!ç{›mK·3y¦·[4 sw⎢°í‡ÝøÖI†½Å·¬îUñ-vA¤ñ-t:Nª™ÕšQû}j¹nc ë¤nñ­ÆVD´ÆzØ­Üâe+ÞVÞղʀ¼¯ðf6p¬÷ÖÅ<±³c)ÒµäÅq:;ôŒX>¶Q~Ï»än)¢Ò²ûÅ~cÞ7é=r¼ömÚ{Íž`^{ÈspZ’žÒQs7 Çæ_ƒ“³t;ýM­rO—Ü-E†ƒì¦~[oÏä¸ädË©NÞµÙ|'{¿EïòÊö\v˜F);L»¯™§3pjq]f°ÚØÁ‡¹!—¥µ<ì~e}ÖâDoßïœiõYÕbÓ }1ŽLOË<í%\¾mç]§¼ìf½ø•qJݵ7 R\ë–vA7Úò{Ìû@ßš8 ™ –“Ѱké¤<‚š%7\ê:Uô×9:ag’éÍBuMô½.ÉÝ3‚Þy²[kʵú^°+É×”mÞ9vχšÀŸ(¤¸¦\9”Oó£Cw2;¼k· þjÒmì¬uÆn1kðÌÝØ=kgéF»_[S}Ô›¯)@´.öîâÌ9Í·†úT~ *t¦EŽxV²¨%¯baíÃZÒ÷<§ªSάµÊ.èF»¿Ãúë€À²´‡Û½ðþ›¬¿VÿÍ~ë¸) iŒ}Û?΀!}|š9îïÒ.÷þ›Âö±Yç 4¸Iÿ-8›9ôۑƯ|ïî(äæÿJµ?œ‹B'JäÐÏűù×à¤!ÝÉú>I1:»³änéÉ^Šv¿–CŸ ç›9¬ä,Ëw1pš„Uk{–|'|Pý9nQש3îç䡺.rX1vÈaÅÜÃ.ä¿F»Cn12²¯à,;/5¬†’)®x+IŽEeÏhPE9¨¡êMºŸÆ±‹ò•07ä° ºÑî×Öô¤kÚ§tó”ùŽùþ¶ ÌBŠ«jJ°ÜUº…µ(Mû”í5JÔè™icÐS3{½À¥Ðvë"é=ÀA'¯8 Ó Å{È\x;û—)]P3f£ËÙ˜YºøŠ4f¾{Ö2憼0Jt§¡±¿<Ù°®zÚ‰³>Ö ìæz€k¶ &£Î›• ÷€rˇ¢®SD„$'_ÞG×Íã“cgÇåÜÃ.èF»_Ã…F¤Àñ3£ ß,[…‡Å®áØä•QŒ´D-½áàLûzz\ _OôW*¡önHîû{|™e÷+xMÅòé—÷Y#gŸóñ*ì7ÖßȤÑ@¿±#oìtA-¯î$gžzêN"£ë«;97ä° ºÑîásRŸ5qVŽ{†Úãž¡*†=Cíq—°nØrù†žD]«päØê³Æ¹!÷=C[»ÃÂ~*a@ßf_ùk?u]¹NŠ×yeÉ-cšºNyWfpÆÉq¥n7Ï4ÆîžÀ¹!‡]Ðv¿˜‡l§¤U|ï>Í+ž(x\÷$åþ€&ù4û`îY^›{wpØ5×¾Ú#kìqëj–Ü-ÅŠ.»_©3ðÞ×ýѳ{­˜+³)*²»‘“ÍÈÀhÒõžÝý_×îd¥q»£qîI$Lôì^ãa÷k{Ä« ÿ*[T%8¨³<Ýb·e_oëýáþ³¿í䜽ï¦n BåáLÖYÝÉ:Ë3öŒu–gîÉ:˺¨{·ûEüa¬C±;u 3ª±Ñ5/gR’gæÿ áuÿ§ðÊÑé»û9s›\––ý°ûŸI=¹ü>z 1+ Ê–ttePöNÊüV)By?O&uZª&ùA¦kiHÛ¨¯aÉÉk…–B7Úý 6Ze¥+qþÉ1lÙ<>Ý…>ƒÞ]·Ûr ïC×;„îºàäáºx:0vÈÇÜ”»¥y<ì~e/’XEB_59Óbˆü V¨OˆeËé†Ü£RÀwDÄʻׂãÙ+tÓØÝ}ÕœòÄJdfÈnŪù¯¹F« UÛì™vj냔ŸŠäèÈ4ˆ='Çæ_OûþàŒˆ ©Z5v“s7V0 B gSÙýÊZµyJb?/q€g‡Ni¨‚ÏÉ} ÙÎ>›høÈçT~|GÈ›î}ñ±g¬¯kÙåÊ1ŽžìV®æ#fÆR¦ zb˜­Ë"Ùð3C™Ëæc͵¼*œœy"¬Ô=®Y{zN6ç†|ò:ìú°û•u7Y·ž“Æö9ù¬ë3{5´ÄLÊÖˆržFÊ«£ŸoQÉ» L?SìáºD5³±²¿¶¹)7»¨íæ=´Ê£kN~¾µÉ2?ÑvVR<±œlÈ ÁšºN1MδZèNæ†ÍJŠ+Pš’Ã.èF»¹¦ žÌ;gAÁ‘åßÂuÏŠhg>£HwñäæQ#çÔìºHŽ6öTÖæ¦Ü-­ùa÷k9­¬4 õ]¡F«»†õ]Žº×»PßÕ¤Û©&Ôw«ãÑíVƒ„±»j”07än)ë»BíØ³~áð>Ô/dùªCdGõ 9t%…®êî¾ê+'iÜêä«6*ž;)wKËxØýZ0bÁI>Qp†}wKžƒÏ£#¸XDu7é:•äA^?3eÌ'Ê,šJÊcFSòªÌÚv¿ø=Ä3 º±åˆF'à Ùsð6Rþ=Ì’fpŒ$*ôqN™ÒEÞ!œ½CÜÒ2v<,x1–{:. µ‰È÷Ç{8VvùN¬MÌ]ÔtÄ@rNo×=€ß>¶÷'ó¹!_¡³øÝn}Ûµë}¿s–\Y©–³V*)·^ZuÆغŸÇTÝÒÜ×µÊIŽ=g‚sC>Ù=«í‡Ý:¢âõ*ªÐiMµ<5Ö`×ʽr¨µX54×mMY…¹ç ^Xõ­\ÊzTQŸÑÒ ãØ¿ÀùbÞϺäàÄÑí ·³ìì|¢xÖ½U–äÓãmEÔˆˆªà”-];Ërlu97äniÙ»•÷ Ï ±kɱk2 sXö20éCZ‹QŠaûGÄÒ5=ªNΠקã—%=T±‚¹!‡]Ðvë·Txûÿp¦å /ËÑ+öÌöJŠ¿ÈPÅžyä?Ï©¤¿f5ÈrÝÐ’ÉZóÐuoMÉ+ÉêzØ­=!꽃ϛñ 6¥™=ðiçDŠ»<ø×ºõ0¨Yº½ÜçÝéo™Yºði7"ʸϻr¥€Ïµ3?ìxݨ®cõéZÈ–Dì`“⾄j±œQ€“* ×§âuÛš½¶=ÔËxÝ'žJˆ×½46Ÿ1ø²Þp¦·P _ÑóxëÄfO zÈÕ}dsD*«úŒÕîUºÝúN`ì®Ê ÌÝÙ—¢-éF»_Û¡OùR¬qb_‡î/F4‰»ÅG–¼Û­^ÁÕ96}à”,ÝÌ]ð`ª²ž!TiQ7ÚºlÁ#ŽÑàKu°ˆÎpŠJ{àí,ù:IHÔpŒÀq£íý }ì€c„¹ç( ¤h÷‹XxåyFá·ÇÞ¥q;£%:d9¥Û…9&CÔíŒÒú~F©õyF·3 ,ÅEv«þ•8ÀÌ ÊÌèÙÏ5OX²ÜŸ±Iñ™©Crx›  *ûê-N^ÒMD;› :-Íëa÷+~eäê5Ìä4ËÞ†µh}J¦U£lõ1Y†uù:ðýÔ%UUÃ으¤{Z÷øØÅëf87äné¥{³;`=WúIÞçc¢dÙfmÒWrb[õæ•ÙÓâé/óhCרà•!øŠ¦;½hcÏ€ÍhsSK¡íuͼŸÙ}©àÀg9-ŽÜìlØ:)_ñ²äùÏð•‚ ù4ÈFv‘c#CgèÄNF®Ro¢ªªuS²tíÁ±õ áÜ»¥%?ì~e­jV Wä?§ÚÛj ®´ƒt,98;UÕaû/ȇíÔ  JåÈÉæ ‡næ~#v}{ÓÜ™û•:¥í~sÍÎ#`®ÕÓ·ª smŸÒœS§ÖHyœ/In˜jÔ%t$ršÅء۬{ÆnªÈÇÜÃ.èF»Ù/©ÿÛu4ƒ?—œÓdï¢N:W—"ËÝz¾>^¨Ë÷G¹¡|STvljrN2°ëšÏ‘cË'ɹ!‡]ÐvÓ7miyxoq–Ue]$yZLÀ¶ªYYÞfÇü´–¥®(÷‚Ó -ºÍ"ϻɓ¹MN»L÷f÷k{†îh]ïwºÎÃCŠ®óìÿ¦údR#²„D@$°m»ñ–¤kÏ2ÇH`˜rØÝh÷kØç]HׇàýÎö¼Ÿ7'ó´zŠã´Þ ¢uJá mˆTÀ89Ë{1%R~†n’›]Ôv¿–oȈ”ò ‹£{ž» |Â[ö!¿³9¹|'FFò S“t‘O³ =2 |DYZÓÃî×ÖÝikŸûaÁéæKõ•6a¥Ì¤¥?ì~åÙµ²ˆt:£¿ß9_®:µjHÀë$ŠŧñÚ$çt•iÔ TRµÝád«Pƒ®}¢8ö¡ü<;%‡]Ðv+ÏéZó×ô}>9ËðFÎ ~­vÉF•”Ï·%?騮 jjŸïœÜ¤ëh䣒⺻‡änin»_Ëa—ï¡¢¼ö|±c âi“ŸÆ]%Ï|óZ5äep·=›}iìîõlœÛ䲨‘²û…š³tÜ4Wµ&ð_gŽã¿¹^÷tÚÌ^¾ŸËf”=Ç¡är+—¦®SÞ œƒåºÃì~m_š-Û°è=gY–:1ÎCœ9ø›6ýî ‘“.]§ŠÞÃÃA?§M¿;öµ‘â{¿;ö‘¹J7ÚúYŒ“˸§û§X”Ü0ÔVµsï8_£8_j’ZuAeuõuNMÒM%ÇØI]}1wb–Öô°›±Ö Â/¶zµ*ÝäS)®»xSƒ?·t£Ý¯ì†—¢2ßËûΞœ-î9ù\ÞsÖó½Ðèr€A×á…<ß älAù\Þ¯Öó½07äÞ³v­‡ÝÌKŸ'V°ë.sv[u¡žîsê¹òʯ‘Qæ8-$\~À\TcÝeà”.ÝzmÑ}ìʺKŸr·´ô‡Ý/b‡ÜkgɱÜòëÔ‹h¢oÚYÃÕ¢<{ÖòÒ䯅XÞÒØêȹ;ñó·jgovçq”ç7¤Üp× çq}çqÕøÕ(7œÇq¯ÖŸ\ßvÃylùù i7œÇ=v '|¡J‡q*ã¨#:ª [@Z¤x™¡›ÀbGV+nŽÍsH õM“ý¾Ñ‡`Ê„¦XOÑRÔ7Éî×r™ð…ô7~Óªå Ù{Yf/ð­=Þ@ï\n‘Oê¢eýõ´j齤k}¥9¶úNsnÈat£Ý¯a#U™uÀä –7{×ôª¤¸ÎSûoT´Ž$jD´~pÊ”îiAècʽECr·´Ì‡Ýª9ƒ;`Çc «ÈÆ3b¿¹ÚS¿sÓÎ «K·° 2`Ç.T™Mé:v,r vì^’'žÏÑ™Bv¿†?•,ŽÉüq–y¯.‡nBOQKwI¡ç¨¶ç:“¿ðÑ TVŒµ~Õé/o^»mÈ66(žY.å§n´ûµ¸$zIïîqɬœŽµY‰—­âùÄ9`o %hgór8þãBHªp›ÆîË •zÀ2ƒ¥ÈTݪmªvÂy¬¶ßBÝe‘§…þð…߬¼$–@fÝY96ÿh6»»îØì¯KÔQá<âM@]¼%è¯+»XÍï 9ý<ˆúooÿëúïL=¿ññwoÿãí÷ŸþÓþûþÅÛ×À÷(þ{­Öߥÿéí7Pÿ³Ëòýq ÿ^–§Ë­ê–_!¿ýÓ§|­ûoÿ…ƒ÷u=>ïŸPÿeäï>ý’ò=¬6äFy®Õ¶·, 3úüEß—­fþ;ÉÜÏYàüÁ<õhþF†?8IHÅÿdüƒr~¤ÿ‘áîw6·dI˜ldøMè'snâo6:þEGHþ…ÑöÇÏä?ÚÈxUlIó?02þ=ºþx²ÃUɧ¡…_#ãTó¼óŒ ð…¯Â·<¡z긢-°(üÝ:~¾W›±üÿ½^„ð ÿ0»âƒþszûŧ_üêÓ•z½8ú÷Lú×ìíW¿y;!Æäÿòã™øØ•¶|:Ùüêýí«ßþ×_þìíWÿôéÏõƒ~ðOø7çïr=ˆ;š+ü]“¿~‰O‰m‰×øÿü—/ò÷þèŸôâ’þ§¹Îß5ùë×¹X2¡®ó_}õ¿ýÛùç¿ýÙÇyâí«ßýúÿú‡ŸýÍÛ¯þ’—ý{¯ÁOúGöØ2zÒ+þä[>¥Œä»fÿaþŒôóíýеê”ú±î~l¤?·Š|ïÏþ‰ÿ*þ%ö7¢‹ýùÙüÅ.õxÛ?·œ|ÿïþ‰ÿ*þeÅFøOr±?;ù¿Öùòl÷²¤|ïEøIÿè‹þû¢ëûÜd·“Žžrò©ï¶ÿ@Õqúk]ªå UÛ•®x¶)_ÕÏ^±õžÕje†Õ"iv iïÁy/j¶ d“ƒ r‹ÔºÜHÉÛÇ:tÃé08d|þè·=ó›^¸íW¸ìcžWn{©çB¼rÛ’ÉúãÞvoèk·¤nÛUnrÝà±02È[¶&‘äs[Ò=äFþ›ÞözJ_¸ë󤛾rÓsÎWDæ•›žÛ¹BÔ›îîe¼Šô.›ÔËG*ß2w-Û#Ï2äîX6¹üÊ_z®ùæð¹€±_Òœï×ÔèÜŽËØ¾í×EýÝçnÇ·ép@éþóèöv*=\÷>§»îªËv‰s|ñ U¾`ÒíÀU0ÄIÿê«¿þê7?ûø`˜þ»¿{ûúýûøû¿þY<Ø~Ñ•áDm3þ<’ -iàÞÙŒ|ÎòïV6hÉo½Oߣ|ðé¾õF}§òµÂ—ôíwJ÷ççºi´É8•¸õ»>ß=q>ÈŒ¸[ÿóíÿüìícýê׿ûßßv§¾{³ý­±ºzZ æi÷ðq ù°Übu?ù«W'NÁóZ!®Ëó‡ßþÃïû›ß~ýëßÿë·íû¾ïG`Ìlh³†ñxþ½ÿˆï³\kèçÒMNôö[]Ro¿ì´%>…(–|äœÓG¦®Ó¢ì¢V?Ô•[Xvµ®Ó@Æå'­ÝuA9ìªsÎÿ\÷üÏÇÎL ó¹MN»L÷f÷þ²Ë~ežžv¹ß{Ù?ŸÔä—ýóÙM?ô²lë¸]öt@ŸøÓÓ‡â¥1*^vÊí²RTgµsNa·ë¶+àc7æøÜ&§]¦{³;^ö޵Ϟ«öÙ,ù$í\oÚïÿùûV?Ñ”é `Õëÿ™ïôïÿðE«Öwþ÷éÿKq|â endstream endobj 348 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 320 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-global_plots_volcano_2.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 349 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 350 0 R/F6 351 0 R>> /ExtGState << >>/ColorSpace << /sRGB 352 0 R >>>> /Length 18596 /Filter /FlateDecode >> stream xœí}K¯nÉmÝüþŠ3”>®÷#CN àH@¶ʵätäÄí$È¿Ï.®µÈúnZRwÛ°á‹è¶H~«ŠgïÚU,ÉÊoö–ßþþí~úó™ÿ½¥÷”ðO«åúÏ?þêí¿½ýöÓó_ÿÓÏÞ>ó)?ÌôvÿûÍg‰ÿäçß"þùŸü—ÃoÿçÓ_üÕ[zûëOùíÏžÿýý§lÝýçO¿»ëOo?sëxOã­¶÷žÞjÞÕÙÞkÿŽ*þ>ü§·_ÇŸÞw)o÷¿çOHï½ÆŸ¾øÐxNû´÷ñ©öþ>“èß|ú9PJO-~@:~P[zŸ%~@úü`÷©ÿ©–ÖûB¹ï÷>\NòúAyjIþ’×jjçÿê$ï.^Þ"îù½çÐdü=yÌÓK<Ð×Yå}­ë‰€¾žÈ^ï}^OôùAÞÉv}AÝê–ú^j<÷v?}ù@Þl<}•xd ïGÖò{žñÈ@^?H6üîÏPüÿ¹a3¿~$ooåiº­·þü{†M0ú{mÑߟáÙŸµb¼gŸí§ó=…t¾Ïî8Öª~zõ½7Ç=/"{«Fà§è“RhCÜ¥ëçO?{~œw{/ÍI0Ê{ËFlCçþƧâ³ýt¼ÏÎÓ„p ¬UüŒô>²pmŸæôNøLvH¡ q—®_‡úOçm¼ú>6Ô'£/%?/êùÇ3"êCô÷,Â::Ã&¤NÕq ¬Uýô0ž‘Wìëg«Fà§è“RhCÜ¥+Õ㌴üü}3AqòûHFíÓL1Ÿ™åùèHYgÏç:{È÷{Û%emã×àœG›ûPÏœ§¶A}¦&§oÉ¡—°·Þ_ÇHú÷®~~¯ùŒßT¨¾ûyQ»œEøê£±E £ú¾Bú|Ëq"žV¥ÓaÔ3c ÷ ¾å­Ÿ¢OJ¡ q—®P¿œõ¤=Öij€M¬â´³Þ”ÇÌx–ÄCíg}l’æ”MÙùiò’—÷œ+ÊÚÆ¯É)äØ| &oÛ(ûµú†\zû¢÷W2’Æy8Ï4–9%‘ÑϬwˆe‹ìl¦ÂŽÖC’îóê…a­â§`<.;®Ø£g«F衬Bâ.]¥þ~Ïûôú³c¼·jÄ3®û|Ïa–Òû7)*i9Ó5p"¬UüŒö>ªãžÏa{«Fè/ÝbHýèªá±-ÒÛìç|\ŒqPIÏjSßæ<®¤gž;¤ó}LǰVñS0Ìþ®g©VÀOÑ'¥Ð†¸K×XŸq˜³ÙN7§Û﬎ÏHËÙ,¨³x6§´ÐÖKþ˜i=°¤ÜPsN>;Ç>ꊶÒÊÜ/9õ"öÖ›¯âé¶Ž3ì6 S2lÖ+ŠÉ^ä3b‹À ÓÏÛ–tœ·-k?ãùS„³ R­Ÿ¢OJ¥žá.]ù*žýSÙgVÏ o‚ 3–ó2 ø!ž±zˆ-ÂÕZçÿJúÌÝq º?U2žyd9®–Z5?EŸ”Bâ.]ãCx¦ÔÑ5 ‰aÆ×”)bV#¶}+¤ó˜îÂ蚆Ä0£M¸z&µZ5 ©OJ¡ q—®Rÿ™Dž\ÚùÂ?nN?ïðPg2~¨çed:¥Eçù@%?‹Rv¬(kƒœz£cËyÐÞvÑ{ð¾)§^ÄÞzkJgŸí¶4c túÌÝg5ÏX²ö™—A ¯tæ 0ljìÄ‘@«úéa¦tÉNX«2€háÚ†7ÛZ!õgH¡ q—®±£æaÃÇÅ(çuƒõùþ‡)h6‡™ÑÙ¥Ç~i‘Ⱦ9'#™ß¸n ²Õîê³OI¡M’¿ÏuÕQS:'»ÏRÑuÒdŒg19ÆëóÓ2ÞÎ2óÌjYŽ‚êYØ%­gaδªŸÆÂ”áæ<Ÿ [ŸZŸ’B=â.]©þc¿ÕqV²Î‰“ ,ÓyÖÕ So„utv!]ÇÝ&ˆ,¿É–Rà–¶I~:¸&›Úw骧¿m)Xçkÿ¸¶vä™l²Ùf<Äå=ÛòC©9m„±ä«cšsœ¸a)[5?Mô )µîÖ5L¶Ç‚8ûá&[5§åÂÇ’†/àf¶ÞË»™®’Žó‚…‘ÝV(p"Jx€Áȧ9ál~W«FÈ”.bHýèúUxæ4BçÙ>}\Œ…­­9¾º…hœçÔEè‘¶šÇ 8Öª»+lŸPŠãú™óÕj÷}vl|¡ â¨ÕqEž–$Bž–RhCÜ¥kØ|gǘÏûq1Ê9U=½›A6þ]„æ×ÒÉpÊY°V5¿Û5î긄/­¡¿t„Ú$9ÿ]W  K8Vnãàc?›˜i=/í|\ˆ˜×lŽI÷™{„‘šûÞÎá¶­på|¶Fh~j}JjÚwéú•¬nÿ¾Õ?þêg¦ÊÙgÚ>—'ðdÙôr‚‘œÂzÕLyÉ›u*,©!¿¤sº7a› 8µÝ/â}SN½ˆ½õÖJÝŽe»«dXø’”CLìb·íqWHç1¼…QcÑ£ø™mbl“V³¯ì“RhCÜ¥kÌ¢Ç]Ü⬠;m?3Z3'tÃ|WEè ¥öÀ„Ñn×öÆYâpl5Ü ì“ÒLo¶á.]ceA÷Y4Ù¾¥á¬a%wk5ó»]N/ì?Ü%†wëNøÖ361£ n­±_œ^Ö§¤•ÛèÑ_uÕ‡°lÌ–íÇäÔãË"3uªaA¤äã9牒g $–ÚÖ¯³lWOìcš€¶AáC@ß”KS`_ôæßRª}8aÖø·ˆ“ S,ºêDv7B±à+RÖ_±í½Ë‡}jÂ’²¶ñkã<¶Y¯‚>fÛ9CË ðSëXRÓI¸[å8ˆ=á‘3œ`¬2g‘@ÿ’"[EÈš,!­£Bˆ~ÈÊÔŠÑgg¨jõ:¬MLØØÙµaÜá¥k|ÏÝNÊòï¹ÛN##ЏÚ{‚òŽÇN„>ÒÒvV{á@t ‹Ñ} \Õ(/"ô=×B›¦¨e×5üˆMÝý`l|—Çdf>‹S!§D é¶  âD$é–âªÖÀ&BŸ~)´i¾²voõgò;Y¬wblÄŒÊøÍÅÃÝRl%;O@Lj/X8K3¼‹E\ˆµVAà§Ö§¤UGïëU×+”+¿­êƒÑ †™ 8R9í>Öu´›Kûy ¨¡>jgDZjÕ9òNŸ”Bâ.]úù[¥þîI”z.ÈD¢ÕÇͱoêPÏ\Ùðí•g¢N™bϤòÌ .·€Ç’ZþÄ™g8 ›Ì¬¶A}¦&³…œz{ë}þîï“ ÆQ–Λñ¸O0:â7ÇÑeY€9c7—‡Ÿ[ÔPH÷‰þD‹¸O0*öêÀDv¢ÕqŸè³xThrÜ¥k„­>ãk-ÍÁ؈˜~Æ Nê-`°]çøêˆRÛ>'"EçaL„U7Î"¡V‡"õI)´!îÒ5\!Çp›gFü¸ ];^xˆã9žarƒÔv®i†1uf.Æ8[!ẹ¿ÙªZ²zH¡ q—®_Á¶ãûÎvøü2?Ão<+ÿÿlzÝóC1µcþ°¼Ob땊_“ãßøÁêûGÛ÷ü€¾%§^ÄÞzkÔ­+“÷ãæ@Ÿ¼Ï¶ÀuMÇ ~ù[òN÷ßZão!uý-äP`C×¼_þöM¹ôöEïï?×Eì¡W0†Ý8#ÿ¸}jÓD¸1ÒÍðFÃmZh¸‚Q0쀳°µzE^ OJ 9ò«®J„\–%[H>­É4³rmÍVùbk6CÚ™]3»Í݆dTXJòvqk¶Ê[³RhCÜ¥kDƒ l¾²GƒF3/沼Ў­ïÉOa4¤v„-ˆêg²dÛ¬‡­/[1û¤´ñ¨´äW]õÑ KSzÆ`ühÈÙðË…+ ç|óìúH}æ'6/ù¶<'aIYÛú Œ3qÎÇ_dX°í ì[rêEì­·¼ÖËrBòpW¯8Óϧ7ü)ÅŽ®³S:"O—ÜaEpø’Ó0GlƒS—m7÷ùªoÈ¥°/zGþÜÐÐø¸L¯œÖ3ìÌâ,"Üìé>Q81ɨðÇôJ´®öI©'#W]#6¶YðÒˆØØfáMgy2ØÍóæ w;¤Åzˆ±|Y'c"rÖp'›«ªUø©õ †´™ðâ\ºÊþÊgLËÁû¸–¡gõ·Yp^SÎdB¶ü i£‡x'R¤çcðü¾Ê—»Õ*(!5m„»t ó1YÖ^*n>‚Á0‚gžS¹€S„›É¥ó”AND’ú`tßÊYN÷B§ÕI…è³iƒ˜¦ã.]c{Ùìl¥Nß^6;y)È™ÊÈ&Æ,‰ðíeHÇyî°Võ—Fv‹Ü’‘ÌèG«)¶è“RhCÜ¥klî‡yÛðõáÆ ¶ï‰a"<8!¤Ë¶¼ÄhgbxC¶Åyoµx"ž1¯âÚwéªa³Ý¥„ÅÍžÏ,\ÉÏ_2m mrJ¡}aÒÊXuÃUrjËK†å g•VÔjщú„”ÚwëOžÑ+AqE6² °ãœhŠp‹|»t1Šdn'Ê $âQ†·š­¡>)•zLp]åg·Mñ9Ïä:†6ŽìåV§˜Û^X !ò¶=LÉû¦œzû¢w˜yHTØÛÍ<$+¬í΄¡œÔ!BSò(B}:ÁòH›Øa‚Áeyµ{«ÕÃÎÝQû¥^Ú¯º^‰˜K$"`­ÈH °¿Å"Ñ÷ ÐQ2ϤÛ"â‰#Qcý£à°)Ñ“—·Z"‘}R m€»u 3oÚ¼=››yÓBü°!\çEÈ$¨!ÕD>š9¬‡Îã1ú~«E*ää­¦p(¢OJ¡ q—®W‘ ìq§Ùyøá$Lû³dkЈ4Ë¥’´œmp"švóbT$Xf/–ê­Öˆ"Ñv‚ hy÷¢k–+>Îù¸9Ìa{JdÞÓ㳺<0%¼I¶E –ÔP¨¯sì«w¬Å‚xÛM‡,Þ7äÒ Ø½5’ºE䆪t§#}XLڳūP²;å>çK¾±}$vk39#­ß8Uiÿ†­* Ðr‹þ’S/bo½£äóÍåE€œÁÏèØë–OhÅDèó{v„’Z( p"´¤1â!ÆV‡'á±OJ¡ q—®Zž"?‡œŒDÆgó.j…)ÜÖ—#þLXF£E–Ž8H·!öy³xÛ ðkô-95%öÖû¸r«ù«n÷§8paV‹.{³ZxÁíþ¬æ8s¹ùÔK*ÜŸâàã#–îM¶}¹?Ù·äÔ‹Ø[ïrÔSÎ3Ÿ¶û¸v`'kõì5Âò“?Í ©¢j¹ƒÕ.€Ëø†ÐjŽm=ú¤Úw骯-ÙépöX2Š}´+óTùD{­Â3gÅ‚­Êi“V;«&Dv#‹ DP—ûV“ÛÓì“RhCÜ¥ëWpVò£ú?ªÿ£ú?ªÿ£ú?ªÿ£úÿŠêŸ"¡8ÑÓ™¯8ÈØå…c»‰ÓD ;fù’/»thè #ät½¶#K•mwºVß”S/bo½cç÷üÉg3³|ã÷0vBø–%‹o ï´­™ßõ…Ô¢ø…3­ú–¯(K•3BnØêÕc}J õˆ»t õg;á/i¸ú`l쟟'|êj2–h’úeºÔ’‰…‘†«8´%»i¶Ú#Ò}ö+I¸KW©oìíÁbt$µó¤ƒX±ÊFBê÷æRKWD‹ðB0*¨€«H†C«< >)…6Ä]ºÊøï<¿¬tö“±PGcØ©ÈR±ˆ*B[íRûp ¬Uýt›ë°5Çu¸è&ã?¼”Äà ÎÌ® q—®‘RÜÎÂ:â,«Ñ~b«ò´ ECJqr üÅ|C’£@§° Ð6~MÎBü0°Åê¼É)ü}KNM‰½õþ*¦Ô³çé ´‹‘u ]-øñ†E„†lé8.:á@$%O“17R 7ª‡Vgò¡OIMá.]þ'Ý׃•i&‡3z‡9»Ç%Yq"ºŠèŠ |âšRƒ‡½¨RhCÜ¥ë•^bJÕàÉTÒê [®MŸ!²TœînL +©%ñb¨r«]C2[öXÞj‹(qôI)´!îÒõZÃNŽDV¢’s®:”GPPý´9¥™´^rÔz–TŽJä$ `ÏInõ¶AiÄõKN½ˆ½õ§xM/•©6“2† -„¡lrН¯äâDiŒf‡vÄ™sO­zé õÉÒЦ!_òÒõ ݰ8Û;tà ݘ°ËÐ!ÂUHçyÁ+B72[ÅOÁðÐþeûKèÆ ©Ç×W]ã;Æâ2²ÇÅ9:Ëatcž\"tž5Cºí „8ÖªòÅ‹gß½¼ÕêË$û¤tð3™ùUׯbȘ z²Ù` T¾î'ãy¾vþjdž àš¶ùSRK D‚Ù`4Ô¼ž|yz«M«°ú¤Tõ­w~Õ5ÊŒv|ÎIÕŽ³Y©ÚÄbñ€pP‚Ò’Ÿ.y¶²`Ä%߯8 唀=ŠÃÛå`È¥°/zË4BÑ0)NMVb![e»CYhò€c= bú¤IÆ@Ù?ຕÜc«Ý ù°OJ¡ q—® ÚPûZû0,Áé´}¬!Ô‰êætØQFêïÊ]‹“E‹\;8GLœ˜1Yxòøæd±»ãªŠšfùÒ_zUýwÒù¥«&‹ŠCÊ"÷‚sêñj'xƦ½öå”Fżä¸RXRENçdøG‰Íªà¼œÒqë¾äÔ‹Ø[ïIÃNŠ‘ÆFâ?²‡n&*"ôÐrH§2üòE¤IÛ†VÎŽK–©ÆV“R4Ô'¥w·äüªëWò!ü¨þ¿åé»Õ`8³„NßqJ® £oÜýÛp~ºœÒùé¼ävccBÓ:‰8ŒkÙ(MΆAè@p‡:w)U±p¡³g]ƒ1=m÷팉:Hvtd¿’Úƒp úu»Ìºnæx›Õ[­q'ú¤Úwé^…ÇПv0üq1ìlØòÄê ïš='B®‚Ç´“4[* p$R\gŒsÂî\£ÐÔ*ÈU jCÜ­k8xN†ùP„yž6ž:Åü-KŒ@;Ï”Ôê„1<‚ŒngbÄÙ­[jµkw©>)…6Ä]º~߯í+>.FÁ>å* ŠË¡\E‰Ø0”« ´˜k©hx?Ï#™iÏrñ~(W±}‹ÈrÆ6 ãóÒ5‚Š´üS¬¨U‡Çò±÷B=&GÍuáhw©C¸ü `0M¸®<¹%BŸîé“RhCÜ¥«žþ<&ø° éEæ »o O¢‹Ðsjbœ§˜÷õ¢òf«zQ`¤î8¤]„LÃR©—ú«®±ßFe·´|¿ ¯€ªVpÂ7_& í·ót©E§ '"E¼ßaàÞi✔h5yj-û¤ÚwéžñS?ÄB‹>.FWÕ¶CÙŽ!»Dø€©¥Õ ¢é{Ãâ0„«v([­~](û¤ÚwéúuÌ<ݶÝ+EÈÆd)H^V¾üĹ[œ ¹0‡–W_„#‘Z½Êê£OJ'oÈd9~×õª,9¬,ôpcnšç£°Ä¢­C‰f—7æBjG(Â(Q6 –¢.ḭ¦8LEŸ”fÚJm¾ê+BÅz]}E€ß‰Þ¬diÈwÎn2'VH7Óª{u¢zÖ ¼Ó¸Œk´ê×R«Ï¬ lTýœõU×pÆ=ë^_:Òc#›÷kò~èÍÊÞ=Ì®$†¸ÌĉXq¤ÆÔÑDº³Wó—¹­åÎ|=ÚL-¯®ë¨ú׬,è]õOTîkå¾ÀéTp®/UÿšyÞ]n•JK*ªþ‰ƒé™XVõcÛWÕ?ö-9õ"öÖû‡Tý³pß™OŸ£\ Ù³jR"<® ¸´q/kUßbµóÿ^…ÛN§l„¦êU] mˆ»t­v·H<¯RF±(¬ÝÅ*åY„ !…——¸ÉJãûÕœopR•ò,Bvh ©Ô3Ü¥kLo'Ç">.ÆÆÊa÷ü­„©Þì6z¤)¤í¸}… dL”A5ÜX2& èSRhCÜ¥kÌX1V8âѸÛf(κˆðƒy1lXĉ¸ªÆ$å¢wÇU¬4hµz„*û¤Ú0jðÒ5ª’Э¸Ü,YêéÄŠ±ì °!ègŠÐ?Bj½ gļ4¨žÜDñ$´ BëÐ )Ô#îÒ5O±ƒ¬kc±Ã,nŠ“•…]HšÚ"ôé®¶3uN¿†¬7¶ªÁÓívŠ:×0"Ъ§F¨Ï¦ñR¦ã.]cmœ¸ÜhøÚ8q£5–Ãf¶CN«-xE [1 q"r$E€‘p%,pI!§U„¾òRhCÜ¥kظž„í6n†7:a¶ð$¦=§ÒÊ lÓv¢Ä}%`d”J.¡*ZM~G(û¤Úw骧¿X´_÷“Ñq7€ïFé&áq!ͼF 'ZÜR™¹+/ÅqEŸ|qï€ ¦ ½ñëEµH¥gÙa7Î|c&llƒ?3&Kà¡ï1‡ÔÂÖ…3­ê§Û2ãznàz%´ Bî“R¨GÜ¥«ž~·%$ÜdÀQí÷Žux/x¹ÆôQ:’K¶U¸|Gb¤æ8+J—kT­pè“R©g¸K×ðQ¢ðØî£<ŒOp±hYÃ~ç™#@ÈG¹Ä8û`”›Ã‰îŸ.M¥Ð®!‡­¶ÈgZ¬ VªkCÜ¥«Nø§9‰ªí×?nR»ðÞNöî‰T‹#w´ÉÏ@ZŽUüFXq²ÙÉšSÒÛ6 ‡Šì›rêì‹ÞIvÄ¥÷Å(·ÓØ^qnUzœ ôæÒÎËnFsÂKï‹a%ô…ÃÐl5ÅV°pâÌÙµ!îÒ5¦¡ayº‚‚ŒŒœ}"6F‘ë¶ ¾§.5³ 8)öØÆ8é“[¸¾±ÈZ« 4 ÕIµîE×pX₾]Üa‰;wò‹ ®þÃ…5Y„¼)¤vE»p r\.FªŽKмÈ"ôNKH¥^ª¯ºê¤gâ²µé—䈃Qxìk)(w\ 0´7.¸‡ü±N°±¢¦''ˆ3ì†aqsŽÚžŸ ¾)§^ÄÞz‡5ÔÚU:LŒ©„CÜZÆÓ„4¯ÒaæŠic‘´’ˆ´22,€A8\nÀV#§Œ}Ršu‡G~Õõ2¥mØ)[Œ‘u·AQýVZ‹¶È6âHô+茥º]Å6⹪վâ: ëSR¨·åwéa×ÅuezØu1×í©xB ÍMbW V'mE£™ƒIR+§ \§¯¥\é÷V®¤Náº}•lÄg*°‡KMá.]#lW=®Ûã|¢x<ç†sÌ=o[tšz&­¼&r'r¸¾Á€MI¬M¶¶(û¤ÚwéªÁ“ìØb*URŒ…X߬‡Æz"tÂQBj%ø…1£^cÑ·¹7Í[t!U h!…6Ä]ºÆ6ÍØëqsé4ƒ¯!¯²›µ™QÛ¤Z˜jq©ÅÚ 7x_Y£u^.Ó—qZ½&ܪ­zqmˆ»tŒ‰‡5ì‹1-ueíÓÔ˜ØGXø(=§Z\ZX$Á q–O¨úÁè–{F.[b«~ª>!¥6Àݺ† e"8¡» …lðœšNŸÌEøzeÆ•¤fƒ ·h†´ðÜañïÝqÉëDè¶6ÅöW]#eèT °`‚‹a~ ËÜI'> áPs‰Õ8CºUX`9‘£zßf’í] ·¶î=_"´Ø!,dÐÖ«®‘-Tú \ïòA€ÑÂd1ì«« ÊákQHí¬L8Wå0 R€ËXÐêµaFŸYUŽ6Ä]ºÆØßVí®.ûÛÎdÊRÁ¾qf`S>G„´ð€æàH̰TÁ +)«´nóVýÖyõ )µîÖUÕþ\%B]À¨ui5nÛôSkŠ€2¬N¥Óʼn›¬‹æÕÏ&cÊ-de°¾YïÞjŠêgè“ÒÆö²_uÁ3-'¢7<¨1ÉÓöŽÚ”8ûo"4"jHm¢DÕ!¸EÕ2«¥Oìì­!Kª‡´0Ð~ôW]_XSÙÄXga4gR¶R·Ù]M[Ù䈢.*âäÍÚÔFšŽ:|Ü"Ü•]*õÒ|Õ5|Ïço%âܳ•~cdù² cá‘Nî> ©­Î´êîC«<^³p'nqªUî> )Ô#îÒõ«‰R«vº/õÉ@qÞiÅq†V>S¡ÈN.Íç‘G¢¹údTTþ® òZ-Ì>!¥6ÀݺJ}{v³y¦öž±,h¡ðÞެFŸ¤4!ˆ•ÿÀ¨º»qà ¥é­–¨ü‡>)…6Ä]ºÆ§{nË¥FñL$+iÆâc'ù¢Ä÷ˆÖ”¢º5q ®`0’æ³76¼ìH¼‚¬OI¡ q—®ñé?WÚ±['#¶üÌxw—á~;¥Ïw]r»Ò± ÒŽ=#9 ›?`Óľm§ÛFô-95%öÖûŠ:² ´!kÃÎHÏ8ÜSu‘ÛPE¸=»tŸ¿F8ÃëZ:#MÇu”Z4Ák¬µâR©ÇP,×5â^°Mïö‚kÄ[G?¼1HH"à ¬LýÌ(გÿ­;1Ý9žµ‘ÝqEì+³8´†±OJµUýU×PŸK¾jí‡õrÍ>X¨÷`©¤ô'ŒKn—¦9Ö)¯µKÎ@­]b;jí²íîµvÕ7åÔkxÞm{°>”+Ø5ëxg;íå…›"üK i?žcá@ä—` |ÔS¸±lÑDh=î!…6Ƀ-¦·ú5,h竱Á¼š{€Úäeéø`>¦f~È%†¼6¿dÝþƒVõÓiŸ×n¡x[¡-[ )Ô3Ü‹®WØ5v1xp%:OUáK]¡Á“CÚxMzNÔÙìÚ£´(bi„¼ ߦ‚r½k{$Ù¥ºh5"pŒïVfá]'c:®i8!œL%‚Ùgà٠wóUWí%­dÓº.qƒ—±XóBÂÔ³SÉ"`¦Ùœ"i?sƒp ®K\ÀðËXP‡&oµGi6ôI)´!îÒ5|ˆ õª¢¾4îûm¨/{{ êK'ò!îZX¨p ÂL#â܅3§®ZMþôÙ'¥Ð†¸K×+¢ZIu‹èaÀÛha‡v›I¾cˆ9ÔCj%„3­únÆ|{nòÌÔZ׉ªõ9ýD5UÇ]ºjìë6?QÕÍ! δj“žRPEhšÎ!ÕÍ!Ê]lU?#UÇuÏe!ŸE ©ÔKõU×Ë VDm\fа’kvЉ²=þ`BÙ)·„vÈ‘Ÿ*,)/&LNË‘œ(ж›×“Wß’S/bo½¯˜,ó—z¼‹dµ¯b⤫ˆÐâšCj‰'‰¸|Ë.QÍÛqIžß"ÂÄ!…6Yþd×U§Ãà f•¬+¨cÕóÏ)ìq[=ì¼Ö)œànÔ‡…ü1WN¸=±¢|‘rN2SMX[8¼í$ûÏû¦œz{ë'݃Y÷ñtÅ[¶S‘srqêëˆÐß±]:­F4q$f¤V‚1p¹Û¦Ï­ouø¹û¤ÚwézeS›W®ljcð äøY fg«G°JÌÝö%µ˜JáD¤+›Úfº<„ÃÜÂVcúbŸ’Bâ.]Ã=‡;zܨÜ¥‡SÈ4Œž,ÂäîRó bEÜ~™M²J"¼æ&Úz—áRh3åžs]¯àe›¦JhU›R3‚o¹EÈt\!µê;Â0 2݉k–=ÍV[Ä9£OJ¡ q—®±"Ls÷ææ+lž„Xäð,«ŠðSô6e4'¦û’¶®†)Íq·í Õ;‡ÂšŠ=»6Ä]ºêÓ-g9ÚM'ªbX­+Bœqžï°äTøÈ,}UR«-¯|(FµÚ~ÄY5BµêeÕ'¥Ð†¸KW}º6ÒÎý–5G޽áCE'£0Ó2¯7)·Ò.ù°aIÅUÁI=°6&¼í¸þK}SîšöÖ;ÂZ±“!ù©Á°âfnÞÙ%BçFÛ¥9q$J¡#£J pÉŽ¯ÙjŠòè“Rh“UûÄu½"Ç—‘ŠãŠT܉dæD![†´Ò U¤bý2R±2‚L¸„Xhõºý}R mˆ»t½\æŠ\—«ÑÜ‘νSv¥õO|¤?Ži;~*á@ÔØƒQ°‘®h74Dh¯4C mˆ»t½2JÇK9O16âðò‚K„fÑÒÍÈvM©õ¥œçæ‰5‹^Ïí;ÑêUÎ}F±Ïá¸KׯĩR0#@ [¯rÏ+ùbÇå d5ö}/0Õq#lXý¥YÅq…sÐjqŽ}•ãAHÂ*¯º~%OÿGõÿ-ÕÏ4F<¶2ó6º) ™†—%B£t†‰+Ä5†ã̈8ì(ò¼×ðg£Õ%3÷0ß …k¿êú•<ýÕÿQýÕÿQýuõÇVÖýoÎØ¸åÁ¬“·­Y˜ª+ÿâ [!­,¦D_²>._ØP¹@áܶEÈ™”BªÜ޲_u~¤ ª61 y›Ùª“È"ÜkRsE'bF:!Àu/ä!B“æCÚ •,q]ôh±GçÊT™&Á1càJVÜ—~N~‚,1ÉíÒ0Ç:å 9  ±V‰ÌÛöBeÞ7åÔ‹Ø[ï«N_² #ö02"Lìüaë–. BNááÒlŽ8âHÄðcmÝaòàÖ©Ö*¯š6Â]ºÆÙTÅmÙ:^qc6&UD|óÊ’-Bóï ©y»„‘¢ž·1æ–ÏuYeFmúfRHMá.]£VY³3iLrbÌG±Å{úÈ"d{¤NKG"n2mÊcE&“•ZsÜÀ‰"ZqÞˆ>‡"IÚvÜ¥kœ1Ÿ¸Öê97d ¼oXÈù„;,ä|†;,Ì]R €Du»›ŒbÇÈÄÁŠe«aã²Ï¬£dåîÒõ¬4yŒ”{¥«EÞçÐK+I±’Œ÷JS,|ÅåvÁ¦°¢b¥«±\IØöµÒ°oÊ¥k¦Ýzÿ€•&'\!›"0Ô9Ÿý üÅq½B5#0@ᜒÛñNy`(8ycJ63mƒÒ¤bÍ”C/ao½Ã“HÓ2»'q™©;}zÑ [ŠbÇP©!E]]âTº×3Ç»î€ËŽc9´z‹@ŸE A«:îÒ5¢ P%Fe%ɰÚÑö)˜Sr!õ‰Ð'4]:UíàHT/+I†M‹ÂÙ´¨V³—•dŸ”Bâ.]Ã,Mf­÷ˆ§Á©AƒU¸â¡u×y§j>2„³F…IS£G< ‚d†—‡nŽÙÉvãRÆ5% †¢Sx¸Ùì:ɳ™|ÄŠò Qœ3Qt™Øa ½j{D¾/û†\zM•í ½¿,%î§*%~4óToÔiîÇ>%ÁCªRâŠÙlU¯¥Äût\Rèøq8Pª‡>_uzÛ;¿Jb°ì^$j‚e «!Bê÷ªb¼£[•ú˜NXWcïì­&eÅ©OJ¡MVI ×5jqŸ<Å‘ôøc [ö¶›Å &ä¢í*J›ŸUCn÷18–TŠ<7pºÝ>(ì©US¼mP>J[È¡—°·Þ1A¯0[&íÇͱÚ忇ɶ™JtÑ8å6QÈO¹ìîXQã.µm¸Û„mpÚ±ív׎ž—œzÑUwëKj÷æKÝZ^ ¾³^&N¡õ«…Ô£ì|î÷ö†Œ¤¨¶w6 Y­‚ðo-¤Ð†¸KW +[Ù8Aç„ß -â²OjRÞØaø¥³ÇPB^PO‡Ø xï¬s–M`ÄžRÉÛõY^KN½€}Ñûë°:–ú  ¥`Vcšcþ.ó÷ØS/‹–“ÔNÁ„ƒŽŒ‚r"Àa×ÌVcбOJ¡ q—®_ÇÓÿ÷­>k2Â'tÕd–õÙÚ5~ÕëG‚ð ©KQ!RÙÙ ¢N) רn^ã—‹·zÕ)]¼5*׆¸K×rЖŽÅûrÐFËÌçiæ¼z9h³òØwÝñyÒµ/ÚÈñòùR7|}qІ¾%§^ÄÞzÿƒ6\¾>z„m“cEKλ)ð}5ØŠÙ)Yé’ÜÁG,)¯ˆá¤¡ ÛàÖeÛ-ܾìréÅÖ[ï¸✆ø­‚dl»ÄƒÕ”6Ý)ýì!¶B'«±‡ÔV}áŒX~Ÿ  'à†C+[]a;³‚ÓÒùøQoéäÜu}mºÕ:‚-;‹ŽÙn±`¶E¸ÑR…~ö(mÞt«µå›+½’©x«U…ê“RÝ%1Ç«®1×UÛµôís]µKÃöw8lª¶Íu+¤S>ãíDv A®†k•íU²YRH¡MRp¬ëªÁƒ£%ÔUÿ¸9LÙf¦¥Šr´åÛ¤KnáŠ*‘JŽ•s¬TÞöu:ǾÓuÝ®°/zGŽ0î8oQ0}Zj».=gÆ<Ê¢U§4Ç–Kn™‚‚XnM‘1ÏÇHàY¦Ú¡/¬… w©+ ’WWL/šžý2‹S¶ð6 sØŸÓ¤ælB8•$¯8w'¶êfs•NgØÆEX³x½íîÞõ ¹ôöEo™`Û<2Ù÷ˆdàëânÝóYádÅË&ê Ìøê½ªžˆ{D0’öz žÿ¢VAÈÿôI)µîÖ5Œù+Ü/›%'ãÖX$~—ŒcB„ð€ÒáÝyAobEyUbqN©ÚâØ¼°º mPŸ©ÉºäÐKØ[oy¦'J¹÷3%|ÜT‚h á¸o´mÅhòé Uò!ïQ%ÀŠê>ÿç¸4…µü%o»¹;T}Sñ…Þ‘.†£‰ëò&\ðò¦Þ¼^z96ø™U….©“ âŠÌj<ãXI¸1uÏHŸZŸ’&”¬ôªk¸’nýú¸æÜ°9Ð*:áÙ®4¡Ùs„Ô®5DSå$1*FpVŒA­y¯Õ'¥Ð†¸KW¤'d÷|±àldáŸi£ Û#·wæð”±fƒÔåX£„uJYcâØi©c‘Ô©¶«'Ž©oʇ\±†½õ¾J¬7zþÆâ@…µ ªPV%¤vצp#€c%´ ?µ>%…zKÅ…\×¶š6켤 `f‘­¨®*B•ZQá@ÌÛ#UÇ ]ZE|æ—ØÄõR}ÕõìRÎ]nýe—"-,x؃0,~õ%HÃ\ç.·˜eÇ’º‚4Èa° Ò˜ºÝHÖ:û–œz{ëýv)­éRnUg[!†û;›ÅIŸ0ÆêvP¸‰^rÛD:–Ôò²â`OClÅž†mƒÂ¯Ñ·äÔk* 3ô;yô+´QŒŠâ¼nl˜/"düæN+à@ˆ¨eJj’‡S_¶µLÙgRéÞÑwéÖ ªr÷áÖ *ˆ7œ—ã.ÞŒö%â3743¤…ÄÛp"E­—Â8±1„ë w«Z«ÝãéØ'¥Ð†¸[רº¬çãbàXxYy’…+â—{ƒ@Gv2.©u!ˆå™ýÎHI¸i6![n|²OI¥^J¯º^åç‘ù«{´Äجˆ.ÆÄäb }‡¡¿E|款Ä8:DœˆeÅ`´í²]tÍÞj²êè“R©Çýë6ËqŸCÒåF‹ql8&ÅYÍÏ6œ{@§dŒ´KŽ“aI5ýÁΩV`RØ"×IwJûÏqÉ©±·Þz÷ú¨f‹36nÁÀµ½GkC„ïÁCº¸Íßã"Ò5ödWTÝ—\èOOvx«G“ülWNr> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 357 0 obj << /Length 1468 /Filter /FlateDecode >> stream xÚµXÛnÛF}ÏW葬ÍÞ/APÀu£¦EàµQh –(‰­Dª$å4ßî’åU4i¢½Ìœ™™=4l&tòý ~¿½ñr.Õ„I"¤æ“ûõDɉá–Pa&÷«ÉΣ4¹ž –,—Y]çÅf:Ú$ߥM:ýãþÇ—sÅ'Œ§T A'3.ˆeÌ#ÜßS!V9þŠF%Õ±ðƒ¼X—Õ>mò²ð@ÜMqšë€Ã,Özœ_ŽÅl—=N¹M²Ýt&éX¿]¨KÜßúYZã¯ööpáVé>k²ª¾‚.’´XÅtØeç¨S–b™ã‡éŒ›$§mL²³®Ê}X‘a'’\a¦§¹ËšÈÙ…!Tõ’%˜T:ù3'–Mçô#ªNfpwD3 ñjoÁ+ÃM ‘4Û,æŽ œéÎé8xÌM´q†ì)sR¢Çš*–d‡]¾ÄAÚduVJ¹íTàZ¶%Ö&«úU0 O¤g Ü•R‹ Þ´Jß@X¸ê\O]×kÈØÆ, ˆÅ wl Ò&…c·}F!dÒ%Ëýj±Cè¼hƒÙ¦'Êi/ÇÛ¢É#dWÈç^$@Aú3ð1¹ûõvQeù%9éõP–u³ðxh8*« ˜sÉ&+ʽwÌAµc¹ÇtwôÛ³ñ¾î‰61~«cˆ³Ù;ÿ›ÿ|wµ}s‡NÜ\Íó‡ª|Ø¥uS©ƒÿÕb[±E]ä‡C† Ù4\ÙÃ-îf±F¨a­Ê¨ÁÈCº¿ '^ä-[T¸Ÿ¼γƒnß¾Ãý9.{Xig×[ÁHù(j!‘„ÆâÕߥWr„‰>ï·ªÓñg÷Úêh{ZOŒJG;Kaëì†#–¶æbUÒÛÅ ·ã*i ‹±-Œ\ö¥B1ÚϨNÖ96HDòÍrQ¤ˆ±ÏÎàC½À|$!“'e“îû´®CÅy;g×VIHæïW@€¥0¢ÃÊÆ\ƒÌ)Xü†G< ÉN ÙI©¹TËÊø¤œÄJÄÌ>ñrXbIpU&FI#]¬È®ˆã²s\ÖáÂõIq¡O„éË£½5ó¶±Ôuç>êœ|kk´1*fH ñÏ1ÄžÂ!ï`’q&|}0J¤:«ÃžjŸO¾MÛuªÒ¬^¦]ÊfÿÀ«Öpza ²3m¨vB†¶NaßRm»iÛP”•Ö˜ ÷ƒ!­r†>‡¡û‹úaU¬ƒô!M/<%Q?åŠ~&†Šûa%•L08\Ò Yóƒ9+ ½€ã•fèGó©“I–6Ç*«_^t–gˆ¤é­Ч„’[=&”Üà}aГ>œ ¤g«¼òÄl÷Ñ/xØ F¨—–@õŽYàÀ¥Ç )ÚS¸s·Xã,Ï@m±>üµØ>¯EO¯"0Š¦ÎøÝ<&à|Ò<Ö[k9by,b4˜Ã‡É@˜Ÿ…òb 4–|ó*¼?”.ĸðÊ*ÆpR6°àO䛂".øYf«a+våòžæ]VlšmH™òÑ?Óé¦ã”ÙߘA¶nÒª L(+Bþ|ÈW ßfÌÈÔ8cðóãcÖˆYËúÓ;º½/ ZƒÂ^ 5•0ι Æ…’ž÷/±$M÷CgÂÛ¨ø'RœwC)© D€Ü'’ò‰aÿW§'=Þ@c†þâà‹%|²°±Æ›ûÿ è‰ endstream endobj 363 0 obj << /Length 1044 /Filter /FlateDecode >> stream xÚµX]£6}Ÿ_Á#Q…×߆jºÒvÚ©ú¡™J“‡Jm…X™¨ d€l·ÿ¾¾¶ 0dWI"E±¯ísìëësí`oíaï§ì~¿_Þ¼»Ì‹P$©ô–¹'¸§hˆ0SÞråýé‹E ¨ðÓçŠ|KH¨X@ñ£H’E@%åþÇEÀ¤²m±í0BE$Ú¢¢ÚJ„2åÅßË_ôBP$„å’çq1Ž™+rŽ#= ìŒ-Áˆ‹pÈX7UR¬T]ª4³Í{WªÓ²rÅýsRg®ó¦.ó²ÚÅ›•mË>—E\vaÆYeƒ1J=[FxäcÇYRÝ•0hµ)Ö–¦ÁQdש—` ж¼{|xбýÀ0X²RLãŽx”^‰ŒȤ%cW"cc+㙃ò K ~¤ë±¾e¢sþ—f¡qYë1®–tHUþ¼êv'«›b›ø9¹ŸBy›Ôu¬§à‚~ùô¯«ò°?†úÝO1tÔuåc<îLRLpñ¹BÄFg€áƨYCÿ»…ÆÐôšªUˆÛ‡ïÇbŒ^Wc÷*¸|€û2†û2kBá÷©°¼ª¼ ê˜è­³"‹‹d—è¢êâ”'é‰vv¢Ÿh'Úå«v7y/oêÞT÷&¡íýÞúÖòý?»Û ÿéÒ_Ú¥`®¡ò\ÿøŽ‘:˜ç,Yµã4  â&ÒOàŒ ¦Äp6Æýíñ­“Ý~›™lvÄ&T˜¤Ó™´,òøyã’1T¶¥Ý·{ä¤ÿñÛãog¸ß˜TX•µ 4µ“."ÁˆˆÀÒœî“Ð$yQŽíHŒl ˜>þ"ƒÛ‚2êØ7̰ Å ca×`á¯Yø‹½ÑP¦:⪄ENúOr‰×\bn“xhv )%ÂH ³OÒf azp‰…˜‘’ŽO^ăcÒòrHŠ&®›¤„CíŽiݬ²O³j£3%÷u+ bfÙRM¨O׿7ʼnèù®¼×ÖÊH¤’3›8˜³>âÔ„@8zXäôD&ÄK½¯*Ûßi þmà*o$ Z¿VÆìţŻŒ’QÏq»I“&s ë½ƒ êÉ¿q^%ëúÊf!>6¶ æffž OΔ´9¸‚¸ƒrž¢CòÅ‚vš„™ÏYJ6Cb_‹ ‘ãÕù, û*Ÿ‰Ñ¦h²ªH¶q Ài²ÍV.6Ý m6÷ó~s—ºçÞ›2¤ú}ÃdS† ­Ö¦ÅFÙ76Øl†&ˆ„DLˆ búî×é5üt&S5WÁYu<ƒ°ÈÜ'$È`k¢œr4äJ ÑÒŒ‡“ ÷†àãc`:!Hj§·"¡Pi rüûäÝ=z‚Eá%¤B ¶8÷‹Áˆ—7ÿˆ endstream endobj 367 0 obj << /Length 1064 /Filter /FlateDecode >> stream xÚµXMoã6½çWè(c!.¿IA6M ´ER >Ø-­-ÙB;kÉúï;CR¶äHŽ›=&¥™yäÌðñ)4ZE4ú튆ß_æWR’j®£y)n &š/£O±ž%FHSB)%,v?§GnÊ5Wa:ûgþ{Ä(‘ÊF c$UÊ*ʲX4ÕK‘a”M±]5ëY¢À±nòæP;ÇdÈ“ž5"¾ÿ9 =üáŒiߌO3o˜io&§ESÓÌô°ä^vrNœm…wúɧgUl ²Ø¶M}©KÜø3UßÔ8XÊ~þ Á‡Hë"_¶~ƒaÔÖë¬#¨°$é¡gV-CÝò§ç/ç6*f‰`2Ýê`—ŒÒø%ßWùvQxûŒöM^ákÿç Þ¢œíÿþóá&sÜU_Ðs¿û²É릆1l&†õQÃö!1ÛÑ´ø@eûŒÑB S#­Óäc€Ê¨Nß«cÛ#^ï;*îápöñÄÅ“çxò2K­€L…ô¹I‘´U˜€§ÎñÔž€ØãÊZކ?dFa ”C§UŸêwN(Øþ.—Uý\ìëj·my }:\6àÃŽ{fÄš{Žrš;H=ª•ãÌ6ÁøÄoÁ¸-ö…È¡|œiXuúæªõ¥…L⼪ޕ»ý)Ÿÿ}¤^'8Bî oŽ´‡o¿ú‚;z‘r*÷×ýù«,óô'YšÆaÅØf‹Ý¶ÌÖ•·v“ÍîMÒ›ß<Ü?fmÞ OÜwêb—]¸*ÓT г„ ,¬Œéš{Á‡ °b”„ÿXà CÅ—¨í†ÃPƒ)8Ýn'‡;ü$åúÒnä’|Çݨ õ}îz…¡0wH. 1'3–¡ƒ…~HmƆÔÔ×C¾m2Ô\îþ¯ƒCÝ,‹—‹LãÎ0 ès%ˆJÝ:íè•zt8æaü:ìׂX‹Á•c¥3¸>•pêBtÇÖ]E,5ŒèÖ|º\[Vey,q 0ú5oòïÖkË £y¿ïTkŽR äîºrOyO‰{ByÉ7‡"c!k0sý‚¶ß$Üàn¡qõ×cˆ³¾}¼ñV÷ó[ ù8G!Ê‘ûÃÈV H#¬vÚc¢l›‡4Ó¹æ}>ܸ#& ·‹8$ÝÛû¸'q¼³&)ä ÔTµvÂÕF)b¹è`hCe;ú@ùT‘6=y ™pŒ£Ç“7D]›ÝŠgån³t½¿XçÛUàš¢F*ô²-pÏsæ?\²_Ãì1ºP‰r˱š§ÜKIWC˜€ítÕ³4JAìN°Ó¥1BL<|\u¾Â ¯3Ñ~Ñ®ÌeøÑæ~ã¿>Þñ´ÃW\B9ðU ToC.uÏãv~õ?ËoÒ¦ endstream endobj 371 0 obj << /Length 1302 /Filter /FlateDecode >> stream xÚ­XëkGÿî¿BèKV¤·Ù÷£˜Bc¢BÛ¤˜Rpƒ9K'ûˆFPÿ÷ÙÙ“NÒÙ–Ý Ìícö7;»ó›™µèÝöDï—3‘¿ï/ÏÞ ­îEr½ËIÏšžW í{—ãÞ3ƒB9e˜äƒB2½‹Õ[-ô„0ܲÊ2Á…6 »¨·cJŠ(•|½ü4Ròh-©a-Md‘§’[Bf …â1h¯«·Bì4¨`<)Á1cØÍ§º´80D À;Þòv1Ú–(£ƒ2^ zé—ð¥àƆ}%«úv^OêQ9G¨u’+ºeÚvdóÅÞ^ͪîÙ¼V?9 f<œÈCµzä°Ÿšv{ØàªGÓ „•çÞ¾XÌÇõº^€±Ú[VÎÇÔ˜Tåz³¬¨3/’Íð8H㻡Š-CýëòÏAЬ­Ë,ך-&ô]•³ûiEíy9«ò4éÔ¦¥ó@ +ʳïëXYOË›ëf { ŒÍªžßÒðú®Ê [›×àÖkØ4ÝvÚS—UNI»F7y &#×.42“j`%Cð[}J;ØϪõÝü:°ñêǬ´¤ TVÀop}®¤¦U?‘;Óîy>+É΋lÏß@»ÛjNÑf2ÁYhKüërš xW•c\’qUo–D±¿«+ù•`úõç/ýì¥ý»_.°#cdý!BÖ7ËÅÍ´\­Wý‹E§©h ßzHÞÖy‘G>åM œÚ3üFg‘@_eù_¿ÿqq 3Ù?êpˆ¢ž>–4ý®M_ÙnUöÀõO‹-VZ1:Y {½mr ˜læ#Œ'€K àÓZI6)Gõ´^—k„Qн¯ÉÙGw6#Šiý ù›ç÷0íYµ,“²pÔ0ŒÅ8ûføù·Å¬\/ëÞÐШ™»¡…ÔYVpójL½ª\ÕÓj7öÖ ŒÔ<¨-?'÷ßf“Âíá&è*w3ÙÁ!‰‡…aC»7vŽG_ìôpg_îÖ³2e3‚ërèh¸Tf߫ř·ÈaB&ò"X"0¥Çfq;îÜ…S)IIAFN}osJÖÜx• T§ €ãÒ ×eÞ>0¢YoRE!vå‘ ~Ts¤â„Dž‡Ôÿ?¤é‚t 2ze¡’¶)ÇŒÂÔs¬¥ÊI§2Ê‚Ûêvt^ÀUéT-3PZw‰º¼WÉ­ÔÑfþ1¤áÑxÓÏ”–ÉÉÛ•ºÞO¡âZ焎,§${(J¦› "ÑŠd‰ð)í9n@¿¬«ï)’Œ·e§²@gÖ“]yÉwIžòöýð€òû,VÁ‹Mf±:f1ƒLÆóB6Ë6b"dª¤þCŽ¢ xŸãÅ#„öxúZdÀ¶Ì÷ˆô¾N— ˜:´—¢yÜ[bKOĆvCõÔçQ…€Ð®qÿÆA•Œ2í å…DO»ãÀÛ6|žH¾úB¿Ú=OüCèô$ÑÞ§8[: QØ e 'G7#¼ûñÙbEså.xn]~Ðy¼€ S„89&왡áIè£|þ„ âõ&îã·E ⯮E;½¤ÔÒø`×ê#Lî2H›{jœñù;R9É5Ƶ;§øÎëãË\€|z s›+¹‚4öZÏCT1÷tÀG¼9éjŸ2`û†ƒ¯Œ‡ë‡ðyh ?é÷V|¸<ûa›æj endstream endobj 378 0 obj << /Length 709 /Filter /FlateDecode >> stream xÚ¥UÛŠÛ0}߯ð£ k­®¶¥ÝîJK/ ´Ð-E±D4±[Ûa»ýúÎx”lÙB‘4·3G#i,’U"’W"Î/æW·Ê%Ž»\åÉ|™ä%wÆ$…*¹ÐE2¯“/l¶aãûÍCZjv™fZkæiÚú±¿hÝ-in»>Í$Û¦’ùMøÝÔ¨6¬¹Ûµ©*Ø8gå[Z,ÒL•¬!aÕ´MïGŠCD<Ðz7„v•~¿¾ºµò„µr–¢€=M„«ÔN¹Æ·DÌI@¦¥à9`d”ÊRÜó4³ÊNx…ñ|‹;™@žeÕñNX±Bx(T»åf‰LL2)¹³çÈëÆ×S,e@„)ËTFªú„ªs\ƒ"S'K‚ ïgif¤sl}3»&ìÛ°è»BnüFÙ>ø”Ëç7﮿ ü¡³„AÇÀàl„Cƒ.¸qÆ¡Öå0ÚÂ0%¸(P£,¸=²Óstà j¯:‚‹¨SRˆ£ø$¦þ?Ìü1LówLËóRØüˆ)]©¥}š§Ås1Ì”(äÜ𬔠;Éè ‚I-¹-,eþ‡"䦔…Œ'ùTàj©„@Þ-H¡ ^–1EÎHÁO©3¬#>·L Æ'Õ“Ô¥Z±û–„Ù‡7´ðUÕ C×”꬯àfJ®ËrßRÚ ž;Ô븨vwBë—~ô¼^* 4{š S£w ~ ?Diá«:Èwš¶†&¥òœ…%YPÝí"Vc–ÚZð=I÷a\²D϶¾ê¢ùãi¦‡ŽO€ºZ;`ýÇ~W¡E‹âåc‡x`²ïˆÔ ÂöÇ&v¹ºÂ*vÆГW‡Ò}4QÝA‹tB`Éc{ôt´žª> stream xÚu»Â0 Ew…GâÚNcÈŠx¶JÙˆNêÿ/”&…‚„,ÅιöMÌØ"ãø'Ëp2 šQƒ§h‚×z²hAsìÄiJ×J>ÔöðB.k…7^ùñ>+³}ñ( :vpû€fŒIu_O4ÿïÊî³Á&Aµ×ˆqj˜îèYˆµ&ÅtÃóBâò’No»]‚'D%9Û endstream endobj 375 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cuffData_schema.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 386 0 R /BBox [0 0 1117.73 782.7225] /Resources << /ProcSet [ /PDF /Text ] /ColorSpace << /Cs1 387 0 R >>/ExtGState << /Gs1 388 0 R /Gs2 389 0 R >>/Font << /C1 390 0 R/C2 391 0 R>> /Pattern << /P50 392 0 R /P112 393 0 R /P173 394 0 R /P426 395 0 R /P425 396 0 R /P344 397 0 R /P199 398 0 R /P57 399 0 R /P72 400 0 R /P290 401 0 R /P140 402 0 R /P505 403 0 R /P118 404 0 R /P422 405 0 R /P121 406 0 R /P369 407 0 R /P467 408 0 R /P82 409 0 R /P262 410 0 R /P167 411 0 R /P395 412 0 R /P372 413 0 R /P228 414 0 R /P231 415 0 R /P25 416 0 R /P289 417 0 R /P144 418 0 R /P170 419 0 R /P470 420 0 R /P473 421 0 R /P257 422 0 R /P315 423 0 R /P427 424 0 R /P66 425 0 R /P115 426 0 R /P16 427 0 R /P389 428 0 R /P341 429 0 R /P318 430 0 R /P196 431 0 R /P496 432 0 R /P166 433 0 R /P499 434 0 R /P357 435 0 R /P70 436 0 R /P76 437 0 R /P366 438 0 R /P47 439 0 R /P106 440 0 R /P109 441 0 R /P114 442 0 R /P360 443 0 R /P363 444 0 R /P100 445 0 R /P155 446 0 R /P303 447 0 R /P380 448 0 R /P335 449 0 R /P190 450 0 R /P263 451 0 R /P466 452 0 R /P326 453 0 R /P280 454 0 R /P413 455 0 R /P416 456 0 R /P219 457 0 R /P222 458 0 R /P102 459 0 R /P283 460 0 R /P383 461 0 R /P161 462 0 R /P309 463 0 R /P386 464 0 R /P448 465 0 R /P491 466 0 R /P493 467 0 R /P451 468 0 R /P454 469 0 R /P11 470 0 R /P354 471 0 R /P135 472 0 R /P132 473 0 R /P164 474 0 R /P457 475 0 R /P146 476 0 R /P462 477 0 R /P464 478 0 R /P274 479 0 R /P7 480 0 R /P84 481 0 R /P74 482 0 R /P141 483 0 R /P14 484 0 R /P268 485 0 R /P46 486 0 R /P245 487 0 R /P248 488 0 R /P329 489 0 R /P332 490 0 R /P187 491 0 R /P406 492 0 R /P487 493 0 R /P201 494 0 R /P300 495 0 R /P277 496 0 R /P306 497 0 R /P5 498 0 R /P214 499 0 R /P91 500 0 R /P20 501 0 R /P120 502 0 R /P216 503 0 R /P78 504 0 R /P348 505 0 R /P225 506 0 R /P377 507 0 R /P158 508 0 R /P88 509 0 R /P94 510 0 R /P432 511 0 R /P129 512 0 R /P302 513 0 R /P181 514 0 R /P351 515 0 R /P172 516 0 R /P271 517 0 R /P126 518 0 R /P213 519 0 R /P56 520 0 R /P207 521 0 R /P210 522 0 R /P111 523 0 R /P42 524 0 R /P291 525 0 R /P242 526 0 R /P323 527 0 R /P445 528 0 R /P403 529 0 R /P481 530 0 R /P484 531 0 R /P294 532 0 R /P297 533 0 R /P104 534 0 R /P152 535 0 R /P434 536 0 R /P337 537 0 R /P236 538 0 R /P123 539 0 R /P68 540 0 R /P374 541 0 R /P227 542 0 R /P32 543 0 R /P24 544 0 R /P175 545 0 R /P436 546 0 R /P178 547 0 R /P36 548 0 R /P48 549 0 R /P313 550 0 R /P393 551 0 R /P346 552 0 R /P204 553 0 R /P504 554 0 R /P40 555 0 R /P33 556 0 R /P35 557 0 R /P19 558 0 R /P75 559 0 R /P368 560 0 R /P371 561 0 R /P365 562 0 R /P265 563 0 R /P17 564 0 R /P421 565 0 R /P441 566 0 R /P429 567 0 R /P149 568 0 R /P397 569 0 R /P62 570 0 R /P230 571 0 R /P73 572 0 R /P233 573 0 R /P147 574 0 R /P143 575 0 R /P192 576 0 R /P423 577 0 R /P320 578 0 R /P59 579 0 R /P138 580 0 R /P472 581 0 R /P475 582 0 R /P39 583 0 R /P1 584 0 R /P117 585 0 R /P314 586 0 R /P317 587 0 R /P259 588 0 R /P347 589 0 R /P44 590 0 R /P340 591 0 R /P195 592 0 R /P198 593 0 R /P343 594 0 R /P498 595 0 R /P256 596 0 R /P356 597 0 R /P501 598 0 R /P408 599 0 R /P45 600 0 R /P2 601 0 R /P418 602 0 R /P30 603 0 R /P276 604 0 R /P253 605 0 R /P108 606 0 R /P362 607 0 R /P103 608 0 R /P288 609 0 R /P169 610 0 R /P452 611 0 R /P469 612 0 R /P9 613 0 R /P282 614 0 R /P478 615 0 R /P412 616 0 R /P364 617 0 R /P221 618 0 R /P224 619 0 R /P304 620 0 R /P443 621 0 R /P381 622 0 R /P308 623 0 R /P163 624 0 R /P385 625 0 R /P13 626 0 R /P388 627 0 R /P409 628 0 R /P492 629 0 R /P495 630 0 R /P399 631 0 R /P134 632 0 R /P185 633 0 R /P137 634 0 R /P69 635 0 R /P338 636 0 R /P417 637 0 R /P461 638 0 R /P394 639 0 R /P438 640 0 R /P350 641 0 R /P310 642 0 R /P359 643 0 R /P96 644 0 R /P99 645 0 R /P247 646 0 R /P22 647 0 R /P331 648 0 R /P334 649 0 R /P189 650 0 R /P489 651 0 R /P373 652 0 R /P279 653 0 R /P12 654 0 R /P480 655 0 R /P415 656 0 R /P215 657 0 R /P93 658 0 R /P218 659 0 R /P453 660 0 R /P249 661 0 R /P83 662 0 R /P157 663 0 R /P97 664 0 R /P160 665 0 R /P382 666 0 R /P90 667 0 R /P87 668 0 R /P128 669 0 R /P60 670 0 R /P131 671 0 R /P353 672 0 R /P450 673 0 R /P456 674 0 R /P80 675 0 R /P270 676 0 R /P319 677 0 R /P273 678 0 R /P447 679 0 R /P410 680 0 R /P212 681 0 R /P238 682 0 R /P34 683 0 R /P241 684 0 R /P244 685 0 R /P328 686 0 R /P460 687 0 R /P405 688 0 R /P483 689 0 R /P486 690 0 R /P148 691 0 R /P65 692 0 R /P151 693 0 R /P299 694 0 R /P200 695 0 R /P154 696 0 R /P296 697 0 R /P184 698 0 R /P125 699 0 R /P264 700 0 R /P376 701 0 R /P261 702 0 R /P431 703 0 R /P28 704 0 R /P177 705 0 R /P180 706 0 R /P85 707 0 R /P305 708 0 R /P503 709 0 R /P420 710 0 R /P3 711 0 R /P428 712 0 R /P203 713 0 R /P206 714 0 R /P186 715 0 R /P209 716 0 R /P506 717 0 R /P122 718 0 R /P370 719 0 R /P322 720 0 R /P255 721 0 R /P402 722 0 R /P391 723 0 R /P267 724 0 R /P293 725 0 R /P400 726 0 R /P396 727 0 R /P53 728 0 R /P239 729 0 R /P325 730 0 R /P433 731 0 R /P355 732 0 R /P232 733 0 R /P235 734 0 R /P440 735 0 R /P145 736 0 R /P67 737 0 R /P275 738 0 R /P474 739 0 R /P477 740 0 R /P284 741 0 R /P139 742 0 R /P21 743 0 R /P119 744 0 R /P316 745 0 R /P174 746 0 R /P437 747 0 R /P226 748 0 R /P258 749 0 R /P165 750 0 R /P43 751 0 R /P342 752 0 R /P197 753 0 R /P345 754 0 R /P500 755 0 R /P37 756 0 R /P367 757 0 R /P6 758 0 R /P171 759 0 R /P110 760 0 R /P446 761 0 R /P260 762 0 R /P116 763 0 R /P64 764 0 R /P251 765 0 R /P61 766 0 R /P229 767 0 R /P502 768 0 R /P51 769 0 R /P142 770 0 R /P168 771 0 R /P26 772 0 R /P287 773 0 R /P468 774 0 R /P471 775 0 R /P285 776 0 R /P254 777 0 R /P8 778 0 R /P95 779 0 R /P419 780 0 R /P223 781 0 R /P77 782 0 R /P31 783 0 R /P387 784 0 R /P339 785 0 R /P390 786 0 R /P194 787 0 R /P127 788 0 R /P494 789 0 R /P497 790 0 R /P136 791 0 R /P439 792 0 R /P71 793 0 R /P463 794 0 R /P465 795 0 R /P444 796 0 R /P252 797 0 R /P107 798 0 R /P358 799 0 R /P23 800 0 R /P113 801 0 R /P361 802 0 R /P55 803 0 R /P101 804 0 R /P424 805 0 R /P156 806 0 R /P18 807 0 R /P193 808 0 R /P237 809 0 R /P336 810 0 R /P10 811 0 R /P333 812 0 R /P188 813 0 R /P52 814 0 R /P278 815 0 R /P327 816 0 R /P281 817 0 R /P311 818 0 R /P411 819 0 R /P414 820 0 R /P191 821 0 R /P217 822 0 R /P220 823 0 R /P4 824 0 R /P183 825 0 R /P38 826 0 R /P159 827 0 R /P307 828 0 R /P162 829 0 R /P384 830 0 R /P89 831 0 R /P449 832 0 R /P130 833 0 R /P54 834 0 R /P133 835 0 R /P458 836 0 R /P98 837 0 R /P272 838 0 R /P243 839 0 R /P292 840 0 R /P246 841 0 R /P58 842 0 R /P29 843 0 R /P202 844 0 R /P401 845 0 R /P330 846 0 R /P404 847 0 R /P407 848 0 R /P49 849 0 R /P490 850 0 R /P485 851 0 R /P488 852 0 R /P298 853 0 R /P153 854 0 R /P301 855 0 R /P41 856 0 R /P92 857 0 R /P250 858 0 R /P79 859 0 R /P379 860 0 R /P375 861 0 R /P378 862 0 R /P86 863 0 R /P479 864 0 R /P27 865 0 R /P179 866 0 R /P352 867 0 R /P182 868 0 R /P455 869 0 R /P124 870 0 R /P205 871 0 R /P208 872 0 R /P211 873 0 R /P240 874 0 R /P266 875 0 R /P349 876 0 R /P324 877 0 R /P442 878 0 R /P459 879 0 R /P482 880 0 R /P269 881 0 R /P430 882 0 R /P295 883 0 R /P150 884 0 R /P435 885 0 R /P105 886 0 R /P398 887 0 R /P234 888 0 R /P15 889 0 R /P312 890 0 R /P392 891 0 R /P321 892 0 R /P476 893 0 R /P286 894 0 R /P81 895 0 R /P176 896 0 R /P63 897 0 R >>>> /Length 63630 /Filter /FlateDecode >> stream x̽ÝÎä8’¦yîWñÝ@D}rwù°˜ƒn ö´]À ö ;«s ‹Èrj€¹ýy^£)Q¤$÷ЗÙÝÈŠCN‘f$Íìµþþñß>~ÿøü¸?ÎßïçóÇoÃ0Ü¿ß/¹åGnùöùýósøøÁëù¯ÿø>þ Ÿö–~túŸÿ‘Ú¾·ÛããüåŸÿ1|üòÏïÏÇçåyæ/áyû|ð—ûíq;ß?þñKzëŸÿUÿÿþõŸÛ`½Ó>Èñã—ß>žß/ãùãrÿ>œÇó'C{œ?Î×áûu¼0„bbô5Úÿœìo|åùýóþq¿Žß÷'sÕ¤Çknø‘è÷ ~|ܟߟÃãã~¹~¿^™û)õ¯»üÕ†û©)ýÓ_?nßÏ—+âÿý¯Ãùûõréññ}¼_Oý©Ìò¯¿~ü_ŸÐ—ÿ˜Îç…ÿ®ü7òßÿîþüàÏ'ÿýÿý»·ýâþí¿œþúÿü׿қþŸ!|~ÒkÔÎw˜rþ¸Þ`‰­‚Ôpº^¿ŸÇÇÇp~~\¯×ó÷3ü.çïš—?þò1ˆN·!X3‹h}½§èáAY Ñ<¦ïÓ¡7<Æï—ÏFôNFþùäß­ÿ½Üò÷ý‘}ÈÞ@‡‹†4ÇSôà$‰þã1 ˆç$ûÁR¨š~;¥E8²Øï¶Ú¯ÏO[þ£ýÅøs‡?é¿ü9ÕüÉô{“?ÁÑ7ÑïEþŒl¥óCüñS7Ä’jÑÇ6é_þåßþ×ÿúÿù?tDüå_´jËy29‡F+¿–ÃÄöTl²ÇçpóMf˜Åãrf“ ß/gÎ,Ûeçõ]¦§v‰]¤]ûù±Ê–ûð…ù1rìÀÙß>þÕN+<†ïÛýã»ø#è%Øþ?i—p‚ïÞ%·Û÷ÏËð1Þ¾#€†ÏïçÏKˆÎÅ“ŒíÃù‚:?aÄçñu¾,ŽŽáúÖQ|¹¦£wuÑŒ×ï‡çýÝóœÛkf¸ˆ%¼”׌·LÖ Ce©Ï–LþÙ¯§´ˆc£,˜Ï¹qÞž·ç“ãùzKÖ$’<˜0ßNLEî b°žÿ=&¼c—ŒcÁãb²$¸$}lèdIkË6„‰th6®ŸOçÇ÷ š;öû 1 ¼åùø>pb±g¿³õŸlt‰ÄçpõÇIaÔNªôï&…ë†çð}d¯ùÃó¢}sŠîÓcþ>=F Gæm¸«Ë•6Êy< þ = ôŨâ9 w ¶xu8anwI¥2ÆeKZa "±ê¤…ì:™œ¿¼%»–rþ"Á{ù¸!@¯Ÿ·!É®‰ —jü7?³ãì–<ûõ¿|$Uyýø:ai ˆ“Ç™Åõ‰ê×9±ó.¿¡Fa@Ù‰y^?¼ÅrÿþyMƒ±VŒV~:”ßÕRþÚ¥ÔšF´8è‘òwiÒ·›Ô¬ Úðĵü°·?¡Üµ~FÂØó)<„e¡ƒ,ÖBÒùƃgˆ Êö_Š2é,è&RW¤§œ9Cœi<£¿äg½EÎè5ç{ˆºß9µ^ÆèðD=Ñ,Q‚G–ËIÞžäõÂQUQ³Q,ÔDź° %³¥Ù2á³Ø»C1»bw!o°R&8’fJ™©g/if~nÊ@ÇžfJo®t34³5ÝŒŸÊƼa|c^Ž_¥›Ý¤Á뜭ºJÖÎNL:$úí‚0¼ˆÝqÔÞ.·ïׇ™C±¯/ðé"9W4ÿ°€õòóÖ¡KÝÁ…*ÊBÕ¥Û«"TÇUG„f)›¥Á–E膴‡ yh©ÍEè…ÈøO_L ½>±¦V‰DÐu•ú!ã)%HW¶¬…+œçxd,²Ûp³dÒ“Ò#Ìÿ¼‚‚• SjA{Jï¨åö}M‰–á3­¦åaßÈÏ6)ZÑ‚ÌFhˆúó ßhyž¿>A|å)KÉó‘ù³ªþ”^  ŸMiðÙFN‹ø‚?¦A}`Ë­Ò¸mQÏ›ö+DfÑ­ÚIuÏùë-NbnÛœÊ|érЉnrŠâ<<Åç¢Á—X—Js)(´|k^ºÓÜ «5"tÖçç }V‡ Ãú¨(I'y (q8³`×5"a¯ÒõàAçðâd&'Ù“ ¨7ÞæÔÉòÔߢEÄg!KyósT„Züì×ÓœLd2´ÙÕ³{Ϙ¢W Ïf÷Ö ‡ÈcrTJ£€ )‘6ì0õHí"§“ðàÛÿ*ù‡ª"x5Î2th†Í ÿòƒ™ÿÿÐÚº}žO àÚG:ô‹h½dùöf~ôqË äÐQR¿ŸFE¾rÖWÄñ öË¢{…šhypôü5ÑH2¥Eͦj*X¶ÁÚ~Žw¡þýZ+zW­Cã¿£*Ë É ým-ÈO )Wº·¨zP­+AX¨(A Åù+” +b[ ”¼^ˬ³4ÝÞ†“ ÅÊÛÛ[&Û›¡ Ž›nïü³_™ngÕ3G im޼ÄSCYó#º„¼2±Oò³V|>(c™7×òþqÇÂýŸè¤wø‘4jƵ‰€í2!90͋¢@sÆkÁ9Rõ3ã4”—щXR]‡âžšàc2¸§ùFŒI+Jè9 žƒ’É hgqPº¡ e/þ[éÅEô -Tà.4J‰}cs•Ï}+®GøSQø¼A‹Ïô¬ðŨ!©{ÑO5z÷GÿøD×®€Ü˜,®F‹­xc"ó??˜m0Œþ"Í2t=.ºž70*×õJƒëzÑ…Fñ…xLƒÊºž{¢Äd*îõníÕôrÇ+ì 5o“=Åï´k²'Ó~Áž‡ôÍÅ© „úyA˜²¼¦p—»µ$Õ·´»,hedÚaÕÕîî¨-è/~X¼Ë4:©%ÒèB°Ê…¬¶[7–ùˆÔKú[ZB ¼VED‹öFÒñîg@4а‰ˆ—0ƒ+oè{ßRK°èÑÕ¯·?K-‰ï¬–Ü&X¢‰5¡ßùzëû_A ³š|ÿäx¸³ j¸IëJp“Ö˜þ”º,%N! úSíM…Ušv¹’ÎÙwÖÐRî®òôÆ0ÁéÈ'Â~ïáth\Bî€Z34 צß"Ü Á5^14jÂupºAI|«R߀&Á3bÿ6TW$è}ï¾%8°­¹š Ó¯ÉF䦹2®û3(RŽ.[::²¦Ñ-:ÆòòHXÏšœÍwr=æÜ:³ˆ;²ˆ¡rfEK9³nŒt䜜Yñ’ά¬_¶çzåÛy¹u!´l³(ÙFçØ2ÐÀ@w™ ÚRj÷÷ÚVéªmÄZ?ãh;ã"éŒãsâ aRkô… æN¨Ø@]Sb,Üöús­çZšè±IAAP;¨úKGÂ’M:RW:Å®g(àÍ”¬J 5qÈjèå\U à–‹1•ôXþ¼°öÓÒL Ú¨4š/w¼Ä¤7`Q±˜*P)·`EÉ7ÊXÇËóBʪãú°¬þ…X9p‚KiùÑl‘ E†¯õr:ZŒ³H_)Ïiê5½qF()L½vZNgÙ¿8ÒΆúÊùž¢ÉbdñŒRë£X:oPšfœ{ ŠÄWò³L½Î©hºmjÃÞÊîÕnm‰÷–¶™hÕçºL rçI.˜–Ùºƒi™¦ Óû¥°>ÓI³lqÂLˆÅr0bù&¨4¾ßrM‡«5^ó¨]âx0ØtðJ‘(,N8\Vx“Ùe©³Æ'gئù-›"côaü-£„‚?øÁŽa§^hØ~,W`9WÛr…žVÅw<¤Ò=$yÌpLS Ú Øå€‰b`¦s¶©F™»ÓDäÏ‹Cž±C¸kþh`Qž><õ÷Ñ¿_«qE‡E€ï÷Ÿ‘]À;ÖŒ£ãK‡1A˜Œ’ùÏɼ î;Æt‘0C•gu¬k¥«ú‡H"|ûýû5 'dÛRßå:<_ ó2m.¼¾àý½,<Ìþëýv­G-­LZZhgæo—@T“¶Æ¦­‰z:ƒˆÕ>óŸ-˜=þwt˜ÏgNf¢òšS5ÿÀr%ðóö¨­dsuhªZ(LÏÉQÓ$*oÆ/¹Bx[Ó<trà4 iÀ#¿Ü‚GÂþÓ5ö‚tuI^9O,7Û7orXB0ÿØ,…æÌû0È{kçàpç\©äÍBk7,1ú+gÎÚfûžqä˼JS·ˆ’ò?Ét0³tÓtpå<ÞM.µÓu· 6NÔËçƒ#ÆHt¬qj±4¨g€5 ż³yj±%®[Œlü„Q„V<žqË`Õ¢¤Å; öÎXM%‹¶ô»ãbK\?…bÿ[Ö+CÁ~Y7¥=™%SÅÞ —×Õø<2‘¡6:v—Øx&ÓÔ7xó¸Þ? èBÜD”ÎãÆÿYÆÒ$S©kÚJ¥$î_1ýgüKDÜbøÀØ+¦ô™@£:S‰Oq°úùŠïiA²X ¨Vb´°°ES 2*¹ÁÐ6ŸÊªA{U¼ïÜMnø»7¢‹B2û•¯6¡ Ìó (>:2úê9‡"©CCG§ <û{¡½Ÿœ„#å jwÁÐK±Ð©á„#Ä’ÀF¦Ï¤/hr«Ž1?où{Á¦˜žxÊÍ[´ ù•}âEÉãß(Ïiôêo\É5yò¦ú°ßàí«ZÈÒa —_¹^q­ÂÕG<ÿƒ÷泉7hH³'N|!?¦!üϦģÿWM¬õÃLÝùÇè97¼Ä)8›X¹à”Qù%Naæ§.ÀÙOvâ<¬Eƒ/±6•Nuà*ë寎vµí¯Úƽ)ä¿0 ,ÂÑýEú(›&{t´·®ÈŽ­ÛCäz–áÆrÁ˜|ŸK?Ë¡#WA$–‡Ã-@%ZĢ˯çÅL:‹ßÕ-a= ½¢Â Ù1]Æ+N7P.j|–|ôg©§:xü2}.R’Öít:|ÎZyó”E€ÉÜÃ=˜ò{Ëý`àëí‚å|!Í‹°’¦Î·6Y†ÕáÞ™` âH×g&Ó©¬S{bªˆhRn |–_ÇOò>ñÖ ? þ_{C û‰í癫MÚ)æLѨF;W"ýÛÄ3øä§M…L<Ó‘²Ü2ˆŒ8Bçµ5™‰Ùz² ¥GG›[ Óä¸%1we’¥½oÀ=–px1?P!›Kñ 'Smõv½.¨ÙÚ»fg……-jeÃ*ib”öFõþ¸ú8jJþl Ç‚|#BÛ•íÛ¤è1N¦(‘Ëçc™C®uljh›Yn;a_ÛÒ—q*]xÕœ­A1‡íÆ‹ôçûý¹ØåÓÖkÅ|iÊ ªépó|ÑÙŒ?PÑ©ôm…h7'”¢&×£%÷ŸÍH\17Ïc˜ŸÍ-…æ¬ ÀQ“7Ê›€¶ÁÛâæøùˆ´XÜö·ÌîÐ4q'Ý ØPv”LW¢Ù2ã]Þ¢  Ç#HQŸ#|Âw¬m‚¾®@óBÔcÑn°´ÒÊÑvEæ‚™4醸q(Z²dcåC‹ÄXÿŽíu·°ºÅ®Àš!çYÀOeJ‘o«ð\Wü ÏŒ34•š2ɶM½¹´æìøàà ¥ÊðÀÐΛJFCú•Lãœ"¿1ÙOìÍ mNÔÆÐyfgšd¬£u¦áIQYˆ4òéÏt%Úüþx‚$Mø'ƒ0¥c‡†Ÿ–O2Ã,Ûkøa;&Ëð§ ?ì{3übL¶\ó¨’u¸Q`ûԬؑ`ÌD9X–­˜›Îkº§+¹HÎ)QÉZ0ÇäfÆ£Ä*T—«ce¸{6rTÅ3K|O fðÌÙª…m)HUéªñ«3›TQÜñ•üìãP¯öÆé†‘¤¸õ‘~Óh†#09å঱Ç8üÙÌÎ4úxCÁ²%Í8Þ ŠÜü+þœG&cÖiæ£O|·mXô/ÅeTŸ[0Åÿ"ÓŒ¼36¦±j냛L!À ߫țÈà-†êÌ Ó'ÖÜy}é‡k®™­µa¯¼òêY,øe]ÁÊ Ã^¢^Gë‹¡š”S"A³ÍbØBN,?[N¸»rÖ¯%+ ÚXõÊX2Ïp?©‹$rÕ¿ZT!A–õLü5Gm±’ *»ZqN_5l‰¢/¶ñ1WT¡MŒa*T‰Tà-=ò|Fâ| ¹t‚ ñün“l[‘,$S¨n#ÈÐ$·ŒT™KZV®*›$_5¥˜ªÐ€\ §)°E.Pxzß— Îwί™ú¸xQFœ1ˆ…¶%…øèQpmƒö0«|Ÿ5Ã-TÊ)PϨø¦î;Ô90Rn£ççDßaJ?m.•EÁî¾PÇf±â15Î ³—tæ´§k^¹:üÿ"ý].ª ºõ¨O¢y¶Œ§ËA¡-ù˜€”7 ¼šc`M§gÎyA„íémAOyz,`ÀöôŽK ÷PÞ€¶ î±-¯_ R[Ø‘Ûêü]†¢µmÚý«hI9 }5™ßÙÖHaÔ‡1ÿo(àä}~ß÷¨ âÃßñû¢dg¡L ,©Äóæ§ÉR(VfazêOÌϱ–ÏF)¢9ZŠl&êj&—ã sãÙén†Åa'EMÛSµù„¤,xªÓ@ëKG¨kùÚ2иõ¯\>c]%;xÅ5AÇ17¢ç æÒ5¦dÚØ‰Hma^Óhê=cïŠÆÙ~o!ù²%ψ&ågÝpü (ÜÄ÷Y©¿W4îÐ|ÃôÐbpc$§0pÂh¨L•hÓƒÜâdÀ„ö\™L1EÅôˆSclé­ýñоóìko›Ú”»¢±–d Ì÷naR¹!EŠÉÏ{¾31o»œ¼DEú3¢X€oÑ‚ ÑhÁ"±<(ëƒÒ°#•JyŒVžÓÔkzã®ï¤ˆ^ËéN/‚§Tp@_¹3å¥Ç8âÙ<ÃŒ=ž ˜>cV›s3^pBDÿù1 ¿ðœrâå¼)XÙ[Ó\ú¬ðœÓ¼gηÜ0eSfÛdØm±)3a“M§íõÁ1„[Øi²hðåµ$S™&û¥äzÜ­=åtÍ"ª­GÄ$5Ípu)PÉWI(èhm=¢Ý•6€i~>ˆCš€Ø‚Vɦ”Ÿٱ+EK(íEéÞI¶Î^%›4kl—Qê„õκW ñ¼Añ¾P’›´E¶—ì›)¹ !›yO!7Ž;8gi*‹ÚÚ`Ø GêeÊxŒYä SïSþ?©ÜRËõw…L7+¢ +ß2ÔYW œ'%ºíäD§8–¡(z$Â,"Pº³‹=°œÝ–³#TԵͻ~xÍ{Ë_C3/Z ) 9¤S S`c·âs¡ Ê1µÆâ)Û‡¤,+•×ëgG£¨»8P šÙÑÚéUTÖ…E¨‡:#ääyOeCK¤œ¾Ïœ]‰‚cj5– N$ñ³Ë-à‹ µÞ„ªb €’=séžjv}íô½-€:Ã^*[œÇäÁ'šÇØOÎŽhE24ç¾ÂøÖìP~vk[I¦hà ‡“²ÈÆÖŸÚÔvp;>wHg=T­9žÝ"Ýb¹)J ä’¡L ý(ÿ37ìVoáp‹é†ÃHiJÔ¸)¬y^Ñ*Åÿô×Óò> x$õž?ÐU.c¦t±rŽáˆQ9ô˜ ¡<ÎC@Ü¡^ƒ¢;ðsº ã Å‚a ª%c0 ˜ü#Â?V18ŒtŽhD0QTƒZlš5ËTGd†´k3ñ|ÉÙot:ÆÁèïüërôíŒAÒÊÌ×f_î¶‘=Ñ…ôJv(©#vjSÇÏ!ö-è¾ðûI“!¿Æ<šãˆl#2‹\^O­‰.œi3Úôm¥:¡Z0E÷j!“D :-üþ,’Äxv‘d2o“Ø (lë$n|P÷h‘œ'¹Š«{›…v[ {Â$ëóÃoŽGyò¶yb<5IæqI«EidÔ£ÜAYépj~4¯ åñ…Åð$°beâüƈx"ôy¨b“€w$–8[ÂkUGr«šZ•ÖŸM ˜˜‚¦Sn¦ØEä1%dÕcoL ¬9?LîÁuðß‚«I{ªcªVåo$’_8U”d†³ÀSË•¸¤¤§³‚„ÉhSJ ‚‡Â¨÷D¢ø3Îr»¬PP´àkj´@(K‡²^ˆ€"ò8%=Ók½F ‡ âr­…B|—ÙwþÔW¼‚yé‘>cì©.— 6ÛÓÅ{bp‰Eºäç4(u™2ñcàæÓ˜· „ןÛäW™bâ_á—%II•x_ðÇWEp'ñKµ@¢åŒG‹8^×I³lq.÷‰U™{ É\ý³'E¹e©ˆDö‘ƒDQ#Gq‹ª¸Ä÷"+Zç™u)èRÎÕ6Ï¡Zße|O LÄ8ä¦ $«ÕðzK¢ddÕœQòí¡$*ÁŽbÛ•ëªà_þ4ÎGçuÕø Ⱦ»x`&_ MžuT+ZLŸq¡iÕâ#D‚‰YÛÍ C ¼"*«[ÀEñ ‘ÑaÚÒÃ'Ò.ÆPËÍ ¸N es’DuÃ0 f4²ªw+ð?/s¤*ŠÅ#´BJ=&.ò“ìæŒ²Ž)µÆ¬”ët Ê–…¹bÃ8d—NþÕq*à…X… ÑQ (ˆy·!÷ê© ød¦EÌÆ"d°)Ú•(¿X„ùw[ì&W¸7Œxj€ª Ô.•5%Õ -iin²¼)•c>ZyóÕ¸±ª€ ”­c©W•´="Û¶_´LUµ‡ˆƒY‰‚´š|κ\„Cqò&!õ§JÁ,¬YyX¶ÊC ZXoZhDÚ Ð™›Qš©f³Ë³¯ %À_m%]+9·Æ‹é|Få88QT°‹¨U”9Å}Ç39ô¾¥£…tøF EnùW'TsÈ_¨5£¯”ç4õšÞ¸Þì®ñn %,"Ù/º~‡¯\A"T:?ÆÏÈ_}´°Oç-ën3νEâ+ùÙG¦^çT4“Ú [Pö°üïús]¦e&Å$ƒE™i™­;˜–ÐaêMfiJ*Á-òz……EKfB¬X†¾ æê aïÈçÚß„G0šJDPýf¸än8ˆÑÉë'œI="R-IBuÊ@ßšÒäÂÑN¥aÄ`á5Z· OñÖ$®U‡ ›<0mù»…JÓ€~¦U ä®Èe>_¹ çBUE€p3i„Ǩ4œiÏA Io ÛAãR,UåãŠz®8þÄj•õs%b;h¼ŒóùödíV$3dDrùk‚ÆE®3·™|h~¡Q¢ l_ÁEŠ…D\±Vx¿MÂcB¬ ‘@—1ŠJĹëòèekLL­ã±å·Ú´³Ðê´O•{…bj˜ëÒT £ï”{oaØ…°õ²ÈN*©i²¥´D¤økŽRå´›–óÛòÙžqh†ZÿÙLª¾˜°n¸S)˜¦¿ ߣÅÉìö êQiñQƒÈ‚´æÂVlVÎaIòÎÏ]EÜ.*FI¤˜ÝÝúþ¤²¨Ûªÿó¢`–dzî^m‘ívLt®J„¦•†žÃ…‹°#š-ó³­Ù„P®kò[š.þZ  |¤Õ¡hNÓ„ŸÎ-ÓTQpû›5Þ§c'·’3:…X!†¿î7b6§Ž‡S ݤÝfðQ€€3X‰ðT^ÆÜéÜÕ~àLþ¹™oî>ÞqŠŽûÿÞ3üì`gS¨r@û(ÁÜ>}_8J(Ô}¹éšÃê(oÇH€ïZzE ÂRœWg—›—?×(úvQdÇÜ ŠÂÕÌXfÃJHË®u{Ö‡ÿ»Ù¹ ôã(-õ†­›äƒ.2BûÏ(Z¢Lû/y>AæÅ‚ÒßÎpæ)"^C þ«·³À,)¶u5Nw¥`)}¦ÿb¹Å‡ô§@ü^F÷_©kw¥'ºå]±.8¯Ú¹ºì€í „Ψ&7Á£(Úx" ð¶uz´J.¢ûnÑ€qTMŒÔ©:…0Iåp\›òç¬Láw“[þ^Úr×[Nö;ç$j £áK,±…"gÙ†6kWÅé‘/\9a»+PÚ¿…$¢ ~-Z ‰Xõ$|䩨‚ }d•ç.‚¹’ù GÆ›*‹³û‰>CÊøYÑ Ä z Õ­•²ÚäôÀ ,ZÕÜM_˜4ø ¬ÛôÃ`†hŸæM0(7Q2Ä.à¢A_²Ú@øz!NÅÔð‹?ž¤çÓô9M7Z‚ñ‰xŽ©Ç žÏÛ ëˆ‡åºžu-ßÁ²ëÜâôÜDZ`Ç Ç‚Í™Î=Ž©.Zpu/ˆGia–-±Ú¤júbY ÛJñv¨÷j#_‰‚¤Þ¹×fCHLI iÓéOYLüaâDâKêä%6\†ý4Õ§n[CÒ_qÌ«Ny‡ËÑøÄa¢˜WôP•”‡¶t²äMiHUTá1Ö(þQ#ßü—t?óÊr+»úâÕxÎS8ˆBƒÎÊ»¸.bµEÑ©uh™Ú­ýdhðbŽ1{ £xª.Œ ÿù0j©ÿDñÄSt®[ņwÆÌÁE»¢¤÷ŠG»ÐNéÿŸ¸7jk ºØbû÷¬ˆF‘ÝRÒù>L™üÁ¤m÷,ld#!gGÂýÛ„? Oüiø£Ðíb¼.¥¦ôJØFU¯-ý)•Š}G9Wnc c¡ZÇà}eJí±ß¸FUR£-òN{%LÚ÷ v„½E} É¢o¯úû1—3•éawq Âv0j:=Ë£ÕÑÛž^p¯gâæéÉž4P|™ÝN²Xï@|oS£µbÎ2b¤¢IŠLp9’aäb¦{2®BÚܤ™Xõ¢Ö0ÞÛ×Ê^QU¯iÜ…Åï—ÿ1Å=]2,ÅeMqϪAÓº@±„òÚ´?Ÿèü*#«°\)Í_<éK¶45ÃIUˆp“ (ȲZÙB朡8×$«½Ét*—Õ —;®ç²:½†”ß2L•S òð¤ÚZnLlîU¬5§e˜mk–¦–¡Úf2gc©éöéþhè,äzÎäêªP% »‡+»¹:ÜGå1B¨Š)…˜k´l˜ü*%úïoRãŽþ@ʧ iÁœ9º¨v1­jÉ!Kó"] ³+»‚·¶,ž›Q¦W¦&7h¸ê=›)YRôÍfÊVTìöm›)¬(i²õ`Ý {åþw?ìsTMJˆ€)ôUû®aæN"xÔ“AB‚iƒä;ðaqI:rìy¹1KhÂCGm<ÿòAiœ…èCþ B£“ÜÃß9±%Yý<¦äÇ4 lƒôïwbUd‡Cî^±+@—':·Ü9ÅT”>†Ï Ó- ³Ñ’&ï1îé+ü"‘+Æ¥^çS«¶àiEKüJFðÆâ>U]÷ù”Γ îd~eŽîàW¿Í/,á` 2N—жN—e‹/µ¥¸NÁ\ï$¤·§¹” Àm;øÂb…³Tf’Zd®JO@wùÒ:vðWÔ#{(+Ê£]>fD%wÉŠÒÔAj“kY+R,=‹sMè±ôõOŠiœjº±wß¡gmsÙp‚án!¨¤t_¾ …EêcLcª+“u*„ÍÇQ ¤lãÞ)[gªÂ[†Κõ^Ñ£3õtÀ¥¨ÃÛý h©§$Ê OØ0šÆUIþ 3häªîjoag!b^í„›D¨ÕîCYoMÖê2â¡­Û9Íô]Sƒw0URâßNšµ‡0#Yß'™I”/§ns¡õ¬·hF€7yPm†Ó;eÙnFÈ]Ä‚hlã Éª{7oÄÀªfbsÆÇÜ)•·Ÿj9rø·ÌYªrÃq åmÅÌ;¡í=üÓG—bbîOL¨jô#ÌÞâ'ÅùœMõq×]l€åì¶b^òìäò%á¨É;‡~ïʼS`y–ÑåX  Dat„CßÌx"~ ^_ 3r"‡ÝiUg lluÕçÀ4|,5¥½JWgúP¸öúë8ܽpKpæqLLX¦ºîb¯›!¬Õ± ƒRñ÷Øÿj{¨ û›Œf­5ò8&$,f‰Ê· õ®_­Ð™ÝÀ–w€<ø š³ë«©ïìol©'ÇÉü0|Mê“N.­îÉ)Ö™Ý6ïÒéÅŠ¡`eÅâGí9l£qpIù} g3!)†¶_…JId†Ö3vTñq®b GòñÔ{|&Ï7ö8ÈáçŸòÐÓú( ¡ý-!‡áî\­ÒÆÓØÎûðü@ùlÝ.FÖŽ1zàÐi¢¢RŠ_>À¸)HŒÑ´ôKÇ„!\AÅÑŠ ã Ùˆ‘JE³ ÝìÉ¿ùÕ–žŽÉöÅÞ†RPUï-k웽P™ˆÚ_:Et8ú ´ßëy(nHö°ò{c²¾é²é=´!DÿÛxЃ5"8%‹(êØÄMX1ÓŠì8)H ¯æŸI«S½MN-€Û$¿ÊM ¿÷B>Dž‘y§*D¹×É£œ jÐ/ÌŸIžÓKäÙ®_–É£,Š¬â­“‡³ ísQ€|mU¿¶»wÕßFÀùÊxmdʦ1-È£M?ætcgγ]ìJm›Š@w]ïçúápžIˆ‹œÿIðÌ@8uÇЄ=Pð5ˆš¸ð‘d<2“+³öAÔU°®gZát¹|uÃ7±®P%Ÿk³ð,"Wu»,ùìàåxcù›F¯{‹¢EÁò•ÿÍxŸà¦º-~Vh¡ôù<º=j½d))#ÈîŠ-hkM‰@s,re!j^g¯ Ъ³FJ i%]˜ ÄöXòÉ‘™c Ö’1Ù[Ž‘I%?…£ ’õãÙøwÆó-4ض.鮟,Äko ÛG0m,„Ÿ‰f7ÇÞHÓ葬ìÏíü")ÎiÅ)ôá“=QAJ=”Ñpa꯭°ä¸±2|½ïï!—ŒQŠÜ¨ló ‡oŽêC•o‘KµŒH¢XK^5‘*Èe+N¤Í3d6Ù`ÝU·c…¿uÇÀJ.à¿V,ÿmJ+PîŸÔËk“ñ L4Vê=)O_^–S"óHf’ýÇJŒ@:#›«›v“Œ–¾ÕFÒ+Ÿþ'çÜ&ä¼¥ÒüjRYm¾iŸÇäåM«¢Fãó¾´Wü|3ËžÕggB)5fö¹ñÓ«ÑÇR“1Ÿ§¯’3­F]âÛæjDnsþ<‚—W#5ZJåÒ"62D\÷UÎ$`!AêW`§RÄ´Z=Ç8]TDªzïi¶fL²ˆìøÂV2ǃŽ˜¨ ;Rdñàt¶›Ö¡Œ«ýP&5™Ðƒ…)N ˜™-N–¬èá¿ÊE¶¹ã‰M¯®¸È†|S"Í‘^kÆehå¾PîªüdÅ/Uéjpå,ŠV£ãK£N¾“b¢n+Hp‚6kÊ:DQµ}ºÉ˜]çƒ4Q…K]qJY !«ÚJà U[õ€qBÕŽ–¬jk¬œb3UÛ_ÚZi–£’ÇT$ZׯU ÌÀŒ% mé²”ã<þ=f¼‰D V€£Š#ñ•&ÜTÿÊh ¬Ž2å,Ù‹´…Ä›*{@AÖ÷mR„’5™+®õŒ%}¹.¥È«CªŠ{†ªDTðË«e‚Ä ¿1TÞU¬úÌzy¨r®ê$pA)jï²B“RPöj7Jbç¿}¯lòœ­†¼È¥XŒá,§pvXK¯ã,1²©/ÃÛvÃgéx"]ØQp<8/x*ßG&ƒJ“hW4æGæhœ›cOV¦›&B½ãYin ß°ÔSA õn4¡Ÿê’Oÿ!A¶¸¾\Jõ ûÒ¤! F]Ç;˜‚ O=÷ZNÜxcî&^ñ/Qýn2o(Éeèªö ¤ž4æ- >sl¡ôN¦Œ'?§±©Ó91 Mm/|V®Ë» y™£j)Á¨Â»ÌÞ]¼›p¡Ã;Ë~ Nÿ(©Yu-[œ<’1j#™ïˆJ;R£È„Ê© Åâ[¡¿MD¼zmr-éœÓŸÒ\ùCÂÐĽLO9¤ëÉ =S¶âð‰¾zÁüUY…P7uÕ°;¨þm0¶ÂÖ‰¦ öå!5ï”Q©úì¨ü ŒV ùü—¦TÔìCnÅ¢_ÆÐÖ1ŸPÅLj›îŠ—º-äEù>†·µÙ8j=fbŠÛ±Z³ êá4Ò)EÝNR<3wIŠzZœ÷¦®i|y`1èz|HŠ©4SyA¤ú5Eø×h£C±ûî2iLO›,Û4S’jIZv°ñÉa±±,I T=µé²ô¦é²dÀ U˜¯ËôÞý”,iq[Ö;Ú«¶˜q[Z:¬¶,Â7ìú ÌÑ4l\,FAÎÂ'WƤcCýKwæ¢í9B‘P–¢ù‚s-ÉÊF˜ºTÖ¡’¬­ÃZŠqéÀþO$HCêë‹Á¥¶½?Ó^ ‰ ‹ØÔ$m/ôÍüß±ž@”2ÏT¼ýbÚVnaÿ*RIÛšKÌ­^8È•>+íVåÃy4MF‘ùÓd–-¬#n»ò_1g KÈM¼ÁÇaý¦&’Iý:›ü–7¡ÊLš˜²4ا0Ã’^BCM4HIsˆÉok±J¬Ò“D×´ã ‹Yw|§<‡Æ-NJ‡yAÞ•¤ Îññ}œ ®¬q.øéÝã\ÒœsØ)T…6j¦Árßpq@(³༳R¥¢á1¢BC광㶸À(0]S…D3Ô"£•,@Í3ÿÍòþ½H§Ð: …V©ª”ißÎçÅ€Ö÷Öé/ÿüᕽEáj!.Àê-ýK&šN#&h.±XËInÕLRùÂØLVÁ¤íIãQ)Ü£ÈñìË,oædÓä\¡åGÕ>Yý`bmOš@2¬M2}©y'rÃÚчÐW)1LïÔ?à¾ÈLùD|~ Ä*VØ0Š¾Ô¹˜s–BR"C ¥j@¦J»n‡ê†]bÈ­u XÿÝr9„a” ÉTÎ?4tµ¤yÙ BU|[ 4Xl©& êe%0.Ñ•Û2bÓ7 Í*Äâÿ¼^Ð…¯`ú½„ýú=†4|&ë£\V,J²Z(½ Œ“ê{'„TõÜÖ°ÃHlE0Dƒ©â¦ìG‹©Ó–¤ˆ«òwùl'“">4iHcQÇþµçÒÒ<­›¦o¡QáŠ%¾Å݈i%$k$žÕsšÅ)š4fŸXiйG‹ÓæãÎÒ҇ʳ OùÞ‰z™žIm­i¼GÉßy”Ô]—ÌØ;ßg_Ò%gì+|ØÃ>ÒˆÐPá¾<¼º…&®÷)VËÒ÷‹–šþ–Î5ÈcÊ•£‹ótMÓw…a­îÿðo¡híÁ=€ÜÉ!T‰ëÄtîK¨Æl%fÛ⇓!šl*m›·˜˜¢|ý¬™ý´‰ry纒ò±[IѥߔÛW™Ž¨Ê§úÇa¢ Âè,1ŽŸÓÿ@*¡<o][ÿéCô/Z‰~:ˆ)êqvg9Z£»”þ©ë²g î®”ÿo~¢A퀒YœDƒÄ‹6T½ŸûXü[d#=õy‡ïõ²“JŒÆøõÿ±Ý 'GT"“³g²ž¥á?ƒ°J‹ÇCË—mJ¿[4aN+Ǫíëg[G&pKÉt7ÜŸÙ©]Oý˜<ö˜ºÊ•¿8VdÞh;È"ðmñÞÌ··vù‡£^f;‚›PŒ¹4cü†º"C }šôñ´ö›Œ¶`7nõX ‚W*cJ° ƒ·,Ä䂦 Œ¶Þœ³ïmN ÜÒU—†¥`Þ‡FÌú•Ä–E,ï‡þ]KÄÿÝ,dy-x'‚ÕÞ¢‰ã®L«ÿÔdëpLgl‚ŸO®ÈªwÿþÙÈpôCÕÿ‰êJS.nBû›™%;KºÖ¾g!“Q$ûEÞKb¬¿ä.\…$6£bÝåoÍáÎ`#`ößL]C“Õ0ÑÖ¼e¢¬I± L×LWKoír*ÞnµV;鮕ðÛë+°gÀa‹ŠþÖŽq¨ÅvŽÖÖ¯[‡$§ê,%Gšã øÆv¡û"3˜É7Kiþ=º3f´ªÆÜ)éB‚/¦rc†%«ˆ›7ñ«¡b<5ãf„‚0¢}¤G"5ÑIUv7XŽ+ÝP.®:$êla‘ësÙH7CY!O{-rŒëd´¯YäÙl{²c‘«Æ{%!XdH_2Ü÷;UuªÜ ºçÜm zOÁ{Ä ”ìæ/gn6…Jã¾û x#ì¢Ø:°ôà˜îmúºÿÇ]ùeVƒƒ‹9ìB„hùñ‘[°.¡pÌÈB“mÈÝ)\&w çä¬{ÞªPª`^¦M:9>Ÿ3ÖâH{š}®ÿLÃäåïÓ̵[D±9—ÒŸ‹sæe„KØœ"DýZšßÌcKÃIUªñl_™° mêFŠ q_§?þBÕ[1„Ϧ‡tË(ÿOþ†Êäªüµ÷þ}uèÿ†®ŽÕcÕr*-êšZx,^U|HÓWßy þüK··üˆ–SüF->U'H3àE°ŒF'QÎ62zÏ\Öó&vÀ0‹M°}™Á¢çhxSÁ‡>§‚—™Êi%ÄcÍ©[QU¬  “cÑà?‘ÔŽwòz}ÂJÖ@ów\¬5t…›X;uFTžàî¦PñQr_±ƒ†_ê úõS¯D½âjáÈ$‰ó-ë3:Ð 7DøÎFÐå¿ÙrTâI´@zäŒr‰52†m+gù»:v°³]b¿xï·¯ Â%8ÐÊZ [,/<›œCÒ=¾ ÃN5Õ/È…þ8çÞp ê(@¾âÕGÉ鸑LGä42‚Fê„«´IÓu‚£šBÂ_šZsØQ$Øu)*¼€õ$j §\A™=4êRc:6gʦ¬ÙÁÄÃí…mPÏà:‰8©Ô®ú†µ6U‡M•‘*­Oê¸ s^|Á—_–bJ­\æ®^$¦¯D\„º ¬mæ¨÷ÓpWY‰„‹bI, då,,7\Œ‚«›P0O;”Œ¦Í¨ˆ‘w÷1ÔdÜqìˆäÕú3à',”zýí‰`zá ÔuŒd6/«Þ±sµK ÔŽemµW‹Tün;x$—NyD0rwVÈ1¨`^!væ5®ó‘º˜*Ç®rF&±Óó0âóÆ-lèeKšð)Þ z`ÏÛˆùÙGF¯ ­ó6gÞZß›¶4€ß©þë;>ÖdYžc0(³ òSEÝ%Û,ƒ…-– RUzU…¸1®e‹/·>©jÍÉÜJv®bb#§1*6뱊®ä1ÔjÒ›æÍ —¶ô€·BºÚiYhàæÒ#,íBGKWnœ­ì\SÎe)Ê5NªÙ9ªño²¯[ˆ7ÄgPÐÑ¿ Y¯7*à™@å˼^‹Ç”$)4äP"ß¡© ˆv.îPJ‘ÚÆßôG#Šô¾ìI”a„“øÔ™Òžªm  L %“j ‹ ³Ýä±f Pð“wÞH>¦xfšgâ>ÓÉT³ìŒ¤Ìõwÿ¤Veµì[ó“!'»Õ–ùÒº öõî$Èó#éX{~ÇÄ"•ù©`–$R¿’QúÝ hGä÷ߨÇ8¤*¦œ)ƒ8•`ïZ‰¡œñÞ*ñ +QW9qÃ.·iKÊEl_b%Þˆ¸B$|Í1ÐÜrù‡A- FÁí EnË5'ld*·ãW›6¢éÝ rÑv˜ù"¤k“IžHd(†?%F¦6Û+¹º U%w“ëdU«)Îø¦ YÆ+å¶~qßtvÉ+$Ff«.Æ–l•°BLø­Í2í6ä s*•«¦Æ%–xÊ2^ëæŠš%o)NÚþYoàV]f$vxr—½|\¬p9hUÍ8žåPML´`S4Ztç;ŠHêkºîg½}%?û0Ôkz£TÅí¶œpgÎIZû _2{;ÆÏÉM«ÑGKrÓNZð”ùŒó;NøHTôÝèTY^ú3´¦\ÕŸ_T$Óhì[Ìwå#¶ç| ¬SÖ ‡(µÐömÎÓ–M‹7/"Òóþzݾ¥ty&Ïøúo=–¾—:W—½*ÓCÿi²îN/¶ÁrzÛÎIŸž,«q]‰là‹#P¹2?Ö ŽßÅP„®_|힢F*¶`§±,Ž»Q§ %׫„.³PÕÎò?&ƒ­ÐOöø}y3©mw¡˜¾õÍ ­Ž̳½N0ëˆ23}ìÀt˜ïÇ®Ìð+Ñ95Œe¨£T8mq™±“íޙߌ•·¹Ì”ŽÄ#6é™!WûCÞ;¹ÑvPøÕq¿àî½<=4!²;Ëô¨Ðׄ®81TU®fŸ-O4r‹«ØÎß…¬èO‹KÕ.éuŒt'AÚR>žz«ï•îÚêøS¹PPqéNCÀ‹v?Á«¥‰Ü :K_$'§ÅÚb®åú+޵¥¼Ð}Àr”HÄÀý÷è˜(¢WÈË»PvÈAGUJN˜+Š UÚb1s¢¥˜9¬”ñ©™ãoíHÉ1c^E®D½¹R àDg‡¢Î y,´}ÑÙûz®á0þý²~³5A$Äu£÷Æb¡ù–aÆç*Ð¥p6«ýF}ý2ÓTõ HU+µ¾€f#- ØÙ€P¸úXê ¶ð²ÑåHQ« Žr(è(¹t×9T s¸-~°¸Ff_^¯ÃDz‹Û—çeràiybÛ%M{ƒ*ÛˆÞ›õo‘@G5ZšùKùûçcÝ0ÕNy¢Fê'§&Im>+ˆiµ*W¼ah¨Ž*Àeäüù‚ßzF©cÌQË„H‚sþ4"iPZÂ`µtI°…HưìäŒ%Ør7Ê|Ff†&7-¢—Qæ;®>ÈB÷gU©ÑÔÄÚ}Xü×)\7)Œ+âø0øtz¤öyý¨|jDµ¥åàþ0lÚz=ÅSú¦zJÿ X¡0õÕi>VÝè;ªs^(WïŸNOS•ÂC¼A>¥EƒæåÿSNŸâÑGƒÏjF"ñlÞ²‘éó’ƒdö©&7N‰¢1¥Ÿà†"|”›„³×ÜKÚÔóA-Ò/ H¦Y¬¢ijgPH¦§sÏb\ºFôgƒtÃËA¡rª‰¹*WjUiƒtTAn]«,4ŽÊŠ[M[m¢91³Óe¥Ë¡ÆYUnn1dGØu“Þºf+8ZcW¶¤ÖÒâwK€˜˜Š]¤3ƒF T;pVQj¬¾ãÛ¡vð›ÊÉSëÕ§Iˆ!'Þ̸P¶Êùª¬LÃB~ÈZÇdà¥WòWî#W]™óÙ3É…75ú]Q°±äòϤ­Ò¯Þƒ5ˆ6§³Š¨`y5ÒDË:=B¥¿á:y(åI>†Ð#zë’Õ˜båòºô–ɺÔ];+—×eünÓé.a¡tÀ;Ã)AÛŠìžúÛÓ¥YÎmßunlA0±iLÂ\Å`I$_¶¶‹&ÿ·æžcÓÅ„¶»£§¦Œ²Ã¹È™B˜Ó)Û”Q§¦ŒÊGòBFeÊÁâçz ðd®ÎMïµ-\'¦FâT«€8ÛÑáO:âð¥`«Õº:J+-ÄüÔŠô‰áª³…ÜmC<‹‰iÜÑ"..[lª„˧^‚p%_á¸?!•ªpidê5µ8ñLá˜5…ŽØÓ”_XÆ~ö1TŽhhq*ϯÃ)œôA¥ ëZœÂIºÊ©BÄÐ6FᢡKôTQ8á_þ…´·¤èBõà4BŠò5H X9Øg ˆÀ/Ç5  ÚEuï€Q8¥úWe V”Â[JÄ&ÅÔœ;ºZ‚!DÊœ7ˆT»^OêMiü¦rÔ¿ZDA³{Ç+iQÖ„91¶…´7lFøL²@¿Dãä£Jþǽ7†w5\ªÌHˆ]¾«¼r· kAÆŸöHg2ÞžH*êŸ7qX-³¯ ‚V"©ßæß_°ñ]xfDÍ‘rÓ]MÂcÖE cK¬6g1£©ï"‡ä;Zi­Áß)gν+X—ä@ ©Í™ïžk9 úc·™óÑä)šOwº;ÓñŽ0ç±Ë@·ÊÞ–Å®,JXñ!ŠA“IV®$¸,_·xmkø¿›%¬ÌÞù‰ºÖ2-ž\ú¤ä1 à6[É ÎbâŠâ <¸8þ(kóNÙ¨”gguÅÑ÷Ö°+€¬HKw{ãî'«¯Û?®Y-Iá™=ÂåvGLOvÆ$ |âs›*mŠó½[õ PÚ¢%+m«l§©Òæ/%kØŒÀ®KKåSû¸sŒ¥Q ©-%«š ¨×n`‡äˆMívÏ2·tãpTÅ\|,½±L˜Ö7K¹æ~=Š£,¨°âõêL²^…p‡!§vÇ“})…|,Kñ‘ p7Ü<{Q³P} «›â8$€*,=7¾9ÒJ‹Á§Ý¦6›“1¾bjgs<¬ÅŽ©-ïX H'ÃÉ ßŸè~ а Ù+À¾¾ ¶„äÚ…H,ò§ý-Yè;kV“• ïÞc 8L õ †v¥pŽP–~Ñj~§D-ŽVê"Èâ‰=Ñ¥ÛÑBü­·\HNâîN€‘–è-ÝŒª¸fR<½›ÒBêë¢ëÍJk„´P Q— 4_¦yèºLZ¯R#Õ©=\¿Æ¥ ê:.uE›ÊzAÌ m"Ÿ6·È|‡– LÏ\Â+X8Ýy¯±ã™ÔW\¬…GøjÙp§ÂÑþþvó—Ùm±úJyNã WcT ‚‚èµ×rR@­ðÙÑ¿¢@cUàqÄ3¹Ê§}´ÀÃy löçw‚"ñ•òœFF¯™fiô’2ÞÆ ¹AY øYÔUºmý¹iËŒiAî<É`QfZfë¦eèîÞÓ”í,Â¥Œ¥fYÐNšeKfB¬X†ˆä.ÅîìáREc¯¡åµ®„¤Þ¤S]¾ÇZ]„ ™H’§t^¶z#7ù KºñX'½t¢«èDe»*Ž”MÂÍ]ÌP‹óÕî-Zà,[f˜œ¢Lõ;:_x‘ÇÊP;ͦKÄÙ \XÅI|, ˜NO!ÓîÑeúáiü[DÐy çù¶ª×Œ$CèÄ×k™½§¸-â\ÔÈ®lÜЕ+8á6±¶=‚`9±º{a©7*™ö…Ý'[Áþ›BÒ7ᤠŠq¿ÏC·­ôÆ ÛÌ(ÏŸ{ªåê–bNx27°}×ô;†+ôC¼€P/ì+ ã}d7KîISæ =D›4oA««qIPRŒ·ÆRór¹’÷ÑidTjØWm{Õ๟†­ =IàJÆ…þm!¢§[$Û4ƒ®¯î`Ý7eŠ^CMÇ]{O·Ö ‰ÝÛÀ9n{BŒ^Ùø†Iø[äN£!E¯/›ÙkÖ^o ¼¶öÀ(~×^{Ä„•µ‡Æ¬ˆÔl¨= þc°¨ Qícæµ£óï/œ] oª0{U9Ê\«:» ÇÎ|ì9.«ÆÙ¹ï{ÍÖÌ÷’Wk`^; Ì+&Ñà,*VqÇõœŽ©ô—yH˜åMMòÌ`nÇ÷îÏçŠøÉ/âš#–še'ÊD´€†Ÿ‹(Õ˜Ü[ ³/×ú&lºòV¥O)ŽÅ·TEJÅp¬6.tFá[¡û)öÓpìУ¥èŒ,gØLgô·v\fò˜‹Ýpiya‰<òthù²œC4 ÿ¢uLÞ†¬ÆŒž^ÍØÎÇ“ÑiãAY'uséíœnµbš—dˆ:V%Áì[í$íZ’‘ +ܼ‰#£#|»U6ršS[n*T&£j•‰3[O¶–ܾ8J¹È.ø$ScOh½ºc-,ìiË‹ö4x²¸ö4 òE{32vqŒÌ ¡Êúß>Óv†€)q(ñµJ¶x(¼Ï©@5ü‘à”LZZ”y"‡.*‹@Ò—À9Þñ ¦¦è%JùE H]jÉ¿Q Æi¼sS^ B@h”¾Ržm*iío…ê¤ÐãµÌÔ«øÊâ:1*ý3' iñÄéR=¥ê͘ýMõ#é±<Û(„T3&VmëÔŸc5ç͔ɓ Rgeâï`Ð)ˆÝa Ô`¡HÌ'²úbª[[Z^}bÕò¿áºæÞ¯ƒu(ÉÂâUMÂ5‹[è (Âi*ÛKö«ü}/ÔW¥/ÕDQq ²äÚBï&„³3'¿C‚®@TeD \QR7„h°é ;’Eç¿3¡WÓê ©”¨"6©T,Rj¡ïÖGþºmZ„iIÆ ¡Ú?Ü}AØÊ{|¡«Ý³°ë‰JïÔ©¨bvMÛó¬¤Ð ÅùFE¥[š=þñð”IÑ]/!ÿ&ºi7lÓkd²çÞ÷éSë»ÐŸ¿oã%ªàª •Qû'D›†ÇÔˆ)4äâL<Ëèly¡ÝFœA(A½uAÆžíµ|KW2¶ç´'ÇxÛþ.s’_åÉõÕºˆ0­S©dƒËkªsç={ãF¶—ÇP§oFÖòêsâL¦Ì4üÁáµ]ÜšŸlG³³Úó þu«‹Çüе9^ šß½Ÿ¬ÉŒ0Îó0¶>G‚“jþ û”½¨ý«},ÃŽ·?“`c—s¡,µíq¼µ·qVŽŠZ&U7íƒ÷ã.²Ä'à‚XŽwnñfëË4)x\’P޵Kñ¢¥kiÞ-'_†ìÒµyÑì[ˆ":ZŠˆ¶‹V$Rhªßí°K¥SßU…™êm\lƒ¡\-±®¥¥5¦e§ãBËPG‡–ís·ÿ¶ÝÊÍÊ@"¨Þ$1_ MÑ\ÆK¬Òãq^Dн2Þ®XdJ%9û÷ÖQnÆQ%)èJá\\¯eÏs²å~½¾xeqˆÿˆ ¬·PŠ“3±/àþöÅ©c_˜¥’”èb÷°Âò8’-41WÝw¾·?a,¦t †ê‰ýâ†W%¥ÂŒŠ†1Tia«XÅ'J¤ð/*ÞŠS]Vëöœô¨I¡Å*Ú¾S5$€sÐßË›MË•WéþÌ?§!Ðezƒðõ‰ÑçJ å{ˆ‰Τà±4e<†Ïr¤§‘G‹Ìüe‹M––ÔKC·só~‘È#S¯sêÔ¨Ú85q¤ë–ªªkvviiñ‹nó ò[hÈn~ÁŸ¿0Ž"zÈhGEe*ËçrƒN¿Y%‚Zô÷3Ž×|ŵ¹HE*[¦@x®ˆ¢©µ(ÀëðZâ`tŠûÑUYY‹›H)Á`ºÅ‚{!È¡`„Y›RE‹¸¥ÚÓ\ ÇÄóÙ¤Ç\"›«–fÕ|‘WSÞaÀ©¯"tí•b(ÍÏGÄaD¼q~‹‚œâ.Õ€:”òÞâð©œ[ƪœÄ~¢µÜž ~Õíì¼ÅQ‚„.ÄkÖg]wz± –ÓÛŠÎÓSÚ1Çl›{ÅÓ÷¬(Âç2œÆaùƾºR8båŠ"ÍEÆRd"¾NÊtºtÌÄTThYÛïÀ¾îÁò¬fb#„ð¹COI²"@9 ¶ÕHú¶ooR\:aÎýþ[®®m/’Ç1¹m! ðµ“Jº¼¹ÄðC¶tk/t¦·{‹V@ }gz}¥ô-.×÷BÖ}E™p?Áî¨?ª©ÙÜâÜ Ì"=ì€V6ÂiPk‹¶8ÑÍý-´MÚ¢PaµU(ÜAbý!h&ÆSŸ¨»Å: ŠÄN€m§`h Çöª%¶’J§Èàf­s÷9UbtO¬LaØŸš ÎU1Sæƒ% à*¹kzy±nŽHpº²J•ÄvG›i¹ÂX2XáfÁpË™Ë N^vo(ö #VvàÔ|É?"ýÀÖ&QgºªÚJô»ãØQÍãmìN71êêpKT¡„´A×é`6!Ég‹ &ÚÀ_¥ƒmÔ_7hÁ°?qæÇXjž,ôucCôù{´û7µÙä¹ÌËnˆóóƒà˜ÿ 䈱ì"ÇŽ áèÕ æPa*mïZòU·êô}kEøÑ ýàd“5 5 PŸÉDz ‡fRÌå0=G_+«‚Ó‘ªäP΂ð€ŠÌ ˆO1F ÞrðO‡cdvvæ±TPãf $1àÒTý<2!e[d‰X[ÉXQò¥ƒ\Ý‹W]ˆTY/èIÖæ<á’Q))ž©7#Að~´»l¹Zœ{¼CMeP4ÅmûWò³ƒ^ý+QhªB@¯½–Ó©¥ÁwÿÊUg˜Nà40Ä‹ÄjS5RoÀeT5P4ÓjzÆAŒø@yNƒR—©†eP<õ6ò°‚¨‡ÀÇ -«?7i™ó+(§ÜÉüÊÝÁ¯Lû¿ˆ½ îXî"®+7HC²^Õ’3!©LÖæ ²È1e{FWCnäaÝÈ&µ Ÿ6!..jÖ D>%\§'¥…XK©UÛ5N¸m}àŽù/Ó€ªUvUFÚ©äØòÊ(Åt™ÐK’r…¿(85ˆGiÿièq{ò½úÕ²À8çeÂ5`ã\©OY¯çÆ-Æ_Œ9±âûµøÙßq0)r 5ÛŠYP¶‹îÿB,k,ï«b‹Ñeñ8}²¢Új[VÝv«òwa«HÄ'…§¬ÇµßÍàtâ¯U›*W2•§ñî¹+„Õåëña×"æ˜ZT¤-V ƒåê;Sý—¿ÛJ=¶ ™Ï[æüõTÿ=µÄË*ŒíÙTfî\I1Ô«©I³½±dzä•Ï[P*2V·*DÊD7ZZ›}O´´u] <>–[Là!F“X}[àqH›ÀC„šÈÌ‹Ú%jy®^‘˺é IsoۭĤõ ±³\~C‰aêJ'J·~Ý0ES ±üœ*}þyÇùšêØ«"ûˆ»#ž%½Ðo9n£EÚÆ²…DÉž©ªˆ§ÍJçÖGÊs½úöK¯½¢½±¿ÐY¦õ‘¸G;†ÏÒ8Òà£E‚vÖÂVMóÍ9üå‘fõôJCO‚ÙÚ ZPõ@-fþ9i1Ñ2eX:Ï0Ø“–Yºƒa™ø†I‰ –rÄÉI+JúÀ–-N— ­¯Ñª£ÄôE/)1hü„¾¡+àª!{z5nÚ"Bå ¡‹“q‡âBR³ˆp…¸ŒC^NåFÑãÁ” :¡”P® Á¬AlQ:š>jÒE®8/ü¥i‚¹»»™Þ!z  ÅZ!–ɲY5¡¿Àß­KQ¨Mƽ¿–4»ô.’àd"–FxbbC­÷=Veimû»e¹Î”¨X7áH,¥†ïö€°i#A潯£ykASN(i?}OŽ–¡r ® ’þmªõƒŠ_qª¡š?(ûTS-‚n¨Í'åUÉÊDŠ<ò¦¬WÃ1ÁÄe^¨¶„×-6OvÚ(9C’øcÐÎ/˜Ž¤v±!nOyOòt X7y÷<& ¸Ì=èzEÖH4SúÜîRIíÒ\2Râ°m'ûê»ØIºPP±j3“ÎY'÷™I š†è~ä'Òì2NÜO½nœXÄ( ÇŠG’ßA5'cÞYȘqìê¥.6¶5BÆŠÑPuÅóTÈįvÜrd1o7E«nùd»¦  ÐO÷·„I1G"¼ x©K"0N`mÓ”1E±’h"=eXxá_s÷„ÏãoŽC>¥Ç¯GŒ£ÞGŤjî{a[ÜClWžXoxb¬…&,³u%e]Wj7Ë-¯©Ý\/Iü2ÍBí¶™;ÕnåQÆ.%Æ3!dºÜ)Ya3L≻vhB“o:~.c1µ¥ Û+æ,÷ý¥2e7ÊzbC–Å›³ UuTAÞºuøFÞŽ“x–nNŽ2ºV´hZK~G-2ÿéÍ{‰-­L3}¥<Û8 `Lš%õv,ŸF}ô[°ˆ8Nâ+*[<Ú•midñ |ôÑ[-iÆñNPä.»ëvË4‹‘©×9ÍF¨ÚÚAÅœî¯ßXV.3 ¼È´ÌÓ„½Æ4 Ë`ÑMðBªŸÈpZ´ðå´äúĪô|ïD9Ô‘Å‚@ÉŽ íúÝ [Ý VžôPJ3töK× ”XúΛɪ8ØØs£ÒpŽDìÝ)NÀ0h±Ÿ’w’å×ñ‰U&¥ U6q耲¿…‰ZbŒ½ ?5aŽ1º\ŽBä×òrù©\ü £ —-Îw¢Áüûµ,ÚctIž¡ *Ë(ùÅ¡`ÄŽlÓkÕôÒ¥”èÙõx£•E=(úA†¼tmYa¡gk=º}$ú"‡ËsöVtd7Õïáþ›ö÷'Eq6uw<«&¦òˆmݽï”xÍî ºlZ/¬Õ(óõá)¬øQAo::Úó4Àç§£°²Ž7P™ø“ÒMuX„Ù^Zžì¨õa :‡X#¦‹*\¸ÒQ-$kiŸm™&]P êÕÛs?&D8Ï$aåq/mP‹78bw÷wü’Eéã¨÷èŽâJwƒ”y¥:·ÝämT¢CϼöüqÛMÚ Ä ÔÇËàZJ7Òƒ$zô§Üùí¥pL¼q^ Ô1O_D#Z½>Lin, ƒ!$®MLÂÇ×je½AIm•Aº+gZ´ip$ãG:°Ò»ÛÁÌ·¯Ï¸ z&VÌn‹Ë9ßÅjKöÙ>¸Âuc™€”TSjËKhÈ;Õpïšsú "(¹ÇPE¹£U*>±º£ év^C4B?󆢞1T™XSí,ÿèW¹:®cYaZvR¬G ¦®´ØÝ5aÊl(¬Ú) ‹X]­þÍB+u2øJr@Wûp$í÷ŽÉÙÊT±Í7ùäK¥á¥èò¡„f¤Š<¾WËÌ.ò…䉡ԜšªÃ&jÂ$ÉáLÄ—.‚EäpžÔŦnX€a ‡aÏ/Ô§øUدþ•l>/ êh±=37ÿ÷{ÓQAì![(çQ þJŽß „„ðlU®çó&Ú²}ÕáQCÍßî ÔUò}åûz¬‡×ÏíC¾œßµÂ¥W–r-?>r ×%ã¼Æ§”3Þ%V÷sÁ’ÜOnù{iË}o…h´ZBìcÔ³Ø;’2ìá,lÿýÒ…®é ÒKe—HëháÓS3žø*D– É µª¿¥G.J4ŸÁ蔬=Lâë¥aÍ¢öÇ_)85aE¼ðcÙrâ&RÝÌ–;á™’œ%þòœ† ^ý ]'¦š ê65–M\:–’Ñy'}èÌdT€*.~É3ð¸sŠwÔ’&-‰@ñ•xJ#£Ç ùèîï³DÚa^þé‡è×ßâãÌ´q^‰ßäÓ ë^7/@:#FõèK«C›9…©‹âõRè5…i#5›Yiuù&èB…\žN¨º« Y=³ í¿7A¨'ƒ.GÃ+„‡ÓBò‡6ƒÅ¼°Ë,Œ=ÚrÑdKȰݢD<®Zÿ´C©>þ;$­‹i€¥’Ëj15çFEOÎ$Ëî€T¦&‰tú{œc2DRuÂ÷d$19βj7>åx»áЋ1ÔÂ?÷%ƒ…o{ Ó– nG‡Ê†hÙ4MŽ3ïQñ”¥P¥÷ñ@é¯ÍEíÓMŠM(˜g½MEîgÂEÔÃvù¹'é€ü6„£<(Ò²ÒäÅè‘ì•0ŠB2–‘tËšd¬¡àia¹ÅªÅ¦ÇöB«É¶A2*bF,Û«5†¹r`„íP•Ju⢉ú<Ï+d“| ;¤Zi«dÓ?6÷ç›dëŒáE²áZ  HgµõãÁÞÛ b{ÜË‚UZQ_ <•€€à ËP7„¶7Ø1¨`^)7¢ãñ’?j 5G¦Èž@?ys±R^¬ð$)\„4¢±Ú³ëcwo1¹!óa“Ò]ìåì¶äIÌŽ0;Ù¨÷ù1@^áž*¬}^@ÞÅ岎C“»’¿±ˆµÇ—óóhøn”'ÑÀ¥S*hÕáß1©ýe~¸÷[q$¶§¶æó Ø¥=Ïm>’ôŽ)8`q–БŠÃ1¹ýež VÊî_ìB¶›éO/Mv£Õïð1íB*'™ÁÜ܇Ԝé‰ñ÷ö!®S¥÷×òè ²ûó>DMée÷cQj~?íW*üCM!¿qŠÚšdïýAéý¦¡ÉæP €Æ³ ·Æš^?öS*‹Õ˜R0vø$šØtÄ­¦÷»ÝJÝgeõ·ow°ô~ƒjÉ:[Ú!˜©Ržn$Ñ’Ýÿ%tO×k¹§³›Ü?“Ùv0P5¼ß’U-³-š&f›ŠEEŠýS3ÛRy¡*AZ]ÇÙÔKt8BmK-4a±YGZ8©Ì1½À³Á¶úžã¨œö¡¶\G¹‰VKO¹Ó—©à|#ંÉnÇÌ3¬È’8QƒÚ ©Hy«þÑ£þ3ãª÷á‚@Ûiï….P¿€®táR:‚aWc¡ ë2®›SŠ#—&OÍaSM“R%âã¿þuíl¢´ ó ‹ûrE± 2à»,°tôò(†ü)8VuQÖèãªI1Ù7[á"ìà³ÔÙ*›+.âË +!Ÿ:ì2LklAz9e5%x8¬0C•ã À‚õ&×QE‡yãiÀư(–æcµBšÛÇÍ”Nq ëÍõ¾jDOÆú•¬b5eí¤Z£"U´¤â±< >Ž'â´Un–¤Jüâíög0ðÔÝÖê-’V w¿ârIïœÐÆ©uÍÍÜT©ìÞòœÆ¡^ý p7¡êÝG•­¹Ò!Ž}øÀ.å¢!*ÖûУI"¯nbi¤ —ž‚"bß*$ÒÐÔmP,=ñ5µ(“B×ëÏõY É“\°,˜ºƒe…m–§›y„{ûvVÂWë²Å 3%wKŠXîΫM—=]UµQ`@  ­¦üñj^¸« íÓÏ£uÖ&^)2:ø&F}2]jd3ÊRS•÷9Xx[ªZMÆ&b`ÈüÓðAÖ«Ÿ¶u"Õz–Q8+ò5ʰ”Ð25$6 pAmøIâZÔñ0³%áAþ’4„Ze;áã÷Ve"EÌÓnYôr‚Oä¥mÛ’}®Pl;ƳP ‡Ô¢Rœé1¦¼B²P„… Û¹R‰âÞÃNl“~ˆCTP!~›nýÎWlðB7¾I]´×è&¢ GáÏìgžóØXž×u¿B·Î^¥q“º€°M·c0ÄL·›.@úóòÚXœh(ºX2çµÕ‡ú1¸b™3:zë’¤.nÊ2yâLÇ”&Ð ÝaÑfé1°b™z÷ã²¼˜¢;½ØK¸m NŒéI­z€5çw>N,óã®O¢=k©ò°0'娨‹µrØžà1xb™ ‡#~áßúB\ØtˆJý64.¦jOô`±LTÅÍI‰pÃy¥òÉÞMâŠPî©?o %%ê´nïþ`8ϵӻÙûLÔëÀpáŠBëfoSV„Ò)`B^ŽÌéÏKê Ç`5Ý+ããY({úî60lŠ‹jØ>>¹ê» [èòJ²d1lT_îP"4û*nYà°Ò˜›(´fC‚éÊ‚ù<ù§X"+% üôNæþú8IÇÑæ't^Â8mþ‰é¡á™š£ª87 Ü‹.¥)éùÑ41=ˆŒ4šé¦‡¿·F÷P@{Ô#­°’)º5eLy½Ù;zî"Áü[¾-²C\Èh€ÝqäØ u•ƒ·¡ÆI*W&h#%â¤3ˆ è(A¨µäûÃi‘†Qo³)v`¾™è åÖ‰ €›_¨¡q$ æhfcg,„ š À™ÆRÓaG.;z/öŠòòÙA*p[î€dö °x’›!2¦¤­íÁ€,P&”¦Át¾ê·ö X‚ëJäÁi¬mÖ63ÑbgUQ;/sœT‚3㿵c»\¹*tL÷9p(åùÈ8­'BòÌ—î÷LE-‰G _ð¡+þï༩á4iÀsCü£7<9Úà¿TÿùѾF˜Ôîþ9-Z&ï¨ë;Ïþ ï;ÊŸ‰qŸ(îg_' †Zädí¶g’üf>@ve`· ¼>º´¶úꈆB2Ýéü Þè•HMØFÁƒ@<¼ø$©tư•{P  ÀUå®Ûd3€ÊäMu±‰r4VL9÷;°2ÿùÃ++ ¡{»Ríñ²iÿ<˜YÈÖËd£‚í'6C›lÇ_eµqjP&gQÁη¯p}¨:[”`·PIªÃëF{'Ò[ëD¥{Ÿ¤©Õ뤋ôÅÖzé{PúïJv~¦6?9º€2?ߊ~¼ˆ;ëN/¶Àrz[ñŸ1=3Tq]4×+¦û±ì#è´Èf©¯)ùþ s ¨}hb³ØîE×ËÓ௟Ž,ü#&Žâ9Kþi/~M|+…ÔI  ²b0ˆhóñ¬Ìó ö|,é/€1ó:EŸâfœÎüú:ä{Ç J×6/ÎÕ/€1óüÐRºÛð˜$Â>”|”E/®^¶¡‰ !‡ ŠiúÙ@’Â[5žúTAò*òF…œT-m.ˆ©×ÕøÖ°lÈеyéUJ%v}ïõUÝ|¥„a…Œ^³À:ÄDÍ´’LÂZuuLÌ;›1Ãl¸1"î–á¥05¢¥˜¬ 3mÝDñ·v˜¨ŒLí,˦V2 o5ËÊ3 ­"–œŸ’–q¨µÈR4 ¯ÞzþÕ°<¥‡[ÉÞÞxt"Xï'ó+`¦ÈªH‰J°Yùi‚g™,D¯7Ss¦XædÖÁ¼þÙǬ%ÆSïº\Hkt¥ y~o¨Ópjåä“—œ  ªà!PJϼù‡RÅdz›*Û°o¦ k¦¤ÓY£eb#n ÇOÛ‰–Ìn¢eQ‹#òœ¾’Á rl Ç› eì)¯>ÍÞâLÙ¦ÓTÐ1s ‹ô˜ògP,yBu:1e•Å,âäJwHñ‰9*C™þ‡SUá¥b¥Õƒ°0Ý3€Å t2Z~|äÎöÏ„|(}€Ê0ì³¹›Üò÷Ò¦RÖõVuгœ€ ê*ÒôÈ:ó‘ÿ¬ÅÄ2´36Ľ[v.zŽàçßâŒ}lVUæFqSÉÅ߬è 'ü{Fd0â¢Zðq¡¨Èñø 1šT¢ŸÿûFˆàÙÉßàH“Îöá½çÇôu:ôçÔF4Cü^ÃiÐ}ðç’>`g¼b cH:óõÌ2ðQG ·ˆë6Íx#ˆß(Ï6*u9£šD±72!‹™­>–YDLcßÇ"¦*_9ž«Åb‹AÔcƒ™¾¬¦Å¢bžNÕÕwšÞ ªt&~ïŒÉ(*n²Hs0í‹FXQJ‚%+WGs­2€C7#Õ«ôÉŠ¾fùkìrŠIUˆÀkÚÀØÏJ½,ÖþúÌÎÿ覬Cg KÇÑ JÄmrƒXæ‰áoÙ zå¢8¬C‹ñÚM+ÞÊ’³2»öe‡È™TõGÁ$í ÁW&Œrs¹’ [ÍXƹ6‘‰6fjÑŠ2Ðß8¢‘nª—Op‘ pyRQX÷? Í–y¡³U—v¦æ ±Ný}.rJoY½&­U>O)`ØšW›O}ˆ²¨ Ûie>|ôñI nÍ'­B)úoðE÷¡Å‘ž×™Cß¿ü–b@¢:Ìò´×i¤eÆŠx;KjÔ¿óoüg'îu7€Š 8b:e›7¦¸Ö¨ûټɑáÛúÒœü¤ >m§d0ï½§Z3q“å ËŒµä>&Å ¬Gü*Yë@’Ö&©_–(/Ì—0%,¿úŸ”ÃôµÛÄwÅÞ„ÕA€-ߎE=8€í¦ Éæv+ŽpT1–6agæÒKûtb*¨T½$­Ÿ7Z×n&ìŽb=Ë C¹ËW¥*ñ¤Å]E±†Â¯PaÅ»ÿ–Í4Á½Ü±*SØ E«ªŠ±ìªÒf¿K0†…¸W ÃCì/жüßZšÛݘÙfò2žl™¿iw›•ðƒ°³ßµ»cTF<.è>´*±þf0BQœ_†OÈŸW0kÒÛ«8•#¨Ž°ˆÇ®è¿pí*Ò¥Á~T Њ3›”SÔß0"Y°ê??Ú·9¢+Ã|³gë.ýžSÛ ]qvIcV]lføEH• ¥GŒþU…PÖ¬9x6üòg¿ž*±Éòê™cE["Iu¼W°Ù8²ï€$wªk±¨HVD'¿B“$2B‡†fˆèß±öï2H+ƒ÷Eû|ÿƒ›ã$ š!ÈGhç… ª¿sÿ\äM›ö íOÚÓÞ mUÙÀGeµ$à b_Þe£«Ûzœ~EÙ-S¤Æx¥¦q­°ûÔÖ8½Ï—´ iˆ³Äá8tƲ#¨òŠbC ×ʶ´WGß&-›dÛÖɤ»Á.ôã%é´D>mý=ì—ŒÈüB£;âåU ee̘Ãûª¥‰|£r…Ô\DtS£.mIÚ—bŒQľB©¼(Çû_ÍD™ÎAÓóUÕ&/¦x†¿á£à±$›ŸÁ«”¦lþ® <@@‡ŽrJZŽû î›:‰¼ -e¿N’F¤ñf¤±ÄØöi‘Îë¤ó°eÙh§ÿöñß?H"6W%µXÿ/¾„¿µ í.Ñt¡RyN%mÈ øaŽóx hžJ˜ùñ¡“ñ¿o|» ‡Z3ÉeÇe{ŠIÃ.Aè’n¯n)gs•%•ÞHÝva¯è£†8t¦?÷†øù·!E ó¿}¬i_BøSf¯•»ûF‡ä4Ÿ¢eïïå¶²Š#Þ]¦&(gty‰‘XtÅ ¬«qó¤T#84(«‘Ï’“åžfÔïMW^ëOîÿ¦ža4šï7u¾CSÊ"ø¡&¸´¯9sgVm2z¿§oW"|Óé7éÄÛ‚–hçŽÍXA´§ùuîïÙ;CnáÔ’±ùû§ç F§Ji„ïðbP°:kÃyÁ¸¢åÂyºR…LáL uÕ0޵2>[Ü8øm HZ…u2Ù­ ‹8|Êž‚ª‚L~/(Û`OÕqaOé¤bOb±u5åy`ƒRó,€L+ùßbk¿æåXé×t—ÞbŒ+(®­;_‡Q|I \Ù•Ä$‰•°lÚ…Uë_#«K=‹V>¾QÄÎO }JÙmßFÈ"ÙǦQø°J¼Ùî±V‰¸ûð¶è¤CVâÖ¸öÄ+ž$ʶV-¸hØõsÞN¦4I~ösú Ûúõ³‹¸m9™ [¼á†#A$¸åû“ ‹†w‹0!Œ XÀya7~~S 7:FnŠé7X`§ê┹JÁX‘ +T†’b¾ X„È1sîÜùç±/òÏ­á-á#H~yg«*5œ ½1$¯3xË Ú‡/#SêYüë½4m1 u1c@éb×3(‚Oè^Äσùçï3‘…Ô¾éæ…b´r(¼}15œ¦#ƒbç¥e&1>%y}Ç¡¬“Ý-ƒoú¤ (M—Ø~Þ½ÊsȾÄFšÎïO¶ûL’‡>s©¥ôÐ䂃)Õ†Ô• ×±Ff RC°»µìû=o» ?M:x_;†”OQo]1µlh›øyl ™ ¹aÆ„Æ)bÒõ†¦gÇŽEWcjé¡k)PúíH‘Näà fë Ú¡¼dØÑo õ›;‰A§ó©£Éêâ¶Ç‘O>déëv-1ˆÕߓͯb-¬¯Sþ½·¤ß¿flŒ-raÈó!?ƒ·Àrfd+؈JŽk´¨Z3Lò/›ô¦hlƒŠvÆÂ‹P¿ék\ Ð@Ÿ“ðm öG¡˜°gTNßxCó÷÷‚2Û£þy·Ö…º¥Åï®è±9tËž|o‰7£]ˆ¾ë-1‚†ð×ÂË@4O©ëO’ˆ¦–W™cGŠŠŽA.þ~·^•j¦ÜþhÁFó¹€Q°ÊÆÉ f†bÕ:iÄÁÁâÿ·;ß”CAM¨Ò”X¢)¥RpX*mi¼žò[A–ínA¤"ÐmêƒnSSæMgÙ»ñ–w kFª´´ùÆA#Æ–Á¥õ;†Qó4Ì¿S´™Õ /]QRFÓζ"df ì»ô£_ò;|n”^ éGÔ!~ðÚÖ'Äý+Û›ËY!Ý¿qvŸ¢î§–‰€7±8_ÕÊKËìàl1JK ˆµ-ºð__‘Y1áÿüê…å­5þÏ»Íü/}xSé£É4ä„,±(,ȶVâ|H5w¼i³­ˆ‘hælô6'g1]&{o\6$C¶çw88ÀcŒlöŒº?y™é§Ìt*“¦ >("cx Ñ=Ö‚‰ë-ì=ñl¢²ä–]›ž+ÏèÀvxlz}åŠÊ:e:›ó}ÿž/½ž[tºoË_dŠÊu_´´Ótšnh-Zt߸V4½ —ŸVuÒ„Û\ü윪!ýèTx‡q(°·ô²hð/µ÷91*+xßHìÖCQè$‰ä2-¼Þ‚ mV¦ÊÜ ×ˆö–/[ç¼¢$äEþ¦¯J#<é#Z:ß £0é%ñNÙ^È_Á¡ùJvxŸ˜:©tPMz°–ÒCs‹üN…•²¡X¿â¾¤r¤–Ý¿O>U‰ˆÔèf¸Yí| úÓˆrsÆçˆ´AÉòµ„“Ô"RyË Ç é¾ä–]篲Ap¨¤b?""gŒ‰–B„R¨ÎÀ†Æ‡è"µ”.:|@S–ÁVø0çÌîß>¤áê2€é”©eƇ”ä1åC´ìãƒ\F—9à±Bpö3"õ1cDéc''p…s´'NHb©æªÚíÝñû '¬ƒŸâÄS» ?ѨÔß»$éÈR½¼VDË€Öh¦A>©¢a#PÇmG}Ó7Qlù•ÔOŽ>)Á| sOéåñRYŸË-"ÉP:¥œ×[¯Ñ…7•>Ú{3nÀ+{ΰ %†wr&ýž·3v¹ƒÔ”Fðš²èœÁºLH¶¾„h|ð²=ï´XÍŠ¸CD>¡òG L™hºø7^*4ìð!wZø»¨øÐ°¸$t*ÏÎ#Ù‰’žjQÆ©!ưþ{–+Ë”Âù¿â÷ÞðˆÜì§Qþ¤,ƒJ-¨ªÀKœÉ*j&µ°|ÙÒàÌŠ5ý§#qs  ¾qO¬ qDqpùÛÚó ñìïe\”‹@SqN'Ñ12Lú¡:NHM°¶lµõÈ‹Y¯Þà”@óP\k´Ä(h«>¢ƒàOéàMY¯*f‰z«æ I ² ŠÒêSC€íÙO7qÓl%<éDdËû ´$‰~G‹TSL¸Õ…VtêBzvBDf]L½$¿»ËÎø7å1 OV]AÀ› ÖØçÊ?G3¶¨‰üskx 8Á»’"ÔÈ]9§h‘¨¶ÆÝtÑõèEÜtè8‘FJú‘»›æ“>‚èÞGáCð­±PÅ6çV€Üø¾ˆ†b6PROm—iù÷AõòûÔ’¾ïâà´/†@Õ©YÍò/`àƒ&(e:Z~œr ÎÞdFn Íwd™Ø©Ã'RÝuI|KrÈõ`†•Js\ø[AÄ3s¯)‚¤Yä.RSÞ?>\Y­Š ñü&¸äjHˆo‰1lv€SÌ ’xvT«%qò5Áœ9 xro 'hêe<Þ`^^]þ#'2GE&±HF—ÙêŒA·Èoe*v‘º3Sˆº>öqBbF”c_:›2vÈò¯c?įß?„´Ò•Â?BzS¼mIFZ°\1`@·©Ú›£!: y["²6¹þú˜‚F‹9MSZ«ùµ Év¿ÄyI€Y¿Ñ‰·E'½õc 7oΔÓDÒŽÙ÷û¼~‡ôß§ “~ÿÚö{[þ8ÊZ|BOW©QGÜÀ8Sà ÒA¬@7@ûJGœW´ËIÓûæ-1ÝÞNð0ãP,Í•4éÁZ¢‡ÁS@S,{`¾©·±ó×± Ò¯ÙEY*¼YæÄFL𲂼LÆnzF¾ûó ¤–D¸K!“‰¤>Ýqà˜jº“Ô“œÔÞC&þ±„]•#f³%؆A{~ ±º"8ÿ:h¿Î¤^€÷§Ú:¼O—å!ÂÀе§œo•œ{TJŸ©ÅêÄ×[¥É«(ËË ¿ÇÍSn›h Òm÷€K™p?TšÜƒµd]¿çVa«¡´„ÌÑDܺEžlšÄvhbNûï X‘;xÏ$V¿‰~8«[ž)ž¦,@ÿa±LY-hD§Mèg[ÿAqt@ÄÀóœØr=Lº&”.RKacK8“ût‚Kd²ªÚÿ½öp¸_3¤/ -Ù#ŠTŠ–BÂ6wK‰“Ó‚·Z&­ÕmDØžB–¦§(UÊÚµs ÷ótX¥ŸÏ+ÿýû#XàÁ«rŠ'yÔ)¶sÊ‚hÙÅ¡¿ò×gŠ+dVˆ–Ú„ ¦´t·Xé#¸0éc'’Ö=aÜ1ý3Îù`¿Ÿñ!wð>#P&€vÀõñQz8+Né(Þ 1á©"KRê'œˆƒ]6…7¾ô µ¡¾ñM–$Ök9AU¥)œ'&}à*4mcÒGjrJr`6O%e­SYcº!8T@nvªPùçE…ŠßÀ•)V܇d ÓÝ[¦œHWSNX‹ꛜ ùÑ€›Bw6>Åtç¶m 1é%˜1í%sÃ÷V‡è G(ßÏÞP¦Òñ†Íš~_Ø‘;xŸ²¦ˆ1ϱ=SqÍ.’¼ûD`»Nt˜ªeÉ)¹e×¥…‰f›Î¾!—<-=®€ârX´¥Æ¤Ï„±ë„µÄz°– w›|Q>°\OEv_¹µqŸÜ¶7™•„¤Gx¡`Üoƒ”ÉïX(­ƒÄ§Ëƒ÷ÞAÑëhÉ$<{ÁQ,Çoi!eÌÒ<Øi0[akË–`éeئ®ÕÊDj¶ÀOlpËMå¹iƒãrE(¬0˜ ‘‚‚ãï‡wtœ0pôVa]²pé$µE'–¨óÑÅà"ò’3G÷% +D(æ:žo£¥¿Ü €¾'”N“ׯà<žÓ(-Bް*¢ƒêÑ?0ãöNxþ¬Š»Lé‚-šrå”$}6Z~PˆÂ[PÉ”Q¶ò%·LUñDKçÌ”Ý*ÔÁá}úFN-§’àˆ æ©Šqå¦àIOÂyœƒÐFYƒ“>¼‰®êl„Ù!©‘pI.±2´ `Àæö5U£ü¼¨Ýö{:t­; ü—,¢çˆ{Å$I¤¹Á*4RŒ µ€?¦²SŽËF¢±ËܲÉÛãò—“Bøí†ýå^TpC죩±s†¦>NßnÌZ\¹o*}tQÅHGì$ÁVʶ¨Žá”]è÷D*Ðyòsµ„´ Œœ¸PÝpv5'•´Þ'o€ ©ô^;±¥v¤#/7ìbRh±2 ¨ÐCǬ*9HÎEK!^›©Ñß} ¥k(¿oŸ÷D‘ @»À’drZÀÎß; ŸÓÞñQ=/‰ø¸ÀÓ«aåOV8n†S´àO-R¦ââ¶âoª•TZv±àÂ*S5ÖoOõÄ!8J±ä¦B„6¼Ó·§ÇUMûð¦ÒG›ˆ%‰ƒ‡ YNG;’4ô¦Í-÷té›ÂBfI^Ú ÙøQ}¨tßßH䔕CK- ,ZJ"Yèy¥e7"ÐR 6áu¸ÀPºÑñ•È¥¶`öFnû$¿Wè»ä‘N»iÏè’ƒO{Im¥—6—€Á” 2ZùèÀ;¥Fú}–œv,ñÞk$ ZFB#XBSÐf´À o¡²·€à‰ðކ){ú0Ñ6  ÔRÜá«ÄÞ©)M© Rã­‰½äƯpUï6ÀÍIxsF“ŸXÕŠ8ÞLôIjè3Ö,$,éçEœÇïß㋺U¡L¯”§ÁNQ9oPuj SÏʧqòªHˆ?~¬àôÉ¥÷-F Rî>[… «•€¤‚žýM^ä.#> tZ6(éþrtÝ&ù 4âI5oèÿÚÔªük¶öÙ/Þ±i‘’1ˆb0\ªX …XyJ<0µ*‹Z—¹˜Z¶Ñkìe…þrscB/QØ/'’¥ä1ÃÝ zàÁß ¡ŒÌôK~,/Ý+çÏÐc­)ÏËà@“5ùÉn.Ú…8KuX=Ð$Ã_Êï³b/xï@ÓsopkDÁoY ¬8ÜGV8Zd¨{ ‹Mäv:…{Sæ¹¹ze›‰byõ¸šPó¤ÉòlŽ8èŒdˆo ï<6Î#†kMkssÕ¹<1ÝE®%:>¬ù²@j8m““m÷ü{kyç0‹™!‰›òÉòèPªJ´€¼¼EUuDw°oà1,}-Z¶ykäŸV.¿Ø45z‰eüç©ÑKA|ù[E*í1¯³¨<5fÆ¡ÙMMåµ`M—Ž8g¹ÃÌ„ðß8i9Øuå÷ÅaÐql䟨ÙÚ¢×Íáÿs¢DƒÌzk8ȵ £˜õ¥¥€sèdÈñ¢ulxsí%Ô§ êO~lEÙHó7¿xÙ8U½è[Óο‹!Ï»Tïý2\ЄS”oɶ“>l™üŒm³£}òžæS¹5;'¯îÜøïñ“úÎ!Ÿ*? ³s¶áKÄð•káóvÉ"Æbú,>2™-èƒTU,øÈܰºk$@ÎE9ç`„Hñ×4 ø]Ýóh|EþÎÚ¤äg‰ÈOð–ò„®HÁžH33’(uḬå¦ßgFÎ%~ï¬eúýv̬#Ö™zÖ ¡¥æŠ>³Àóé Ò2©AøÉ‚ºó^É-ÓI¾ð²ÀáKx‡®m2’fE¡º±(¾5ÑÝí^ÑòSó´”GÌçe#À)N `<‰y9bô‹ìXÝ*¦ýÁ¶þû¢dòÞÛ*z® ¥)_è$Ï»éâ'(ÔàŸ™—ôyf»”ê”=,«ÇÆ­~VˆM‹Ñ¤Ô9¦b21oÊU7¬ž¿T–f; ó§r‰ÒÑôT„·Ä#:–‡æƒÿ2-¾‡PeÃm°[ò¯ÍŽH)Vé×_*¾'ÆâD®Š®P¼Ñ¢4*bÜòb¢mË>Rõw|O.¸Žm ZÒQBÉL?æð¦kTô˜_Dɘ‰¯„@™‘ÚJ­žÉ¡*P¨gæ‡x[7Œ,ê¹Ç…Åmˉ¸<•©šÎ 8ʉD­û¢PޏÈñÊMã¦EGˆ™? ë“ò€÷¶‰ij( œ¶'±ÅÂ"ѹâ-a7Ê ƒ]Ž)·l£)O˜U–ƒ7™¬ Å6å©9^‹ñ–§fñ³©É-Sc€¥œOÍè:2'bòÃŽ—°1zëM“õÑ=óÜ’Ÿ>afÜó"nmÓÕë×¥kÅ©³z`çþIĹ¢P»¸\ú¨ë®@ÄŒ[&áܼɸô,¦‹EÓìß ¶]cäwðHÙÐ*°ÅëjÝÔû²j·T+ï¤êžÒí©§³Lk½…­Ü#¯è µ¨9é£T;’õiâºp…ù7Žx èÓuRöøô1¿Ÿ'F ‡¦gÐ.´È³ƒ_ÊßAJŒ]çˆÏIÁ«ãÑ’4|Ý¢¡%æqAØnTNDþœ:&%?^Òb³6 H›ÍJÍsz½¬æá:g^™+ƒ0 sŠ 1•ÉëΕ.]œ+î…Çâ‚™ûض‹e`MP¨‰„ÚK××ýåßOðn£[ËUw­öju=a´2:o(Qî9&í59±u½îËÔ•ÁqzK£ýú?ýzòeE/ÃEqÔÊѲ{×gvÞç7ÎÀ‹æÍ¢ÊÞbS’¼ÕÙ+Ѷ¤ü|(¿k5½]³ý2.ªïÎLå,˜$9ò„K›Bv ®A0ÒŸqOæ´<£UðyðûIÄzð;UQ {\ŒYÆå•u¨r«"úC,žLgv=L»:Ö´2ÃÄ]Zöã©$¾êy¼?Ð6¸áOsÊp4µ·ØÝ!ÙÊÇ¢T‘Æ#1 *žº»ƒÐÙì¿‘B²çÅÑ€ÓML™\ür ×-©¹F³8 œm\µ‡©wmv|ìòö‚pßñҢǡMlý£Yl<19ÉÖ¢´²ãáDö¥/}yƒ'À£g;>¹­¡ž‰¿MZÁ-ÿný2Çmø·R¥Z’)À>k¹¤Št}ZñUÚ¶h. ¼XT¥Yë#…ܵ¤pQ¥äƒ/ƶËd%é.F½Íª¿–ED%s 0ލ¢ê ¦ ÞUôú1Ýçx³KE'ÿ(h„ÃCå£åØiÁGŽ[>¾ã8ËßxÞ =5bò’êÐS‡-pzä2¢žý-°™ „ÉýðÏ<Õ;ï ‚i4¥ÁF ÒòG¸,Òè’•ë3-’™ðlQÏšvF³'¯ÍT›_ÄÙÌ”6åÖ™b +3u`ñÏÌS½ŸMƒÏn+%ÆÒAF·÷nÊ®‘'-d [3PŽ-2’†××ÒüŸÝ|nߌŒ¦µäÐBºÈ<ÔÔÁÉk‰¥7¾#×8; ñëoÑB¢5QµâèªNR‰ªùY‹ SFr‰.ªu©Êh2Bowm`d·%K±ˆ'œDxqU¸Á¤à’„+d#ëß§òÅÒ]«M‰`Ò–b1þÇÓÃý/ÿëÇÿó­/¼ãX X“Yzà¦hI‡…µàߺtj‹’Yînjø¿EŽÅ!}%GÞsÒ{t›yâäeVO56Ñ‚ÊS0]M²ÖE–ø12ï€s“Gëloœ•â4üý5Ì ¯Ãç‰9:‰¶À;xzŠ›5 rì±Ø;Xh›¶öóB ã‚£WÁŠ •º#?² ÉSÀòRBâé;è*œ5º×P$å…â1êé?Ä^ÅPTâ×d‹{‹–¦oqº*rnºÅóÏ~e¸ƒuo©IQDz牙ûà ¢€ÌˆEÈŸµæ°HÛÉ–y_¢–íKáJÚtZðaô+qÇ |ئC“ o¼=‹Fç©Øc–s> 9¼Æ!l­ÀB:#,È?TùF°¡ÒìƒÜ&°Ú™¡SƒM?7‘b°ééNd÷f¦µ˜Ð<3묘ý92B‚T‡`Ñ”,áDo+¢ÁŸ».|ðÅ7åÐ!{6KWGÀ±x€5žîýåÄ1´(CG|Ñb½M"ãW˜a¼"B 3žñÃ@|Dê [¦aLbip|ë 1IñŸ3ï~ŒÔàÝž@™,Å­D˜ëÓ#¯Êêô,_žp.êJh¹;=YöÍôû”.·vAÔŸÁ”å5…xNvÜ5B.àìýâQl \G•»Â`‰`]hÖ7½]¸áu•*(Å‚çZ{8´@¸±Šˆ–¢î”m!ócªâK??~=T¤ ù/ˆK˜©{¸g`¢èîyo¹!¤”ÁG ôB|;“xÿÎÀ„+%`§S±¡9 ¿Ì;Rêqçµ§#Ø}«›ð›VÙljŒžS{ÓM0Þeß‘.F¢÷¡ãÓ¡“ÿö×~2»T*L^Y’åUL¨/¹1Qýž•ò"äéQ÷úsÀصèw*©—,ÞVA8hJ RK[¸_Ñ ÷­Ç4˜Ë«jwЫñlxÁ»Û± WúE†¸KdB݉¼Ã_ÿßóšTÿ’2 ôJú)º}¼ôizÙ>õ–rlé¦×Tӯاùg«¾ÖÀ–Šmæ–ä†~7ª=cv%ûˆ¨¯´gÄÕâ²è9Þû¶Ôâþa±Ÿp½)˜tÐÏà…ÍKòE Ô"“½;¨{ÉXVš,hbý¹ôäM°l)…ø ´Ž”S/ –­`PJ+0(s<šÁcÎáZ0_fp,ŽÏ±,ƒQS‹eÙ‚·<ó'n?DJ¹KJ%•é+wnSq:U®”×AE†âó†”B££…ÅN‹Ü)2~Óí—9`ëUo)Ÿ­t!i´¨Tbªv1l9œdãX;aê-‘uýˆĮ̈÷>Z˜Òy‹è½4âü”H¼%öžé©œÉ"jáb Â –x6GjÛÉÕkfZõºá¤…¸ó cŠò¤åiÝ0iyJì²ÏvÒ¸"9¦HuŠî“0]4mK+¬ o‚ƒŒÝ˜Ô›`Üœ¨Ür™ïþWs¯¸|Y-J ¬@¯)RQpÁiB™7SÐDî/á 1/°¸QItW2†ˆ®QFÕ$²Û^ D!¡2B7¬À¡º Hó»6Ì ÇàW©TíòÄŠÔ¸MºÇ„ãܦ„4á0Ûø+Í\Ÿ¶¢ñç)ª].oœ}$e¾O{À˜_'™ædãËH(‚~÷P0h_'2q³_‡ñ èÁyO ïèý’ïy‘_ŒŠ¤ªp’ˆr´jÝÍ9ðe_dàtnƒþ„Ó…×Ù4ÛåÆwóØ1ˆd3Ì-þþ ¿€áåHTd…»Ûu=±íã*(bÃþ¿Ü±KkóG!rŠ.t“ù£è -;AYA;þ°å‰˜Nü÷ù7þä?Ûº«@ºè¡òÃdZþÖßf ;Œ—ˆêÄ}ÞÚ‡¥fÒ1¾]ÇI=<'äÉ7õV0eÇq》¾Ý Ò:6ŽkkÄ1âó«9=M ¸ìºxcŽ?Äã.ÓmÔÝ“çÙ¾SŒ³hæÖš×  åûG åÍ>áÚOyŒCu›‡Å±Ë‰ÌWi§w\,PEØj8€™ÜoÕ¢ŒT‹®Á•q‚cSQ1d7TP’T"++µŒ*ekCÔY• 5ž6ÚÒï€fëÑ&ÙH[ÂEŽðIS"ERiç´_†óÞ“y2øfÀ¼çsÏ$†Ü7ýç k,R(¥ßÆo›æ&fÍ&M¶ÚÒc ÿ/MʇºbrÙ4@q äÊžÑarªä1.ñ‘ÙçV‰Þ¢5•[@Ûº Ãß¹òѳøüÃ;›+Êøh& i´Ñà²PA½!´N}ü8dY¥~k:«¦íÆÙ*¯Õ<97ôfŠœÅ­3•çE2íÎs¹6SgاåˆD·š_bC)ÕjtKI‹Êk«Ìj¨~rw¬Âðœ6OÑÙ!µø‚ &  -pÆ‹•|BI/Ì|кÂN×È\´Á-™„7ZdE´hϤ*XvYG$MÔ¿kM0bŸ÷0ÁÐB@mÒàpÁ™x@N±[NŽÒ¸üi€ ðAþÎE„ODö9WUä8ëþïC `‰ƒXµõXqg´é™@<Â!úe‹©ß.ª:4'K ~¨±ô rÉb@kIMíÆ˜Jr’¨à6-['úŽ,ÚeKEÃ쿌ºÀã'ÆŠÓ]C9ùžÙá'.áêéí ¥§P0n¯mþXgf¨¸½gƉŒ¡¾h #fq-n"ÐLJõ¥^wyf^'³¢bþg®àé/Æ}b®³8W·Ë¥goûš] qjkKœ!Ú°„›º"JÕe]¼µ(SˆT,nVç‹"åd¥&6;•ýíØÓ}hˆ,Rœò”³¹4+T+ÑÙ~ÖžFZË{ùõá ßa2Ÿ)V­j¸ÝDÌÅöV ÷¬Ëî\áR³:Ê´X¶šX-æÒ1E»®Ðx¤Ä麖TP»7)æOLÛW¸¸<"44Aï×f-úAlœ¬F¦=Àa÷Šfþ{•B¥Le͈¥lš4ãkÃg"7¼·`|W-ßb•z¿:ÑmÅ Ç[ògjß8ܰ•ä‘×3Òo:-GŠ·D‰¼è‡Æ/½oÈ„Mã™¶¤GKHäæo ™E?ôT—™÷>Íë¼mŲ)¢ z]3i,þ'ÍÄ;›Æ2iÐiêcV' ˆÐœ†oƒ·33ÌXX•M<²^—˜jß/bµXÜ2¶iEÁ5¾t½ 0o9dýÈ·âC2,»£å4ç*'%´)*]kVÜ©7°ì•v#2™î~rÓƒäUÿª5õIÄ kè£Æ1]®*(‰y‡°8©Ï8¹ €dÚ¹ØÑÖWQÕÇ áD¦:HuP6Øú'Ê1©\Êᩌi:.ëöƒ4–™BM;r¦¼åT“Ѥ…åpÙd'9Æ¿I™ XòƒlWšÅ¿hXI^Ð3DŸŒÞ/Î{^4¨Tdê¡;8‘s¾b-Bc˜¾îËÊË‚±ç³37¿ˆU¯Yäz™¹}¥|ÄÐ?G€ÛúVZç€ÊVb‡ssسYÆacË9UaV“ÎþøÖXyVtséU¯~ö—ý>,M¼aç5¸µ3>ó+‹Sè/æOé4üo®!ø˜ÇÇ2Á§=ß8\cIoŒ·5þ…ÛÌkѪhMj;GbÛ]Æ’ÚÕ&9ð×þÖæßþ÷êöNÇá ïlmtŒHJž˜ã2pø»vhÖú ‡3Îï8,ÁÅD‰Y$Ž¢"*%½‡ª@(•¢´H¢Ž·’mMkYÞ\©St´ MÐÐL;Ç7ÌSigâ0HxÍ\[ª¾£R¯­iHm£rµ˜|méO©‘æ;|åüëj»¨°¨oDî¥k"Ö´¾RÙ#¿^í»í §V³1 ™iBU’Ñ ÿQ!Âv å È_‹Ám’dPˆ1Ù9a;Tˆòí;öÆÀ!EV©l°™+ „!&Û¨X Ñb 1ú–¾å±Œës/ËY;ÏÞfÙÉ(Ÿš–›"zqQ=H¥¾2Þ»…øä†æ$·/eMâVy êc¤º£„‘÷.7\´`JtZ0L,—Ç~ErS­Jñ7‹¤*ŸSôÔô»Þ“B F-‡;OKe7#ð–;#Qzuô#>›£˜¾ÇgÕÈÕXòg¬kóuFƒ "žŸ?¦.qiø\ršËySL%ÕoŠr°bŒ¯¦ZŠ'™?™ó-7L§)OÃÊ4ɾ[›¦< «ÓĽ!©f*¥n]&Mƒ/¯VH eš±&€F¹¦ç>E Г­Â略’?46"­^ätºÉ ”$à£ÿÞ50qœº#°·¤ý`°± ì? ·ã»*‹Lµg¢Q½¢D´hÊÈi–‘Ç`t—«„©j©“ß±äJ¾½gÿa”®ã¶ôU ¬àÞ‰+ðñÎm8 p”Œd T}‰ÎäN$ÙLÞ‡Zo°1HO¾;…‚¦™±1ë2[7&²Ìd[¢tH{~7¢Êvdecêã|²F³m€¡¯øï'Î;¢µú}ðz Ä/Üç 2S0Š C.Q•aÉY=’Û+ ¾ÈMw½=MšðÙâ†àƒýJ<Ò¾rôáU¹ ]ß5î`N÷•îEW›ó¥5õ’‘3]g‡¹[jWpäéÒ$å¨ÜgÌû䈖µ‚™uÞcÈÙ“±®¿ûÙ”÷Fmå\3hYaŠý&­ (=šeÑî;¥à½['ý —È)Û"oƒvxk|D à êtfÏè–/SHeö€äEC—2¨™J’†f¦Š´fTômæáŠ•­“1´ÑŒ²X9) û9SHõ…Ô—æÔáY¹ŠÝÒI) Kãò|ñÑì»<Ý<_ÉD+ž?FTÇ€ÖY_&Jä£ü¾Ðœá[+„Ý‚aøPJÄÒ35øÈ‰#Í>ÞÖMÉùÌ•hæÃcíí<‹àš IõÊ;9aÐÛìƒá­Ï^:ÈPlCïˆÖ"f‘î·ÉA Gvløo‹SªE›Vð‘¿k“ëOml;¾Õ®Å¬ ­ƒ@›Q]›_‡@|f±Ÿ®+¨,ØèO#î¤æÖ!¢o”º‚^³!è·žn¸”nCâü %Z……˜‰o ÉŠ H‡ C•[+9‚® býBްUÀÏèb× !³9Ã’¡Fc2K(>@ìß‘¹É§ÞPŒ:JÁß™-“DDÈ"‡ÁÎ1"&P‚òFÍ®Y¢´ì@déØÁ¡õçKÎ~£Ï U·¼¤`âN˜&£®Ì #{kòÌè{jà‘mƒöpö'„0¸`Ãb_òçÔ)=2Ä•:nþyÛž¤xý:yš£Ýù*CLóWæËòÚ%^˜¯²*bvÒ|©°E´œðnA&J¸Þ³¶Ågy,¬ÚèØBNV„n§°×Õ #íG2%zšâ:ÂJ¶Bß ÃAg1BçjËaÅëxæÄût¹ø™(K1N¹Œ -â »DN(›*Ñ'Pž¢?¢E3Å2ÓE_ æO“àüwBüÌÝ0#Óû• «“kÅE+¹éóqm°V­@B)˜B@fëV ßYN°Ò¦>~r@Ej͹×9¡TOò«dÍÇlt‚ ˆ¦žª6G^èèU Å=´º@/ÔÜWò,•Õ² Î!Ùâ¶Y+p«>ý#•aýTü þS¥F¥›.SPs^…,V˜¯B.?Sqk†«0µ(Œ6V!M!°Dþ5¿[‹n7Í¢læ ýê%Ç/ÁTËiÄp£ÅhN¹«h63‚,1ÃtEºÐHÉÇ µÏ}©W•žIœ‚ÛÇv<‹@5hˆ?˜eÚï€kòIëš‘г7©©?UfuÍ’ÈÝ2mzÐ"¦Fë4OÙf@vhÝLÔL±Í&?¿B Ž8 ÏÜÏsao#§ÜBŽ/Æó Ð up Â³ÝŽ}Î)<>ÿàˆH[:Z~ë¶P €¢Ìþ|ª¹çÏ”MÑ[ÊçÔ=5}㵿º¿FO´)qfAž¹ENo¹ÀE¨"|ô,>³s½÷ÑÂ>·X¼8?%$oÉŸ½gzê\ЦqRr Én­Mkçéhî팪^7œ´wdLQž´<­&-OÀ`Ò8yŠð𨪴ěDsiZB0aÅ2ô]Pœ±7l¨ {ØŠCôN¼÷m½Z‘/:ùStbxŠ Çä†#ŽUKPÙ-¸P£YÔœ9Û)žK‡8,ÚF WÑ*Ñ¢Ù±AÏœ÷còòW¿ë‚š-QÑ(ìD’« šWyeº5÷øgdŸq«=‚$Þ‡Zýl5–OÈÓ †Û XŸ¦£^gc]Ygë^þ"3Žh.xƹÿóã/ÿª#zÝËoëLj»›š 4z;ÖaW]K^'n»2Ñ}¿¯í#É Z±‰ &‹®êËp?`‘!Zè|}¶”††åØËàÐ> W€öLU8vzL™ªJâ ©‰­'[¾?¬±{î½¥a×žÖ #»stÉ¢ÒB`pæóžcpo䫞ðk)JUŸ;ÐK˜–Ñ¢Ù¶–ºL‹ÒC-œ83Ÿ‰PnàÃ_p>´N@œEË]qȤ?ëé'Þ¢E•[ð½û/¹KQòPï—^§®Ókÿ¨ô±Ll¬þ9ÁÍ)öüò9™$dQ¥~' âKm+9ŸâØOúÑ¥“¹ÊrñÅÌ,ÌÕtöæsu1¯Î•. tú8äR·Ðµ5IU(êø^ Dði¬ 8…ÑãÛkrI:ÒÀbáÝ7cv)ŠfµÍnbºKt€æÓ*³\»iZ§˜./B]iÐ>ca*›ƒ—H§Iõ«&+Ô½AIp·^ QºÅi. øJŠ?‘¡ï}¨!Ð,¯ P¨`]à¦R1]À†['u·`ù™‚ß>¡?*,oQà‚fw¶ ¿OaÍ2–'™À’¼‰À¹‹®Ð³â \nœÐº]´/·1þJÄ®j^¦µÖ¡Ò;grÞžå.ÔÛŽç×"™ðÝZ0À ¤2ýqîSôŒS¡­PøM š`¼Û'Føó÷\Ž oï±ãîÆä#¾÷é3õ{Dqå¡+Qžbʉ–œÜ ŸƒùkC_Ý"€ØèE½As€fÿ€vº³/TY`tœìE ø¶ õù¦küªãD¬¾%A¼kñA)&Ka_£¾—¥îC¢8´"r›<s:(ÌHC“'‹]ºZ;C§Í–‡ÿ»¼rNð(?õ†Ñ«R•Tº"J + 3>îö7 mAsÐthdzéo'¦æ)#NÄnp¢Â7Œ%ÔîU?ݱ‚uô™þ‹B>Ó—‰ÖåCŸño)­í®t–âcÞûBØr?×û·ãœ@(7q¥nü’D}Càà ¶þ¿[t`œVc5q¤ ¡P®ŸŠàqPåŸ3¦Â•¤Ô‚)¤Ê?Y 4‹IªDñ‰åÜ$‰/9Ûz÷â4HŠeòJ"/5¹xÉ€ÔÄ"'Öeûrß ø†'nó°û.ÍäèÅÜ÷ìÉ`«=ª½)ÆFÇ‘>óç1Ç-uû£ ju`Üyê#.ö‹Ž¹úç6ð{­“ù«éˆ½§Š[.¶Z?©ò•˜¨°›Â`åesƒË*YÅnoŽ V:·É`ÍæèÐ`Ͷ}ôÉÖwîUÚ¬›î.O›šÎ™’ÖT~X ŠzæðTa¹D¸"ÿÜÂíwibQF¤»\ЧԳ'NŠX«ôAÂ,*«šç-„þöZT»(~Ä'Øêâoˆ†Ü {¬}‡²„`QÃÚž;j:PéÂî=âIö&eÌC3—¾DÆ£þÇçßêÏŒ/ 7¾âˆWÄç蘞8¡æÔÛH:±îæ5¬_·6c>ÂfÆ¿&4I¶ÃÞŒ1ƒiMÔ3¦¢^>«T÷a.ˆ›‘h“`Ú–ËDT1ù}Ÿ!î¢uû¯òu|†Ü §P<ŠÊs¯óýÙ–²Œ` :!…ô§lþ°“N§œÎ %¨žºå %tÁƒ¬jÛi§Vzñ ©¯ðL ’•-'€SûÈnÃò&ÛB1ªšÅ"Ågò›ÿ²ç=<Ž‹¯wG%½Ž÷ð) –Jò“#pi-#A™#G1à”Fܶè¨E á©z&ª['À‘«’èäKþ¸lè'f†Ê|sÓ%6¦ÏLE€Þ#ÀêÜ"<¥­ÂÁ×¶’³å&Wa(ÓÓRìZŠú7-OÙˆzî]Y•ÕMt/Äàý<³$ó|‡{B#F[é-æD`B]c{ÓTcÓ]®žkìô5ÓØ)i ^¢|î°7¼ Çz’ß(N6 ‘<rW“Ý1ý7 › ¯”0_L÷2¼A_ºx¤#‰ñ÷W¥qD£h]ê)ö"Ž!m$)œA¤W0‰ÐMÀÄ%ÌÉ>Kö⢙±r& ƒÃh1t™šÜ®áþÛ¯šNà}3°Æ’õ»}ÝtŠ~ ÏÖuƒ`=F/N{%2[‹xS(-w[jò  :ÖõçGi!º+ªQdÏÃõ‘Rx:а¤âójš[-¿u[°l võïØ’¬~>¦—䩘™éßïUÈǼ5d·vàáö‚;§˜ «G§â3ÝôŽG Ýì´¤ÁÆwB÷ô–,œè—ž: &µj‹9Ñ<:ýµ¨ã¿…ÓãP=z<_!é<Ș<_yF7ÌWˆ¿?_Ä1еºòM²u¹´-¾Ô:’úøy˜Ð’‘ö—?ãGA—%ƒ®vÊ?€ VôIE)¤åpz¢L)foH?TæðwÓz(Šžj W»ù5l‰Jñ’ÇEÈt¡v¹ÖµbšÒgMÞ}},rý“RE+U$Óå¡ï´6ò¸²ZAª€À‚µô+o¬a&º[:xùò”‰Õ®–¤@0‰’œHÑZ%½`"?PÊ’¶NUEàõÍ»quÞW tŸÎ¸kDÔ ®GÚJjëbCtËÅ#ä²\¹qƒË²û}ØXŠMܨøì´"B™×ä˜ÔzKj2Z[×¼€Næ2¾Kë ß¾Bëwa&³±ã,ËŒð<ƒ¥6æ²ÞÉäîôÙŽð@Ëëõ‚cgj‰ñß6öä½³«nDlªè_wwú²!žwï’åÔNa£Ê˜Ðß|Ê;‹Ci‹=²Ãø&t #VÿζÐdtö¾5£T™?â©Ï¼]/ö@;¼µÐ”<<¹&I“éÏžÑDûÍž"¡³ª.gc0&òUj[à¡JmëO¦Ñ˜#fÖØ#©t©ý{PŠY‹©"—=¥¾Ô¢6Zò „¿|ÚïXÈq«sÜß>LyñÂ`Q›ýn±<Ò02¦CРȨõU¢ú5ìq2qE*ö‡¹OS ìÃ|_›ª"–$èìõÁðÖ¸¶¼ ä¦À'ÑÞ°¾³Ç1¼žœ)Í%QßPH+†Çš¡æâ€*…vãÛm=¸&úޜж8¥X´gÅ$ŠêaoëÏìçw†q,¤XŠñþÔû|¦×ÇólŸÃ"Þñ*…:­B ÚßæߢÏ: ©;Áˆw|[Ø"±û•´ú1‘:²,ªø-4â›jvÄLë– ¬ª&¨²W1g¼!Û3‚V$ð›èPþͯ¶ôú¤©1T„À‹Ä:Çxw4Âh磌B#Z޾í÷ú,­â°i%²äAúy€ ,è÷iÑX².„–Z熬Q‹`-â~c÷'±;’9]‚I›óÏ”Uô©Þ‰v2Höµóp&§±&–)ÍμSö ÞËâQ"ŃógŠ'úô’xÖ‹oiõ˜xùŸqÞ²x8›€iøIíf¥GJ¿¶»Òsììÿ{ì„~ŸØixpdÓ¦>5âÑŽ¦_æcgÌqaãUcm›ŠÈlÝSçú€±~%v«â6ñ8ÙùOÂmÛ©Ó8º&Âày js5,© "ß4¤¼¨èÍùÅ”m¢«‰b1½àq”Üæ˜ÐŽäõÞ¡Aؤ âœ"‚Ð4M|†ýÄq!/_´ r:-x÷•Éžž¹œH8¥Àè-å³åȈRM_Àö[è†-‡+7$Éåcf/½6«8ºŸÅ-§ÎG‹XÕY ‰j>`‚:ÒSB ñ–ò9õìÇDdÖyMªÉ \˜`·ø­xýÚ„…¨óczò„å)Ý0ay>ú_ÓsF+`Z‚ô¥Õ¶¤L¨‰ ,S‚êÑÕÀ–‘…ÿ]­«îÉéÆ=c—?%c]M +·d–Ñ‚2òÿêÖj"3K>Ørµ-J+êºTÒ°áÎqÍò3v¾î-,Åľ²–éïİ[ó³BF;»N‰ë%cI9,`on˜ís\‹ËUÂñZFnàè ú1á˘¢Å¤'°:I@ÜÕŒ&óe;Q„Y~ætŽPÏhÔ‰L.'ËL¦R¡« >&›ñ„˪Ù]>YŠ—Q»jÚV³rÈáÈP™€»Š„»Œ£ÜÊ]O°“¡‘ÖœB!>Ù•D/d8œ{66ö”Æ„•‘½‹¼dR¢Eu‡)jÜ%4àjG{ô-y©) ¼äe“¬B^fúKv¬=#ieˆ­îÕ k nØÖòÑCÒæ ž;ó'õÞr܉u§º:OJ¬×ä¶Ñ#¢Jdäò‡ý‡ÜÔn² Ø»¸oWåxfñ[mõ¡Yûœ“³n•7„åÒ¾åW“Ò`õ¾Ý'H/ï[å¹>ïmÚ—Ÿqfà³þì¼ãàJ# Ĭ¿½Ö£÷¥–cŽz}Uži=ªhW³ÖãN°>ˆìÁmµóû'óWþ šL€™x„ÆŸ'G$=Úàté;TžNÑ\ﳫ­ ÷ dU³uÁe&rÕ(¤Â˜&²4Ç-„ÇdÏ Œè.J¬UTSE–.†\ÞÉ0 ö2x×åÞ›JkÆ:Mxgy µ˜KÙX¦ãbŒÚƒìFQ]p ´Æ¸3æ}˜[¥k’psGKÆÜê+Ù sû—6\š IÕ-+Ò¬ûÄ*£b¹R‰¶vYËq$ÿ*bÙʰ™«ð–jû–Ü%pJoŒ¶þlB¨·rn¡õ¦¨¢$2Ž×$k‡+$©¤ÈšÌÕï–»zÂx<_ZEòjW§€qKWU-&óbI"qȯtUõú8ŽêCëå®Öö;`S—¯”òƒ²{P£è^+ù ‹&=‡«q0r.+cŒËaÆÅˆ‚D1½Î¸DÏÌ2Î}³Þn&ÒÒñDºX¤˜ñtàØ9¹GS* •ÕHåðJ €#ó Ìe¨«/€e)[ñY9p˜ ºá>šÞiRø4õ*ý[„ÞâWÈ)ahö¦ICêŒßÁ"äÐГG-.n1Ç_ñ7‘ÍŠžôÆSôô1ðª}…¸Òy 4†‹(}'KÆß“?§¾é¡sajz½ ñ…€w£Ôê×AçÌæ.Dο§t»˜¨2wyz7ÍÝdsg©‘1Sð@ªo+‰º€ÚÏDdôÚDæ;¢FpokÔHŠ#¨$¨ø,^Æ=4¦ñ¶qk{•Ž?~YíBª¤êr¤.Pý»›ˆÖÆh+šØ B²A©É&Oé–ª2ìW¼´BËç¿4 P‹sL¾Ã~=WMëÄewÁc]+—?ˆ|C¤¼k‡{Ǭ5’™¤käâäsŠÊ“J¼Œéé`SUçKØ4ïŒݳ?I$6t”Öë*ñ'Þ î†E±ÿî*þ_¯[yD¿ˆMI¹%§Ùiǧq½U5yõ¯¬.²Ulº.½iº.é°Âæ 3}oBåL†ät»‘£_£SÅ{‰èCôü[ Ë—uȶ;¬3tpû$€$ò@è™? 8ZGËè2ݬn. ï‹Å7ÇI¬¹ÇÕîá6Ý¿)…€™‹:)0M\jù'R¥¡÷uŒE碻¦IW=Ži¯ˆØÆî5 ”@¥]¡Ãƽ.jO˜JhªA~6¼•[Ø¿ŠZÒ¶Öåªz ¥× ßúGÃ2ŠÂÈ_0,Ó¶°¶¹¶ÉŘ©Û 4½DBðï‡=75‘eê÷²äoy`fÒ„‚À˜¥Á^…!– ©7Ñ @“Æ-ÒàÖb¥D…“NOwš¤Ç„X̾ã=åsêž:%Lšµ±Ìw„Iõ£óË\¨[g.feiæb¾³¼G3—’Ï– uMš©³b?ç-±ð:Ò ¤±?h¨Ò»‰,:C÷Z/ÜÓ¨·ô×8Ru ÈqnOd}­¿g&hËÑ'NHljÝúGߌÉÈäc¶ég´ØtQ,_œ<[Ó**JàÉ¿ÖCE×-î¡M¨H•Ì *ª2÷ç¡"L~œ·ÑZƒ¾†ŠpòQŒŸ£Ý'§B•8Gî¢W\º(M—@÷|S‡QZÕ–Y¦¥KPÿ¦eÚ¥›×´ž•2{T$#½ͧÿ‚jÞ)?ûËåúî’e ‘ñÆQå·ãPîC›ˆúÐÅê¹êhê—ù[$êeXIÞOTè÷ØA¬b…öébÌE„…£rA§ßá‹ÒEÁÒDn²«Ã*[ïv«¢ôÓd¨PEá`fæÿ–LÍ@!ൄ¾¬Sß‚F޵Ð0áß‹yfEô/Áܹ$ ¸¥Ç[a¾| â*ÏÈO†ê” 5|¿Žñ1¦™g²0ÌeÉÒoµP?Z-'ø{'¤TEÉÅØ°-IyE3DƒÁqÃÿÑbècÚ’À¸ŠW—Ÿq[t2+âE“†Ô=Ø¿Cyº´t Pë¦é·È§´K ½‹ $XRJHJ|Ö“Ó(Ѥ>ûÀJSŒ=Z\6w––^T>[÷” ž¤—å™ k-ã-@ãQR?ºt`6}LçûÓg›ØEêÏ)ó°eúHg VCµýr÷ê:˜f},±Z—¾—iT§ÆC‡ÂgÀuå7í\Ÿ¹T)îˆGPêFNÆÁ€¾ä)TÖ„é]ý[®æ³Å€x'‹„4Qå´wÿð8‹åÇ\Pʶq°~¸¢Éö ºùƒþöswþÓ® °Å¯¾ ¤èk*Æ«GTÅ]¾ ‰ÇšrFÁgm [C²ÐÂ`–èÇ×,‘Js…ÕçnŽ>þóô/šI~:ˆ!*ê~G ŽeèlFýZügÈ}Mn¨» ìû¯ÍpbqFL/h"T½ŸÇ|ü[b#eõygÞëe'H þ†ö¤²GªD'gÿd=J£(¾œ@Èy“·žGÛ™ YðÅQo°ˆk±èBÿ®agȈ\J®»áÍ®íjè·}²ÛcèÐg"å›cEǯFü呯o óïF½Ì6Ä8Œ)úÏ1~C·Êèž&(¡ð¢Éh †ãÿƽ-Ÿ ºJ!¦²Å°:fð 19¢yFÛhL»Ù÷6&Xî3é«­†a)˜fÑØø»Y¿ÒزˆÝ¶Íáÿn²´߉˜µ·d@‡ ã¸õÑjCõ§uŸpÎØ >ŸÜóTïþý²‘™ Ø•®'¶+ ¹„±Ùß’÷®ÅÏÇÔ¾g!“a$ûEL­¿¥>îBXwù\sä3ÜÆ—ý7ƒkà0Y ´æ-°&`A · ÌKßJ&²±OH²ë›3{E?§ðí¤¿VÊos “ÔAàXívŒíÚAÚYZ[¿®’œÀÙQìY<Óv¡sõÎRW~ vÆŒV5™;•^ÈHðE¸,(YE\ Ù„±þY‚ŠþÔ7“!Ù‡£·é÷;©D3€å¼Rûr÷Ò.±gE®×e#Ý e>mµÈ1®“Ѿd‘g³=ìÉENÝúò §,<$÷/î[¯T4уzØ­tÎMYŽ·ä]]â¨Ä)vÑïùøiI5¨²²ò¸P Ь* Ê€‹‹ý㪴ÂÎ=xmú÷ßz œÃ”õo¨¬+%›þ|ÿï×íß1ÓƒõÄq‹MQD8{©ä*;埔~{Ëoݪ'Ds„Ù¶¤;UôŒ§Î…§“rÞÄA¹…`ÙÂ&æû#Wf*ä¼2Sð`YJeêz3+!¦Áߟgê@øˆê-!RGÓà?iåê•|{a<èÛEœÉMÈ=×DM§à½ÔΠ†RèïÏKtÙƒ¥Aüˆt¶õ“ýB<&ô¿rþÉrl‘u¬Øa‚–¥¼³3t'ÁO´’"¢Ñsö)ßU=£Ûæ„o×$iâæXÌzšÁEá¡D­Yéô]{…Çú7'€© øùÝ«òÝ>dn}>ÞXÜLGg>ÎfïÀõðAŒ_6|‹aÈ8~jÀk(EˆE¨BJRÿafc÷ëé_&EÝ ¬´°Y/ºD¯òù“eÊ+5‘csŠf£ (þß}…‡+¼Z Ï| ‚`‚yÇ$@¡)D3t$dHÑ-BòSWjÀSXª·V"n+Ý Õ7½ŒhÚq%ÆÚnŠ8åü Ó&ÁE‰!Ífn"†ÇÝûP‹qõœWέ?##5×ëoK`Í g .¸#ó¶-ÎÆÎ¬µÝú=îÜ+Y^Š'²Žã¸¿Bîû0Uù¬² ñÔ5ûmx°„#öà"éJ<Šªj'?uwÑ#ë]µ˜.ªÄØjS_5kâPœ_Ù)Yî -?4ѧVú4@À»>ø@M±àŒè^M–»°aØv°Úܱ ù-ÉEX’ÄŽ—ˆaO±Ï!0 ÷RÊÑ—2S½ÅÔR°úªTw¡Âæwº~‘_]r½cxÜ€PÜyݲˆÐ~_Í–»`cquŽ8"ýÓ˜»f|é9”„4 àÔŒŸ¦Â"Ð*•²‹ã™¿§>£J§W«Ï€í¥+¡c³ i6ìŒM¤W`ý0u4a„ hP-;™\‡£KÙ˜ðÏ/™\{öôl㬛\Ñ3[=¹oÉdĨØt™]Ú6È,ú€ÛKÓ;5¡¸`fô’ }¥|³‚ÄÉRôüÜ"ƒˆ}ˆ:‘-}TZÄãAÅw°/¼·†P5RGËo½V<áù;7ü³ä–T4š—øÇÜ š¾À•U<œØk:n!i‹È„÷,ÛKNè$vzîF|ƼñÎG ºmI>ÄwBvo_þì=ã©• mZçm{ÚÒõëXßñ²î”å1Æå)Cü6©’n;‰ý)c {SFÌFLj¨«j%Â~µ-¾ÜÆ¢ªI´ëz·r¦wB’¯ÔyÅ¿ÆÉ«z¹äDÏ®æt,l¾rÝ{luð¢ÚEìt• pVWñ†âÔ=È?™üëòby‹æêý†²VX˜„ÕüeS‹j%8rÀ@Ô¥ù¯g:‰‡PS0u[Öñû í›B¹¦ ÷¡Æå-Îô®ßÁvÃÍ*p„êNWu®»âÒß=ŒÅ"GK—G+GV—YŠrj¹9š5;GJUV¤þMJVîDLÉõ¥9vt|D±×ñµQW¦JÑ2ÛO\»Ü_þûdU•å/{üÞÞ¢iÛ]KÞ·¾™¡þ÷lž2®7®D÷ª¬ˆ™éŠès¯è‡$2Ã/p¯5•!‡¶¸Têd»¿Icå} 3e¤ñÆÈõ½mÚð5•±¾á‚¸<<ü#d²õ§ï¹WèˆOß'†ªÕÓgËSÚEHR,³2‹Ôwön'íNvåV½?õVߪݵÕñ§ré +±Fº‰"Ÿ»xCœT'áEòDºQ°-‚§¤LàX«½E\žŒšP9b¨ø>Ë,&A͉ ¥ú$ÐWJ_È ç¿3…K9è¨J sE´J¥+fN´3GŸš9þ­ i"f̫Ԓ¤W"W <¢èìP”Ù'sE+Ð}_Ÿ»ôÝ2l$s†Å@Ý”A_,$6Â2üö»E ˆ¨«IFñ÷2Ó¥þŠHŸR§f“éLìP‘/ËѬ¤Ê@Û¢P ïK½Á“‡Gn µªX«T ‚åŠR+âP•Æã­uøýâð¾lÇúoYxZžØvI¯ˆC¥[;Ñ{S£þ­áÇwþŸõòÄ ¦K†ÔŸZ$‰+_ëIAL‹·ëp ††ê{„åAÀ¯—¢Ò+8JcÎZ&FžóËŒ¤Qi‰ƒ ÖÒ5Á#ݲ“3:–hËÍ,³ë ÈÐDò¦Eô2Ë|c§ó¨2£`!äý³*§è®dbí>R„V¸nR4טñbøéô‘ë»êÊñEU[Zîã¦í©‡ø”Þ©'¥…¬Pþ‘ž5h€>VEã;êá|íH!uuúd1U)<ÄäSj4.ÿ÷rzø!>zoðYÍD¤9›·¬dú¼ä ™½ª;‡$ÑÒfC>ÊMA âÙëÙKy\¤çjÒ/H–Y¬¢ijg@=X¦YYD×®•:lñ ÚœûÏHò%æª\ùT RÉíAmŠ¡LmÀAgÁ!25fÐi!ÖÕ¿bã¨æP®hš 'Fv¸“4«ªdÀ8+ÍÕˆì»Ñ[X×ìqG«ïÊàÓZj~×Ä@ÔM¢[ œU”ÚC…”ï¸$¨iÛXcS]"}ð ±²Uà?µêRýÁÔ’”>H?­Ç$ݯ\ÄdÎgÏnN“ßõ¹Ç’WÈ ·é‹£a ‚ætV,¯FhY§{@úu Jy’!pÄh]²S¬\^—Þ2Y—ºÆcåòºŒß­:Ý¥,”x§;%È`Љ!ÈàÀÝø>ùrœ1òƒe` œö87ì\ÝË«ÃÀ¦1 sˆ;öõ*ÎqlºšÐv·sôÐÕQv0E®r&¦ÂtÊvuÔ¡«£ò‘Ü訬B9Xü\ÚU™ë³…KàÄÔHœ¢ŠMÑáO:ÄgM¢¢øpKù74‹m‹ •pùô”ĺ’·ð ÜŸˆJ•¡Ô3=5µ¸ð pÌš#޲xTOþoÁREô³—9¢¡7Sy|ƒ™ÂIRšL]o¦p’.ÎÔ¥ ch#õ°iÊ; ž[LË;Z´vWß`=P”hÑ#Å%a ’½^ögã¼f"È"µcy#* @ÏWµV”¾Ÿî›Cv›y©CU˜óMÕÙ.—ƒž¦4~ƒõ¯š(hÞ7’Õ+ikâœè[£í'Çú·!H>ª·ÜG}xqàReDbìò}Ú•»…‰@Œ_NòÌb¼=ÑT”ån("V™-³ŽGÚ–– þMZ–á¾­Â2D4RSÌßßLã»"$ðdDŒr[-Â}N¤2FT …2›bká$›âGkë®tÌ‹7W+×@r$):÷ÃqÖõlÊ´ E«CÅ“¿edA.$8‡óÿJQC /ºh#ƒíyÁ:2~îòh‘ŽPD7Ô͉,`i¢„Ø, E¦nþŠŒ`Œ–©&òŸ%·Á°&ÐÝ!PýÉx/á®—ÑØfˆî2Ì“º†îrÏL ¹o :£´i*‹þt}€-?}Zj¤.´¾x¿ ±ÑÆiY~ gf ´@dP²Œ¸ñPYª\"%@éQRWÒg&_¤®Yˆæ:µPê'}G-$Û«À­·ÜÑ›YâszKùœ– Oõoœ)*CT å¼Ek*·°6!£ã-ºEÕ`÷,>®SïѤúx&->âh ‰PèÑÞR>§žñÔ¹mm×m+4!ú@€}ÛÑQ½n8iyb!þ…IËSÔLÚ!Ľ>i'’Ä~ ^ïkÓBßÒT›ÓŒhŠàƒB|Ïm_#xnlÇ %cRu(I¬Í€WÜ•ô Å\$Ðb*ŠEéÎyÜ©ëÎe€¯@û;úLV<Ò³‡i•ãNí`%gK}$ÂÊ ÐÞbH¹EÓDýU¥¨ál$çÁN”ùÏì`«g±‚´á»µïê˜ yxä+¾ÓÛýùg„ê,"«`®)¸~’¾¯5| ˆ¦';c’>¡e§ Mq¾w« -Z2hS_e;MA›)YÃf†7¼_X*Ÿ*ØÇ=Xœ(ZHƒh)¹XíДg\»b»E§v »§Í-]9Õ”uöe `zï,%„7`gŠ£,¨°âåêL²^“„p‡¡§6Ç“}«„¼/­úèy9ïf@³€¾„ÕM qì@–žß2;æ¦öa³©ýfô‚©Íñ°¦¶¼cqP$Z mœÜ·doæOtç…ÁÅì±U3(–«»àAã: ”;ç@/Bægn‘¡I¦®\è×טŠÀL׆ëNáøL’&tÑYŽ|ÿA¶m D•8öïà6ÏŽ]·©·”Ï©<Õ¿qUEÂWxê¨å ÐO1‰W g‰Õ/~Äg²j¡øÔûh!¡tÞ¢LÝ4âüH¼¥|N=ã©Yf©÷:½íP$»_¶nõºá¤…¸ó cŠò¤åiÝ0iytùigÒ”¯ëS„}„MaùºÞ×¶%3V,C”GË (ðfdslYÙüBP‚'oÒþgÂı«šà;<±;ŽóË+QôœdºæÃ0!¨‰V¥Û,&¬,ˆhÍ÷1B-Îö¥·h³lEí¨crËI2Õïxxíï¼|>QÛÿiªö¨2‡DƽšC¹œV«c¢_tÝî¼&Ͻ-µy{@S$‹áP´î¸t-ÿ&æ M]Šù.jà+¥³d”øÛkí²¥ +¹Ì2Pˆy‹»Hö¸…8Z÷]a)ÈôÌRïÔ¸1œ&ªµÿ`vÕ »ˆ‘åÂ?fié;²lLz+ãv”‡îªõAV³µ1 Í ”H.äBµú:® Y­A)»M³c‘S}uýÀ{eãÄ$5­É€ûBJ¯ì5koÔ‡æe>ÖCJ…„z#þÈŠ öä¸ÁUÖ‘ÆŠl.íQ˜ ;ûDâi/ž{Ó5·m¼ðDª…zQáÄ\¿©>»ö‰h)ã…Éy^Ûúfvîû^³}7ahä9JƒFRï˜l»`,ܱ®ñ_›·±~ìS“.‰€, q@ïuô™‘’{¡ó—³9Ÿ+šOþ{‘»RŒÓòèd̘ë=¹‘Þ}$N”½­xÄ—«R`†³W–Â!Š}™ÐQÙ+Õ<©S5sŸöSªç§1®£¥`Fu–3l†ý[¨3yÌöƒi¯Ö/^ZË—å*ñø·P ë´‡˜!t5eͦÛõ3Çd‚Yë$¶~¹ 5TÓ¼$CÕ±* »ŽÈ§Q A¥˜¢éK18Á•ÞhÜ+p8Íþ¬{7U*“^õh«Ì$[KJ¨êRØpH“ÈÔ€ÇÌÿl=:Œµ°°§-/ÚÓXàÉânìiä‹ö4fdìâè™B•õ¿…&1¦íŒSŠK:Ek¢d-Ô„ñœ 鹬šÒK‹r$äz²@ƒÉd¡F‘ŸaPÊT/8D œRjÉ¿Q tÆi|ç¦ ”Àݪ·”ÏÖ_öo¿tRìR‹* RWØßr;ò÷Ô+ý;5J>ñ‰Ó¥ú”F¨oÆèoªtÈËgë…¸€Jb6‰UÛŽa%õëXÍùe³ ÊâÁ…¨óeáo˜ C{0A"ýb %*Œs‰ÕSÝBßÒò «Æ4ãXÌ%GtVBš ‹—Óï„]ã—þ¥WHNSé~Ù¯òLåÄë @5©T½Ce ˆþj‰¹tÓ¹¢¡Nœüb ¢HŠl‚haV Æ]ê¬nq“´ªß™Ò«eõÔ!JT;ÍBpTÔ-ÕàÝúÈ_¶M‹2ÝhgqK „Çû¬vÏÊn¤VtX(Q§¢Ê®õ±å8d©KëvV‘m§ÿ¶4{@v¾‚A§# !»^J<þM˜ºk7éªk“וÁžFïç™s¦j“Í¡Z£Ê¥¸j“ Ó•áiŸj&E†ª€Ó¹´y£G<@Ðh][f{í ¨û2úcÚ’ ûʺ ûúä¾ïj]W¦5`Jܘü{:wÞ³7nĵsÍ õx32ʫΠ–ÊW™3Øð×+×vqo|²ÍÎê/æobóøÀÚìÙ®Ç7æO–tFMçñ1¶>¯„ÑÔóǾµ”í_ícÌaðxÛcÞWö7t9•¡ˆýì÷ã­½ ˆ[íªøZ’JÓ>x?B k|BtQùWü®D¥2LJó–t‰¢¢÷ˆ—Ç‹–.P!Ì´äFL|S}$ƒ—}‹pBEGKQÑv%‘VSíßÚ`— SßU/˜:c\Á‚¡\-±¡¥¥5¦e§ãBËPG‡–í–ŠûKj¶Ü>¹ˆFÕS¹”ák¡«jJ‰ªyû6Ö{¼Îp‰ñ }Ùº¶%ᤎé­Ú·»JmЇ™ØÆÊ5‹Yx户ú|S<¯˜6yg Ç\:›CK³j¾É«)ï°R×qêSbs°RŒ¥ùzAl/âíˆókr2¶ ÔI8zÞ[ì£Êù·f¬Êù÷‰¯I÷”qã}x ÆÑYûÖŒ$t¦ A}Ö ‡› ÞZ’Iždñ'v÷9á;{p yÁb£GÖ†Ó„ þ¨i CuHsånêK-j;qÃý½´ß¡})1ƒåw´ê~<þ».â÷9A›@Ûê"$}Û÷HŒ7 )®G0çþ ÿ-—¬É>YX±Hðµ“ôØÞ±!=i8CÛ[Ja²ÕÃۼŠ+ Ù{0¼1(}g‹‹ÂÀõÝèºï(hí'Øø£êý-¾S؉Њ›¢ j´h‹¬mîo±müÝXaµÅŒ: ·“Zˆš‰þÔÛ|³ZgჩHAÔ=Ý D[8µ-ù°•TäC7k[º¹õ\7šÊÄ‘ñ†ý¡ ó.àâðÁp‘Þ5\^¬›=ˆ6Ýl¯t«;h¦ç ã\à 7 †ûhÌ\VÈpò²{C±_è±òئæKþW’8À$ WõE‰ž§$qhTfȈ³²ãPÆœŽ ­>_pö}}nø·et‡û® Ã~ðLçî8v6^¡£K®UÖO)ýiy-ËÁlBÒ¤š ¦ã°Ã%¾*Û¨¿®È‚nâ̾ÔsÒàu›†xæï=÷Ž’nì¦Hm6y.ó²[êüô 8æŸAÑ—MâØPË\­`¥àSzÓꯊø¸E§ï[+ÂîdèÇLv§F¡ês y_qÈa&`.‡é)žµ°*8)âC¶ß,oª8Ȭ øc”è-'ÿtª1zfggî›Q¥A5®–²Iã]šêt§S&´Œb‹,kµœW/<ÃFé „W"U€ÆKO’µƒ9O¸dÔô‰ÏTF‘Š x?ZÈÕl[.çß¡ú/,šâ¶ý-ù³÷ƒ§ú7.D¡)_ž§ŽZ´–ªÙÞý-a:SÇü#¬6ÕŸô\FUå­úd|#„/(ŸS§ôÈTm1¨9õ6ò°B¨»ÐÇ -«_7i™ÏWH:1f'ÏWžÑ ó•e?˜/b¯bvÎ\¦ ü$ÜMÛ’3©LÖæ âX`îGF×CîäaåZ”6ŒcÔ#(0kF"‹Ÿ’ ®S“ÒB¬jÕv‰nÝ—wÇü—i@}%»Ô!àæ,îö. D)Ž°Ë„^’>*þE¹ª©As”öŸº÷üÖ¿jJa_ð¾,¸NüQ®)wV¨Î}»ßÌE9±âýµúÙÀßq0)r ˜me—c:qßû‡•À¦[ñ¢Øb°,§OVTö÷qpªGÆoÏl©øxÊz\€ýn§)æ–£ÙêÑ]ÈӛƻçõÇ auùúã@|“7Y€©EåÄbÒY.i3èßþ쿜‚¯oWØP­ÍùAÿ-U¯Ë*ŒíÙ3wÊ”?.”?Š>Ô«©I3,™‘x-©É)«úÿ¥¨øH&ŽÔPLJV¦ðP£I­¾­ð8¤Má¡BMeÆ™½®ð¢S:ÃK·L-n1iýc"Cì,Ão€v ¤®0QºŸê†)šZˆå<¨H÷ççkª¸®ÚáW¼ã³´ø–ã6Z„6Ú%{¦§Pï:V:·^R>§nðTÿF„ýòÔQ ÑÞØ_`ˆi½$n|ŽnÄg!ŽÔùh‘¢µXáE7?$Äáï(Uÿ¤xá,¯Ôõ¤˜M†-¤º#Љé‰G—L',DGÓ“',Oé† ËÂL˜@LL)Gœœ´’­wµmq¹LdEm@3v½b@ü„¾pÕ=½7m€ÆyU‹‡»Åɸ¸Ô,!\.ãЗS½Qp<œ*A'”Êuu•5hZ”…Ò)-pz^ø—¦ æîîf7ï‚[P^Kd…Z&ËfÑ„þ·®ï ®1÷þþZÓlÂ-\yÀÉD,øÄ4 >¦žéº¸ÖÃce™¸N€ø#Õíêî& üÛñÝî6mâ"È|ôv·4…oú{r´ •[pQ òïKmTüŠ H hþ @Q-µºÝP+{ÍÁG(€KëFÇGÞ”õjØ'˜¸Œ hKx]³y²S!6²tÐ0?FýGà|ëÄt&uÈ qvÊ{’§pÜŸ»}ŠËÁA— ʰf¢Òàv$µë9pIÈH‰Ã¶cœl«xëjëJÒ…‚ŠUE˜tÎÊ8Y¹‘ÇLUßÕ‘sœD³É8ñe¼lœ=«:‘â‘äwPuÄwV2VÌQ¯®àµ5JÆŠ’QWuñTÉį6ÜÇc1o”áU÷|²CÓDQ¾x¹§û[ʤ˜#"^P¼Ô%§«š‹ƒ¶kʰ¥¯$š§/ü«}žð¹ÿÝ~ȧô8áõˆ~Ôû¨˜TÝ}/ƒZ¥u9õÆ'ÆZXR2[·æ® ÎË2 vs"ñËP4 ì¶–`·ò(c—âöKœ™®!JVEéªÁîEB8ÑÉ‚7ŒŸËXLm)‘Âöß‚9ËÍtžÿÆ„²žØ¥Eñ¦ÀìBÕÇT·îǽ‘·#`Ÿ…ÍÉQkE‹ö§µäï¨Eæ?Oó§Ä–Væ”ÞR>[?Œ`LÈ’z;–O£gŒ[°ˆ8Nâ-*°{µËÅRÏâ3SསµÓ’Fß ‰ÜewÝnYfÑ3=u.E³ª¶~P1§ûëwkկ˓Ƽ8iyBšIôÚ¤aXÆÝD/¤úæI ‡¦…7§%7VsÞ+&R'¢Š$C;ÒµËóê^Ø¢èf¬°Bð„C9(Í`ÐÙ/¬,±ðΛɪ8ØØsW¥-à‰Ø;”/»Öþ3eèÄ0l±Ÿ’w’å×Í«NJ«lêpþ;LÔc¬¸abŒIÁ]·"ÖcŒ³NB.è¯öô©^ü£ —-Îw¢Áüýµ.ÚbtIŸ)GÐÃübP0ü—ëòÚbu9îànVÀhbTõ è…ÔkË œ­õèö‘ä[ zñ÷ì­ènªÞÃM-ý÷O z­bw˜<«'¦òˆ}ì>vJ¼fw…Ü`¶!­kÕ䆜¾£’9em?*êMGGœFø|9L¶ì'jè~Rº©‹0ÛKk“µ>,¡Sçkİ(ž«£ZHVkŸ­Ú †õ U!¢nH½?ö}B„óØIVwkƒZ¼Ác|>Ü#ÜFK¥÷£Þ£Š+Ý Ræ•lžaòöu/&Ç÷^{ þ¸í&4ø×_?þ…¥@`‘'qŒ° Þ¨¥t#=HªGÊß] „ÄqLî· ¨ct$<½‰F´z} ˜ÒØXFCH]‹šã–6S7þïFUìPÍ­­2Hwål"‹¾ ö¢d|ZÁÀJïn¶ƒ™oߟ%põL¬˜Ýk–s¾ßÏU+ë7R•o0ïTÀ½kÎIèoˆ äºcåŽVQó4Õ€¦{dÑ|æ žÑU™XSt–ô«í×±¬0-;ë«:S†‘áo`V‡¦«v‚‚À"VW+G»DËH'ƒ¯¤cèêޤýÞ19G]™â—ú•/1Ðå=2*VB ÍH•x"|¯Ö™‚x¢+õLMáp¡‰º4Ir8ñÅž›GbÛ?obKÙ„U¼ ;R6ÚÄ]ÔŦnX€a ‡aŸ_2¨ñ«¼ý“AÍçÖ ŽÛ3óÞn÷:§£‚ØC¶PΚ2%›B稟¢  +Zâuý„Á#y D ay9P¡Ô »ô³˜ý% &Š}# ×¢äN4ÿW9R™àtæö:£ÇãstAOMß°û—TšR]jJ™×|'½èÄ`T)÷%~|Ä¢å·n‹ úßI޵Pòø”2ÂyâT|šÎYƒ‘#š†þ¢Ö±¸uQÛs[æ)iÃ<&3ן'ÌÏÕy‚ö»^!V\8ö‘Y›‰¢/ìõÿýßÿý÷ÿúO·ÝÉL~dÕ\[~RN¥~ä«s êaÆ}¸Mª"£vÖë³€•þ{“ y\E4J"ÛDÓ2ÚëÔ” å’Ký3-]¶\n²•J»v†“Q­Ú£Cxʺy¿N‡`YCé‘Ri¡§NaI4°% *3Õ\lÙ\CS›¸ùÞ¸úù¢ùò”ÿç†_)úPë L7Óõ»íèPõ -›ò“J¯ûEŠ`¯ÇìYᦧá¢Äf&yÔëRäB<ƒ>¬WA{’•vÆ}@Tă¨Ö¾±°¯TD†Á~%믛 ðHÿ>?À—²˜hŸóJZ,+"ƒ'!tÁ’Žz}ؘ²… KôÅ‘”÷ÔGà>´R›|±GH¾j¥-ŠMÿ([z/± úð¢Ø`¸©K1Xmã°¤÷6(õÎ÷G[7I+êûMÓ§âàQ$»éJÅþÛ‡œÊ+åF6ÎÚGmdä ±"o®–|ó°Þa%‡'¹ÉR&DËÔÝmL!½5¡è Ep5¡ÃÑÅhG·F-ÆèxAîa`Wûœ2”ï@ºNE™=úê\qv½¬ãÐô®´I,bíñv|ë³Ç´q÷‘òÔáNó·O†y^æ^8ƒmF÷>&gŒ/¬ÿþ8×ç‘ÜkÜ&G‚þJC=ïAÖñiRÀgœcN ¿~|oâÁS–y­¾!É<ïC`Ê0É ¶ï>¦fÞœ¢¶>Ù{P–¹!4ÙòG«?¼Õ—@zãDA+u¤˜à Æ»i˜²‹YænR~XÉåýK,ËÜC’ŸÚ}‚•/ðt#—“$óo‰çz:®åbÃaŽ9ó™Ì¶,‰Š²M̶hš˜mªY™æõOÍl[Î7Ct>î* »¸DÇÇ]>þ kšudðg¸ ¶äœÛr5·Ê22§œ Ïö+´~Djp=t›>¤xº£.?Ï0¨ËÞf©Vv¯ Ï”*µÁýÁŠ~Õû°Ðzöu‘ Ò/Üߊ\¸˜ÌÅк]äÂB;¯˜S g’§ô­õ©–I)Vðño]:›¨pC"ìQ÷ÇåÂV+b¸Ë¥ßÖùÙ{yC~eÿp¬ê¾¦«÷«…1UlÝy¨Ú ¿jtb·A}Zk•o …9ɨ Æ^\Øï™ ,‰Dʈ]ñ'<45& xnˆô†'g¢Hü—z~þhï‡#Ì zŽ® 94-“ïèÑw>û+üÙ¹SþùGôû@9{ûoÑÂâË-1ToÉ’°§cž…¨RϘÊÜ’:¯c¾jêçQ3+³¦˜ 5WqÁ2“ê¤t)D—àR2Vwc£>$6!^¹c7ÑKH:—ÿ꪿¥ë¹á—ê Þ‡Zådt;¦3ÉÁ2$»»ÐcÌ.‘­³™EdºZøA¼Ñ+‘šHm›ØÛƒ@<¼ø”ÿôa#+÷€ :’³N€«ª.÷Åf•UA¡©<3QŽÆŠ)çšVæ¿þãøÊJCéÞ.|ElÚÅ›VÛF± úð¢Ønlml†¾Øö!¾ÊjãÔ ZK“¦oçÛ÷¸>Tˆ›-J°[@’êpÇ;r¯¼µNTAöI¶T½Nz¼‰øH¶F^gúT »<ÉEUyÝŸÏ÷Ê~ÔñPy>ß >nâΆË-Ðo-n0†g†*®‹þøöɘ(ã»cbgÝ,øšrÀß 2׈ڇö!6ûÄ\ôp½<þúr>x1qÔpiçO{ÑMfqš9Àk²Gß]¦„ Ÿˆßå°ˆþ<îCƒ•q^ Áž†þ3¯Sð´ ÖéC¾wÌ:¸=¸9W¿ÆÌ㥠·á>Ieúù§ÓÍk|—mhjCÌáÃb>;’¤ðVõ§>Õ_Ð¼Š¼QÕ!•K[`Hb*Æu1¾5,înµyá*%È»¾õ¥‡.`zêÎ BF/YaíKb3­2¸VÝ`ãΦ†HÌ0nôˆ+NøR˜ÑRL uV™¶n¢ø·6˜"(ÐK ,Ë.*™„·šfV–¡–š ÃèO?%^²…Ô<ý}Ø¡L­rì¨?:‘¬ƒÌ”X)q¤ i?}K&ÄBôz75gÊeî!–ã2™÷À?û8õDê]—ë9 <ɇшçw·Bñ~ÑûÅS= §QN>yÉ Z‘ ¥ô,Ñ›¨T¼?›¥²Nûf©°fJ*Ñ.15[¦)pÆ-ñXðiÙ²)7¼_Í–eF-ŽÈSzK&ƒNÎãMز`ö”WŸûflgÊ6ú3¦¢ŽKX¤SòÓâ9×ÈÏ“2€8ªD÷ó#7p¾«^(œåõ@e¤ÎŠÞÙ)þñ1ƒ\¡2™7üÖi€™ãß`‹ Cðfééþ1ÞÎÓ¿s‚@éŠâYhPÅÂËáì/Йc÷Vx—âóÜëhù­Û¢aÆ7BG•r‡‘*Ÿ­WzäLjR ó¦˜Å $æOLQxeЍeÐÎYwŠ>V¦è Ê{L½¤™„Ñ4øšj¥Ã´ÆÃîp¢î¹…uj铚ó<Sq²ª µßˆêJ‡èeH«Ê6ÔQ.®Sǹ8PµEér;ÊÇ7‹ÈÁrÂ=¬“‹÷ÁÑ48Ysñ-æ²ÒúS±!I_[ÑòQµl*Š ªt ¾Ãíï ­) P ’dë=H„“ÿ‚ÓM1èìšjrU®SË’',õWœ*³©”Z[³COØgg2œ‹êêvÍ3ĶG”B Ëô «ujÃÛ2: ­i¯†Û† ư»ºý$èÈi ™úшšå§xbª[¿Râá,¢‘:½ ò ¹bcÅRÙ‡o*’$;ötáx®‹±Ý’Ìð›6š‹ ¬Kuñ;] ¯H•¹À³|ð%SÉ‚M?eE’ñv%Fç;¿fEtƒí§ÅRÑöYs+afCĈˆ ޔޗjP[bGüØ[Ï9§6¥ÕbæVßA¼×狳ʫPÀO1U”®1ã%®Ö¬D3|6|û³_µÚ¼ƵLR@åt6Gö’äN˜o­6ƒÉpAr’ñ+ùIeG†fˆèßP±öï2H%c~ðâ¨ý ßüÁ…ZÒ}Ä´O FƒêÁÜ?›<^CBB {#Ib_¬ú€ÏÄjHÁç¢õLïcI–!Raâz!ÿ¹ì>´¥™Þf‚ 0…IÙ%Š4³Ä…C8 ú²!Èï°!¡€…keDú«cl“–M²ä—EwcºÀÇ­è´$>mý=ì—e¶b3¶ÔÕÙx>H¡¸fÎá}h)E"_aÕäýYIëå¦êœ V%ú4$ż¶¿Têžu•fR© ˜ÎNntÆ!JU?<ð %#Ž”š¼Òl~«¯èô€Í¿ÓÍ|{`JÇ$‡„ t܇tßÄ$òftPÊvL’z ñf¤¾Dß¶¡HŸë„yزl´Ã|üÇÿO#s endstream endobj 392 0 obj << /Length 904 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 206.3152 450.2884] /Resources 905 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@é@”ž$ endstream endobj 393 0 obj << /Length 906 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 743.324] /Resources 907 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@é@”¦% endstream endobj 394 0 obj << /Length 908 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 166.3216] /Resources 909 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@é@”®& endstream endobj 395 0 obj << /Length 910 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 166.3216] /Resources 911 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@é@”¶' endstream endobj 396 0 obj << /Length 912 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 177.6576] /Resources 913 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@é@”¾( endstream endobj 397 0 obj << /Length 914 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 358.4668] /Resources 915 0 R >> stream x+TT(BCC „Rɹ úž¹f .ù@é@”Æ) endstream endobj 398 0 obj << /Length 916 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 62.0304] /Resources 917 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@é@”Î* endstream endobj 399 0 obj << /Length 918 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 251.6592 149.3176] /Resources 919 0 R >> stream x+TT(BC3 „Rɹ úž¹ .ù@é@•Á5 endstream endobj 400 0 obj << /Length 920 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 806.5564 191.2608] /Resources 921 0 R >> stream x+TT(BC3 „Rɹ úž¹– .ù@é@•É6 endstream endobj 401 0 obj << /Length 922 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 51.012 220.7344] /Resources 923 0 R >> stream x+TT(BC3 „Rɹ úž¹† .ù@ù@‚^ endstream endobj 402 0 obj << /Length 924 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 668.2572 712.15] /Resources 925 0 R >> stream x+TT(BC3 „Rɹ úž¹†† .ù@ù@Š_ endstream endobj 403 0 obj << /Length 926 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 708.7492] /Resources 927 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@ù@œV endstream endobj 404 0 obj << /Length 928 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 675.308] /Resources 929 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@ù@œ¥W endstream endobj 405 0 obj << /Length 930 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 202.3134] /Resources 931 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@ù@œ­X endstream endobj 406 0 obj << /Length 932 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 582.3528] /Resources 933 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@ù@œµY endstream endobj 407 0 obj << /Length 934 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 697.98] /Resources 935 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@ù@œ½Z endstream endobj 408 0 obj << /Length 936 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 729.154] /Resources 937 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@ù@œÅ[ endstream endobj 409 0 obj << /Length 938 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 80.168] /Resources 939 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@ù@œÍ\ endstream endobj 410 0 obj << /Length 940 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 615.2272] /Resources 941 0 R >> stream x+TT(BCC „Rɹ úž¹†– .ù@ù@œÕ] endstream endobj 411 0 obj << /Length 942 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 224.1352] /Resources 943 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@ù@œ–U endstream endobj 412 0 obj << /Length 944 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 690.0448] /Resources 945 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@ù@œžV endstream endobj 413 0 obj << /Length 946 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 580.97 604.458] /Resources 947 0 R >> stream x+TT(BC3 „Rɹ úž¹FF .ù@ù@›a endstream endobj 414 0 obj << /Length 948 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 713.8504] /Resources 949 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@ù@œ®X endstream endobj 415 0 obj << /Length 950 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 680.6926] /Resources 951 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@ù@œ¶Y endstream endobj 416 0 obj << /Length 952 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 428.1832] /Resources 953 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@ù@œ¾Z endstream endobj 417 0 obj << /Length 954 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 219.034] /Resources 955 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@ù@œÆ[ endstream endobj 418 0 obj << /Length 956 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 669.0732] /Resources 957 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@ù@œÎ\ endstream endobj 419 0 obj << /Length 958 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 191.2608] /Resources 959 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@ù@œÖ] endstream endobj 420 0 obj << /Length 960 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 695.146] /Resources 961 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@ù@œÞ^ endstream endobj 421 0 obj << /Length 962 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 662.555] /Resources 963 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@ù@œŸV endstream endobj 422 0 obj << /Length 964 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 130.364 665.389] /Resources 965 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@ù@œ§W endstream endobj 423 0 obj << /Length 966 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 94.6214] /Resources 967 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@ù@œ¯X endstream endobj 424 0 obj << /Length 968 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 154.9856] /Resources 969 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@ù@œ·Y endstream endobj 425 0 obj << /Length 970 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 273.4468] /Resources 971 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@ù@œ¿Z endstream endobj 426 0 obj << /Length 972 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 709.316] /Resources 973 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@ù@œÇ[ endstream endobj 427 0 obj << /Length 974 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 582.3528] /Resources 975 0 R >> stream x+TT(BCC „Rɹ úž¹Æf .ù@ù@œÏ\ endstream endobj 428 0 obj << /Length 976 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 505.268] /Resources 977 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@ù@œ×] endstream endobj 429 0 obj << /Length 978 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 392.4748] /Resources 979 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@ù@œß^ endstream endobj 430 0 obj << /Length 980 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 917.0824 284.216] /Resources 981 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ– .ù@ù@Üi endstream endobj 431 0 obj << /Length 982 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 95.755] /Resources 983 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@ù@œ¨W endstream endobj 432 0 obj << /Length 984 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 676.4416] /Resources 985 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@ù@œ°X endstream endobj 433 0 obj << /Length 986 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 235.4712] /Resources 987 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@ù@œ¸Y endstream endobj 434 0 obj << /Length 988 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 645.2676] /Resources 989 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@ù@œÀZ endstream endobj 435 0 obj << /Length 990 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 125.512] /Resources 991 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@ù@œÈ[ endstream endobj 436 0 obj << /Length 992 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 228.953] /Resources 993 0 R >> stream x+TT(BCC „Rɹ úž¹&¦ .ù@ù@œÐ\ endstream endobj 437 0 obj << /Length 994 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 146.4836] /Resources 995 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@ù@œØ] endstream endobj 438 0 obj << /Length 996 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 731.988] /Resources 997 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@ù@œà^ endstream endobj 439 0 obj << /Length 998 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 109.6416] /Resources 999 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@ù@œè_ endstream endobj 440 0 obj << /Length 1000 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 103.6902] /Resources 1001 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@ù@œð` endstream endobj 441 0 obj << /Length 1002 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 70.5324] /Resources 1003 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@ù@œ±X endstream endobj 442 0 obj << /Length 1004 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 720.652] /Resources 1005 0 R >> stream x+TT(BCC „Rɹ úž¹¦† .ù@ù@œ¹Y endstream endobj 443 0 obj << /Length 1006 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 92.921] /Resources 1007 0 R >> stream x+TT(BCC „Rɹ úž¹¦F .ù@ù@œÁZ endstream endobj 444 0 obj << /Length 1008 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 59.1964] /Resources 1009 0 R >> stream x+TT(BCC „Rɹ úž¹¦Æ .ù@ù@œÉ[ endstream endobj 445 0 obj << /Length 1010 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 342.0296] /Resources 1011 0 R >> stream x+TT(BCC „Rɹ úž¹¦& .ù@ù@œÑ\ endstream endobj 446 0 obj << /Length 1012 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 451.7396 382.8392] /Resources 1013 0 R >> stream x+TT(BC3 „Rɹ úž¹¦¦ .ù@ù@Îg endstream endobj 447 0 obj << /Length 1014 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 206.3152 450.2884] /Resources 1015 0 R >> stream x+TT(BCC „Rɹ úž¹¦f .ù@ù@œá^ endstream endobj 448 0 obj << /Length 1016 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 605.5916] /Resources 1017 0 R >> stream x+TT(BCC „Rɹ úž¹¦æ .ù@ù@œé_ endstream endobj 449 0 obj << /Length 1018 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 80.168] /Resources 1019 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@ù@œñ` endstream endobj 450 0 obj << /Length 1020 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 266.6452] /Resources 1021 0 R >> stream x+TT(BCC „Rɹ úž¹¦– .ù@ù@œùa endstream endobj 451 0 obj << /Length 1022 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 17.004 725.1864] /Resources 1023 0 R >> stream x+TT(BC3 „Rɹ úž¹f .ù@ù@¯c endstream endobj 452 0 obj << /Length 1024 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 1030.442 739.9232] /Resources 1025 0 R >> stream x+TT(BC3 „Rɹ úž¹f† .ù@ù@·d endstream endobj 453 0 obj << /Length 1026 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 180.4916] /Resources 1027 0 R >> stream x+TT(BCC „Rɹ úž¹fF .ù@ù@œÊ[ endstream endobj 454 0 obj << /Length 1028 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 405.5112] /Resources 1029 0 R >> stream x+TT(BCC „Rɹ úž¹fÆ .ù@ù@œÒ\ endstream endobj 455 0 obj << /Length 1030 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 326.726] /Resources 1031 0 R >> stream x+TT(BCC „Rɹ úž¹f& .ù@ù@œÚ] endstream endobj 456 0 obj << /Length 1032 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 292.718] /Resources 1033 0 R >> stream x+TT(BCC „Rɹ úž¹f¦ .ù@ù@œâ^ endstream endobj 457 0 obj << /Length 1034 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 673.3242] /Resources 1035 0 R >> stream x+TT(BCC „Rɹ úž¹ff .ù@ù@œê_ endstream endobj 458 0 obj << /Length 1036 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 640.7332] /Resources 1037 0 R >> stream x+TT(BCC „Rɹ úž¹fæ .ù@ù@œò` endstream endobj 459 0 obj << /Length 1038 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 999.8352 147.6172] /Resources 1039 0 R >> stream x+TT(BC3 „Rɹ úž¹f .ù@ù@ïk endstream endobj 460 0 obj << /Length 1040 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 154.1696 285.3496] /Resources 1041 0 R >> stream x+TT(BC3 „Rɹ úž¹f– .ù@ù@÷l endstream endobj 461 0 obj << /Length 1042 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 571.5836] /Resources 1043 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@ù@œÃZ endstream endobj 462 0 obj << /Length 1044 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 315.39] /Resources 1045 0 R >> stream x+TT(BCC „Rɹ úž¹æ† .ù@ù@œË[ endstream endobj 463 0 obj << /Length 1046 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 326.1592] /Resources 1047 0 R >> stream x+TT(BCC „Rɹ úž¹æF .ù@ù@œÓ\ endstream endobj 464 0 obj << /Length 1048 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 538.7092] /Resources 1049 0 R >> stream x+TT(BCC „Rɹ úž¹æÆ .ù@ù@œÛ] endstream endobj 465 0 obj << /Length 1050 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 106.5242] /Resources 1051 0 R >> stream x+TT(BCC „Rɹ úž¹æ& .ù@ù@œã^ endstream endobj 466 0 obj << /Length 1052 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 732.8382] /Resources 1053 0 R >> stream x+TT(BCC „Rɹ úž¹æ¦ .ù@ù@œë_ endstream endobj 467 0 obj << /Length 1054 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 710.4496] /Resources 1055 0 R >> stream x+TT(BCC „Rɹ úž¹æf .ù@ù@œó` endstream endobj 468 0 obj << /Length 1056 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 73.3664] /Resources 1057 0 R >> stream x+TT(BCC „Rɹ úž¹ææ .ù@ù@œûa endstream endobj 469 0 obj << /Length 1058 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 748.4252] /Resources 1059 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@ù@b endstream endobj 470 0 obj << /Length 1060 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 714.4172] /Resources 1061 0 R >> stream x+TT(BCC „Rɹ úž¹æ– .ù@ù@ c endstream endobj 471 0 obj << /Length 1062 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 331.2604] /Resources 1063 0 R >> stream x+TT(BCC „Rɹ úž¹ .ù@ù@œÌ[ endstream endobj 472 0 obj << /Length 1064 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 516.604] /Resources 1065 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@ù@œÔ\ endstream endobj 473 0 obj << /Length 1066 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 549.7618] /Resources 1067 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@ù@œÜ] endstream endobj 474 0 obj << /Length 1068 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 554.8972 257.5764] /Resources 1069 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ .ù@ù@Ùh endstream endobj 475 0 obj << /Length 1070 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 714.4172] /Resources 1071 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@ù@œì_ endstream endobj 476 0 obj << /Length 1072 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 689.2288 580.6524] /Resources 1073 0 R >> stream x+TT(BC3 „Rɹ úž¹¦ .ù@ù@éj endstream endobj 477 0 obj << /Length 1074 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 659.721] /Resources 1075 0 R >> stream x+TT(BCC „Rɹ úž¹f .ù@ù@œüa endstream endobj 478 0 obj << /Length 1076 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 637.3324] /Resources 1077 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@ù@b endstream endobj 479 0 obj << /Length 1078 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 527.6566] /Resources 1079 0 R >> stream x+TT(BCC „Rɹ úž¹ .ù@ù@ c endstream endobj 480 0 obj << /Length 1080 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 17.004 637.3324] /Resources 1081 0 R >> stream x+TT(BC3 „Rɹ úž¹– .ù@ù@ž n endstream endobj 481 0 obj << /Length 1082 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 799.7548 437.252] /Resources 1083 0 R >> stream x+TT(BC3 „Rɹ úž¹– .ù@ù@Êf endstream endobj 482 0 obj << /Length 1084 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 169.1556] /Resources 1085 0 R >> stream x+TT(BCC „Rɹ úž¹–† .ù@ù@œÝ] endstream endobj 483 0 obj << /Length 1086 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 701.3808] /Resources 1087 0 R >> stream x+TT(BCC „Rɹ úž¹–F .ù@ù@œå^ endstream endobj 484 0 obj << /Length 1088 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 115.6272 603.3244] /Resources 1089 0 R >> stream x+TT(BC3 „Rɹ úž¹–Æ .ù@ù@âi endstream endobj 485 0 obj << /Length 1090 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 593.122] /Resources 1091 0 R >> stream x+TT(BCC „Rɹ úž¹–& .ù@ù@œõ` endstream endobj 486 0 obj << /Length 1092 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 120.9776] /Resources 1093 0 R >> stream x+TT(BCC „Rɹ úž¹–¦ .ù@ù@œýa endstream endobj 487 0 obj << /Length 1094 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 655.47] /Resources 1095 0 R >> stream x+TT(BCC „Rɹ úž¹–f .ù@ù@b endstream endobj 488 0 obj << /Length 1096 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 623.1624] /Resources 1097 0 R >> stream x+TT(BCC „Rɹ úž¹–æ .ù@ù@ c endstream endobj 489 0 obj << /Length 1098 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 146.4836] /Resources 1099 0 R >> stream x+TT(BCC „Rɹ úž¹– .ù@ù@d endstream endobj 490 0 obj << /Length 1100 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 113.6092] /Resources 1101 0 R >> stream x+TT(BCC „Rɹ úž¹–– .ù@ù@e endstream endobj 491 0 obj << /Length 1102 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 298.386] /Resources 1103 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¤¬„ endstream endobj 492 0 obj << /Length 1104 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 503.5676] /Resources 1105 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤´… endstream endobj 493 0 obj << /Length 1106 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 648.1016] /Resources 1107 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@¤¼† endstream endobj 494 0 obj << /Length 1108 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 748.4252] /Resources 1109 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¤Ä‡ endstream endobj 495 0 obj << /Length 1110 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 109.6416] /Resources 1111 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¤Ìˆ endstream endobj 496 0 obj << /Length 1112 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 439.5192] /Resources 1113 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¤Ô‰ endstream endobj 497 0 obj << /Length 1114 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 357.9] /Resources 1115 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@¤ÜŠ endstream endobj 498 0 obj << /Length 1116 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 130.364 654.3364] /Resources 1117 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¤ä‹ endstream endobj 499 0 obj << /Length 1118 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 729.154] /Resources 1119 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¤ìŒ endstream endobj 500 0 obj << /Length 1120 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 358.4668] /Resources 1121 0 R >> stream x+TT(BCC „Rɹ úž¹†– .ù@¤ô endstream endobj 501 0 obj << /Length 1122 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 538.4258] /Resources 1123 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤µ… endstream endobj 502 0 obj << /Length 1124 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 593.6888] /Resources 1125 0 R >> stream x+TT(BCC „Rɹ úž¹†@žK>PA ¤½† endstream endobj 503 0 obj << /Length 1126 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 706.482] /Resources 1127 0 R >> stream x+TT(BCC „Rɹ úž¹††F .ù@¤Å‡ endstream endobj 504 0 obj << /Length 1128 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 124.6618] /Resources 1129 0 R >> stream x+TT(BCC „Rɹ úž¹††Æ .ù@¤Íˆ endstream endobj 505 0 obj << /Length 1130 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 997.0012 436.6852] /Resources 1131 0 R >> stream x+TT(BCC „Rɹ úž¹††& .ù@¤Õ‰ endstream endobj 506 0 obj << /Length 1132 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 819.5928 747.2916] /Resources 1133 0 R >> stream x+TT(BC3 „Rɹ úž¹††¦ .ù@¥Ü” endstream endobj 507 0 obj << /Length 1134 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 549.195] /Resources 1135 0 R >> stream x+TT(BCC „Rɹ úž¹††f .ù@¤å‹ endstream endobj 508 0 obj << /Length 1136 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 349.398] /Resources 1137 0 R >> stream x+TT(BCC „Rɹ úž¹††æ .ù@¤íŒ endstream endobj 509 0 obj << /Length 1138 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 392.4748] /Resources 1139 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤õ endstream endobj 510 0 obj << /Length 1140 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 998.1348 447.4544] /Resources 1141 0 R >> stream x+TT(BC3 „Rɹ úž¹††– .ù@¥ü˜ endstream endobj 511 0 obj << /Length 1142 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 99.7226] /Resources 1143 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@¤¾† endstream endobj 512 0 obj << /Length 1144 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 582.9196] /Resources 1145 0 R >> stream x+TT(BCC „Rɹ úž¹†F† .ù@¤Æ‡ endstream endobj 513 0 obj << /Length 1146 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 207.4488 461.0576] /Resources 1147 0 R >> stream x+TT(BC3 „Rɹ úž¹†FF .ù@¥Í’ endstream endobj 514 0 obj << /Length 1148 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 77.334] /Resources 1149 0 R >> stream x+TT(BCC „Rɹ úž¹†FÆ .ù@¤Ö‰ endstream endobj 515 0 obj << /Length 1150 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 363.0012] /Resources 1151 0 R >> stream x+TT(BCC „Rɹ úž¹†F& .ù@¤ÞŠ endstream endobj 516 0 obj << /Length 1152 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 177.6576] /Resources 1153 0 R >> stream x+TT(BCC „Rɹ úž¹†F¦ .ù@¤æ‹ endstream endobj 517 0 obj << /Length 1154 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 559.9642] /Resources 1155 0 R >> stream x+TT(BCC „Rɹ úž¹†Ff .ù@¤îŒ endstream endobj 518 0 obj << /Length 1156 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 473.278 616.3608] /Resources 1157 0 R >> stream x+TT(BC3 „Rɹ úž¹†Fæ .ù@¥õ— endstream endobj 519 0 obj << /Length 1158 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 1030.442 739.9232] /Resources 1159 0 R >> stream x+TT(BC3 „Rɹ úž¹†F .ù@¥ý˜ endstream endobj 520 0 obj << /Length 1160 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 326.1592] /Resources 1161 0 R >> stream x+TT(BCC „Rɹ úž¹†F– .ù@¥ endstream endobj 521 0 obj << /Length 1162 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 681.2594] /Resources 1163 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¤Ç‡ endstream endobj 522 0 obj << /Length 1164 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 648.6684] /Resources 1165 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ† .ù@¤Ïˆ endstream endobj 523 0 obj << /Length 1166 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 472.7112 754.0932] /Resources 1167 0 R >> stream x+TT(BC3 „Rɹ úž¹†ÆF .ù@¥Ö“ endstream endobj 524 0 obj << /Length 1168 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 164.9046] /Resources 1169 0 R >> stream x+TT(BCC „Rɹ úž¹†ÆÆ .ù@¤ßŠ endstream endobj 525 0 obj << /Length 1170 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 209.9652] /Resources 1171 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ& .ù@¤ç‹ endstream endobj 526 0 obj << /Length 1172 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 687.7776] /Resources 1173 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ¦ .ù@¤ïŒ endstream endobj 527 0 obj << /Length 1174 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 228.953] /Resources 1175 0 R >> stream x+TT(BCC „Rɹ úž¹†Æf .ù@¤÷ endstream endobj 528 0 obj << /Length 1176 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 139.682] /Resources 1177 0 R >> stream x+TT(BCC „Rɹ úž¹†Ææ .ù@¤ÿŽ endstream endobj 529 0 obj << /Length 1178 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 536.7254] /Resources 1179 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¥ endstream endobj 530 0 obj << /Length 1180 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 713.8504] /Resources 1181 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ– .ù@¥ endstream endobj 531 0 obj << /Length 1182 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 680.6926] /Resources 1183 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¤Ðˆ endstream endobj 532 0 obj << /Length 1184 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 175.9572] /Resources 1185 0 R >> stream x+TT(BCC „Rɹ úž¹†&† .ù@¤Ø‰ endstream endobj 533 0 obj << /Length 1186 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 143.0828] /Resources 1187 0 R >> stream x+TT(BCC „Rɹ úž¹†&F .ù@¤àŠ endstream endobj 534 0 obj << /Length 1188 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 125.512] /Resources 1189 0 R >> stream x+TT(BCC „Rɹ úž¹†&Æ .ù@¤è‹ endstream endobj 535 0 obj << /Length 1190 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 514.9036] /Resources 1191 0 R >> stream x+TT(BCC „Rɹ úž¹†&& .ù@¤ðŒ endstream endobj 536 0 obj << /Length 1192 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 77.334] /Resources 1193 0 R >> stream x+TT(BCC „Rɹ úž¹†&¦ .ù@¤ø endstream endobj 537 0 obj << /Length 1194 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 799.7548 437.252] /Resources 1195 0 R >> stream x+TT(BC3 „Rɹ úž¹†&f .ù@¥ÿ˜ endstream endobj 538 0 obj << /Length 1196 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 625.4296] /Resources 1197 0 R >> stream x+TT(BCC „Rɹ úž¹†&æ .ù@¥ endstream endobj 539 0 obj << /Length 1198 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 559.9642] /Resources 1199 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¥ endstream endobj 540 0 obj << /Length 1200 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 250.7748] /Resources 1201 0 R >> stream x+TT(BCC „Rɹ úž¹†&– .ù@¥‘ endstream endobj 541 0 obj << /Length 1202 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 582.3528] /Resources 1203 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¤Ù‰ endstream endobj 542 0 obj << /Length 1204 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 725.1864] /Resources 1205 0 R >> stream x+TT(BCC „Rɹ úž¹†¦† .ù@¤áŠ endstream endobj 543 0 obj << /Length 1206 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 263.2444] /Resources 1207 0 R >> stream x+TT(BCC „Rɹ úž¹†¦F .ù@¤é‹ endstream endobj 544 0 obj << /Length 1208 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 439.5192] /Resources 1209 0 R >> stream x+TT(BCC „Rɹ úž¹†¦Æ .ù@¤ñŒ endstream endobj 545 0 obj << /Length 1210 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 143.6496] /Resources 1211 0 R >> stream x+TT(BCC „Rɹ úž¹†¦& .ù@¤ù endstream endobj 546 0 obj << /Length 1212 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 668.2572 386.24] /Resources 1213 0 R >> stream x+TT(BC3 „Rɹ úž¹†¦¦ .ù@¦˜ endstream endobj 547 0 obj << /Length 1214 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 110.7752] /Resources 1215 0 R >> stream x+TT(BCC „Rɹ úž¹†¦f .ù@¥  endstream endobj 548 0 obj << /Length 1216 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 219.034] /Resources 1217 0 R >> stream x+TT(BCC „Rɹ úž¹†¦æ .ù@¥ endstream endobj 549 0 obj << /Length 1218 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 98.3056] /Resources 1219 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¥‘ endstream endobj 550 0 obj << /Length 1220 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 116.1598] /Resources 1221 0 R >> stream x+TT(BCC „Rɹ úž¹†¦– .ù@¥!’ endstream endobj 551 0 obj << /Length 1222 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 668.2572 712.15] /Resources 1223 0 R >> stream x+TT(BC3 „Rɹ úž¹†f .ù@¥á” endstream endobj 552 0 obj << /Length 1224 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 335.7948] /Resources 1225 0 R >> stream x+TT(BCC „Rɹ úž¹†f† .ù@¤ê‹ endstream endobj 553 0 obj << /Length 1226 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 714.4172] /Resources 1227 0 R >> stream x+TT(BCC „Rɹ úž¹†fF .ù@¤òŒ endstream endobj 554 0 obj << /Length 1228 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 719.8018] /Resources 1229 0 R >> stream x+TT(BCC „Rɹ úž¹†fÆ .ù@¤ú endstream endobj 555 0 obj << /Length 1230 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 187.2932] /Resources 1231 0 R >> stream x+TT(BCC „Rɹ úž¹†f& .ù@¥Ž endstream endobj 556 0 obj << /Length 1232 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 251.9084] /Resources 1233 0 R >> stream x+TT(BCC „Rɹ úž¹†f¦ .ù@¥  endstream endobj 557 0 obj << /Length 1234 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 230.0866] /Resources 1235 0 R >> stream x+TT(BCC „Rɹ úž¹†ff .ù@¥ endstream endobj 558 0 obj << /Length 1236 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 549.195] /Resources 1237 0 R >> stream x+TT(BCC „Rɹ úž¹†fæ .ù@¥‘ endstream endobj 559 0 obj << /Length 1238 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 157.8196] /Resources 1239 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@¥"’ endstream endobj 560 0 obj << /Length 1240 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 709.316] /Resources 1241 0 R >> stream x+TT(BCC „Rɹ úž¹†f– .ù@¥*“ endstream endobj 561 0 obj << /Length 1242 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 675.308] /Resources 1243 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¤ë‹ endstream endobj 562 0 obj << /Length 1244 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 743.324] /Resources 1245 0 R >> stream x+TT(BCC „Rɹ úž¹†æ† .ù@¤óŒ endstream endobj 563 0 obj << /Length 1246 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 703.0812] /Resources 1247 0 R >> stream x+TT(BCC „Rɹ úž¹†æF .ù@¤û endstream endobj 564 0 obj << /Length 1248 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 571.0168] /Resources 1249 0 R >> stream x+TT(BCC „Rɹ úž¹†æÆ .ù@¥Ž endstream endobj 565 0 obj << /Length 1250 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 213.0826] /Resources 1251 0 R >> stream x+TT(BCC „Rɹ úž¹†æ& .ù@¥  endstream endobj 566 0 obj << /Length 1252 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 287.6168] /Resources 1253 0 R >> stream x+TT(BCC „Rɹ úž¹†æ¦ .ù@¥ endstream endobj 567 0 obj << /Length 1254 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 132.597] /Resources 1255 0 R >> stream x+TT(BCC „Rɹ úž¹†æf .ù@¥‘ endstream endobj 568 0 obj << /Length 1256 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 547.4946] /Resources 1257 0 R >> stream x+TT(BCC „Rɹ úž¹†ææ .ù@¥#’ endstream endobj 569 0 obj << /Length 1258 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 669.0732] /Resources 1259 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¥+“ endstream endobj 570 0 obj << /Length 1260 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 94.6214] /Resources 1261 0 R >> stream x+TT(BCC „Rɹ úž¹†æ– .ù@¥3” endstream endobj 571 0 obj << /Length 1262 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 691.4618] /Resources 1263 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¤ôŒ endstream endobj 572 0 obj << /Length 1264 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 180.4916] /Resources 1265 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤ü endstream endobj 573 0 obj << /Length 1266 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 659.1542] /Resources 1267 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@¥Ž endstream endobj 574 0 obj << /Length 1268 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 569.8832] /Resources 1269 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¥  endstream endobj 575 0 obj << /Length 1270 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 679.2756] /Resources 1271 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¥ endstream endobj 576 0 obj << /Length 1272 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 139.682] /Resources 1273 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¥‘ endstream endobj 577 0 obj << /Length 1274 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 191.2608] /Resources 1275 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@¥$’ endstream endobj 578 0 obj << /Length 1276 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 262.1108] /Resources 1277 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¥,“ endstream endobj 579 0 obj << /Length 1278 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 127.2124] /Resources 1279 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¥4” endstream endobj 580 0 obj << /Length 1280 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 662.5892 767.1296] /Resources 1281 0 R >> stream x+TT(BC3 „Rɹ úž¹†– .ù@¦;Ÿ endstream endobj 581 0 obj << /Length 1282 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 673.3242] /Resources 1283 0 R >> stream x+TT(BCC „Rɹ úž¹†– .ù@¤ý endstream endobj 582 0 obj << /Length 1284 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 640.7332] /Resources 1285 0 R >> stream x+TT(BCC „Rɹ úž¹†–† .ù@¥Ž endstream endobj 583 0 obj << /Length 1286 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 198.6292] /Resources 1287 0 R >> stream x+TT(BCC „Rɹ úž¹†–F .ù@¥  endstream endobj 584 0 obj << /Length 1288 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 130.9308 729.7208] /Resources 1289 0 R >> stream x+TT(BC3 „Rɹ úž¹†–Æ .ù@¦š endstream endobj 585 0 obj << /Length 1290 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 686.644] /Resources 1291 0 R >> stream x+TT(BCC „Rɹ úž¹†–& .ù@¥‘ endstream endobj 586 0 obj << /Length 1292 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 105.3906] /Resources 1293 0 R >> stream x+TT(BCC „Rɹ úž¹†–¦ .ù@¥%’ endstream endobj 587 0 obj << /Length 1294 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 72.2328] /Resources 1295 0 R >> stream x+TT(BCC „Rɹ úž¹†–f .ù@¥-“ endstream endobj 588 0 obj << /Length 1296 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 130.364 643.5672] /Resources 1297 0 R >> stream x+TT(BCC „Rɹ úž¹†–æ .ù@¥5” endstream endobj 589 0 obj << /Length 1298 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 998.1348 447.4544] /Resources 1299 0 R >> stream x+TT(BC3 „Rɹ úž¹†– .ù@¦<Ÿ endstream endobj 590 0 obj << /Length 1300 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 143.0828] /Resources 1301 0 R >> stream x+TT(BCC „Rɹ úž¹†–– .ù@¥E– endstream endobj 591 0 obj << /Length 1302 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 403.8108] /Resources 1303 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@¤¶… endstream endobj 592 0 obj << /Length 1304 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 106.5242] /Resources 1305 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¤¾† endstream endobj 593 0 obj << /Length 1306 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 73.3664] /Resources 1307 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¤Æ‡ endstream endobj 594 0 obj << /Length 1308 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 369.8028] /Resources 1309 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¤Îˆ endstream endobj 595 0 obj << /Length 1310 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 655.47] /Resources 1311 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@¤Ö‰ endstream endobj 596 0 obj << /Length 1312 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 131.4976 675.8748] /Resources 1313 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦ .ù@¥Ý” endstream endobj 597 0 obj << /Length 1314 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 136.848] /Resources 1315 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¤æ‹ endstream endobj 598 0 obj << /Length 1316 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 623.1624] /Resources 1317 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@¤îŒ endstream endobj 599 0 obj << /Length 1318 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 451.7396 382.8392] /Resources 1319 0 R >> stream x+TT(BC3 „Rɹ úž¹F .ù@¥õ— endstream endobj 600 0 obj << /Length 1320 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 132.0302] /Resources 1321 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¤þŽ endstream endobj 601 0 obj << /Length 1322 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 129.7972 719.235] /Resources 1323 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¤¿† endstream endobj 602 0 obj << /Length 1324 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 246.8072] /Resources 1325 0 R >> stream x+TT(BCC „Rɹ úž¹F@žK>PA ¤Ç‡ endstream endobj 603 0 obj << /Length 1326 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 154.1696 285.3496] /Resources 1327 0 R >> stream x+TT(BC3 „Rɹ úž¹F†F .ù@¥Î’ endstream endobj 604 0 obj << /Length 1328 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 450.8552] /Resources 1329 0 R >> stream x+TT(BCC „Rɹ úž¹F†Æ .ù@¤×‰ endstream endobj 605 0 obj << /Length 1330 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 697.4132] /Resources 1331 0 R >> stream x+TT(BCC „Rɹ úž¹F†& .ù@¤ßŠ endstream endobj 606 0 obj << /Length 1332 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 81.8684] /Resources 1333 0 R >> stream x+TT(BCC „Rɹ úž¹F†¦ .ù@¤ç‹ endstream endobj 607 0 obj << /Length 1334 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 70.5324] /Resources 1335 0 R >> stream x+TT(BCC „Rɹ úž¹F†f .ù@¤ïŒ endstream endobj 608 0 obj << /Length 1336 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 136.848] /Resources 1337 0 R >> stream x+TT(BCC „Rɹ úž¹F†æ .ù@¤÷ endstream endobj 609 0 obj << /Length 1338 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 230.0866] /Resources 1339 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¤ÿŽ endstream endobj 610 0 obj << /Length 1340 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 202.3134] /Resources 1341 0 R >> stream x+TT(BCC „Rɹ úž¹F†– .ù@¥ endstream endobj 611 0 obj << /Length 1342 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 62.0304] /Resources 1343 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¤È‡ endstream endobj 612 0 obj << /Length 1344 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 706.482] /Resources 1345 0 R >> stream x+TT(BCC „Rɹ úž¹FF† .ù@¤Ðˆ endstream endobj 613 0 obj << /Length 1346 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 615.2272] /Resources 1347 0 R >> stream x+TT(BCC „Rɹ úž¹FFF .ù@¤Ø‰ endstream endobj 614 0 obj << /Length 1348 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 382.8392] /Resources 1349 0 R >> stream x+TT(BCC „Rɹ úž¹FFÆ .ù@¤àŠ endstream endobj 615 0 obj << /Length 1350 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 819.5928 747.2916] /Resources 1351 0 R >> stream x+TT(BC3 „Rɹ úž¹FF& .ù@¥ç• endstream endobj 616 0 obj << /Length 1352 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 338.062] /Resources 1353 0 R >> stream x+TT(BCC „Rɹ úž¹FF¦ .ù@¤ðŒ endstream endobj 617 0 obj << /Length 1354 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 472.7112 754.0932] /Resources 1355 0 R >> stream x+TT(BC3 „Rɹ úž¹FFf .ù@¥÷— endstream endobj 618 0 obj << /Length 1356 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 651.7858] /Resources 1357 0 R >> stream x+TT(BCC „Rɹ úž¹FFæ .ù@¥Ž endstream endobj 619 0 obj << /Length 1358 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 618.0612] /Resources 1359 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¥ endstream endobj 620 0 obj << /Length 1360 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 248.2584 380.0052] /Resources 1361 0 R >> stream x+TT(BC3 „Rɹ úž¹FF– .ù@¦š endstream endobj 621 0 obj << /Length 1362 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 266.6452] /Resources 1363 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¤Ñˆ endstream endobj 622 0 obj << /Length 1364 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 594.2556] /Resources 1365 0 R >> stream x+TT(BCC „Rɹ úž¹FƆ .ù@¤Ù‰ endstream endobj 623 0 obj << /Length 1366 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 336.9284] /Resources 1367 0 R >> stream x+TT(BCC „Rɹ úž¹FÆF .ù@¤áŠ endstream endobj 624 0 obj << /Length 1368 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 292.718] /Resources 1369 0 R >> stream x+TT(BCC „Rɹ úž¹FÆÆ .ù@¤é‹ endstream endobj 625 0 obj << /Length 1370 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 549.7618] /Resources 1371 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ& .ù@¤ñŒ endstream endobj 626 0 obj << /Length 1372 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 691.7452] /Resources 1373 0 R >> stream x+TT(BCC „Rɹ úž¹FƦ .ù@¤ù endstream endobj 627 0 obj << /Length 1374 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 516.604] /Resources 1375 0 R >> stream x+TT(BCC „Rɹ úž¹FÆf .ù@¥Ž endstream endobj 628 0 obj << /Length 1376 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 372.07] /Resources 1377 0 R >> stream x+TT(BCC „Rɹ úž¹FÆæ .ù@¥  endstream endobj 629 0 obj << /Length 1378 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 721.7856] /Resources 1379 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¥ endstream endobj 630 0 obj << /Length 1380 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 687.7776] /Resources 1381 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ– .ù@¥‘ endstream endobj 631 0 obj << /Length 1382 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 689.2288 580.6524] /Resources 1383 0 R >> stream x+TT(BC3 „Rɹ úž¹F& .ù@¥Ù“ endstream endobj 632 0 obj << /Length 1384 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 527.6566] /Resources 1385 0 R >> stream x+TT(BCC „Rɹ úž¹F&† .ù@¤âŠ endstream endobj 633 0 obj << /Length 1386 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 663.156 320.4912] /Resources 1387 0 R >> stream x+TT(BC3 „Rɹ úž¹F&F .ù@¥é• endstream endobj 634 0 obj << /Length 1388 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 493.932] /Resources 1389 0 R >> stream x+TT(BCC „Rɹ úž¹F&Æ .ù@¤òŒ endstream endobj 635 0 obj << /Length 1390 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 239.7222] /Resources 1391 0 R >> stream x+TT(BCC „Rɹ úž¹F&& .ù@¤ú endstream endobj 636 0 obj << /Length 1392 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 426.4828] /Resources 1393 0 R >> stream x+TT(BCC „Rɹ úž¹F&¦ .ù@¥Ž endstream endobj 637 0 obj << /Length 1394 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 554.8972 257.5764] /Resources 1395 0 R >> stream x+TT(BC3 „Rɹ úž¹F&f .ù@¦ ™ endstream endobj 638 0 obj << /Length 1396 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 670.4902] /Resources 1397 0 R >> stream x+TT(BCC „Rɹ úž¹F&æ .ù@¥ endstream endobj 639 0 obj << /Length 1398 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 701.3808] /Resources 1399 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@¥‘ endstream endobj 640 0 obj << /Length 1400 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 663.156 320.4912] /Resources 1401 0 R >> stream x+TT(BC3 „Rɹ úž¹F&– .ù@¦!œ endstream endobj 641 0 obj << /Length 1402 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 374.3372] /Resources 1403 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@¤ãŠ endstream endobj 642 0 obj << /Length 1404 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 251.6592 149.3176] /Resources 1405 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦† .ù@¥ê• endstream endobj 643 0 obj << /Length 1406 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 103.6902] /Resources 1407 0 R >> stream x+TT(BCC „Rɹ úž¹F¦F .ù@¤óŒ endstream endobj 644 0 obj << /Length 1408 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 997.0012 385.1064] /Resources 1409 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦Æ .ù@¥ú— endstream endobj 645 0 obj << /Length 1410 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 352.232] /Resources 1411 0 R >> stream x+TT(BCC „Rɹ úž¹F¦& .ù@¥Ž endstream endobj 646 0 obj << /Length 1412 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 634.4984] /Resources 1413 0 R >> stream x+TT(BCC „Rɹ úž¹F¦¦ .ù@¥  endstream endobj 647 0 obj << /Length 1414 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 51.5788 461.6244] /Resources 1415 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦f .ù@¦š endstream endobj 648 0 obj << /Length 1416 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 124.6618] /Resources 1417 0 R >> stream x+TT(BCC „Rɹ úž¹F¦æ .ù@¥‘ endstream endobj 649 0 obj << /Length 1418 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 91.504] /Resources 1419 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@¥#’ endstream endobj 650 0 obj << /Length 1420 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 277.4144] /Resources 1421 0 R >> stream x+TT(BCC „Rɹ úž¹F¦– .ù@¥+“ endstream endobj 651 0 obj << /Length 1422 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 625.4296] /Resources 1423 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¤ì‹ endstream endobj 652 0 obj << /Length 1424 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 593.6888] /Resources 1425 0 R >> stream x+TT(BCC „Rɹ úž¹Ff† .ù@¤ôŒ endstream endobj 653 0 obj << /Length 1426 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 416.8472] /Resources 1427 0 R >> stream x+TT(BCC „Rɹ úž¹FfF .ù@¤ü endstream endobj 654 0 obj << /Length 1428 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 703.0812] /Resources 1429 0 R >> stream x+TT(BCC „Rɹ úž¹FfÆ .ù@¥Ž endstream endobj 655 0 obj << /Length 1430 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 725.1864] /Resources 1431 0 R >> stream x+TT(BCC „Rɹ úž¹Ff& .ù@¥  endstream endobj 656 0 obj << /Length 1432 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 304.054] /Resources 1433 0 R >> stream x+TT(BCC „Rɹ úž¹Ff¦ .ù@¥ endstream endobj 657 0 obj << /Length 1434 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 717.818] /Resources 1435 0 R >> stream x+TT(BCC „Rɹ úž¹Fff .ù@¥‘ endstream endobj 658 0 obj << /Length 1436 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 335.7948] /Resources 1437 0 R >> stream x+TT(BCC „Rɹ úž¹Ffæ .ù@¥$’ endstream endobj 659 0 obj << /Length 1438 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 684.0934] /Resources 1439 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¥,“ endstream endobj 660 0 obj << /Length 1440 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 921.6168 759.1944] /Resources 1441 0 R >> stream x+TT(BC3 „Rɹ úž¹Ff– .ù@¦3ž endstream endobj 661 0 obj << /Length 1442 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 353.1164 741.6236] /Resources 1443 0 R >> stream x+TT(BC3 „Rɹ úž¹Fæ .ù@¥ô– endstream endobj 662 0 obj << /Length 1444 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 68.832] /Resources 1445 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ† .ù@¤ý endstream endobj 663 0 obj << /Length 1446 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 360.734] /Resources 1447 0 R >> stream x+TT(BCC „Rɹ úž¹FæF .ù@¥Ž endstream endobj 664 0 obj << /Length 1448 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 374.3372] /Resources 1449 0 R >> stream x+TT(BCC „Rɹ úž¹FæÆ .ù@¥  endstream endobj 665 0 obj << /Length 1450 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 326.726] /Resources 1451 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ& .ù@¥ endstream endobj 666 0 obj << /Length 1452 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 582.9196] /Resources 1453 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ¦ .ù@¥‘ endstream endobj 667 0 obj << /Length 1454 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 369.8028] /Resources 1455 0 R >> stream x+TT(BCC „Rɹ úž¹Fæf .ù@¥%’ endstream endobj 668 0 obj << /Length 1456 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 403.8108] /Resources 1457 0 R >> stream x+TT(BCC „Rɹ úž¹Fææ .ù@¥-“ endstream endobj 669 0 obj << /Length 1458 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 594.2556] /Resources 1459 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@¥5” endstream endobj 670 0 obj << /Length 1460 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 116.1598] /Resources 1461 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ– .ù@¥=• endstream endobj 671 0 obj << /Length 1462 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 560.531] /Resources 1463 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@¤þ endstream endobj 672 0 obj << /Length 1464 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 342.0296] /Resources 1465 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¥Ž endstream endobj 673 0 obj << /Length 1466 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 84.7024] /Resources 1467 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¥ endstream endobj 674 0 obj << /Length 1468 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 725.7532] /Resources 1469 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¥ endstream endobj 675 0 obj << /Length 1470 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 102.5566] /Resources 1471 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@¥‘ endstream endobj 676 0 obj << /Length 1472 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 571.0168] /Resources 1473 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@¥&’ endstream endobj 677 0 obj << /Length 1474 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 273.4468] /Resources 1475 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¥.“ endstream endobj 678 0 obj << /Length 1476 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 538.4258] /Resources 1477 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@¥6” endstream endobj 679 0 obj << /Length 1478 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 117.2934] /Resources 1479 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@¥>• endstream endobj 680 0 obj << /Length 1480 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 360.734] /Resources 1481 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¥F– endstream endobj 681 0 obj << /Length 1482 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 625.9964] /Resources 1483 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¥Ž endstream endobj 682 0 obj << /Length 1484 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 732.8382] /Resources 1485 0 R >> stream x+TT(BCC „Rɹ úž¹F–† .ù@¥ endstream endobj 683 0 obj << /Length 1486 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 240.8558] /Resources 1487 0 R >> stream x+TT(BCC „Rɹ úž¹F–F .ù@¥ endstream endobj 684 0 obj << /Length 1488 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 699.1136] /Resources 1489 0 R >> stream x+TT(BCC „Rɹ úž¹F–Æ .ù@¥‘ endstream endobj 685 0 obj << /Length 1490 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 665.6724] /Resources 1491 0 R >> stream x+TT(BCC „Rɹ úž¹F–& .ù@¥'’ endstream endobj 686 0 obj << /Length 1492 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 157.8196] /Resources 1493 0 R >> stream x+TT(BCC „Rɹ úž¹F–¦ .ù@¥/“ endstream endobj 687 0 obj << /Length 1494 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 681.2594] /Resources 1495 0 R >> stream x+TT(BCC „Rɹ úž¹F–f .ù@¥7” endstream endobj 688 0 obj << /Length 1496 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 514.9036] /Resources 1497 0 R >> stream x+TT(BCC „Rɹ úž¹F–æ .ù@¥?• endstream endobj 689 0 obj << /Length 1498 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 691.4618] /Resources 1499 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¥G– endstream endobj 690 0 obj << /Length 1500 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 659.1542] /Resources 1501 0 R >> stream x+TT(BCC „Rɹ úž¹F–– .ù@¥O— endstream endobj 691 0 obj << /Length 1502 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 558.5472] /Resources 1503 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¤À† endstream endobj 692 0 obj << /Length 1504 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 917.0824 284.216] /Resources 1505 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ† .ù@¥Ç‘ endstream endobj 693 0 obj << /Length 1506 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 525.9562] /Resources 1507 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@¤Ðˆ endstream endobj 694 0 obj << /Length 1508 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 120.9776] /Resources 1509 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¤Ø‰ endstream endobj 695 0 obj << /Length 1510 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 921.6168 759.1944] /Resources 1511 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ& .ù@¥ß” endstream endobj 696 0 obj << /Length 1512 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 492.2316] /Resources 1513 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¤è‹ endstream endobj 697 0 obj << /Length 1514 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 154.1354] /Resources 1515 0 R >> stream x+TT(BCC „Rɹ úž¹Æf .ù@¤ðŒ endstream endobj 698 0 obj << /Length 1516 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 375.4708] /Resources 1517 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@¤ø endstream endobj 699 0 obj << /Length 1518 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 538.1424] /Resources 1519 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¥Ž endstream endobj 700 0 obj << /Length 1520 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 714.4172] /Resources 1521 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥ endstream endobj 701 0 obj << /Length 1522 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 559.9642] /Resources 1523 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@¤É‡ endstream endobj 702 0 obj << /Length 1524 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 626.5632] /Resources 1525 0 R >> stream x+TT(BCC „Rɹ úž¹Æ@žK>PA ¤Ñˆ endstream endobj 703 0 obj << /Length 1526 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 110.7752] /Resources 1527 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†F .ù@¤Ù‰ endstream endobj 704 0 obj << /Length 1528 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 394.1752] /Resources 1529 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†Æ .ù@¤áŠ endstream endobj 705 0 obj << /Length 1530 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 121.8278] /Resources 1531 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†& .ù@¤é‹ endstream endobj 706 0 obj << /Length 1532 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 88.67] /Resources 1533 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†¦ .ù@¤ñŒ endstream endobj 707 0 obj << /Length 1534 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 426.4828] /Resources 1535 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†f .ù@¤ù endstream endobj 708 0 obj << /Length 1536 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 369.236] /Resources 1537 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†æ .ù@¥Ž endstream endobj 709 0 obj << /Length 1538 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 730.8544] /Resources 1539 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@¥  endstream endobj 710 0 obj << /Length 1540 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 224.1352] /Resources 1541 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†– .ù@¥ endstream endobj 711 0 obj << /Length 1542 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 131.4976 675.8748] /Resources 1543 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆF .ù@¥Ñ’ endstream endobj 712 0 obj << /Length 1544 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 143.6496] /Resources 1545 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF† .ù@¤Ú‰ endstream endobj 713 0 obj << /Length 1546 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 725.7532] /Resources 1547 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFF .ù@¤âŠ endstream endobj 714 0 obj << /Length 1548 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 692.0286] /Resources 1549 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFÆ .ù@¤ê‹ endstream endobj 715 0 obj << /Length 1550 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 309.722] /Resources 1551 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF& .ù@¤òŒ endstream endobj 716 0 obj << /Length 1552 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 659.721] /Resources 1553 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF¦ .ù@¤ú endstream endobj 717 0 obj << /Length 1554 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 697.4132] /Resources 1555 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFf .ù@¥Ž endstream endobj 718 0 obj << /Length 1556 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 571.0168] /Resources 1557 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFæ .ù@¥  endstream endobj 719 0 obj << /Length 1558 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 686.644] /Resources 1559 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@¥ endstream endobj 720 0 obj << /Length 1560 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 239.7222] /Resources 1561 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF– .ù@¥‘ endstream endobj 721 0 obj << /Length 1562 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 129.7972 719.235] /Resources 1563 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¤Û‰ endstream endobj 722 0 obj << /Length 1564 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 547.4946] /Resources 1565 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ† .ù@¤ãŠ endstream endobj 723 0 obj << /Length 1566 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 662.5892 767.1296] /Resources 1567 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆÆF .ù@¥ê• endstream endobj 724 0 obj << /Length 1568 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 115.6272 603.3244] /Resources 1569 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆÆÆ .ù@¥ò– endstream endobj 725 0 obj << /Length 1570 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 187.2932] /Resources 1571 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ& .ù@¤û endstream endobj 726 0 obj << /Length 1572 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 569.8832] /Resources 1573 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ¦ .ù@¥Ž endstream endobj 727 0 obj << /Length 1574 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 679.2756] /Resources 1575 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆf .ù@¥  endstream endobj 728 0 obj << /Length 1576 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 357.9] /Resources 1577 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆæ .ù@¥ endstream endobj 729 0 obj << /Length 1578 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 721.7856] /Resources 1579 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¥‘ endstream endobj 730 0 obj << /Length 1580 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 806.5564 191.2608] /Resources 1581 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆÆ– .ù@¦"œ endstream endobj 731 0 obj << /Length 1582 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 88.67] /Resources 1583 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@¤äŠ endstream endobj 732 0 obj << /Length 1584 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 999.8352 147.6172] /Resources 1585 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ&† .ù@¥ë• endstream endobj 733 0 obj << /Length 1586 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 669.9234] /Resources 1587 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&F .ù@¤ôŒ endstream endobj 734 0 obj << /Length 1588 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 636.7656] /Resources 1589 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&Æ .ù@¤ü endstream endobj 735 0 obj << /Length 1590 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 298.386] /Resources 1591 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&& .ù@¥Ž endstream endobj 736 0 obj << /Length 1592 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 658.304] /Resources 1593 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&¦ .ù@¥  endstream endobj 737 0 obj << /Length 1594 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 262.1108] /Resources 1595 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&f .ù@¥ endstream endobj 738 0 obj << /Length 1596 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 51.5788 461.6244] /Resources 1597 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ&æ .ù@¦› endstream endobj 739 0 obj << /Length 1598 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 651.7858] /Resources 1599 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@¥$’ endstream endobj 740 0 obj << /Length 1600 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 618.0612] /Resources 1601 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&– .ù@¥,“ endstream endobj 741 0 obj << /Length 1602 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 274.5804] /Resources 1603 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¤í‹ endstream endobj 742 0 obj << /Length 1604 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 661.4556 756.3604] /Resources 1605 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦† .ù@¤õŒ endstream endobj 743 0 obj << /Length 1606 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 527.6566] /Resources 1607 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦F .ù@¤ý endstream endobj 744 0 obj << /Length 1608 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 580.97 604.458] /Resources 1609 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ¦Æ .ù@¦˜ endstream endobj 745 0 obj << /Length 1610 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 83.5688] /Resources 1611 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦& .ù@¥  endstream endobj 746 0 obj << /Length 1612 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 154.9856] /Resources 1613 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦¦ .ù@¥ endstream endobj 747 0 obj << /Length 1614 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 375.4708] /Resources 1615 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦f .ù@¥‘ endstream endobj 748 0 obj << /Length 1616 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 736.5224] /Resources 1617 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦æ .ù@¥%’ endstream endobj 749 0 obj << /Length 1618 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 130.364 654.3364] /Resources 1619 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¥-“ endstream endobj 750 0 obj << /Length 1620 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 246.8072] /Resources 1621 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦– .ù@¥5” endstream endobj 751 0 obj << /Length 1622 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 154.1354] /Resources 1623 0 R >> stream x+TT(BCC „Rɹ úž¹Æf .ù@¤öŒ endstream endobj 752 0 obj << /Length 1624 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 381.1388] /Resources 1625 0 R >> stream x+TT(BCC „Rɹ úž¹Æf† .ù@¤þ endstream endobj 753 0 obj << /Length 1626 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 84.7024] /Resources 1627 0 R >> stream x+TT(BCC „Rɹ úž¹ÆfF .ù@¥Ž endstream endobj 754 0 obj << /Length 1628 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 347.1308] /Resources 1629 0 R >> stream x+TT(BCC „Rɹ úž¹ÆfÆ .ù@¥ endstream endobj 755 0 obj << /Length 1630 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 634.4984] /Resources 1631 0 R >> stream x+TT(BCC „Rɹ úž¹Æf& .ù@¥ endstream endobj 756 0 obj << /Length 1632 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 51.012 220.7344] /Resources 1633 0 R >> stream x+TT(BC3 „Rɹ úž¹Æf¦ .ù@¦› endstream endobj 757 0 obj << /Length 1634 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 720.652] /Resources 1635 0 R >> stream x+TT(BCC „Rɹ úž¹Æff .ù@¥&’ endstream endobj 758 0 obj << /Length 1636 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 130.364 643.5672] /Resources 1637 0 R >> stream x+TT(BCC „Rɹ úž¹Æfæ .ù@¥.“ endstream endobj 759 0 obj << /Length 1638 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 455.1404 188.4268] /Resources 1639 0 R >> stream x+TT(BC3 „Rɹ úž¹Æf .ù@¦5ž endstream endobj 760 0 obj << /Length 1640 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 59.1964] /Resources 1641 0 R >> stream x+TT(BCC „Rɹ úž¹Æf– .ù@¥>• endstream endobj 761 0 obj << /Length 1642 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 128.346] /Resources 1643 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@¤ÿ endstream endobj 762 0 obj << /Length 1644 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 17.004 637.3324] /Resources 1645 0 R >> stream x+TT(BC3 „Rɹ úž¹Ææ† .ù@¦˜ endstream endobj 763 0 obj << /Length 1646 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 697.98] /Resources 1647 0 R >> stream x+TT(BCC „Rɹ úž¹ÆæF .ù@¥ endstream endobj 764 0 obj << /Length 1648 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 72.2328] /Resources 1649 0 R >> stream x+TT(BCC „Rɹ úž¹ÆæÆ .ù@¥ endstream endobj 765 0 obj << /Length 1650 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 719.8018] /Resources 1651 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ& .ù@¥‘ endstream endobj 766 0 obj << /Length 1652 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 105.3906] /Resources 1653 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ¦ .ù@¥'’ endstream endobj 767 0 obj << /Length 1654 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 702.5144] /Resources 1655 0 R >> stream x+TT(BCC „Rɹ úž¹Ææf .ù@¥/“ endstream endobj 768 0 obj << /Length 1656 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 353.1164 741.6236] /Resources 1657 0 R >> stream x+TT(BC3 „Rɹ úž¹Æææ .ù@¦6ž endstream endobj 769 0 obj << /Length 1658 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 248.2584 380.0052] /Resources 1659 0 R >> stream x+TT(BC3 „Rɹ úž¹Ææ .ù@¦>Ÿ endstream endobj 770 0 obj << /Length 1660 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 690.0448] /Resources 1661 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ– .ù@¥G– endstream endobj 771 0 obj << /Length 1662 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 213.0826] /Resources 1663 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¥Ž endstream endobj 772 0 obj << /Length 1664 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 416.8472] /Resources 1665 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@¥ endstream endobj 773 0 obj << /Length 1666 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 240.8558] /Resources 1667 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@¥ endstream endobj 774 0 obj << /Length 1668 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 717.818] /Resources 1669 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¥ ‘ endstream endobj 775 0 obj << /Length 1670 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 684.0934] /Resources 1671 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@¥(’ endstream endobj 776 0 obj << /Length 1672 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 263.2444] /Resources 1673 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¥0“ endstream endobj 777 0 obj << /Length 1674 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 130.9308 729.7208] /Resources 1675 0 R >> stream x+TT(BC3 „Rɹ úž¹Æf .ù@¦7ž endstream endobj 778 0 obj << /Length 1676 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 626.5632] /Resources 1677 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@¥@• endstream endobj 779 0 obj << /Length 1678 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 997.0012 436.6852] /Resources 1679 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¥H– endstream endobj 780 0 obj << /Length 1680 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 553.7636 235.4712] /Resources 1681 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥P— endstream endobj 781 0 obj << /Length 1682 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 629.3972] /Resources 1683 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥ endstream endobj 782 0 obj << /Length 1684 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 135.431] /Resources 1685 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–† .ù@¥ endstream endobj 783 0 obj << /Length 1686 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 274.5804] /Resources 1687 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–F .ù@¥!‘ endstream endobj 784 0 obj << /Length 1688 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 527.6566] /Resources 1689 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–Æ .ù@¥)’ endstream endobj 785 0 obj << /Length 1690 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 415.1468] /Resources 1691 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–& .ù@¥1“ endstream endobj 786 0 obj << /Length 1692 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 493.932] /Resources 1693 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–¦ .ù@¥9” endstream endobj 787 0 obj << /Length 1694 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 117.2934] /Resources 1695 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–f .ù@¥A• endstream endobj 788 0 obj << /Length 1696 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 605.5916] /Resources 1697 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–æ .ù@¥I– endstream endobj 789 0 obj << /Length 1698 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 699.1136] /Resources 1699 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥Q— endstream endobj 790 0 obj << /Length 1700 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 665.6724] /Resources 1701 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–– .ù@¥Y˜ endstream endobj 791 0 obj << /Length 1702 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 505.268] /Resources 1703 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¤Ê‡ endstream endobj 792 0 obj << /Length 1704 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 309.722] /Resources 1705 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@¤Òˆ endstream endobj 793 0 obj << /Length 1706 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 217.9004] /Resources 1707 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@¤Ú‰ endstream endobj 794 0 obj << /Length 1708 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 648.6684] /Resources 1709 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@¤âŠ endstream endobj 795 0 obj << /Length 1710 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 625.9964] /Resources 1711 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¤ê‹ endstream endobj 796 0 obj << /Length 1712 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 655.7876 150.4512] /Resources 1713 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦ .ù@¥ñ– endstream endobj 797 0 obj << /Length 1714 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 708.7492] /Resources 1715 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¤ú endstream endobj 798 0 obj << /Length 1716 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 92.921] /Resources 1717 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥Ž endstream endobj 799 0 obj << /Length 1718 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 114.4594] /Resources 1719 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¥  endstream endobj 800 0 obj << /Length 1720 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 450.8552] /Resources 1721 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥ endstream endobj 801 0 obj << /Length 1722 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 471.5776 731.988] /Resources 1723 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@¤Óˆ endstream endobj 802 0 obj << /Length 1724 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 81.8684] /Resources 1725 0 R >> stream x+TT(BCC „Rɹ úž¹&@žK>PA ¤Û‰ endstream endobj 803 0 obj << /Length 1726 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 336.9284] /Resources 1727 0 R >> stream x+TT(BCC „Rɹ úž¹&†F .ù@¤ãŠ endstream endobj 804 0 obj << /Length 1728 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 331.2604] /Resources 1729 0 R >> stream x+TT(BCC „Rɹ úž¹&†Æ .ù@¤ë‹ endstream endobj 805 0 obj << /Length 1730 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 455.1404 188.4268] /Resources 1731 0 R >> stream x+TT(BC3 „Rɹ úž¹&†& .ù@¥ò– endstream endobj 806 0 obj << /Length 1732 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 372.07] /Resources 1733 0 R >> stream x+TT(BCC „Rɹ úž¹&†¦ .ù@¤û endstream endobj 807 0 obj << /Length 1734 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 559.9642] /Resources 1735 0 R >> stream x+TT(BCC „Rɹ úž¹&†f .ù@¥Ž endstream endobj 808 0 obj << /Length 1736 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 128.346] /Resources 1737 0 R >> stream x+TT(BCC „Rɹ úž¹&†æ .ù@¥  endstream endobj 809 0 obj << /Length 1738 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 225.5864 743.324] /Resources 1739 0 R >> stream x+TT(BC3 „Rɹ úž¹&† .ù@¦š endstream endobj 810 0 obj << /Length 1740 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 68.832] /Resources 1741 0 R >> stream x+TT(BCC „Rɹ úž¹&†– .ù@¥‘ endstream endobj 811 0 obj << /Length 1742 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 17.004 725.1864] /Resources 1743 0 R >> stream x+TT(BC3 „Rɹ úž¹&F .ù@¥Û“ endstream endobj 812 0 obj << /Length 1744 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 102.5566] /Resources 1745 0 R >> stream x+TT(BCC „Rɹ úž¹&F† .ù@¤äŠ endstream endobj 813 0 obj << /Length 1746 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 287.6168] /Resources 1747 0 R >> stream x+TT(BCC „Rɹ úž¹&FF .ù@¤ì‹ endstream endobj 814 0 obj << /Length 1748 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 369.236] /Resources 1749 0 R >> stream x+TT(BCC „Rɹ úž¹&FÆ .ù@¤ôŒ endstream endobj 815 0 obj << /Length 1750 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 428.1832] /Resources 1751 0 R >> stream x+TT(BCC „Rɹ úž¹&F& .ù@¤ü endstream endobj 816 0 obj << /Length 1752 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 169.1556] /Resources 1753 0 R >> stream x+TT(BCC „Rɹ úž¹&F¦ .ù@¥Ž endstream endobj 817 0 obj << /Length 1754 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 394.1752] /Resources 1755 0 R >> stream x+TT(BCC „Rɹ úž¹&Ff .ù@¥  endstream endobj 818 0 obj << /Length 1756 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 138.5484] /Resources 1757 0 R >> stream x+TT(BCC „Rɹ úž¹&Fæ .ù@¥ endstream endobj 819 0 obj << /Length 1758 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 349.398] /Resources 1759 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@¥‘ endstream endobj 820 0 obj << /Length 1760 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 315.39] /Resources 1761 0 R >> stream x+TT(BCC „Rɹ úž¹&F– .ù@¥$’ endstream endobj 821 0 obj << /Length 1762 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 655.7876 150.4512] /Resources 1763 0 R >> stream x+TT(BC3 „Rɹ úž¹&Æ .ù@¥ä” endstream endobj 822 0 obj << /Length 1764 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 695.146] /Resources 1765 0 R >> stream x+TT(BCC „Rɹ úž¹&Ɔ .ù@¤í‹ endstream endobj 823 0 obj << /Length 1766 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 662.555] /Resources 1767 0 R >> stream x+TT(BCC „Rɹ úž¹&ÆF .ù@¤õŒ endstream endobj 824 0 obj << /Length 1768 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 130.364 665.389] /Resources 1769 0 R >> stream x+TT(BCC „Rɹ úž¹&ÆÆ .ù@¤ý endstream endobj 825 0 obj << /Length 1770 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 668.2572 386.24] /Resources 1771 0 R >> stream x+TT(BC3 „Rɹ úž¹&Æ& .ù@¦˜ endstream endobj 826 0 obj << /Length 1772 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 209.9652] /Resources 1773 0 R >> stream x+TT(BCC „Rɹ úž¹&Ʀ .ù@¥  endstream endobj 827 0 obj << /Length 1774 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 338.062] /Resources 1775 0 R >> stream x+TT(BCC „Rɹ úž¹&Æf .ù@¥ endstream endobj 828 0 obj << /Length 1776 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 347.1308] /Resources 1777 0 R >> stream x+TT(BCC „Rɹ úž¹&Ææ .ù@¥‘ endstream endobj 829 0 obj << /Length 1778 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 450.606 304.054] /Resources 1779 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@¥%’ endstream endobj 830 0 obj << /Length 1780 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 560.531] /Resources 1781 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ– .ù@¥-“ endstream endobj 831 0 obj << /Length 1782 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 381.1388] /Resources 1783 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¤î‹ endstream endobj 832 0 obj << /Length 1784 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 654.654 95.755] /Resources 1785 0 R >> stream x+TT(BCC „Rɹ úž¹&&† .ù@¤öŒ endstream endobj 833 0 obj << /Length 1786 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 571.5836] /Resources 1787 0 R >> stream x+TT(BCC „Rɹ úž¹&&F .ù@¤þ endstream endobj 834 0 obj << /Length 1788 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 247.1248 347.1308] /Resources 1789 0 R >> stream x+TT(BCC „Rɹ úž¹&&Æ .ù@¥Ž endstream endobj 835 0 obj << /Length 1790 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 472.1444 538.7092] /Resources 1791 0 R >> stream x+TT(BCC „Rɹ úž¹&&& .ù@¥ endstream endobj 836 0 obj << /Length 1792 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 703.0812] /Resources 1793 0 R >> stream x+TT(BCC „Rɹ úž¹&&¦ .ù@¥ endstream endobj 837 0 obj << /Length 1794 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 363.0012] /Resources 1795 0 R >> stream x+TT(BCC „Rɹ úž¹&&f .ù@¥‘ endstream endobj 838 0 obj << /Length 1796 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 549.195] /Resources 1797 0 R >> stream x+TT(BCC „Rɹ úž¹&&æ .ù@¥&’ endstream endobj 839 0 obj << /Length 1798 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 676.4416] /Resources 1799 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¥.“ endstream endobj 840 0 obj << /Length 1800 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 198.6292] /Resources 1801 0 R >> stream x+TT(BCC „Rɹ úž¹&&– .ù@¥6” endstream endobj 841 0 obj << /Length 1802 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 645.2676] /Resources 1803 0 R >> stream x+TT(BCC „Rɹ úž¹&¦ .ù@¤÷Œ endstream endobj 842 0 obj << /Length 1804 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 138.5484] /Resources 1805 0 R >> stream x+TT(BCC „Rɹ úž¹&¦† .ù@¤ÿ endstream endobj 843 0 obj << /Length 1806 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 382.8392] /Resources 1807 0 R >> stream x+TT(BCC „Rɹ úž¹&¦F .ù@¥Ž endstream endobj 844 0 obj << /Length 1808 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 737.0892] /Resources 1809 0 R >> stream x+TT(BCC „Rɹ úž¹&¦Æ .ù@¥ endstream endobj 845 0 obj << /Length 1810 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 558.5472] /Resources 1811 0 R >> stream x+TT(BCC „Rɹ úž¹&¦& .ù@¥ endstream endobj 846 0 obj << /Length 1812 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 135.431] /Resources 1813 0 R >> stream x+TT(BCC „Rɹ úž¹&¦¦ .ù@¥‘ endstream endobj 847 0 obj << /Length 1814 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 525.9562] /Resources 1815 0 R >> stream x+TT(BCC „Rɹ úž¹&¦f .ù@¥'’ endstream endobj 848 0 obj << /Length 1816 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 492.2316] /Resources 1817 0 R >> stream x+TT(BCC „Rɹ úž¹&¦æ .ù@¥/“ endstream endobj 849 0 obj << /Length 1818 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 207.4488 461.0576] /Resources 1819 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦ .ù@¦6ž endstream endobj 850 0 obj << /Length 1820 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 225.5864 743.324] /Resources 1821 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦– .ù@¦>Ÿ endstream endobj 851 0 obj << /Length 1822 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 669.9234] /Resources 1823 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¥ endstream endobj 852 0 obj << /Length 1824 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 636.7656] /Resources 1825 0 R >> stream x+TT(BCC „Rɹ úž¹&f† .ù@¥Ž endstream endobj 853 0 obj << /Length 1826 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 132.0302] /Resources 1827 0 R >> stream x+TT(BCC „Rɹ úž¹&fF .ù@¥ endstream endobj 854 0 obj << /Length 1828 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 503.5676] /Resources 1829 0 R >> stream x+TT(BCC „Rɹ úž¹&fÆ .ù@¥ endstream endobj 855 0 obj << /Length 1830 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 98.3056] /Resources 1831 0 R >> stream x+TT(BCC „Rɹ úž¹&f& .ù@¥ ‘ endstream endobj 856 0 obj << /Length 1832 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 175.9572] /Resources 1833 0 R >> stream x+TT(BCC „Rɹ úž¹&f¦ .ù@¥(’ endstream endobj 857 0 obj << /Length 1834 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 347.1308] /Resources 1835 0 R >> stream x+TT(BCC „Rɹ úž¹&ff .ù@¥0“ endstream endobj 858 0 obj << /Length 1836 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 351.9828 730.8544] /Resources 1837 0 R >> stream x+TT(BCC „Rɹ úž¹&fæ .ù@¥8” endstream endobj 859 0 obj << /Length 1838 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 113.6092] /Resources 1839 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¥@• endstream endobj 860 0 obj << /Length 1840 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 473.278 616.3608] /Resources 1841 0 R >> stream x+TT(BC3 „Rɹ úž¹&f– .ù@¦G  endstream endobj 861 0 obj << /Length 1842 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 571.0168] /Resources 1843 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥ Ž endstream endobj 862 0 obj << /Length 1844 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 538.1424] /Resources 1845 0 R >> stream x+TT(BCC „Rɹ úž¹&æ† .ù@¥ endstream endobj 863 0 obj << /Length 1846 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 798.6212 415.1468] /Resources 1847 0 R >> stream x+TT(BCC „Rɹ úž¹&æF .ù@¥ endstream endobj 864 0 obj << /Length 1848 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 736.5224] /Resources 1849 0 R >> stream x+TT(BCC „Rɹ úž¹&æÆ .ù@¥!‘ endstream endobj 865 0 obj << /Length 1850 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 50.4452 405.5112] /Resources 1851 0 R >> stream x+TT(BCC „Rɹ úž¹&æ& .ù@¥)’ endstream endobj 866 0 obj << /Length 1852 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 99.7226] /Resources 1853 0 R >> stream x+TT(BCC „Rɹ úž¹&æ¦ .ù@¥1“ endstream endobj 867 0 obj << /Length 1854 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 995.8676 352.232] /Resources 1855 0 R >> stream x+TT(BCC „Rɹ úž¹&æf .ù@¥9” endstream endobj 868 0 obj << /Length 1856 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 65.998] /Resources 1857 0 R >> stream x+TT(BCC „Rɹ úž¹&ææ .ù@¥A• endstream endobj 869 0 obj << /Length 1858 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 737.0892] /Resources 1859 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥I– endstream endobj 870 0 obj << /Length 1860 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 579.8364 549.195] /Resources 1861 0 R >> stream x+TT(BCC „Rɹ úž¹&æ– .ù@¥Q— endstream endobj 871 0 obj << /Length 1862 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 703.0812] /Resources 1863 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¥ endstream endobj 872 0 obj << /Length 1864 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 670.4902] /Resources 1865 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@¥ endstream endobj 873 0 obj << /Length 1866 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 637.3324] /Resources 1867 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@¥"‘ endstream endobj 874 0 obj << /Length 1868 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 224.4528 710.4496] /Resources 1869 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@¥*’ endstream endobj 875 0 obj << /Length 1870 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 15.8704 691.7452] /Resources 1871 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¥2“ endstream endobj 876 0 obj << /Length 1872 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [ 0.5668 0 0 0.5668 997.0012 385.1064] /Resources 1873 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦ .ù@¦9ž endstream endobj 877 0 obj << /Length 1874 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 217.9004] /Resources 1875 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¥B• endstream endobj 878 0 obj << /Length 1876 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 662.0224 277.4144] /Resources 1877 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥J– endstream endobj 879 0 obj << /Length 1878 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 920.4832 692.0286] /Resources 1879 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¥R— endstream endobj 880 0 obj << /Length 1880 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 702.5144] /Resources 1881 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥Z˜ endstream endobj 881 0 obj << /Length 1882 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 582.3528] /Resources 1883 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥ endstream endobj 882 0 obj << /Length 1884 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 121.8278] /Resources 1885 0 R >> stream x+TT(BCC „Rɹ úž¹&–† .ù@¥#‘ endstream endobj 883 0 obj << /Length 1886 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 49.8784 164.9046] /Resources 1887 0 R >> stream x+TT(BCC „Rɹ úž¹&–F .ù@¥+’ endstream endobj 884 0 obj << /Length 1888 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 688.0952 536.7254] /Resources 1889 0 R >> stream x+TT(BCC „Rɹ úž¹&–Æ .ù@¥3“ endstream endobj 885 0 obj << /Length 1890 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 65.998] /Resources 1891 0 R >> stream x+TT(BCC „Rɹ úž¹&–& .ù@¥;” endstream endobj 886 0 obj << /Length 1892 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 998.7016 114.4594] /Resources 1893 0 R >> stream x+TT(BCC „Rɹ úž¹&–¦ .ù@¥C• endstream endobj 887 0 obj << /Length 1894 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 667.1236 658.304] /Resources 1895 0 R >> stream x+TT(BCC „Rɹ úž¹&–f .ù@¥K– endstream endobj 888 0 obj << /Length 1896 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 818.4592 648.1016] /Resources 1897 0 R >> stream x+TT(BCC „Rɹ úž¹&–æ .ù@¥S— endstream endobj 889 0 obj << /Length 1898 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 114.4936 593.122] /Resources 1899 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥[˜ endstream endobj 890 0 obj << /Length 1900 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 127.2124] /Resources 1901 0 R >> stream x+TT(BCC „Rɹ úž¹&–– .ù@¥c™ endstream endobj 891 0 obj << /Length 1902 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 661.4556 756.3604] /Resources 1903 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@¤Ôˆ endstream endobj 892 0 obj << /Length 1904 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 915.9488 250.7748] /Resources 1905 0 R >> stream x+TT(BCC „Rɹ úž¹¦† .ù@¤Ü‰ endstream endobj 893 0 obj << /Length 1906 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 1029.309 629.3972] /Resources 1907 0 R >> stream x+TT(BCC „Rɹ úž¹¦F .ù@¤äŠ endstream endobj 894 0 obj << /Length 1908 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 153.036 251.9084] /Resources 1909 0 R >> stream x+TT(BCC „Rɹ úž¹¦Æ .ù@¤ì‹ endstream endobj 895 0 obj << /Length 1910 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 805.4228 91.504] /Resources 1911 0 R >> stream x+TT(BCC „Rɹ úž¹¦& .ù@¤ôŒ endstream endobj 896 0 obj << /Length 1912 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 454.0068 132.597] /Resources 1913 0 R >> stream x+TT(BCC „Rɹ úž¹¦¦ .ù@¤ü endstream endobj 897 0 obj << /Length 1914 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [ 0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [ 0.5668 0 0 0.5668 250.5256 83.5688] /Resources 1915 0 R >> stream x+TT(BCC „Rɹ úž¹¦f .ù@¥Ž endstream endobj 901 0 obj << /Length 1916 0 R /N 3 /Alternate /DeviceRGB /Filter /FlateDecode >> stream x–wTSهϽ7½Ð" %ôz Ò;HQ‰I€P†„&vDF)VdTÀG‡"cE ƒ‚b× òPÆÁQDEåÝŒk ï­5óÞšýÇYßÙç·×Ùgï}׺Pü‚ÂtX€4¡XîëÁ\ËÄ÷XÀáffGøDÔü½=™™¨HƳöî.€d»Û,¿P&sÖÿ‘"7C$ EÕ6<~&å”S³Å2ÿÊô•)2†12¡ ¢¬"ãįlö§æ+»É˜—&ä¡Yμ4žŒ»PÞš%ᣌ¡\˜%àg£|e½TIšå÷(ÓÓøœL0™_Ìç&¡l‰2Eî‰ò”Ä9¼r‹ù9hžx¦g䊉Ib¦טiåèÈfúñ³Sùb1+”ÃMáˆxLÏô´ Ž0€¯o–E%Ym™h‘í­ííYÖæhù¿Ùß~Sý=ÈzûUñ&ìÏžAŒžYßlì¬/½ö$Z›³¾•U´m@åá¬Oï ò´Þœó†l^’Äâ ' ‹ììlsŸk.+è7ûŸ‚oÊ¿†9÷™ËîûV;¦?#I3eE妧¦KDÌÌ —Ïdý÷ÿãÀ9iÍÉÃ,œŸÀñ…èUQè” „‰h»…Ø A1ØvƒjpÔzÐN‚6p\WÀ p €G@ †ÁK0Þi‚ð¢Aª¤™BÖZyCAP8ÅC‰’@ùÐ&¨*ƒª¡CP=ô#tº]ƒú Ð 4ý}„˜Óa ض€Ù°;GÂËàDxœÀÛáJ¸>·Âáð,…_“@ÈÑFXñDBX$!k‘"¤©Eš¤¹H‘q䇡a˜Æã‡YŒábVaÖbJ0Õ˜c˜VLæ6f3ù‚¥bÕ±¦X'¬?v 6›-ÄV``[°—±Øaì;ÇÀâp~¸\2n5®·׌»€ëà á&ñx¼*Þï‚Ásðb|!¾ ߯¿' Zk‚!– $l$Tçý„Â4Q¨Ot"†yÄ\b)±ŽØA¼I&N“I†$R$)™´TIj"]&=&½!“É:dGrY@^O®$Ÿ _%’?P”(&OJEBÙN9J¹@y@yC¥R ¨nÔXª˜ºZO½D}J}/G“3—ó—ãÉ­“«‘k•ë—{%O”×—w—_.Ÿ'_!Jþ¦ü¸QÁ@ÁS£°V¡Fá´Â=…IEš¢•bˆbšb‰bƒâ5ÅQ%¼’’·O©@é°Ò%¥!BÓ¥yÒ¸´M´:ÚeÚ0G7¤ûÓ“éÅôè½ô e%e[å(ååå³ÊRÂ0`ø3R¥Œ“Œ»Œó4æ¹ÏãÏÛ6¯i^ÿ¼)•ù*n*|•"•f••ªLUoÕÕªmªOÔ0j&jajÙjûÕ.«Ï§ÏwžÏ_4ÿäü‡ê°º‰z¸újõÃê=ꓚ¾U—4Æ5šnšÉšåšç4Ç´hZ µZåZçµ^0•™îÌTf%³‹9¡­®í§-Ñ>¤Ý«=­c¨³Xg£N³Î]’.[7A·\·SwBOK/X/_¯Qï¡>QŸ­Ÿ¤¿G¿[ÊÀÐ Ú`‹A›Á¨¡Š¡¿aža£ác#ª‘«Ñ*£Z£;Æ8c¶qŠñ>ã[&°‰I’IÉMSØÔÞT`ºÏ´Ï kæh&4«5»Ç¢°ÜYY¬FÖ 9Ã<È|£y›ù+ =‹X‹Ý_,í,S-ë,Y)YXm´ê°úÃÚÄšk]c}džjãc³Î¦Ýæµ­©-ßv¿í};š]°Ý»N»Ïöö"û&û1=‡x‡½÷Øtv(»„}Õëèá¸ÎñŒã'{'±ÓI§ßYÎ)ΠΣ ðÔ-rÑqá¸r‘.d.Œ_xp¡ÔUÛ•ãZëúÌM×çvÄmÄÝØ=Ùý¸û+K‘G‹Ç”§“çÏ ^ˆ—¯W‘W¯·’÷bïjï§>:>‰>>¾v¾«}/øaýývúÝó×ðçú×ûO8¬ è ¤FV> 2 uÃÁÁ»‚/Ò_$\ÔBüCv…< 5 ]ús.,4¬&ìy¸Ux~xw-bEDCÄ»HÈÒÈG‹KwFÉGÅEÕGME{E—EK—X,Y³äFŒZŒ ¦={$vr©÷ÒÝK‡ãìâ ãî.3\–³ìÚrµå©ËÏ®_ÁYq*ßÿ‰©åL®ô_¹wåד»‡û’çÆ+çñ]øeü‘—„²„ÑD—Ä]‰cI®IIãOAµàu²_òä©””£)3©Ñ©Íi„´ø´ÓB%aа+]3='½/Ã4£0CºÊiÕîU¢@Ñ‘L(sYf»˜ŽþLõHŒ$›%ƒY ³j²ÞgGeŸÊQÌæôäšänËÉóÉû~5f5wug¾vþ†üÁ5îk­…Ö®\Û¹Nw]Áºáõ¾ëm mHÙðËFËeßnŠÞÔQ Q°¾`h³ïæÆB¹BQá½-Î[lÅllíÝf³­jÛ—"^ÑõbËâŠâO%Ü’ëßY}WùÝÌö„í½¥ö¥ûwàvwÜÝéºóX™bY^ÙЮà]­åÌò¢ò·»Wì¾Va[q`id´2¨²½J¯jGÕ§ê¤êšæ½ê{·íÚÇÛ׿ßmÓÅ>¼È÷Pk­AmÅaÜá¬ÃÏë¢êº¿g_DíHñ‘ÏG…G¥ÇÂuÕ;Ô×7¨7”6’ƱãqÇoýàõC{«éP3£¹ø8!9ñâÇøïž <ÙyŠ}ªé'ýŸö¶ÐZŠZ¡ÖÜÖ‰¶¤6i{L{ßé€ÓÎ-?›ÿ|ôŒö™š³ÊgKϑΜ›9Ÿw~òBÆ…ñ‹‰‡:Wt>º´äÒ®°®ÞË—¯^ñ¹r©Û½ûüU—«g®9];}}½í†ýÖ»ž–_ì~iéµïm½ép³ý–ã­Ž¾}çú]û/Þöº}åŽÿ‹úî.¾{ÿ^Ü=é}ÞýÑ©^?Ìz8ýhýcìã¢' O*žª?­ýÕø×f©½ôì ×`ϳˆg†¸C/ÿ•ù¯OÃÏ©Ï+F´FêG­GÏŒùŒÝz±ôÅðËŒ—Óã…¿)þ¶÷•Ñ«Ÿ~wû½gbÉÄðkÑë™?JÞ¨¾9úÖömçdèäÓwi獵ŠÞ«¾?öý¡ûcôÇ‘éìOøO•Ÿ?w| üòx&mfæß÷„óû endstream endobj 306 0 obj << /Type /ObjStm /N 100 /First 886 /Length 1718 /Filter /FlateDecode >> stream xÚíYÛnÛF}çWì[máÞoA ¶›ÔiR;@®~ ©µÃV]Š*ì~}ÏP’#UV$+zHš 8;œ=»3svvDka˜`ZX¦è˜2ÏÈ´×LKÁŒÅXJfÁS1ëèi˜°—–EéñtL !2@RQ3IP*ˤV$Î2­“Va:´Òa¤1Þ`q˜ š4‚U™Ö;ôih•Â~µÖi S´u­ XŒ´‚;Ö“€Y»ÕÚ3å­dÚ`V áŠ^gÚXòŸ4§À1ä’&[Ñä°4Àt‚è-6ç4fXÄÉÑt ã 60Ž {60ŽN3B@€‘3l`FaÏXÊ(ƒ¥l„ìsòD[ ‚1Ý+ƒtø˜i'™që9àyõA!ÄX4œˆÄh¤ d2j9€ý[A޸ȬԤñÌ*2í¡¡ÈÂÌvð©§h,‘É´™×“­‰$Xßi0ÛS‘cë=4Xņ(³sBxb„€,DlÛ €EÆIP+ ÍQ1‚”Î`FÄÀaóO³< 4 €Î„,‚¬Îa¿lu^ÁÎB€ @'8àဠ.¶ l€Mèˆ oÈ&0/”Î"" 6pÛ ÂŸ¼$°ÕKÂÁzÈgB0äó ôˆ˜é‰Š´öDéˆÿÞ™½çLJ‡Å(õ@=xr–=z”ñW7W‰ñ_†eÝ«†—'“Ùˆñ×ÕðÉpT}z}T]\¤& Ë4bïA >¨†ã‹Žÿ5®ÛÔO-“Æð^ÝöÓhTñ˦ø;ñ¢·‰—USŽýtÍÛªßK|P”M=äçM‚ ¦e™†-ïUXbTx>¬Û^ºà ÖæeêUý~q«ü8^ÍxÐ/Æ-¯/ëaú“—ᮊ2ew6©h«zxT´‰í=T4*†‘Î*ã÷3þ¼î­|÷ª‚lï„=kŠ«U9b/Æíոū—MÝ—©¡·&׹ܟ®U“j¶ü$ÀOëa›ñÓñyÛ I)3þ[1 wjv²aü×Ôÿ;µUYd·Yéª 2vH}'䃃ºß»wž î~|[üðwæ1|Oyí~õ¯–­ýZ¦’ÛšJÎ}5~y¹ìWÜÖ//6;" v†9ár§ìZ;£cî­Û,N÷¦ÿÖ\nÛ¼Û:‚–j¿X‚mðˆ ^™ûÿ…n™Éô…ȱYd‚Ìm˦?Øoú"þI1ëvèóød™i‹3S,¶QÈ¥Vàº}vÚbJ†Û”‰\/z¸øZ®mLÄ\3Ã{p­joüЦ.û^1liuô%¿ÛÌ\óôùoÏ^ý|XTMMšâØíšziÍ·¯ž¼=:™[SNÖÜ{^”ìÅ){äÈ}nØïã¢iÿa`C—ñkô†{%Íb2¹dö>¶íÕCÎ;åå´ÌëæòÃ>L©é”J-¤WÁ˜wBü„û«;<>"ÍÔÇ5Q"ëÓ›Q›ÇËšèIº¬FmsÃöžôêó„¶õEÓKÔ]±½Yœöi½««~ ;ÇùkœŠégI~ôzòǺnoЦº"Ê(ÃÚVu•w†|×Äu¨Û#¢ÍìÔMŽ> stream xÚ­˜Ájd7E÷þ ý¥R•JfÉ0àU†dY$Æ †À0ÿÏœk¯² ¶uíî>õ¤:¯-uY9jÏ‘›a< 6–ã+ŒÑ‡Y0ãe‡8_ŒðÜFP§|€]îãLxŒðüŒsáy2Âó;2àq yàÅ—k©XŒðtMžj,rðš /ø¾ð¨¹æ©À£qÇZdë+¸ËžG€z˜µ]°‡i[Áå•k | Èδê¤dþºbA>¥Å‚œ£ çR€œk¼¿UBN¦_ Y÷u r¦ä„| rB® ™µ]b‹µôŠº6lªUw´.¬Ÿ-5‹!@¾‡®©]7ümÌÔ0fKC!×¶µœµ 3s5™˜«k9Ô¶ ÈÌÍB«T€\ZWÖxrá–2ir $õf¿týÒCøËE“Bé*Qà­As¦’+!Û¤•¤’~ª±æØôWi)©ÐÍú)mR©Æò±MÍœ+”Tƒ'ïíª±RI55|©Æ¢†›jðc{©]"©†Q#ÔøiÔõyÒº}\5èI5Œiªa©¤¦›†ö>==<~þöïËo¯ßÇŸ?~z|þúחןއŸß‡ç?ÿåï^_¾½àù«f«sŽ_>|Ð׎ÿÍr±¢‡bÖ+{X)Öía]±ª‡¥›‰;XòToº-,½ÅðÆÝÂ2±vKÞ{÷ºõO¨…%ï½Ç{“÷Þã½É{ïñÞä½÷xoò>z¼ßò>z¼ßò>z¼×>J›”–¼ï·¼ï·¼ïµ7О­…%ï£Çû-ï£Çû-ïO÷Úûh{ÔÂ’÷§Ç{—÷§Ç{—÷§Ç{íí´—oaÉûÓã½ËûÓã½ËûÓã½ö®:×´°ä}öxoç ïãí(Õã}Øûù¬…%ï³Çû÷Ùã}Äûѳ…%ï³Ç{õudnaÉûìñ^8èàÞÁÒyZgÿ–¼¿=Þë“}ñÖOá£÷ endstream endobj 1984 0 obj << /Type /ObjStm /N 100 /First 969 /Length 794 /Filter /FlateDecode >> stream xÚ­˜MŠ\G„÷}ŠºÁdfý&-lc˜•…´/l1 Â`t_6ÖR$ ýb&ûETWDÖË·ÈfÍ­[Û«·½¸Fó‘ýu`´ˆ ˜°Z7l8­ïýÈÖ¼ÃÚ˜€yD›óèm"cc´e0)óXm˜Ç€yœ¶'ÌZÔ^0Ok‡ÅÙt˜µÌ4˜%˜ó-Ìs À|—° ž÷TÁ;äSwû€‰ðþíÍá÷6QÆA`©ßúB‚—¾ÐXzóh¬ BƒÂt4V²¡hl½ÌDc;-ÒÅ[ ;¿ÚÁhì B“N ±7­ÂI4¶ÒÐÀ„¼Î²Ÿy½=Ñ®¹§ ]wµÉá×^í—gÉèkðÙ 4´‰×bm„b€FZ‹~MN¡¡Í‰qmÖŒq}NiÌktNúÐ1¯Õ¹Ah¤4Ö5;¥±°Âõabc·kAB $ƒáÊ›Ž+BçV'èV¥‘ëÞ»A·zˆ¬=„DÕ­u÷ r!oU#¦4˜kÀµj¸&\»†kÁuj¸6\YÃ¥<¤z§„‹†W÷Upq,¥ú·„‹CG'@ WÀ5j¸È}ÖäžþϬÉ=|fMî9ë3krÏC&³&÷zL…YMîujŠ«&÷z–‰«&÷z¢‰«&÷÷qm5¹¿|«É=#ƒYMî:ÌjrÏØbV“{³šÜ3:™×äžá˼&÷Œoæ5¹g4¯É=#¤yMîBÍkrÏk^“{aóšÜ3J›×äžaܼ&÷Œó5¹ç Åÿr¿~”ë~§°ˆ"2’½ˆŒèÇ("#û1‹È¬"2Ò»ˆŒøÇ)"#ÿ‘Ed4@·"2: u€Ó½æèçKsð•Ñý»øL°¬ endstream endobj 2035 0 obj << /Type /ObjStm /N 100 /First 970 /Length 771 /Filter /FlateDecode >> stream xÚ­—ÍjTA…÷óýÓ]¿Ý²P²2èFB@‚äýñœšK)÷žáäVî®ï2³–œ1ÇZ:Gïkdò.cù¢Pˆrlˆl ¢eÅÐé QÖºåq hÙæ‡b ¡áxB!ʲK)¢¬qË¢¬=2•í -Ÿcƒ!æ6fvGÌ¢,ç0˜#Ëœå¡þLFó¤*·.Ì]QùÏ+ÐC„ ÷c1¿N ¥*}t3b8U¹¸ ¬HªrÑÕ+ˆÃ¥ËuÄbÐ\T\D¢G&M¥*—dÅà™å¢Ç6&åym+—#\G*º=ÎaÒ½†ÌÉulb…àPåâx¹qPNUnàÈ•IwR•»qú“ëØ‡s@G%º™Á¡¸ŽƒÆ­[8?¨rÑÕIz¸•‹±˜ô$U¹è‡ë@p(¸H>$¹u‚c”ä6 #³¥Tå¢Ç¥rªr9¨“:9©³\ŒêL¬CpŒ˜^ºXŒÖ°ËZTI%CkÜ# U® ­Ç>A­rÑ£F^pŒP墆=Ö¡¢+èQc/Uuã:=jð±ÇTå¢G¾à¡ÊE~‘¤*—ÈY^îî.×Ç?¿Ÿ¾<¿o×ǯ¯?^žßÝnïo·‡ï—ë×O?=?½ >ðð T1àqŽÏ—û{þiü1c±l*æ,¶›Š‹¦b˜Ô ‚{Šm[MÅ‹IO1Œ*ŠiS1¾}ð¾î)Æ^~=ÅH€5 $Àš`M °&„xB¼‰!ÞD€’o"@I€7 $À›PàMð{âô&ø]szJ¼‰%ÑD€’€h"@I@4`$ š0M ˆ&ŒDF¢‰#ÑD€‘€h"ÀH@6`$ ›0M8 È&œd^?ãšp½ý&ì)F²‰'ÙD€ÇíoO1°›p°›p°›°›°›°ÿ!à/ù«·ü endstream endobj 2086 0 obj << /Type /ObjStm /N 100 /First 970 /Length 786 /Filter /FlateDecode >> stream xÚ­—ÍŠ\W „÷ýç æH:¿`¼pL`V1Î&²HÌCðûãú4ÙÄK#n×PÝ¥:Wª¾js¿­7óèm^­íÍ«7›dFs?€Ùx›ÀjÑ'` $uZ\¨ÑÛ˜`m,x›ú¤@$5Ú²L¤V[[c $uÚ^[ÊãÊ Ôìí ŒÉæxžÞ®cl†@R£Ý‹±)/½''ý¾±67(Y]lâ«Æ›}Qñ·ì¿ûáøŽÁ dU'×%«ËHµAÉªÆ N°.w–s,Ãè6‡Øª±.%w€’Õe#àß;YÕ8§ôëŒdu¹Î9öÁÕ¸§Çš÷Î9Ž !à2.”¬Ú+ƒ  Jv©åÓ³AÉu¿sŽs™XµJ­Ç©Œ qŽ«#oú'”¬jÌÀéU9’Ue8½”¬j¬Ë9d\ˆÛUcsëBmÔ™³ªq4+BJV5®g{&h½¶LŸï &µ'«Qí[ç úV‡‰ö0m·Èqh¡Ñ"^ï²dU#G>ÔF¡dUCC¯vA°®9ö¡Q98‡«F¾ôAɪFŽ~¨BɪFø%KäÆ~¼yóxúðï—O¿¾|m¿?}xÿóÓóç?ÿ~y÷úòÓëËó§ß~ù럗O_xþl‹ PÇzûøxû–¿X?.6;Eb±[$¦1ëšÓ±˜‰ļHì"5bš4‰"1¾}”ä1¾À‰1p‹°IÀ-JÀ&·(ú¾w=‹Ä6bE ÐcKbE ÐÃLbE ÐSAbE àùk½(<­%€-@«P‘‹D/J@î"½(¬3fE `#2+JK•YQØËÌŠÀjgV”¶C­×Eb$ÀŠÀŽjV”Ö\³¢°)›%€eÛ¼(ìëæE `å×ï­"1à5 p~xègg‘ ðY$F|‰‘ßEb$ÀO‘ ð[$F¢‰‘€°"1^$F¢(Fâ ˜?.F¢(Fâ»|:“¸– endstream endobj 2137 0 obj << /Type /ObjStm /N 100 /First 970 /Length 768 /Filter /FlateDecode >> stream xÚ­–ÍjTA…÷óýÓ]¿Ý²P²2èFB@‚äýñœšK)Hæžpr«NÝ®of–Ês,Õ9Òx]#“WË…B”cCdSø-+†N§Hˆ²öÐ-ˆAËæ0?kX… Ç Q–XJáeňÃX–eí‘‘¨liùÛ 1·1³Ë8Â`®eÙ8‡ÁYæ,õg2š'U¹xYÎÜŒºøÏè!ÂxÛ„ÏC+ÿdÀ`¦Y.ûlþ¼m—‹c¤*=\9A>Qºœ# ä¢â‰q˜4•ª\¼$ (ƒg–‹ÛØ’çµ­\¼áy¨*zœÃ¤{ ™“#lb‡*Ç‹€TN·aD”IwR•»qú“sìÃ= ‹£€ZTœã ‡ñÑ)Ϊ\ôpeÒƒnå¢G,&=IU.zÄá×&z$á%ù˜ ÃÈ6>ì©Tå¢Ç¥rªr¹¨(ÅMåbUgbÃ1b{éb­e·µ¨xxK†ÖºVª\Z odÊEZyÃ1*z`éÑc*º‚µö†UÅ‚rAZ|Cp¨rÑ£VßpŒPå¢G-¿IR•Kä,/ww—ëãŸßO_žßÆ·ëã‡×‡×/Ïïn—÷·ËÃ÷Ëõë§Ÿ¿žŸÞoxxL…ß7Ï—û{þhü1.‘ž¦bÜCpÒS,Xl5K“¦b›Å´©Øa1ë)†UE1o*¶X,šŠ ‹eS1`M °&¤Þ‰›àM ð&dß>zzŠ‘o"@I€7 ëö¹ÚSŒxJ¼‰­/Mð»æŠ&”DJ¢‰%ÑD€’€h"ÀH@4`$ š0M ˆ&ŒDF²‰#ÙD€‘€l"ÀH@6`$ ›pM8 È&œdN²‰'ÙD€“€ÝD€“€ÝD€“€ÝD€“€ÝD€“€ÝD@€ÝD@€ÝD@€ý>#¹2 endstream endobj 2188 0 obj << /Type /ObjStm /N 100 /First 970 /Length 787 /Filter /FlateDecode >> stream xÚ­WMkTA¼ï¯˜°Ó_Ó3<¨9ô"ˆ A‚ ùÿXÕÉE¡CØWP»Õ5oºÞô×3æ·9Òy•‘É« !0€b|¨n‚jE­a3 ¨=lëàò9< _J #ðK(ÊÇ#€¢ÖX‡¶<ŠÚ#WBÙ ’Š9¶Óln§çÐq”ÆÂŠòq¼ÌYôgÒZ$Q±ø oZ~Ùj¨ÒÞÂÏ”÷£üÛ¤ÁeDÅ¢ŽmZ\ATìzð•/_ö…a\Á:¼£d¹Ž%4šBÄ/'j¬C§iDÅâ#)à4žY,jl§Sî×öbñq”ëÈCDv£Æ9tºeèœ\ÇV 8Œ‹í…A¢ *vaËNw»±û“ëØ‡}@[¥¶éÆ¸Žƒuëû§u›‹Ñ0:=¨^,j,¡Ó“DÅ¢Æ:\Œ‰Y·Û¨ÉÛXŒnô ‹GÙ´hM bÙ¨b§ÎbѪ3±ŽÀ6¢{Éb1VÍ"DI¤ÃªÝ- T¬«†7“bQ£Z>°@Å¢š5ä‘UÔ¨¶´ª…sŠÕøã@Å¢Fµ~`ŠEjþÐ$*–‘ó¼ÜÜ\®w~ß~x_¯wï?\o¿ÿ|xû|y÷|¹ýv¹~ùøã×ÃýÓànÍ©²ùøtyó†ÿ¶^/Æ&B7ôˆ±ÑP=b‹bÚ$–³&±M1o;‹1tÄV“˜P,›Ä”b»IŒ 8M Hž’³)xÚC¬)ɇùlJ@ò<˜M À±±¦à0ƒXSp*@¬)<qØ6‰)ÅšÀ)@gS8H¨4%€³ˆJSjœ‘¦ÔD$M àP¥Ò”ÎeàzÄ8Ú©4%€Ó¡JS8`bric¤)s‘§&1&@›ÀaMbL€6%€#¿jSøÖ Ú“㋇êjc4›Ä˜ÝMbL€ž&1~qìcLšÄê•V›Ä^ÞŠ{Ęó&1&Àš L€ý“€x½`M &ÀþKÀ_—¶¹º endstream endobj 2239 0 obj << /Type /ObjStm /N 100 /First 970 /Length 772 /Filter /FlateDecode >> stream xÚ­˜ÍŠG E÷ßSÔLýIªã…c ³ŠI6…mƒÁŒßߣÙeC÷…Û-ݪÒi>fؼ­·a«·ØÜG‹à>uˆ¥K:»ÍyÖæJËÛꆉ´N[g>$®ÖîmÛEŒ¶¢{6Þ”Xç$vó‘mL"-o~‰µC"­ÓÂC•÷U@,ëíl‚)æÙd¶Ùî$˜-‰´v»—`¦,½§§ú=ˆfJW—aä&êàasõ˜“x®×fîùW' /Tºê³ÝPéê²)`¨tsXß×}Æ:|4ŠE„zø%i,TººD xDºêq6I9¯³ÓÕåNÖ…{Ôã^ZžÑfï¬ãL) ˜‚K¥«ãU@”¡Òuù"é TºG§ßYǹÌ®Žj®CR—bW=6[g:?©tÕƒ‘RFBJ=|ô*]õðË:\J®wõ¶ÎuŒ3r›´˜y4+R •®zÜÉÖi4¥ÒeP;›Ý™Ôž®Fµ‡Öá:FMoEo+‡ÝÇ@j¶•ãΈJí×#[9ð_k¤«9ò£Tºê¡¡WqQ¸S=rì]£º AJ=rð]ÁK©G޾ë¥ÒU~ŸJäv<Þ¼y<}üñï—?_~¶¿Ÿ>¾ÿðôüýÓ×—w¯·ß^oÏÿ<žþúýó·—/?/<_ZÕœšÆÞþx¼}Ëßòÿ_Œo„޵¦˜Qlc”õÅ©) úöÔ;³¢b—b^SL£ªbQTlPì›»EÅ ÀŠ˜`EL°"&X¬ˆ€ VDÀ„+"`A€° ÀŠX`E,ð"òw¢ÀoÍéE,ð"x ¼ˆ€^DÀ†/"`C€°!À‹ØElˆ"6D¢ˆ€ QDÀ†€("`C@`EDQD€AÀ)"ÀòEœ" N§ˆƒ€SD€AÀ)"À!ààpŠp8ÿ!àLhºh endstream endobj 2290 0 obj << /Type /ObjStm /N 100 /First 970 /Length 789 /Filter /FlateDecode >> stream xÚ­—A‹\7„ïó+ôVê–ÔØSLr „³&`üÿI}=§äh–7µÔ¼êÒS×SÏØv[oc{o1ù-‚Okc € $3›Ù¬fžÔnÞ ’:Í=®Ôìm® mnX[ºSÀ’šm,¤vÛ[3’:-vHy^„Z½‰1Ù<ÏËÚ5Œ-Hj¶{1¶ä¥÷ä¤ßk+@Éê2¾±:øòÞªa†½­ÛŒç±ñïƒÛAɪŽ,îJV—‰ÀÞJV5–³‚}y¢°¹ŽÑÀÚ`A¡Ë¿Ám7Y]ñÈ/‡jœ‰SöëÌdu¹Æ:â‚`jÜ‹Ó3šõŽü1!¶Œ %«í•AÐ%»µåŽÉ dv¿³ŽséXm•ù™OãB¬ãªÆäѱBó¹[ŽÓ«k&«{àô(YÕ€jȸñå]5‚GÚF Sh1vÔ+BJV5®9h’¥Q% D§ödÕª=´ŽÐ6ª{aµÏf1@²æÙî¡Jv6φwɪF¶|h…’U 5½jŒ ‚5Õȶµª¯É:L5²ñCÆ…’UlýÐ6:IH5²ùÔ,‘›ñx÷îñòñë?Ÿ~}ûÖ~ùøá§—×/~~ûáùñãóãõÇËo?ÿõ÷Û§o^¿¸šSm>ôøåñþ=¾¿_Œw„v¾Fl!æEb´²ú¯FŒ4¨+kÄb»Hì"5bê4‰"±Ø-3^B½HÌ+J€^Õ+J@pÒö¢è}/±¢èÌ1Îþ±ŠÀD¤¡HŒŒ¢<ç²¢äh7ŠÓá(J¦[Q˜QÝŠÀ˜ëV”&eEb$ÀŠÀ¼îV”F~·¢ð«Á­&“n§HŒØ-#Þ‹ÄH€"1àV$FÜ‹ÄH€Ï"1à«HŒø.#^”€Aü? Xß/F¼(ƒÌÿ%à_;JºÞ endstream endobj 2341 0 obj << /Type /ObjStm /N 100 /First 970 /Length 771 /Filter /FlateDecode >> stream xÚ­—ÍjUA„÷÷)æ îLÿL÷@ÈBEÈÊ A\h‚ÉûcU_W.¥!ÜS¡r»«ÏôwÈY!g̱Bçãu^e,_ QŽ ‘¤ð!ZÖ:" ÊÊ¡)ˆAËæ0?kØ ŽoB(DY6öR ‡(k}Ë¢¬±•í -Ÿ#Á3™]Æs…(ËÆ9 æÈ2gy¨?ƒÑ<¨ÊÅÇræfÔÅ?Ž"Œ·ñ5áýæ×É€[©ÊEMFÜNU.>Œ™ª\ôpåûðŽÒå{1h,*豓†R•k DrÑ#­~ ªrñq„sÄ¡¢›èq“æ2'çHb@p¨rq¼HåTån¹2iU¹‰ÓŸœ#÷€.ŽJ4Á¡8ÇAã­ œT¹èáʤ=ÜÊE½˜ôU¹è±ç@p(¸9Ñ£n]â¥nSbIã˜JU.zQ*§*—‹ŠPÜÔY.VuæH#¶—.†ÑZö\‹Š7vÉÐZ÷ÄŠB•kCkáÁUW¹èQ+Ÿ8F¨rÑKëPÑô¨µO¬ªºqAZüDp¨rÑ£V?qŒPå¢G-MJP•Kä,.ww—ëãï_OŸž_Ç—ëã»÷ׇ—o?žßÜ.oo—‡¯—ëçß>?½~ááÅ0†<>^îïù£ûÿ‹‹iS1>g@xO±ÍbÞT,Xl7#Px~õ#“x´bm§©Ÿ xf÷[MÅH€7 $À›àM ð&„xB¼‰!ÞD€’o"@IÀn"@IÀn"@IÀn"€ÿ'ên" þ×ÜM( ØM( ØM( ØM( ØM ØM ˆ&ŒDF¢‰#ÑD€‘€h"ÀH@4`$ š0M ˆ&œD^ïGM8 È&œdN²‰÷ÛÛeO1M8 È&> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1922 0 obj << /Length 2442 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2443 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1923 0 obj << /Length 2444 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2445 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1924 0 obj << /Length 2446 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2447 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1925 0 obj << /Length 2448 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2449 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1926 0 obj << /Length 2450 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2451 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1927 0 obj << /Length 2452 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2453 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1928 0 obj << /Length 2454 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2455 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1929 0 obj << /Length 2456 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2457 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1930 0 obj << /Length 2458 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2459 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1931 0 obj << /Length 2460 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2461 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1932 0 obj << /Length 2462 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2463 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1934 0 obj << /Length 2464 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2465 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1935 0 obj << /Length 2466 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2467 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1936 0 obj << /Length 2468 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2469 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1937 0 obj << /Length 2470 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2471 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1938 0 obj << /Length 2472 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2473 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1939 0 obj << /Length 2474 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2475 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1940 0 obj << /Length 2476 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2477 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1941 0 obj << /Length 2478 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2479 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1942 0 obj << /Length 2480 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2481 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1943 0 obj << /Length 2482 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2483 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1944 0 obj << /Length 2484 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2485 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1945 0 obj << /Length 2486 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2487 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1946 0 obj << /Length 2488 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2489 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1947 0 obj << /Length 2490 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2491 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1948 0 obj << /Length 2492 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2493 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1949 0 obj << /Length 2494 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2495 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1950 0 obj << /Length 2496 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2497 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1951 0 obj << /Length 2498 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2499 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1952 0 obj << /Length 2500 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2501 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1953 0 obj << /Length 2502 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2503 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1954 0 obj << /Length 2504 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2505 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1955 0 obj << /Length 2506 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2507 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1956 0 obj << /Length 2508 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2509 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1957 0 obj << /Length 2510 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2511 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1958 0 obj << /Length 2512 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2513 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1959 0 obj << /Length 2514 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2515 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1960 0 obj << /Length 2516 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2517 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1961 0 obj << /Length 2518 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2519 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1962 0 obj << /Length 2520 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2521 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1963 0 obj << /Length 2522 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2523 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1964 0 obj << /Length 2524 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2525 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1965 0 obj << /Length 2526 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2527 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1966 0 obj << /Length 2528 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2529 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1967 0 obj << /Length 2530 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2531 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1968 0 obj << /Length 2532 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2533 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1969 0 obj << /Length 2534 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2535 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1970 0 obj << /Length 2536 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2537 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1971 0 obj << /Length 2538 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2539 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1972 0 obj << /Length 2540 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2541 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1973 0 obj << /Length 2542 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2543 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1974 0 obj << /Length 2544 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2545 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1975 0 obj << /Length 2546 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2547 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1976 0 obj << /Length 2548 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2549 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1977 0 obj << /Length 2550 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2551 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1978 0 obj << /Length 2552 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2553 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1979 0 obj << /Length 2554 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2555 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1980 0 obj << /Length 2556 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2557 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1981 0 obj << /Length 2558 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2559 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1982 0 obj << /Length 2560 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2561 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1983 0 obj << /Length 2562 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2563 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1985 0 obj << /Length 2564 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2565 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1986 0 obj << /Length 2566 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2567 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1987 0 obj << /Length 2568 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2569 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1988 0 obj << /Length 2570 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2571 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1989 0 obj << /Length 2572 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2573 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1990 0 obj << /Length 2574 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2575 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1991 0 obj << /Length 2576 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2577 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1992 0 obj << /Length 2578 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2579 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1993 0 obj << /Length 2580 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2581 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1994 0 obj << /Length 2582 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2583 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1995 0 obj << /Length 2584 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2585 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1996 0 obj << /Length 2586 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2587 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1997 0 obj << /Length 2588 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2589 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1998 0 obj << /Length 2590 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2591 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1999 0 obj << /Length 2592 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2593 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2000 0 obj << /Length 2594 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2595 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2001 0 obj << /Length 2596 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2597 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2002 0 obj << /Length 2598 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2599 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2003 0 obj << /Length 2600 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2601 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2004 0 obj << /Length 2602 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2603 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2005 0 obj << /Length 2604 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2605 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2006 0 obj << /Length 2606 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2607 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2007 0 obj << /Length 2608 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2609 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2008 0 obj << /Length 2610 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2611 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2009 0 obj << /Length 2612 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2613 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2010 0 obj << /Length 2614 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2615 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2011 0 obj << /Length 2616 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2617 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2012 0 obj << /Length 2618 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2619 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2013 0 obj << /Length 2620 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2621 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2014 0 obj << /Length 2622 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2623 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2015 0 obj << /Length 2624 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2625 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2016 0 obj << /Length 2626 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2627 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2017 0 obj << /Length 2628 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2629 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2018 0 obj << /Length 2630 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2631 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2019 0 obj << /Length 2632 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2633 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2020 0 obj << /Length 2634 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2635 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2021 0 obj << /Length 2636 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2637 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2022 0 obj << /Length 2638 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2639 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2023 0 obj << /Length 2640 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2641 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2024 0 obj << /Length 2642 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2643 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2025 0 obj << /Length 2644 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2645 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2026 0 obj << /Length 2646 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2647 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2027 0 obj << /Length 2648 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2649 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2028 0 obj << /Length 2650 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2651 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2029 0 obj << /Length 2652 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2653 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2030 0 obj << /Length 2654 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2655 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2031 0 obj << /Length 2656 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2657 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2032 0 obj << /Length 2658 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2659 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2033 0 obj << /Length 2660 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2661 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2034 0 obj << /Length 2662 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2663 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2036 0 obj << /Length 2664 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2665 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2037 0 obj << /Length 2666 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2667 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2038 0 obj << /Length 2668 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2669 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2039 0 obj << /Length 2670 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2671 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2040 0 obj << /Length 2672 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2673 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2041 0 obj << /Length 2674 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2675 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2042 0 obj << /Length 2676 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2677 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2043 0 obj << /Length 2678 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2679 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2044 0 obj << /Length 2680 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2681 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2045 0 obj << /Length 2682 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2683 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2046 0 obj << /Length 2684 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2685 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2047 0 obj << /Length 2686 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2687 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2048 0 obj << /Length 2688 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2689 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2049 0 obj << /Length 2690 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2691 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2050 0 obj << /Length 2692 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2693 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2051 0 obj << /Length 2694 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2695 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2052 0 obj << /Length 2696 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2697 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2053 0 obj << /Length 2698 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2699 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2054 0 obj << /Length 2700 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2701 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2055 0 obj << /Length 2702 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2703 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2056 0 obj << /Length 2704 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2705 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2057 0 obj << /Length 2706 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2707 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2058 0 obj << /Length 2708 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2709 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2059 0 obj << /Length 2710 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2711 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2060 0 obj << /Length 2712 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2713 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2061 0 obj << /Length 2714 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2715 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2062 0 obj << /Length 2716 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2717 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2063 0 obj << /Length 2718 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2719 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2064 0 obj << /Length 2720 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2721 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2065 0 obj << /Length 2722 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2723 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2066 0 obj << /Length 2724 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2725 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2067 0 obj << /Length 2726 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2727 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2068 0 obj << /Length 2728 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2729 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2069 0 obj << /Length 2730 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2731 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2070 0 obj << /Length 2732 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2733 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2071 0 obj << /Length 2734 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2735 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2072 0 obj << /Length 2736 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2737 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2073 0 obj << /Length 2738 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2739 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2074 0 obj << /Length 2740 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2741 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2075 0 obj << /Length 2742 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2743 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2076 0 obj << /Length 2744 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2745 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2077 0 obj << /Length 2746 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2747 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2078 0 obj << /Length 2748 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2749 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2079 0 obj << /Length 2750 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2751 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2080 0 obj << /Length 2752 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2753 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2081 0 obj << /Length 2754 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2755 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2082 0 obj << /Length 2756 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2757 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2083 0 obj << /Length 2758 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2759 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2084 0 obj << /Length 2760 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2761 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2085 0 obj << /Length 2762 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2763 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2087 0 obj << /Length 2764 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2765 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2088 0 obj << /Length 2766 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2767 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2089 0 obj << /Length 2768 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2769 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2090 0 obj << /Length 2770 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2771 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2091 0 obj << /Length 2772 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2773 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2092 0 obj << /Length 2774 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2775 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2093 0 obj << /Length 2776 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2777 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2094 0 obj << /Length 2778 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2779 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2095 0 obj << /Length 2780 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2781 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2096 0 obj << /Length 2782 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2783 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2097 0 obj << /Length 2784 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2785 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2098 0 obj << /Length 2786 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2787 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2099 0 obj << /Length 2788 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2789 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2100 0 obj << /Length 2790 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2791 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2101 0 obj << /Length 2792 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2793 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2102 0 obj << /Length 2794 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2795 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2103 0 obj << /Length 2796 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2797 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2104 0 obj << /Length 2798 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2799 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2105 0 obj << /Length 2800 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2801 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2106 0 obj << /Length 2802 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2803 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2107 0 obj << /Length 2804 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2805 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2108 0 obj << /Length 2806 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2807 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2109 0 obj << /Length 2808 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2809 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2110 0 obj << /Length 2810 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2811 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2111 0 obj << /Length 2812 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2813 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2112 0 obj << /Length 2814 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2815 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2113 0 obj << /Length 2816 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2817 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2114 0 obj << /Length 2818 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2819 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2115 0 obj << /Length 2820 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2821 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2116 0 obj << /Length 2822 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2823 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2117 0 obj << /Length 2824 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2825 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2118 0 obj << /Length 2826 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2827 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2119 0 obj << /Length 2828 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2829 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2120 0 obj << /Length 2830 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2831 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2121 0 obj << /Length 2832 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2833 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2122 0 obj << /Length 2834 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2835 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2123 0 obj << /Length 2836 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2837 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2124 0 obj << /Length 2838 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2839 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2125 0 obj << /Length 2840 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2841 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2126 0 obj << /Length 2842 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2843 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2127 0 obj << /Length 2844 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2845 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2128 0 obj << /Length 2846 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2847 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2129 0 obj << /Length 2848 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2849 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2130 0 obj << /Length 2850 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2851 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2131 0 obj << /Length 2852 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2853 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2132 0 obj << /Length 2854 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2855 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2133 0 obj << /Length 2856 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2857 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2134 0 obj << /Length 2858 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2859 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2135 0 obj << /Length 2860 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2861 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2136 0 obj << /Length 2862 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2863 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2138 0 obj << /Length 2864 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2865 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2139 0 obj << /Length 2866 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2867 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2140 0 obj << /Length 2868 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2869 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2141 0 obj << /Length 2870 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2871 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2142 0 obj << /Length 2872 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2873 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2143 0 obj << /Length 2874 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2875 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2144 0 obj << /Length 2876 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2877 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2145 0 obj << /Length 2878 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2879 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2146 0 obj << /Length 2880 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2881 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2147 0 obj << /Length 2882 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2883 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2148 0 obj << /Length 2884 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2885 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2149 0 obj << /Length 2886 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2887 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2150 0 obj << /Length 2888 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2889 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2151 0 obj << /Length 2890 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2891 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2152 0 obj << /Length 2892 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2893 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2153 0 obj << /Length 2894 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2895 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2154 0 obj << /Length 2896 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2897 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2155 0 obj << /Length 2898 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2899 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2156 0 obj << /Length 2900 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2901 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2157 0 obj << /Length 2902 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2903 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2158 0 obj << /Length 2904 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2905 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2159 0 obj << /Length 2906 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2907 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2160 0 obj << /Length 2908 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2909 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2161 0 obj << /Length 2910 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2911 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2162 0 obj << /Length 2912 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2913 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2163 0 obj << /Length 2914 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2915 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2164 0 obj << /Length 2916 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2917 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2165 0 obj << /Length 2918 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2919 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2166 0 obj << /Length 2920 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2921 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2167 0 obj << /Length 2922 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2923 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2168 0 obj << /Length 2924 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2925 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2169 0 obj << /Length 2926 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2927 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2170 0 obj << /Length 2928 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2929 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2171 0 obj << /Length 2930 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2931 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2172 0 obj << /Length 2932 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2933 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2173 0 obj << /Length 2934 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2935 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2174 0 obj << /Length 2936 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2937 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2175 0 obj << /Length 2938 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2939 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2176 0 obj << /Length 2940 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2941 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2177 0 obj << /Length 2942 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2943 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2178 0 obj << /Length 2944 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2945 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2179 0 obj << /Length 2946 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2947 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2180 0 obj << /Length 2948 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2949 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2181 0 obj << /Length 2950 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2951 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2182 0 obj << /Length 2952 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2953 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2183 0 obj << /Length 2954 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2955 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2184 0 obj << /Length 2956 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2957 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2185 0 obj << /Length 2958 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2959 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2186 0 obj << /Length 2960 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2961 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2187 0 obj << /Length 2962 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2963 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2189 0 obj << /Length 2964 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2965 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2190 0 obj << /Length 2966 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2967 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2191 0 obj << /Length 2968 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2969 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2192 0 obj << /Length 2970 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2971 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2193 0 obj << /Length 2972 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2973 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2194 0 obj << /Length 2974 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2975 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2195 0 obj << /Length 2976 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2977 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2196 0 obj << /Length 2978 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 2979 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2197 0 obj << /Length 2980 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2981 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2198 0 obj << /Length 2982 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2983 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2199 0 obj << /Length 2984 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2985 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2200 0 obj << /Length 2986 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2987 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2201 0 obj << /Length 2988 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2989 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2202 0 obj << /Length 2990 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2991 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2203 0 obj << /Length 2992 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2993 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2204 0 obj << /Length 2994 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2995 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2205 0 obj << /Length 2996 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2997 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2206 0 obj << /Length 2998 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 2999 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2207 0 obj << /Length 3000 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3001 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2208 0 obj << /Length 3002 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3003 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2209 0 obj << /Length 3004 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3005 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2210 0 obj << /Length 3006 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3007 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2211 0 obj << /Length 3008 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3009 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2212 0 obj << /Length 3010 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3011 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2213 0 obj << /Length 3012 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3013 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2214 0 obj << /Length 3014 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3015 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2215 0 obj << /Length 3016 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3017 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2216 0 obj << /Length 3018 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3019 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2217 0 obj << /Length 3020 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3021 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2218 0 obj << /Length 3022 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3023 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2219 0 obj << /Length 3024 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3025 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2220 0 obj << /Length 3026 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3027 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2221 0 obj << /Length 3028 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3029 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2222 0 obj << /Length 3030 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3031 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2223 0 obj << /Length 3032 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3033 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2224 0 obj << /Length 3034 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3035 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2225 0 obj << /Length 3036 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3037 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2226 0 obj << /Length 3038 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3039 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2227 0 obj << /Length 3040 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3041 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2228 0 obj << /Length 3042 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3043 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2229 0 obj << /Length 3044 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3045 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2230 0 obj << /Length 3046 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3047 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2231 0 obj << /Length 3048 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3049 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2232 0 obj << /Length 3050 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3051 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2233 0 obj << /Length 3052 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3053 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2234 0 obj << /Length 3054 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3055 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2235 0 obj << /Length 3056 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3057 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2236 0 obj << /Length 3058 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3059 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2237 0 obj << /Length 3060 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3061 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2238 0 obj << /Length 3062 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3063 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2240 0 obj << /Length 3064 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3065 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2241 0 obj << /Length 3066 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3067 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2242 0 obj << /Length 3068 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3069 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2243 0 obj << /Length 3070 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3071 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2244 0 obj << /Length 3072 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3073 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2245 0 obj << /Length 3074 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3075 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2246 0 obj << /Length 3076 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3077 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2247 0 obj << /Length 3078 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3079 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2248 0 obj << /Length 3080 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3081 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2249 0 obj << /Length 3082 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3083 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2250 0 obj << /Length 3084 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3085 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2251 0 obj << /Length 3086 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3087 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2252 0 obj << /Length 3088 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3089 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2253 0 obj << /Length 3090 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3091 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2254 0 obj << /Length 3092 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3093 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2255 0 obj << /Length 3094 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3095 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2256 0 obj << /Length 3096 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3097 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2257 0 obj << /Length 3098 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3099 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2258 0 obj << /Length 3100 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3101 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2259 0 obj << /Length 3102 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3103 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2260 0 obj << /Length 3104 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3105 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2261 0 obj << /Length 3106 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3107 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2262 0 obj << /Length 3108 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3109 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2263 0 obj << /Length 3110 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3111 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2264 0 obj << /Length 3112 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3113 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2265 0 obj << /Length 3114 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3115 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2266 0 obj << /Length 3116 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3117 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2267 0 obj << /Length 3118 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3119 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2268 0 obj << /Length 3120 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3121 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2269 0 obj << /Length 3122 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3123 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2270 0 obj << /Length 3124 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3125 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2271 0 obj << /Length 3126 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3127 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2272 0 obj << /Length 3128 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3129 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2273 0 obj << /Length 3130 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3131 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2274 0 obj << /Length 3132 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3133 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2275 0 obj << /Length 3134 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3135 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2276 0 obj << /Length 3136 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3137 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2277 0 obj << /Length 3138 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3139 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2278 0 obj << /Length 3140 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3141 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2279 0 obj << /Length 3142 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3143 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2280 0 obj << /Length 3144 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3145 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2281 0 obj << /Length 3146 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3147 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2282 0 obj << /Length 3148 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3149 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2283 0 obj << /Length 3150 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3151 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2284 0 obj << /Length 3152 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3153 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2285 0 obj << /Length 3154 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3155 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2286 0 obj << /Length 3156 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3157 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2287 0 obj << /Length 3158 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3159 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2288 0 obj << /Length 3160 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3161 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2289 0 obj << /Length 3162 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3163 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2291 0 obj << /Length 3164 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3165 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2292 0 obj << /Length 3166 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3167 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2293 0 obj << /Length 3168 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3169 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2294 0 obj << /Length 3170 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3171 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2295 0 obj << /Length 3172 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3173 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2296 0 obj << /Length 3174 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3175 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2297 0 obj << /Length 3176 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3177 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2298 0 obj << /Length 3178 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3179 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2299 0 obj << /Length 3180 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3181 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2300 0 obj << /Length 3182 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3183 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2301 0 obj << /Length 3184 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3185 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2302 0 obj << /Length 3186 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3187 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2303 0 obj << /Length 3188 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3189 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2304 0 obj << /Length 3190 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3191 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2305 0 obj << /Length 3192 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3193 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2306 0 obj << /Length 3194 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3195 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2307 0 obj << /Length 3196 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3197 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2308 0 obj << /Length 3198 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3199 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2309 0 obj << /Length 3200 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3201 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2310 0 obj << /Length 3202 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3203 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2311 0 obj << /Length 3204 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3205 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2312 0 obj << /Length 3206 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3207 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2313 0 obj << /Length 3208 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3209 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2314 0 obj << /Length 3210 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3211 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2315 0 obj << /Length 3212 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3213 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2316 0 obj << /Length 3214 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3215 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2317 0 obj << /Length 3216 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3217 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2318 0 obj << /Length 3218 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3219 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2319 0 obj << /Length 3220 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3221 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2320 0 obj << /Length 3222 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3223 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2321 0 obj << /Length 3224 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3225 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2322 0 obj << /Length 3226 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3227 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2323 0 obj << /Length 3228 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3229 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2324 0 obj << /Length 3230 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3231 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2325 0 obj << /Length 3232 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3233 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2326 0 obj << /Length 3234 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3235 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2327 0 obj << /Length 3236 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3237 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2328 0 obj << /Length 3238 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3239 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2329 0 obj << /Length 3240 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3241 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2330 0 obj << /Length 3242 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3243 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2331 0 obj << /Length 3244 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3245 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2332 0 obj << /Length 3246 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3247 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2333 0 obj << /Length 3248 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3249 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2334 0 obj << /Length 3250 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3251 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2335 0 obj << /Length 3252 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3253 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2336 0 obj << /Length 3254 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3255 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2337 0 obj << /Length 3256 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3257 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2338 0 obj << /Length 3258 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3259 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2339 0 obj << /Length 3260 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3261 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2340 0 obj << /Length 3262 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3263 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2342 0 obj << /Length 3264 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3265 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2343 0 obj << /Length 3266 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3267 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2344 0 obj << /Length 3268 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3269 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2345 0 obj << /Length 3270 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3271 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2346 0 obj << /Length 3272 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3273 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2347 0 obj << /Length 3274 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3275 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2348 0 obj << /Length 3276 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3277 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2349 0 obj << /Length 3278 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3279 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2350 0 obj << /Length 3280 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3281 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2351 0 obj << /Length 3282 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3283 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2352 0 obj << /Length 3284 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3285 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2353 0 obj << /Length 3286 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3287 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2354 0 obj << /Length 3288 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3289 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2355 0 obj << /Length 3290 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3291 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2356 0 obj << /Length 3292 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3293 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2357 0 obj << /Length 3294 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3295 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2358 0 obj << /Length 3296 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3297 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2359 0 obj << /Length 3298 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3299 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2360 0 obj << /Length 3300 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3301 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2361 0 obj << /Length 3302 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3303 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2362 0 obj << /Length 3304 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3305 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2363 0 obj << /Length 3306 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3307 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2364 0 obj << /Length 3308 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3309 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2365 0 obj << /Length 3310 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3311 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2366 0 obj << /Length 3312 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3313 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2367 0 obj << /Length 3314 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3315 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2368 0 obj << /Length 3316 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3317 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2369 0 obj << /Length 3318 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3319 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2370 0 obj << /Length 3320 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3321 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2371 0 obj << /Length 3322 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3323 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2372 0 obj << /Length 3324 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3325 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2373 0 obj << /Length 3326 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3327 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2374 0 obj << /Length 3328 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3329 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2375 0 obj << /Length 3330 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3331 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2376 0 obj << /Length 3332 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3333 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2377 0 obj << /Length 3334 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3335 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2378 0 obj << /Length 3336 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3337 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2379 0 obj << /Length 3338 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3339 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2380 0 obj << /Length 3340 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3341 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2381 0 obj << /Length 3342 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3343 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2382 0 obj << /Length 3344 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3345 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2383 0 obj << /Length 3346 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3347 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2384 0 obj << /Length 3348 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3349 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2385 0 obj << /Length 3350 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3351 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2386 0 obj << /Length 3352 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3353 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2387 0 obj << /Length 3354 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3355 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2388 0 obj << /Length 3356 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3357 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2389 0 obj << /Length 3358 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3359 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2390 0 obj << /Length 3360 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3361 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2391 0 obj << /Length 3362 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3363 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2393 0 obj << /Length 3364 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3365 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2394 0 obj << /Length 3366 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3367 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2395 0 obj << /Length 3368 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3369 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2396 0 obj << /Length 3370 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3371 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2397 0 obj << /Length 3372 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3373 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2398 0 obj << /Length 3374 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3375 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2399 0 obj << /Length 3376 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3377 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2400 0 obj << /Length 3378 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3379 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2401 0 obj << /Length 3380 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3381 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2402 0 obj << /Length 3382 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3383 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2403 0 obj << /Length 3384 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3385 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2404 0 obj << /Length 3386 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3387 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2405 0 obj << /Length 3388 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3389 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2406 0 obj << /Length 3390 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3391 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2407 0 obj << /Length 3392 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3393 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2408 0 obj << /Length 3394 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3395 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2409 0 obj << /Length 3396 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3397 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2410 0 obj << /Length 3398 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3399 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2411 0 obj << /Length 3400 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3401 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2412 0 obj << /Length 3402 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3403 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2413 0 obj << /Length 3404 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3405 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2414 0 obj << /Length 3406 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3407 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2415 0 obj << /Length 3408 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2440 0 R /SMask 3409 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2416 0 obj << /Length 3410 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3411 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2417 0 obj << /Length 3412 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3413 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2418 0 obj << /Length 3414 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3415 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2419 0 obj << /Length 3416 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3417 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2420 0 obj << /Length 3418 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3419 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2421 0 obj << /Length 3420 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3421 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2422 0 obj << /Length 3422 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3423 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2423 0 obj << /Length 3424 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3425 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2424 0 obj << /Length 3426 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3427 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2425 0 obj << /Length 3428 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3429 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2426 0 obj << /Length 3430 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3431 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2427 0 obj << /Length 3432 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3433 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2428 0 obj << /Length 3434 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3435 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2429 0 obj << /Length 3436 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3437 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2430 0 obj << /Length 3438 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3439 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2431 0 obj << /Length 3440 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3441 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2432 0 obj << /Length 3442 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3443 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2433 0 obj << /Length 3444 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3445 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2434 0 obj << /Length 3446 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3447 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2435 0 obj << /Length 3448 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3449 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2436 0 obj << /Length 3450 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2440 0 R /SMask 3451 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2437 0 obj << /Length 3452 0 R /Subtype /CIDFontType0C /Filter /FlateDecode >> stream xEX |SUºo£R눓÷æ=gÁyŽ;£(²(« ÊRè¥M÷tÉÚ´Y»—–¯@“.é’¦I“¦Mé¾ÐÒ…– ²«¨ˆ Èè(°ô%¯EBBZŒ1!e• ;«tõÙnzÙÈž“˜Îóå’½WÓ ‡¥-­<,ê} ¸ü Û·ÝÓ” îÔ.Ã(Âaì®ó¶A½½ºÑâ†O•fhÍj0kLY#(”2}|>h‹Õ% „Wp›;zv gžÃ뀻Ξ€Ãã'š/!tcW~§ ±’==>s¨â\[â0ŨÈy†)±4¸A”„r7Î’½?¦ /`Ö†z§×Þæ6[Â>Üìµ`Õ^Ày¬¸Œ.„=XLìÆ“ZêŒ&Òª'«&]¡œê4o—üTúí쯢)bwn¾–„N]:Mýh¸’9›{5´4¶Wu# `{^³jskt¶Lp´45zk¡¹ÆgmG¸ˆ#*O8Ô*¬‰¸‹¼Åž& Ü ; ܺÐ×dZT)˜ž«RƒJ““€aÔíX`TîsêVÜ\PfÊ–ˆ Ãt³B r•y'®£n¾_¦ÏOˆ³»˜§­ÙÕR-4²È{8¦l¦dXãÈ(ܼ£ú*ÃÅÍù0´Ëë¥ZÔ—šö€ºPkÔiÁ¨Ë×gÃ]©“飿_â|W§æKnÒ@Â#LôÀ*¶H¼ù‚¡Îšc+ëžêÒzò–cyPƒÖ2 ØÌ+É-ÉÝ ¹{s÷š¤(¯69Áè,ôb; ÷5[EZÞfoSË=BîðQZ¼O>ø=ø!„q?’¤Œ‹!q'ãnÓz¹9þ÷ÿ"û’ò+Òï`óH†ñö%ª³ÔUœê±w¢[LÕ‰cSqtj˜ÃÓäh®om«¥ á NdöGC_´s=> ¸8kmÜ6nÛ¦X%¡¬JNƪÖ7d{׳ç)…or3%îÛžœÌRw¦+Ù±KìlLO‡ôtc®Œ°ÄÛÒ ió!ùi„aìjhê¤ òÜ3JFW¡¡ }ÖÖZu»{ñ()r ÍEú= /Ö—Ja{!KÝ£.4äƒÂhR¡ PY•Õ`îU.OÒ¸¿¶ÂZ*öUc- /×¥­…Ìštr9ìÂÔœ,ä™ ³ö(` åïiçPŸúš‡m§p,§G=G"F’§'æï+/øšûì£àæØiý%p‹%ûÓ­™6¸ä½¦£íØjuׂ§ÖæB +ßže³UU‘Pkì,ºZV£­wv;Ž5ôuù ³m¤Žñ2ÓtîWzU¦Àb¢ÆÂ†œzÈjJ¶EˆÙ£,Ò›Ao.Ðc ¦Zç2AMAc¡§Ž›Ø[ÆCF§ :4ödŒÜ©KJä”0ýË/ⶆÔNué•NÀÇ仩Dî»k’vôîwZ¡ÇÖæqw£µ¶»bʽû=H˜zSw!y ’F·º—"b%ñ³Ç§B%„aì+ü ùèjÝè~\nZ“± Â…à…aÂ}ÔûÐÏq>Âýeü=‰dþ‰;qó4w—ÄУ#öQhî„æÎš1< xÖ<ªhÅÁ”úx„hLÒ+R@žbŽÄõ€[m;›€‹ä/©ËoÐ5ª)óì,þ!Ž-¥ÞaY©*ÜrSjaÂf wÇŽB̨ö,~ø¾ãlïÐûÆ-ïÆÍ÷êÌù¾¢LûŠP¦=þÓÔ§Åü Åý—ò—Ùßïô‚‘ùgðA>àa £oó_Ä…L(»Íb‰Šf1¡ˆä Æ(Z=Pœ¹÷‘Æ#ºÞ$èMj ÇWheºÈd)¤Ä†e‘·-}!¼Áž@ÆßÇÿŸ$³*£<‡‰ËGr;+[àm¨iÇaÀñì®xG`)S‰ü\þw’ÃØUÙüëû#ºÎdW*Êe¤'OÔSÊç®J¸ëÈ&q¨ ËçÒ:¶âbÀ˜üdt ufªZrÆÚl¨ÕU¤í“Âþ'Y™|_Ö3X4Uƺ"@f!+±”T”VBiÕ^Gi q!¬tXß&«]eúr£ G|óWÓ^zW4ퟃ¤þïËSóGêCæ'Dþ†µe쀲vìÆbü·Ø“„RþC-a5*Ê’ , •H.ô¿øLtÃÔ<þuî°Dæ.2„‹ì ¿TÂM£‘jHùCÈ^âdLèF¶L±GéqӯŠ1qBÂWÔpÔÜþ4óÑÈ Ð=¿"€{Oz£ð5CåÌJ=Ô¥µ!œÄ¯kl­–~Ëê±?eþeš¦bÂãg’䯦Á4î&ó‹O‰Aý qÜ n„(sø£²—Œ;A³*g Μ[³Ð»ê£®™¯#‹z/c8§r9-¦NÐ˜Ç BIk©‰Iü£îºï}pŒô½}òKŠÿ@r\ãP‚bþi(ÿ8­ Þ-c›4ø ƽËof—è¯?’}Kb™hF–QÈ>¾[#±D4%÷gƒ3Ï]ìEÇ^»§<í¶nì5õ¤{!½9©–h_ÕDmdæè -,/g|ãƒHãsL8‚,]ØÎ춺Ê:+4Wù,Ä'Oã¤vP C±®¸˜PÖfiHÃ_Q-@Ø‚õ»ÂîƒêÑâsd[JÇDèÇoµ_ª; M«¯â瀟›o(/ƒa4õBÔg”lìy_du6TélJ› ê¥ÕqÖ8°Äò%>aX˜¾²#ãVmzжCxúJrWÅO§òÀ}K;.ºÛ ´0n=G P` ôØâ§÷Ò]7Ì„(aX4Ñi"€ÛHD¾Áa¯‚GWåÂûxDéÝuV)†¨ò2GT¹·¸%¯ -éu»’PfNWA†Ê¸WS·;,œ”†ò·{G±~ÑÞñ/¢_2÷¯;Ö…ða Ådœj ¨ý^2ò‚ݶ6,š/î!ÄŸ†Ïvm|¶^”ÿ oS˜¸¯\„S7?äîEàÀÏãÞ\ÏùwIzN9.âÚLežß=»¼Ö¼LÄÆMJÊ€]êå"»XÚ¸®oô‡‘ŠpOµõœü H¨ØHº3š"­«á9dEs½ÙNÈvfTSplÅ8…j“ bpàöêÝ®$p%uêGº°µÚé—«¶­²¨ æ­VGÄË >5Â@(¸·y¤c7¦} ßü¬éÁ#0täXó‡Ýò;9×ÀŸÚ(y;ñÐúúy@*g\Ý“è†$÷NÛV„õ¸UAËЬÄÇ:Öô„A÷ö“Šëbuê†×ɲAÈ$ë^aÜyþØ«ÈÔg²¤ •Ê1ê0óz¤å½Ô²iÖ]}\Œƒ_žyN»ÒñO^›Ç”w¬2Áñ|©Äž[¯oСb‰J ×çmÏJ€¤Uk’U“àx¶¯ø(|Šì€ºBWc†Æì¶<*eçpÐ톚–ò±½ï€^©ÍR™Ae–1¦4iŒíƒØþ̳ø¿ó® £phtÜØÔwæµi¡z®DÑ–"nÌ^ŘŒÌÍ“V'ž¼n‹vÓ^"­ÝH;ü·p¨Ås êÚ­ÝxðŒiDÙöóæps$®°>Åq±¬ji:¶6kŽö˜| m¦†LÕËe ™Ãq `´%¡& 8÷ƒ¤>·^W— Ä Åmåò@iä\̨ÎÊVšAI ‘¨ÉVŒtí>»i-Ÿ^k¼0pú'&¼g±+×GÀôžc§-ƒÕ‘Þ;:mGi{Lš7²¹$ø&, ô<Ï- Ò:ÐÿV|>ÉÜ­N»¼Þš6ììËiW¹Aí–ÙÈ›PªÑ쳺0eo Ю½ìdõ¨«zÎëøá žÐvï†î˜†(që»5+*>4©|³ Ö%²TÊm€Ô mZA ð³itÄ£A¶ÿMÛ¸‹(…6‰ßQżåŸÏ¾áç‹…íÿ\v›Ÿ+á)b&ó‘=Ä?ÆþÇÿ˜øWx’öž_Òwœïú¿%߯‡˜ÿ–„~oä·ߦ­)Ã9Ì¿övàýñýÔÓ7·o‡Çý‰3HöI«dvŒ:¦ùHg„[6’ÛchΆò¦Hò—flÙœ›SÖé—#,À5®ðÃ1¤:Yv9ùÄ2Vp)|-§.d›6¦ÍYÑ®º„VHhÍñàûŒÖÎ0¾2Ýž ö¬–¼.±Pu4ÔwB•«¼  x•¸­G™$ô×#Æñð0ˆšß˜ýÿiç}à endstream endobj 2438 0 obj << /Length 3453 0 R /Subtype /CIDFontType0C /Filter /FlateDecode >> stream xUW lT×/¹aKIú¥F iC‚BB¤QˆB!„¤bK QÁ¦@ð2cãuÆöì»Ç3ãñr½ÏâÙ7gÆ;^c R”&ì ¦i¥´„¨jÓHUËÿæ;Rß·µÕ×¼3Oÿÿ÷î»÷ÜsïÏ-[&ÊÈÈXýv^±¼|w¹L¹éåM/‰2–‰D¢ úÛÄ=É=…+ŸF^úà'³:’^¹n­H´jÇÊç(ˆ W®@ü¨0–¯-ÉÈxhõ®ürqÁ¾ü™²X©‰–Ðuž\:¿˜h­h­0]*òˆÎgô.‘,¹ºtãÒ·–&–m]v,'ùäÆC¯?4ñpÙÃßÁ¡æòȵå/ߺüì ùŠî7V¶âjî>ç劘‘_GöãÏ_×ìÎÏ„üÌÃå»r°ÐUƒ[Òuî#üSHpVLا)ò.J„ÃQ/$½Îa„xA>|xà?c"i÷N9zª =]Üyá()µ'Àªp”b>`¶» "…ˆ´Ç8Š0ˆ)$ ˆÌj¶›Íç¾føut–!,E~˜þà\šN(rif57Í>`=ŒÕA¯:°ÖVÕê ¬†Èê³ ÔU V*ÛuÞjðZŽ0B7&]]AH„¼½“°•¦«9Üêi°ËíÅ`Ìî7:ÁèT¶ÊJPi5 ºªÆP§þI$͓ޡx7œšü8þÂoð¼eB Êx¾È×Ô£ºQºæª;´Ö´×¸j5„ÿ)’Zw»Á õ®OChÕJÜR}‰µá8J|¥I(K†ñà•®ÉsiHF:fÚ`²mþ¬»ØL³¢M箆 ¶×:‰ÄXKÀ §³ƒ€~{‡Ù fçqßk8èÏ Ëc Wõâ(àÙðøð \Ý@¸‚3æ± «ì<Ѷø#©9|67•®“RTך«Ál­± ÐÐfñÙÀg?cþ“.˜Ç4©JHVøJP˜¥ÉÍ/†ü’wõ¯#¼†Bù ÔLà °ÏÐ`ΞdåÜ=çŠçYsÏõ§n€Øy§?­º¨åHv˜Ò]Ë.a¦ô#ÒÞlH \yàÊkÍÇÀšmûàÈËÛrxÿ1%À¬„°?ÀS5ÝÖÞ|éæÞdðä–@œ ‹,Ý@¾¤Ó äU:òÕM¦6´ÕêÓ-Ø‚­­thi|–ì«#ûês<ò¶ö²_] ¤,F†aqg¿“аÜç¬\=3 ½{)þYz‹½C0U³ùÁ”¬ôÑð¾%½¬*G–ÒçF‰àuäR„¥¤Â$” FüŽ º?@¸€¦Ùü©¸ûì·\„I˜"š€œšÓN¨_éæb"Ð?%š2¥Rn„JS™nt³yç oJõ ~x/zsì<Œ¿ØEÃÞ‹i{ÂýsÒüôÌççeýé’h‚JW‚¥­´e”'¹óÃR˺4¹‡±Û]ÈOšvǹõŒ^c)w[FÙsÊ’Ò„A–»¤¥(¯Öi€=®dõéÊx!D˼'ÛÄÐ"o,¢+ω4e zÕ6Åk’iŒ;Cp»œÎ‰^[j(••‰#ïTRbíѱ#ãpäƒÊ›ø à×7'ÏÂé³%n!Làˆm@¿à«édØýlŒðo±~¾ä.¿…ü™ÝBØmTEÞæ½„ÝÏwÒÛH¶°¯-ü+„ßAÃË=ÁÎq£LåC[Ï:bm´aM#رkaN[µ£ séývÂÿDˆ_š°OPÜL¢áDÀ ]±~÷B ×÷ñË¡b…ü-‚Òe»¼¦!„Iì ‡ÁiMa? ìøB`{›Ô××96pØjì¶PkÔfµ46E ÕvÌJ•Æûiüˆ¾|KI*_²C³%L{ƒ;„cî"Ôgø ¹CÇ~‚º‡Ã1ˆôž |†àÂöç÷‡âžaŸabiÏ(Mtœ¶ŒªÒ J—ùÄ,5©d ’YĘ˜éÇd“õšFF±ÇK»ô &ûðžò—¶àžTöȾ¨ºŠ¿¼»:q&>¼–ú©}×Ê'~‡â{q'àåÞìCó>}°jVÊ%™˜5j+Á§õ¨Z+ Y×TÅÐÀÿe1ïŒÖì^¨J(;J °Â`,»¡V êœë 1d¯ì­‹Û}`éRz‹ò±Âlª»©V…4ùO /dÜÿäj*¦¹šŒ¸Ç…3õYzˆèýjO%„zbñ¤ÒþÞö„NŒ×ÆÔ‰*ÅóÜ FÛ# äÍ—B…ö8TË%B)|7˜Ó'‡°1n§É0Œi´"ÝZµ½pÿ[füDlþ p³úíÜcw,S¾!‹<åQ0vƒÆ5¶›ðk©±³úbn'þx ôAOç ‡û[œVŽgÏ;‘–Y U4Æ‚– ¸¨h‡¹Óe‰éC ði\š54«‹ñ8]þòBõô-íˆ[C`îTx  ±Ü¬U€V^]„tùïõm6°‚ÎñNééŒuQ§u¤Ú¨ðöa·#Yµ˜´Ücì_™úˆ=d €1*÷” zYªÐÑVA^[‚bÀü–2—‚9=ªÓ»q§7¾3Öœš‹º<£¤¢rÞÝ/ÝŠð*þ2!™ñ”æ ~A%0vsb &¦>J|.T¾ Æ1ŒKYÎ@µz^ÂW°™x§gXàòTõª ÔI™p¬ãX¼Ø±”a`Yk¹[áì~ÕYÁŒdG,ïsk˜~SR¥eê³5Ÿk"¸ÛrDY ’ƒ;¥ˆpû‚Á>ðÄÚq hæ™”&½ÑåêBKÂnÌìŸñÍeü#àçá«#30<}1ù;¡ˆ×FlóžœÝÌý‹»ËÌ­<¾‰°ÿp áçñᄾ‰gÈÜEr.!Ì3d¡ö‰çKúúÙ1—.ÝîþŠVíUxWrq;ôd²›³ßˆ¤z ªË‚ò‰?á0æªÊr 4Çp·n ì“@¿xL3…0#¡T?øÃÞ”û°´ªš·—¼“y ²Ží–¿†ðnë?xÞ»*½‡ì#TçÖôÿý굅ÞdÕBcÁgÎë|?vµÐíõ'…vgÜØ-óƒÁ)o¡db7Üg’UqA+ü:¯Æ¥—ª¥Ë‹mÅúЕ”+%&è3wj}rð)Ú ð(-K›”MhѺL~êaái©õ×zëÝP©b®’†Ó¶nC ~©3›ö&[¯ þyŠB^ýÉTÃPMÊ2oõ#GË ²ë û¢ðàz2§Yœ -s¾ÿ¿Ï¿¸ÀÑ¿ÍJèa'<­·8w—ŽFŽ¢0g'Üès³›Ù¬œi)qɽHHÇL—0Ýs˜?š\¯«½ ö–z²Ý°3HÞ  É"p¼Oqo~Ÿ™ƒÉñëÑ{·ñ²fFÓ’Ô{Í4]ÖÓR?®í) ¢CÖF¥²ËlJ#( •àN¹G¯¿µ§úŒØHÉŒyTŸRÁxqô˜Ðï“gÍ£¹¿PmAØ„»¢Yã9^q oû5ÿ¿ŸI+… úy#Zuè±ÿi, endstream endobj 2441 0 obj << /Length 3455 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2443 0 obj << /Length 3456 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2445 0 obj << /Length 3457 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2447 0 obj << /Length 3458 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2449 0 obj << /Length 3459 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2451 0 obj << /Length 3460 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2392 0 obj << /Type /ObjStm /N 100 /First 970 /Length 1130 /Filter /FlateDecode >> stream xÚ­XMkG½Ï¯è{ÛUý Æ •P¢ƒc‹ØFè°‘yƒ¾öàüû¼W»«l‚CB(Ð̼Ù7]U]U¯§GÒu„¤§ZæUBk¼j" À˜T;A šŒª!ÅBÐŒê!u©C.ƒ@B®J ¡`$@0*‡*‰ UC +7£zhµÁrT‰#$ð9 CXIFå0+ˆ%Fã`?6†V‘±8IaÜ Uøp¯ð¡Êð*†)óÑŠ °&"cá'u†X ‘±8eèµ %qu0£d9* ´ 'Ñà£FÚ‘±85è ¼5cë6a@m› œ†rm‘íð1#í4FΣ+@à@Æ¢¼¨[QòÄH{#2¶£ú‘óèƒ}@¥ÒÔ)b@>2S×Q? cá£$F:à£dcᣠ#ÈXø¨ƒó@à@`G„ÆÔ ”QÓ40e¯%"cách"*DƲQ#Ù©ÑX´jl˜Ç@ѽd1™dÍ>Dˆ‘†dí>Т@Ææ¬áOIŒ…kù2¦4Ì|`nð!ÔƒÒžÂÇ@µ4£÷³ K4S$‚ ) ÑÚ@ƒ¨Y1 iÊhþ¬LDFÓ•éÕ«iñîéáúü —‹w§g‹ó»ÕͼÜ^N¶—ó«iñéç_›¯7ÎïØœš`=†÷Óë×üKõÿË4–ŒqAí}ŒU«NÆ5'c:ÞÇ59†±ÆÞ„l|Œ±Yѱ>Ƹ¸@ý>Æ(­è¤€FG'4.ÑIXïaÌI‹PtR@ãjиdF't*@œÀ÷o'ðžÅIÜdqR7Yœ`¯BqR·3xÏ:£ÄIÜTámïdŒ 'pk‡ý…“1*@`LuR€m¯ÔIÜæfuRwÊYÀÍvV'ØFTÀ-V'ð«!« ?læ»_8âÓîW¼s¦Å›Õ·ë/›¯aä²õ|¶¾­G_Vœ]Ñ$þ™È]¬pøÍ’/Å»‘÷–P\ûî~ÿì>ÁV$‰/ÅØ&sKüÇd~¾8þ|úþ ™ò/ÉÌseMÓ?'3Ëa2¥ý5™ý»É̇ÉlñoÉ|Yq¥Ët¹8?9Y®žç/!åbò½š¤‰‘/GIvü! endstream endobj 2453 0 obj << /Length 3461 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2455 0 obj << /Length 3463 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2457 0 obj << /Length 3464 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2459 0 obj << /Length 3465 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2461 0 obj << /Length 3466 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2463 0 obj << /Length 3467 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2465 0 obj << /Length 3468 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2467 0 obj << /Length 3469 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2469 0 obj << /Length 3470 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2471 0 obj << /Length 3471 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2473 0 obj << /Length 3472 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2475 0 obj << /Length 3473 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2477 0 obj << /Length 3474 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2479 0 obj << /Length 3475 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2481 0 obj << /Length 3476 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2483 0 obj << /Length 3477 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2485 0 obj << /Length 3478 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2487 0 obj << /Length 3479 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2489 0 obj << /Length 3480 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2491 0 obj << /Length 3481 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2493 0 obj << /Length 3482 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2495 0 obj << /Length 3483 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2497 0 obj << /Length 3484 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2499 0 obj << /Length 3485 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2501 0 obj << /Length 3486 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2503 0 obj << /Length 3487 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2505 0 obj << /Length 3488 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2507 0 obj << /Length 3489 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2509 0 obj << /Length 3490 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2511 0 obj << /Length 3491 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2513 0 obj << /Length 3492 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2515 0 obj << /Length 3493 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2517 0 obj << /Length 3494 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2519 0 obj << /Length 3495 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2521 0 obj << /Length 3496 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2523 0 obj << /Length 3497 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2525 0 obj << /Length 3498 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2527 0 obj << /Length 3499 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2529 0 obj << /Length 3500 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2531 0 obj << /Length 3501 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2533 0 obj << /Length 3502 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2535 0 obj << /Length 3503 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2537 0 obj << /Length 3504 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2539 0 obj << /Length 3505 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2541 0 obj << /Length 3506 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2543 0 obj << /Length 3507 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2545 0 obj << /Length 3508 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2547 0 obj << /Length 3509 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2549 0 obj << /Length 3510 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2551 0 obj << /Length 3511 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2553 0 obj << /Length 3512 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2555 0 obj << /Length 3513 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2557 0 obj << /Length 3514 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2559 0 obj << /Length 3515 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2561 0 obj << /Length 3516 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2563 0 obj << /Length 3517 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2565 0 obj << /Length 3518 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2567 0 obj << /Length 3519 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2569 0 obj << /Length 3520 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2571 0 obj << /Length 3521 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2573 0 obj << /Length 3522 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2575 0 obj << /Length 3523 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2577 0 obj << /Length 3524 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2579 0 obj << /Length 3525 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2581 0 obj << /Length 3526 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2583 0 obj << /Length 3527 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2585 0 obj << /Length 3528 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2587 0 obj << /Length 3529 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2589 0 obj << /Length 3530 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2591 0 obj << /Length 3531 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2593 0 obj << /Length 3532 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2595 0 obj << /Length 3533 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2597 0 obj << /Length 3534 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2599 0 obj << /Length 3535 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2601 0 obj << /Length 3536 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2603 0 obj << /Length 3537 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2605 0 obj << /Length 3538 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2607 0 obj << /Length 3539 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2609 0 obj << /Length 3540 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2611 0 obj << /Length 3541 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2613 0 obj << /Length 3542 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2615 0 obj << /Length 3543 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2617 0 obj << /Length 3544 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2619 0 obj << /Length 3545 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2621 0 obj << /Length 3546 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2623 0 obj << /Length 3547 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2625 0 obj << /Length 3548 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2627 0 obj << /Length 3549 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2629 0 obj << /Length 3550 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2631 0 obj << /Length 3551 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2633 0 obj << /Length 3552 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2635 0 obj << /Length 3553 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2637 0 obj << /Length 3554 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2639 0 obj << /Length 3555 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2641 0 obj << /Length 3556 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2643 0 obj << /Length 3557 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2645 0 obj << /Length 3558 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2647 0 obj << /Length 3559 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2649 0 obj << /Length 3560 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2651 0 obj << /Length 3561 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3462 0 obj << /Type /ObjStm /N 100 /First 872 /Length 460 /Filter /FlateDecode >> stream xÚ’A’à ïû =ÁBHàÿl§•JÖq%U{À"0 j&cæ´ÃÆÌ²IÙ¶Uê0Ôa^Tí¡*~P%B· tkXÔê´‰nÉ ÝÚ6ÑíÃÝ–Xìi…n—a=÷6,çyØBw[øÓ6º³l£;Õžty&‰ê0m©Ns­iRšL&[¤.XRw™¦K M ÍÁI—žÔ²”CâÀYûR‰aJ ¨ ‰¡JðÄ9$†+uÔ˲”‡ƒ–Sⅳ̸œC—rõÆK‰›Oö~✀˜çk@%5 Pa ÒJnn@âj@Zh@6^ˆ,¦pubštwˆwÛ3Ñ~*¸Ñ€ôÛ€Šn4 ^*¼ÑDÔ€'€‚®à`»Ä¬–Œ£¯Ùš V‚`é$XJ0,ဥÀÒrXJ0H°´– K°”`X:$XJ0, K €%°”`¬æ—ÀR‚ÑO#×h@% (ûP‚ó6|åg<Æö÷ºþ~·ö¹þm\ôo£÷χǷ»þ1^=\μ8.÷ÜϼÝ{ïwßzþpßýüÛÏýë;^ÇÕóÃüH8à‹ endstream endobj 2653 0 obj << /Length 3562 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2655 0 obj << /Length 3564 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2657 0 obj << /Length 3565 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2659 0 obj << /Length 3566 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2661 0 obj << /Length 3567 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2663 0 obj << /Length 3568 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2665 0 obj << /Length 3569 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2667 0 obj << /Length 3570 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2669 0 obj << /Length 3571 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2671 0 obj << /Length 3572 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2673 0 obj << /Length 3573 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2675 0 obj << /Length 3574 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2677 0 obj << /Length 3575 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2679 0 obj << /Length 3576 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2681 0 obj << /Length 3577 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2683 0 obj << /Length 3578 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2685 0 obj << /Length 3579 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2687 0 obj << /Length 3580 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2689 0 obj << /Length 3581 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2691 0 obj << /Length 3582 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2693 0 obj << /Length 3583 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2695 0 obj << /Length 3584 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2697 0 obj << /Length 3585 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2699 0 obj << /Length 3586 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2701 0 obj << /Length 3587 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2703 0 obj << /Length 3588 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2705 0 obj << /Length 3589 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2707 0 obj << /Length 3590 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2709 0 obj << /Length 3591 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2711 0 obj << /Length 3592 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2713 0 obj << /Length 3593 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2715 0 obj << /Length 3594 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2717 0 obj << /Length 3595 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2719 0 obj << /Length 3596 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2721 0 obj << /Length 3597 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2723 0 obj << /Length 3598 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2725 0 obj << /Length 3599 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2727 0 obj << /Length 3600 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2729 0 obj << /Length 3601 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2731 0 obj << /Length 3602 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2733 0 obj << /Length 3603 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2735 0 obj << /Length 3604 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2737 0 obj << /Length 3605 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2739 0 obj << /Length 3606 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2741 0 obj << /Length 3607 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2743 0 obj << /Length 3608 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2745 0 obj << /Length 3609 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2747 0 obj << /Length 3610 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2749 0 obj << /Length 3611 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2751 0 obj << /Length 3612 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2753 0 obj << /Length 3613 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2755 0 obj << /Length 3614 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2757 0 obj << /Length 3615 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2759 0 obj << /Length 3616 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2761 0 obj << /Length 3617 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2763 0 obj << /Length 3618 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2765 0 obj << /Length 3619 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2767 0 obj << /Length 3620 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2769 0 obj << /Length 3621 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2771 0 obj << /Length 3622 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2773 0 obj << /Length 3623 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2775 0 obj << /Length 3624 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2777 0 obj << /Length 3625 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2779 0 obj << /Length 3626 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2781 0 obj << /Length 3627 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2783 0 obj << /Length 3628 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2785 0 obj << /Length 3629 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2787 0 obj << /Length 3630 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2789 0 obj << /Length 3631 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2791 0 obj << /Length 3632 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2793 0 obj << /Length 3633 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2795 0 obj << /Length 3634 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2797 0 obj << /Length 3635 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2799 0 obj << /Length 3636 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2801 0 obj << /Length 3637 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2803 0 obj << /Length 3638 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2805 0 obj << /Length 3639 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2807 0 obj << /Length 3640 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2809 0 obj << /Length 3641 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2811 0 obj << /Length 3642 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2813 0 obj << /Length 3643 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2815 0 obj << /Length 3644 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2817 0 obj << /Length 3645 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2819 0 obj << /Length 3646 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2821 0 obj << /Length 3647 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2823 0 obj << /Length 3648 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2825 0 obj << /Length 3649 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2827 0 obj << /Length 3650 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2829 0 obj << /Length 3651 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2831 0 obj << /Length 3652 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2833 0 obj << /Length 3653 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2835 0 obj << /Length 3654 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2837 0 obj << /Length 3655 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2839 0 obj << /Length 3656 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2841 0 obj << /Length 3657 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2843 0 obj << /Length 3658 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2845 0 obj << /Length 3659 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2847 0 obj << /Length 3660 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2849 0 obj << /Length 3661 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2851 0 obj << /Length 3662 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3563 0 obj << /Type /ObjStm /N 100 /First 872 /Length 464 /Filter /FlateDecode >> stream xÚu’[–!Dÿg,¡ÜÿƦ.“œ<磃-eÉíÊØkÚec¯m“RV*û2Ôa¾©ê¡ÚzA¶%B——ºûGuÚD—rC—e]]¶ÐÕ°…_MÛèjֻʰÜç²Dw†%~gZ¡;Û ÝÑxÒåu™$ªÃÔRæÚÓbk1Y”H](°¤~Üeš.14)4']bxRÛP‰gõ¤Ô:PC•:á ç®ÔQ,CbÈRZN‰g™9p9%†.åê·$n>ÙûÁyb>_*©Ñ€\Ø€ kVrsW2B*°Ñ€ÌBd©ÈF2T*´Ñ€L×€Šmpqvˆ‹WÇ«ÅéÄ¢g‘³Â HD xøÛð€‚®à趘‚ÝR‚qõÉÒ± K?A‚¥ÀnXJ0,m€¥ƒKý°”`X€¥ÀÒ‰ ÁR‚`éhXJ0úï.°”`d#I `)Á°ä ¨£eJÐË|ÅßÃúþ®:éß{ë<ÞŸ{OgØ{=¯º\õs}¾ÿýçî÷ü§ùvß›þƒ1o3¥ø|ë[}ÿNßí}Öó½wóüÏ á= endstream endobj 2853 0 obj << /Length 3663 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2855 0 obj << /Length 3665 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2857 0 obj << /Length 3666 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2859 0 obj << /Length 3667 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2861 0 obj << /Length 3668 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2863 0 obj << /Length 3669 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2865 0 obj << /Length 3670 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2867 0 obj << /Length 3671 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2869 0 obj << /Length 3672 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2871 0 obj << /Length 3673 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2873 0 obj << /Length 3674 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2875 0 obj << /Length 3675 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2877 0 obj << /Length 3676 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2879 0 obj << /Length 3677 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2881 0 obj << /Length 3678 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2883 0 obj << /Length 3679 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2885 0 obj << /Length 3680 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2887 0 obj << /Length 3681 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2889 0 obj << /Length 3682 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2891 0 obj << /Length 3683 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2893 0 obj << /Length 3684 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2895 0 obj << /Length 3685 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2897 0 obj << /Length 3686 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2899 0 obj << /Length 3687 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2901 0 obj << /Length 3688 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2903 0 obj << /Length 3689 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2905 0 obj << /Length 3690 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2907 0 obj << /Length 3691 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2909 0 obj << /Length 3692 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2911 0 obj << /Length 3693 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2913 0 obj << /Length 3694 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2915 0 obj << /Length 3695 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2917 0 obj << /Length 3696 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2919 0 obj << /Length 3697 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2921 0 obj << /Length 3698 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2923 0 obj << /Length 3699 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2925 0 obj << /Length 3700 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2927 0 obj << /Length 3701 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2929 0 obj << /Length 3702 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2931 0 obj << /Length 3703 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2933 0 obj << /Length 3704 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2935 0 obj << /Length 3705 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2937 0 obj << /Length 3706 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2939 0 obj << /Length 3707 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2941 0 obj << /Length 3708 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2943 0 obj << /Length 3709 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2945 0 obj << /Length 3710 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2947 0 obj << /Length 3711 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2949 0 obj << /Length 3712 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2951 0 obj << /Length 3713 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2953 0 obj << /Length 3714 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2955 0 obj << /Length 3715 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2957 0 obj << /Length 3716 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2959 0 obj << /Length 3717 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2961 0 obj << /Length 3718 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2963 0 obj << /Length 3719 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2965 0 obj << /Length 3720 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2967 0 obj << /Length 3721 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2969 0 obj << /Length 3722 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2971 0 obj << /Length 3723 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2973 0 obj << /Length 3724 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2975 0 obj << /Length 3725 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2977 0 obj << /Length 3726 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2979 0 obj << /Length 3727 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2981 0 obj << /Length 3728 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2983 0 obj << /Length 3729 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2985 0 obj << /Length 3730 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2987 0 obj << /Length 3731 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2989 0 obj << /Length 3732 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2991 0 obj << /Length 3733 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2993 0 obj << /Length 3734 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2995 0 obj << /Length 3735 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2997 0 obj << /Length 3736 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2999 0 obj << /Length 3737 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3001 0 obj << /Length 3738 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3003 0 obj << /Length 3739 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3005 0 obj << /Length 3740 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3007 0 obj << /Length 3741 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3009 0 obj << /Length 3742 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3011 0 obj << /Length 3743 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3013 0 obj << /Length 3744 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3015 0 obj << /Length 3745 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3017 0 obj << /Length 3746 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3019 0 obj << /Length 3747 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3021 0 obj << /Length 3748 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3023 0 obj << /Length 3749 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3025 0 obj << /Length 3750 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3027 0 obj << /Length 3751 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3029 0 obj << /Length 3752 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3031 0 obj << /Length 3753 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3033 0 obj << /Length 3754 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3035 0 obj << /Length 3755 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3037 0 obj << /Length 3756 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3039 0 obj << /Length 3757 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3041 0 obj << /Length 3758 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3043 0 obj << /Length 3759 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3045 0 obj << /Length 3760 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3047 0 obj << /Length 3761 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3049 0 obj << /Length 3762 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3051 0 obj << /Length 3763 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3664 0 obj << /Type /ObjStm /N 100 /First 872 /Length 467 /Filter /FlateDecode >> stream xÚu’Ûq#1 ÿBX|!ÿÄn²äµ­«2— Ùb<Š3‡]g.LÇŽ¦u™s˜/fA--Àþöe ·Ãr=4p[jpûØ€;—M¸6Ñ;ÃÜY†ô9ÇZ².Ûp¶Ñ«a®–¸R{âêºLˆæ0iæÚS±T Š£Ôe/¥»DËã¦dͱS.?¥mÇP…àDY玥 Áx*Ž©JÁ¸*Ýð‰r ÆWéªc¬R0ÎJ޵‚7ÊsÌÕŒ»’ª·½)¸ýIÞ åIÀüûÚ ’Š6ȃmPai/·Aâjƒ´ÐX´Az!²RdÑiª *´hƒt×[ðpÑfTpÑé· *ºhƒ4NxU$LDm°ú·`yµ• èÆ)«^2”`:0%¨Bç,»ÀJ0˜íV‚™hq>€•``À¬ssc¢¬ssu+Á\Àhð;¿”`îîRçX æFµ *ÁlƒÈ+Á¡á3¾ýáÇŸkê=Ÿû í¿ë×z?÷ž÷ë[ç½÷áÞk|½Å/ö~Ÿó»F×Ç?²?îýî¯úÖ˸û~ŸÕ©Ï½¿uýóù¾½û?ÿ7ú×Ù?˜á2 endstream endobj 3053 0 obj << /Length 3764 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3055 0 obj << /Length 3766 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3057 0 obj << /Length 3767 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3059 0 obj << /Length 3768 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3061 0 obj << /Length 3769 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3063 0 obj << /Length 3770 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3065 0 obj << /Length 3771 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3067 0 obj << /Length 3772 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3069 0 obj << /Length 3773 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3071 0 obj << /Length 3774 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3073 0 obj << /Length 3775 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3075 0 obj << /Length 3776 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3077 0 obj << /Length 3777 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3079 0 obj << /Length 3778 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3081 0 obj << /Length 3779 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3083 0 obj << /Length 3780 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3085 0 obj << /Length 3781 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3087 0 obj << /Length 3782 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3089 0 obj << /Length 3783 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3091 0 obj << /Length 3784 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3093 0 obj << /Length 3785 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3095 0 obj << /Length 3786 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3097 0 obj << /Length 3787 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3099 0 obj << /Length 3788 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3101 0 obj << /Length 3789 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3103 0 obj << /Length 3790 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3105 0 obj << /Length 3791 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3107 0 obj << /Length 3792 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3109 0 obj << /Length 3793 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3111 0 obj << /Length 3794 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3113 0 obj << /Length 3795 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3115 0 obj << /Length 3796 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3117 0 obj << /Length 3797 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3119 0 obj << /Length 3798 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3121 0 obj << /Length 3799 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3123 0 obj << /Length 3800 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3125 0 obj << /Length 3801 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3127 0 obj << /Length 3802 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3129 0 obj << /Length 3803 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3131 0 obj << /Length 3804 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3133 0 obj << /Length 3805 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3135 0 obj << /Length 3806 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3137 0 obj << /Length 3807 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3139 0 obj << /Length 3808 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3141 0 obj << /Length 3809 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3143 0 obj << /Length 3810 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3145 0 obj << /Length 3811 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3147 0 obj << /Length 3812 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3149 0 obj << /Length 3813 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3151 0 obj << /Length 3814 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3153 0 obj << /Length 3815 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3155 0 obj << /Length 3816 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3157 0 obj << /Length 3817 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3159 0 obj << /Length 3818 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3161 0 obj << /Length 3819 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3163 0 obj << /Length 3820 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3165 0 obj << /Length 3821 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3167 0 obj << /Length 3822 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3169 0 obj << /Length 3823 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3171 0 obj << /Length 3824 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3173 0 obj << /Length 3825 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3175 0 obj << /Length 3826 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3177 0 obj << /Length 3827 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3179 0 obj << /Length 3828 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3181 0 obj << /Length 3829 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3183 0 obj << /Length 3830 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3185 0 obj << /Length 3831 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3187 0 obj << /Length 3832 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3189 0 obj << /Length 3833 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3191 0 obj << /Length 3834 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3193 0 obj << /Length 3835 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3195 0 obj << /Length 3836 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3197 0 obj << /Length 3837 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3199 0 obj << /Length 3838 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3201 0 obj << /Length 3839 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3203 0 obj << /Length 3840 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3205 0 obj << /Length 3841 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3207 0 obj << /Length 3842 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3209 0 obj << /Length 3843 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3211 0 obj << /Length 3844 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3213 0 obj << /Length 3845 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3215 0 obj << /Length 3846 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3217 0 obj << /Length 3847 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3219 0 obj << /Length 3848 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3221 0 obj << /Length 3849 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3223 0 obj << /Length 3850 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3225 0 obj << /Length 3851 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3227 0 obj << /Length 3852 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3229 0 obj << /Length 3853 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3231 0 obj << /Length 3854 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3233 0 obj << /Length 3855 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3235 0 obj << /Length 3856 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3237 0 obj << /Length 3857 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3239 0 obj << /Length 3858 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3241 0 obj << /Length 3859 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3243 0 obj << /Length 3860 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3245 0 obj << /Length 3861 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3247 0 obj << /Length 3862 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3249 0 obj << /Length 3863 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3251 0 obj << /Length 3864 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3765 0 obj << /Type /ObjStm /N 100 /First 872 /Length 456 /Filter /FlateDecode >> stream xÚu’ËuÄ0 ï[K¡¯ûo,îKž×I¶d „8‚{›#Zô6W †ÇÃj‘bTäb!Tk…­B·½ˆnûµ^G tÛnèö‰î´˜èŽbâwF,tgÅBwN,tW ¬Ú¥Øø]#ºkÅAw¹=ë²µ°Ä£Â[G°æÉ ><9ÁÓ3 ¯L›fZ ¿!ËÊ v¬ PN°X7 œ`°®„å;€¢@9Á`]€r‚}×ÁÞPN°X×V€N° öN0gåÉ÷¸ç{¼?;ßûû­Ïšÿjoúª9ùYãçÛëÇóáûkýüÑÃÓ÷ÙÿÃÿ^ûç¹Ïžï^ÏÞ`¾Ÿÿás}®ÝïçáûãåùH©ßU endstream endobj 3253 0 obj << /Length 3865 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3255 0 obj << /Length 3867 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3257 0 obj << /Length 3868 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3259 0 obj << /Length 3869 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3261 0 obj << /Length 3870 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3263 0 obj << /Length 3871 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3265 0 obj << /Length 3872 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3267 0 obj << /Length 3873 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3269 0 obj << /Length 3874 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3271 0 obj << /Length 3875 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3273 0 obj << /Length 3876 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3275 0 obj << /Length 3877 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3277 0 obj << /Length 3878 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3279 0 obj << /Length 3879 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3281 0 obj << /Length 3880 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3283 0 obj << /Length 3881 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3285 0 obj << /Length 3882 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3287 0 obj << /Length 3883 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3289 0 obj << /Length 3884 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3291 0 obj << /Length 3885 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3293 0 obj << /Length 3886 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3295 0 obj << /Length 3887 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3297 0 obj << /Length 3888 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3299 0 obj << /Length 3889 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3301 0 obj << /Length 3890 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3303 0 obj << /Length 3891 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3305 0 obj << /Length 3892 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3307 0 obj << /Length 3893 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3309 0 obj << /Length 3894 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3311 0 obj << /Length 3895 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3313 0 obj << /Length 3896 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3315 0 obj << /Length 3897 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3317 0 obj << /Length 3898 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3319 0 obj << /Length 3899 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3321 0 obj << /Length 3900 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3323 0 obj << /Length 3901 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3325 0 obj << /Length 3902 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3327 0 obj << /Length 3903 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3329 0 obj << /Length 3904 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3331 0 obj << /Length 3905 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3333 0 obj << /Length 3906 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3335 0 obj << /Length 3907 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3337 0 obj << /Length 3908 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3339 0 obj << /Length 3909 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3341 0 obj << /Length 3910 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3343 0 obj << /Length 3911 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3345 0 obj << /Length 3912 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3347 0 obj << /Length 3913 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3349 0 obj << /Length 3914 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3351 0 obj << /Length 3915 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3353 0 obj << /Length 3916 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3355 0 obj << /Length 3917 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3357 0 obj << /Length 3918 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3359 0 obj << /Length 3919 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3361 0 obj << /Length 3920 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3363 0 obj << /Length 3921 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3365 0 obj << /Length 3922 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3367 0 obj << /Length 3923 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3369 0 obj << /Length 3924 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3371 0 obj << /Length 3925 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3373 0 obj << /Length 3926 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3375 0 obj << /Length 3927 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3377 0 obj << /Length 3928 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3379 0 obj << /Length 3929 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3381 0 obj << /Length 3930 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3383 0 obj << /Length 3931 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3385 0 obj << /Length 3932 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3387 0 obj << /Length 3933 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3389 0 obj << /Length 3934 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3391 0 obj << /Length 3935 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3393 0 obj << /Length 3936 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3395 0 obj << /Length 3937 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3397 0 obj << /Length 3938 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3399 0 obj << /Length 3939 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3401 0 obj << /Length 3940 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3403 0 obj << /Length 3941 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3405 0 obj << /Length 3942 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3407 0 obj << /Length 3943 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3409 0 obj << /Length 3944 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3411 0 obj << /Length 3945 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3413 0 obj << /Length 3946 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3415 0 obj << /Length 3947 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3417 0 obj << /Length 3948 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3419 0 obj << /Length 3949 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3421 0 obj << /Length 3950 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3423 0 obj << /Length 3951 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3425 0 obj << /Length 3952 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3427 0 obj << /Length 3953 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3429 0 obj << /Length 3954 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3431 0 obj << /Length 3955 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3433 0 obj << /Length 3956 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3435 0 obj << /Length 3957 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3437 0 obj << /Length 3958 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3439 0 obj << /Length 3959 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3441 0 obj << /Length 3960 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3443 0 obj << /Length 3961 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3445 0 obj << /Length 3962 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3447 0 obj << /Length 3963 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3449 0 obj << /Length 3964 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3451 0 obj << /Length 3965 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3866 0 obj << /Type /ObjStm /N 100 /First 872 /Length 460 /Filter /FlateDecode >> stream xÚm’Av¤0 ÷9…Ž€dcÌý/6UJúM:Í,L!»üuÎ8bÔ¹b:ìØ ëˆ,ÇŠ\Ž3Jj­(±µ£ä.'¹­/ÆÓ©‹nr׎)·8åvÅi¿=cÉíKnïXr÷¶ª»â²ß=cËÝ+¶ÜÍöàÆqc¯g$s‹bZl ÑDE—Á-“¦#µ¨¥:#õL§B£€‡yŸ*áL! ˜J±F¤VLQØyë5ø4X³ATmLàËÎ4KåÆÖnÐ5[ïn?ÚçmçÓ„9¾jA’ªdÁjAÂ*Ó¦Õ‚ÆÕ‚æÕ‚V-È^ÊÈ‘U ^f+LhÕ‚ì®ZØüA(€[àªÙoµ Ñõo0ØxÞ ¼jA"ª¼ým€'*fLl‚S'' ' ×$Aãàf‚3ý„ûçÎþË(Ú[¸úH,º™…O>4èE‚17œ$èR+8IÐããK¦œ$èaQð^ÁI‚ ` ’àhAÛ“`žã+¯ü]Ów¯ùßϯù·óyüË]?ß÷ûûc­ÇëW¯Çuv~ì÷mͧëÇç»?z}¬ÿgîq'þmíóÿ¾­²½¿þ¥à endstream endobj 3454 0 obj << /Length 3967 0 R /N 3 /Alternate /DeviceRGB /Filter /FlateDecode >> stream x–wTSهϽ7½Ð" %ôz Ò;HQ‰I€P†„&vDF)VdTÀG‡"cE ƒ‚b× òPÆÁQDEåÝŒk ï­5óÞšýÇYßÙç·×Ùgï}׺Pü‚ÂtX€4¡XîëÁ\ËÄ÷XÀáffGøDÔü½=™™¨HƳöî.€d»Û,¿P&sÖÿ‘"7C$ EÕ6<~&å”S³Å2ÿÊô•)2†12¡ ¢¬"ãįlö§æ+»É˜—&ä¡Yμ4žŒ»PÞš%ᣌ¡\˜%àg£|e½TIšå÷(ÓÓøœL0™_Ìç&¡l‰2Eî‰ò”Ä9¼r‹ù9hžx¦g䊉Ib¦טiåèÈfúñ³Sùb1+”ÃMáˆxLÏô´ Ž0€¯o–E%Ym™h‘í­ííYÖæhù¿Ùß~Sý=ÈzûUñ&ìÏžAŒžYßlì¬/½ö$Z›³¾•U´m@åá¬Oï ò´Þœó†l^’Äâ ' ‹ììlsŸk.+è7ûŸ‚oÊ¿†9÷™ËîûV;¦?#I3eE妧¦KDÌÌ —Ïdý÷ÿãÀ9iÍÉÃ,œŸÀñ…èUQè” „‰h»…Ø A1ØvƒjpÔzÐN‚6p\WÀ p €G@ †ÁK0Þi‚ð¢Aª¤™BÖZyCAP8ÅC‰’@ùÐ&¨*ƒª¡CP=ô#tº]ƒú Ð 4ý}„˜Óa ض€Ù°;GÂËàDxœÀÛáJ¸>·Âáð,…_“@ÈÑFXñDBX$!k‘"¤©Eš¤¹H‘q䇡a˜Æã‡YŒábVaÖbJ0Õ˜c˜VLæ6f3ù‚¥bÕ±¦X'¬?v 6›-ÄV``[°—±Øaì;ÇÀâp~¸\2n5®·׌»€ëà á&ñx¼*Þï‚Ásðb|!¾ ߯¿' Zk‚!– $l$Tçý„Â4Q¨Ot"†yÄ\b)±ŽØA¼I&N“I†$R$)™´TIj"]&=&½!“É:dGrY@^O®$Ÿ _%’?P”(&OJEBÙN9J¹@y@yC¥R ¨nÔXª˜ºZO½D}J}/G“3—ó—ãÉ­“«‘k•ë—{%O”×—w—_.Ÿ'_!Jþ¦ü¸QÁ@ÁS£°V¡Fá´Â=…IEš¢•bˆbšb‰bƒâ5ÅQ%¼’’·O©@é°Ò%¥!BÓ¥yÒ¸´M´:ÚeÚ0G7¤ûÓ“éÅôè½ô e%e[å(ååå³ÊRÂ0`ø3R¥Œ“Œ»Œó4æ¹ÏãÏÛ6¯i^ÿ¼)•ù*n*|•"•f••ªLUoÕÕªmªOÔ0j&jajÙjûÕ.«Ï§ÏwžÏ_4ÿäü‡ê°º‰z¸újõÃê=ꓚ¾U—4Æ5šnšÉšåšç4Ç´hZ µZåZçµ^0•™îÌTf%³‹9¡­®í§-Ñ>¤Ý«=­c¨³Xg£N³Î]’.[7A·\·SwBOK/X/_¯Qï¡>QŸ­Ÿ¤¿G¿[ÊÀÐ Ú`‹A›Á¨¡Š¡¿aža£ác#ª‘«Ñ*£Z£;Æ8c¶qŠñ>ã[&°‰I’IÉMSØÔÞT`ºÏ´Ï kæh&4«5»Ç¢°ÜYY¬FÖ 9Ã<È|£y›ù+ =‹X‹Ý_,í,S-ë,Y)YXm´ê°úÃÚÄšk]c}džjãc³Î¦Ýæµ­©-ßv¿í};š]°Ý»N»Ïöö"û&û1=‡x‡½÷Øtv(»„}Õëèá¸ÎñŒã'{'±ÓI§ßYÎ)ΠΣ ðÔ-rÑqá¸r‘.d.Œ_xp¡ÔUÛ•ãZëúÌM×çvÄmÄÝØ=Ùý¸û+K‘G‹Ç”§“çÏ ^ˆ—¯W‘W¯·’÷bïjï§>:>‰>>¾v¾«}/øaýývúÝó×ðçú×ûO8¬ è ¤FV> 2 uÃÁÁ»‚/Ò_$\ÔBüCv…< 5 ]ús.,4¬&ìy¸Ux~xw-bEDCÄ»HÈÒÈG‹KwFÉGÅEÕGME{E—EK—X,Y³äFŒZŒ ¦={$vr©÷ÒÝK‡ãìâ ãî.3\–³ìÚrµå©ËÏ®_ÁYq*ßÿ‰©åL®ô_¹wåד»‡û’çÆ+çñ]øeü‘—„²„ÑD—Ä]‰cI®IIãOAµàu²_òä©””£)3©Ñ©Íi„´ø´ÓB%aа+]3='½/Ã4£0CºÊiÕîU¢@Ñ‘L(sYf»˜ŽþLõHŒ$›%ƒY ³j²ÞgGeŸÊQÌæôäšänËÉóÉû~5f5wug¾vþ†üÁ5îk­…Ö®\Û¹Nw]Áºáõ¾ëm mHÙðËFËeßnŠÞÔQ Q°¾`h³ïæÆB¹BQá½-Î[lÅllíÝf³­jÛ—"^ÑõbËâŠâO%Ü’ëßY}WùÝÌö„í½¥ö¥ûwàvwÜÝéºóX™bY^ÙЮà]­åÌò¢ò·»Wì¾Va[q`id´2¨²½J¯jGÕ§ê¤êšæ½ê{·íÚÇÛ׿ßmÓÅ>¼È÷Pk­AmÅaÜá¬ÃÏë¢êº¿g_DíHñ‘ÏG…G¥ÇÂuÕ;Ô×7¨7”6’ƱãqÇoýàõC{«éP3£¹ø8!9ñâÇøïž <ÙyŠ}ªé'ýŸö¶ÐZŠZ¡ÖÜÖ‰¶¤6i{L{ßé€ÓÎ-?›ÿ|ôŒö™š³ÊgKϑΜ›9Ÿw~òBÆ…ñ‹‰‡:Wt>º´äÒ®°®ÞË—¯^ñ¹r©Û½ûüU—«g®9];}}½í†ýÖ»ž–_ì~iéµïm½ép³ý–ã­Ž¾}çú]û/Þöº}åŽÿ‹úî.¾{ÿ^Ü=é}ÞýÑ©^?Ìz8ýhýcìã¢' O*žª?­ýÕø×f©½ôì ×`ϳˆg†¸C/ÿ•ù¯OÃÏ©Ï+F´FêG­GÏŒùŒÝz±ôÅðËŒ—Óã…¿)þ¶÷•Ñ«Ÿ~wû½gbÉÄðkÑë™?JÞ¨¾9úÖömçdèäÓwi獵ŠÞ«¾?öý¡ûcôÇ‘éìOøO•Ÿ?w| üòx&mfæß÷„óû endstream endobj 3966 0 obj << /Type /ObjStm /N 100 /First 865 /Length 463 /Filter /FlateDecode >> stream xÚ}“mn! Dÿç>‚m0÷¿XßXQÓ(m%ϲì3 “1k˜Û˜UV*ˎʶHÕcÑÓ×BóË-C5,§ê°Üª<øƒÊâ¡çec©òòª›â­kS¼í6ÅÛa%ÞN+ñö°oO[âí²ÕóËVÏoÛÚí>¶Õg_Ûêsܶúœ°£>üõ9ÃŽúœi7à1yÅ;Ë®x‡sº6Àªð~ÃI]¯®[„zÝ@¨ÙM„ºÝP;X‘ ÷B ïB¨#ø"_ÈCä y@.‡<]òç’€<¯ä‚\™»A@æ:ñYî”C–=Å~CþT@–AÅ-†*N²¨ò™‹ ™Tœ)äRä+2wò©8eȨJ.ÞEæúÓEÎDˆœdÀE&"ãD*6• !2!I§ð&•œÊ‹y@"ãVʨÛ(¢”mÓ9ä¹"]ÙF±0+% ·Q.Û(>Í6jBn£È`¶QS¹yBÞ"Ël£Àg5!+LER³¢a¶Q¹"¼ÙF±…l£ø;6Jyöñásá]žck”¿Æ÷äSôoÓo+ÞÇkÑ'þùÏ(ÿewŸ_=çÙÄù±wèÏ^Ü?ŽõŸÎ endstream endobj 3968 0 obj << /Type /ObjStm /N 100 /First 862 /Length 454 /Filter /FlateDecode >> stream xÚmÓ[’Û0 DѯK @âÁýo,}r<ã¸Je@u$’í™¶lg–mJ[QÆ.嚇j-ó¤ºùPéÇâPÓ¢ªz¬Ú6Zi0\ Ãëe¯Ý^‡¼Þ–x},ñ:-ñº¬ðZ_…×c¼"ûdβÆ·Æ›°Æ›mƒ7ÇoÒoÊ.Þ´]¼Ñ4ñæÚÅÓM_€W]ˆ7Ô@j¼;æ=j@oªAá{[ î5À—”\KòÉ;i$oÖgI>N#ùÉGr-ɹ¸"97d¶ª–äDvÉ…¬¯óBÖ–ùså]r#ë{½‘µ‹ÞÈ.y]ò kc}]ò kN~‘µ×~‘CòEÖ,c!kûc!‡"°5ïpäh5È1jšæZ°P¥Á©íj¸¥µ‰ý¼%™ìÔ–LxJ«ûJÖYŸÚ’ÉOiý‚•Ò$¨Žd"TZÑHd=„¨ŽdRTZã F%# ùH&Hu$“¤’D©Žd²TÚ‡ L¥÷Ä §dâTÚ™ O¥7*ý©âÞÇÌC¹ãøh~ž¾®äz]ìW?ïæï0~ö‹÷€ýû©ùq|Üúßü ž§¾ݳô·c¾ýίOøúÎ?§™Î8 endstream endobj 3969 0 obj << /Type /ObjStm /N 100 /First 863 /Length 470 /Filter /FlateDecode >> stream xÚm’[rc1ÿ½ – дÿM'¶3U.éAæÙdžͳӦLÙ‘¹v1g˜‡¬›oÙ0/Ùiá²ÛbÉ‹|`v8Ôq „N[ЧÛR<ÃVǧíŽ/ÛªžÛ¶Êç±}áeÚQý¤+ÕÏkBŸ–Š—[*^aÙñi¥¾jY©Nm+Õ©cwÀããªN•]Õ)ž©w^Þ9¼Kd ŸŒÊSErŠL¿ž"3=O‘r‰ìKdžâ%²C¾"ä+23ö+r„Å9ü™çÆ9X!r°.2„¶%£pDŽk¡}I$ •ÓqDž[(DŠŠÅ‰jBn¡øŠ%2»Kä y‰L>¶È¬Wl‘dír.ÈGd4ŽŠÕ‹ F´PK{;!³ÑBAŠ9D©4J)êD)µ!³8¯ú¡r\õ£Y õ£5ëQùöÛãQõtò᣿ùøö¾ÖË¥úÊ=¯|ýÿ:õYâIªÏ Jü\Úã?'~œ·6êÅyû=ùžúl§^;úlòïíþýi¤ÏI endstream endobj 3970 0 obj << /Type /ObjStm /N 100 /First 863 /Length 459 /Filter /FlateDecode >> stream xÚuÓ[r! DѯBK@FÍþ7–¾“²ã¼ª\FfàˆòìÝ1böVL†—‡kÄaÈÈb¬ÈÍ8#Ÿ¢’ñŠZŒÕ~vy3Zû\{1^W,¼ž±ðzÅÂëûž¿bßóûØkÅuÏûTÌk)Z­Š&¿fx‹Ç"¿vˆüºBäW‡ð¤8x:q˜?~MÎuüžƒ~šƒLÇo:HuVd’ël$óÎL²vu†Ù#ä3–eXc88–gXž›Àòå•–×"°¼šÀò¶,!÷dÆòFNËÙ‡JŠ#ßPR¥eÊ#3©|iI”–©|ð²ï1©‘Ò2ERY²¯6)“ÊòAöËåAöm×@®íÙ¯[¹Ü‰\r€ìT"»'*‘gF²KR…ì6©Bž–'²‹TÙSÙ_µ]¶ZÈn¦ZÈËòBv!‹’û«è!yaÑÔriëBvËÕ…ì­u!/úÙ]Xl¬y[nämYÈæKȾò¶|°²¯¨²ÿUsŒ‡ôð=ªù¼Oþü~~òsÏ=¼vü³ükѾ7}­x&ýñÛŒ¾çÐßGzw^‹ÊïÇè¿’¾û¿S<}€õÏ5 endstream endobj 3971 0 obj << /Type /ObjStm /N 100 /First 863 /Length 461 /Filter /FlateDecode >> stream xÚu“k’$!ÿ÷)8‚ ”pÿ‹m~Ìì<6¶#: JËDSzW–-Û•m›ð,{ÜZ!ÌCq›§â1/Å´pÅkqË⾈,Òø…¨ñËËU ;*r·U¹ÇŽÊÜ´œñÇrƯ北eûmê»Rýr{T¿Â„®ÚvU§Ž]Õ©´¯+ñêZ‰We%^µµx½¬ÅkŽ)ƒ¾lºf†“®™JsŸ©‡DÅú’¨K=ØnêõZ$'i%w(¼S ä]J Wù%ÏU9!÷‚,3í¥¦Ù‹ë®š‹qÉi‡,;Íî\zš»rùi‡,AÍ~]†šëóÙ!ËQdIjnÔKä€,MÍ™\žšKv‰êàâ%ª9e,‘ƒX3E¸CæÜ!Q½‰ŠÒA’ QѽIT”6‰…›Qòˆ¢sbDñˆ#ò†<¢h¦Qø uPÈ#ŠþŠŇ1¢äEËňbiŒ¨£¾ù@QÀbD%dõR'ä>FTBQ yDQ0FTBQü«öòWÝWÕ<çÇ~½úZßs‡j>¼ŸÏoFýâ}ÍjÙOòÛ_½ÁýÞa®ÿ/ÿÜݯézSàÇ뿸z¿¹zýRÄÏÛ endstream endobj 3975 0 obj << /Length 1603 /Filter /FlateDecode >> stream xÚ¥X[oÛ6~ï¯0Ò‡ÊX¥ò~†=,iŠ®ÛZ ~؆b˶6YÊ,¹CöëwIù"3³=Y:"¿sáÇÃ&£åˆŒÞ½ á÷‡É‹7×BŽ¨È¸Pl4YŒ¤if2Âõh2Ý&zœRJHr¹)ò®¬—ã”+•¼+êŸtrStíønòã›kfG6³Š)„!£”ÑÌPãQÂx«üx÷ô™HÒvͦ˜û÷²Æ_™äNÒ8Jx& Xw¹ýL8GP€‹x—6`£›ûq*Uò{1¦É¬·Ô;œåµ€ïÌ$!À&êc’Éb¥I ]æð¹[±ø„Δ•½ÇeÑap±Âži½¸.ºU㼇"4»"¸WŸ(&é¿ö™Ìºlœ*Î’ßÆF$ÍR.a ÁŠeVÊàb èÛ¸€¢s±ñ/<¤êŸsÿóeÌtâ Õlü”fá?½ZBJÓrþÊ¿úϽ¹]5›nZçëâU$!‹j[´þ½küo9/jŒ¨ë »xôn°°nÄÒUÎ=>âHÈÎ ø«lWÇXmQA%¾ ë!Nèg{ú}ec2™ç]îX—¯ªâ #ðêêGŽ &­q)ßÏÛïRG7÷ýU{4Eŧ„Èø!53|ðÑ…-vKïü¼‹_úx9%„rt¤øÅÀ̬šp çv`vËéV]1çJžHu%O\e/bµ¸µwCLDÐäÄ‘1WL±¡™ ã]¥¡ŠG©Q~ô$®†Ià@HÙœŒÄhce¤ú.2?IŽÊ˜/bìÉâ ïë,&{†%—…ÛHî ©=Û.¯÷üƒOgÑ;ÆÔçK@öQ;œ-\ϦIÛåõ¬ðx ì °¤$a˜*6Yâ˜Þ‰ƒåëQoª¦kÝA %p™×uÓÁ¹m1’ÂâáuŒz›âázø)L™—‹EÌ>k¶uûP¶ ¤´†R c®]>y·Ý¸ãÇ¥]Ö‡EÀ–‰¿mùw°ŸÜÜŒSc÷¸ÓŸËx¬—Wÿ—«X¼›fÝtŦ=@GÜëgV¨Aoªræ$Æ>ôÿPêAIdωê¤*ŽÈÏ{p¢§=qwËO3AugML0ÀJt/z"PñÝ ×@á;1±K(ÖŽú0n2!Λ!X¿)†qÌPül¨ãM<ÔC:“Öþ–êÌKDWplÇRTaæl,/b"‹LPµJ· @"eæ`¦AAïôé¢Àê¹]‡Kò p æF¨¥1-ØzîäG"®Á ŠJ%yYå÷U0»^‹Ë: PC ø@zN#&4c$µAEµ¬R°ºúRÛNÏš*o[¬—6Éý¶ó®òù¼ÄÕÏ+B>ƒhZ;¼­Qmv+ ³×>{æ²Ç‡Hö`^ôqIÎ4É$£}dn)úöá¡ÈàPþ:w ï5×R"ôa“æ>˜EãM* É4p-Þ £×û‹P ǧרm½NFž¶A2c努Ê"Â" H1yñòúÓ‡Ÿýã— áwg;>‰î[æÞÚeOkŽU‘ÏQ¬`ÛÃßõ㡆¡½bèN37§£xÕ$8vûyŠXxÁ­a­ï­)¨I‡|íŽ«éª ÒdÖ¸½˜VMØ@ÁÉaÔÔÃ^o¸.ïqò¦¹Öw¡,ƒ„ /R¦™Ì éTõFF *’P¬D,âÌåávÈÛ›KÿÂ-RU|CXïô«1Þàôåp ÆIFÄ49B‰S~ºé}X/V ØÏŒ¡ÂzÞLE <˜¯Õ ên5¡€+v Á2»+ÃÞ¨¬>–3âNFÜE*G€`òÞ`á2¡ö%\Ù Su¤bŽ•sTY²‡%¥ñ·BF™ŒQ¯ )¼Ì±£?·yÝM¡}»fÿE@cÐÏçÅOר,\( Ã>~ØqûŒ4±1&°ƒ Tµ™ ®fñ•åC°K‰v×-ù$ú ŽEVƒ†Àâ=¹”»ˆ°Rpeƒf%Ÿ®†Ã¢‹ý¬ÕË÷^è§ÔEgÈ 0Öþú^÷œ>Wº ™¿Oø¾wÔóú¾·û{îDvЄ†-Y&TˆÞ+ÒÝŒ·“ÿY~Ùí endstream endobj 3979 0 obj << /Length 1862 /Filter /FlateDecode >> stream xÚ•Xë㸠ÿ¾E°ý°`¢êý(Ú×éía{O\è‡^x%ã»ÄÎù1Óýï”dÇÉÚÙíKõ#ER¤ºØ/èâ›74}ÿñøæÏï•X8â4׋ÇÝÂ*"ŒZn fñ¸]ü'+šjWÕÇu±½[*®²&?žî–,;øu™ýÝRh#³Ýé·ãÝ’3J³MUîÖÏð(£âìPÝý÷ñ_‹¥`ÉqJE|a~üaµ¦øÇÞ¸H_<ÕÕÓ!oÚ&!R©¢V Së¤ ›â4`yôRŸ—$™sÙó׫ xÆ)š:À‰s!ˆ•0 IŠ&Ö2榤ˆR &ûi€dfˆv)BYÒeL㜥]’'3H³'“Ó2-·!`·¦’t”¤æ%lˆ,€DW5Ì%Úˆ $ 4™±°YgìôÁô q—Æ –c$˜’*=xŽ_3y6F‰TöRâï]^¶ë¦Í[„êÀ`\ƒ¦M»õ/1ˆ§vaðÓß&±?Rêæâð‚Y#ÜŒÄ5³$B0n'½#?UƒÎ1£‘!æá&ÓyG\ Ñ d†,"GY¶"–qëß#üŸ~ö§C±É[Ÿ‚ò§o¿G71vNê8yÄñj'û°Pu§&n|-Ú碌ã½/\ãÛ)½“ðgŸomkz2Ëpú¸ZáçøñÀi`Èúÿt¬qrìýÎ&#<¬÷¨Û!cŠ”x$–AšR$ªPŸ/æãÕüu½«ó}s3ÆÂ™N„ø—Y±FôLY÷±Ï$aÚ™¹dxÐúÌ ×Y Çg‚ôìœ ´DBË<H¼°6¤>­Ösyí.½ÆíS¨Y‚Ïe±1î(GÏ…<Ùk~•@×_Phô—šŸ×}žbŸÉSEÙúºÌël›üà·)€¤ÿ_¿¼ 2GË‚…B½¾jFH‹d,îw`Ç¥¶q¹w>duR®ÆÍ]c€è¡V¢5ìÊ cB YZê”Ss0(c‘Xô!Í÷Ê(E˜¤¶W†‹  NEçòc€Ò’h¨Êº‡’Œ€Ë(fâ¹U³Ù3œ«vãBú¹ô«ȵκÀn„$£L«Ù0ð»ß´Å‹_Ç7Y¹oŸSB„ÖÝN'Aþ_…§0µßðß›>;é Ðä—±©/cÓÓlŸ+G…»qj—ÄIy™Ú¿ÂÒÏyVí&mà’À« ë¦;ýÏO]¹MØã²¡÷HÏú’8Æ`Äv`à e=Ã_&81Úö }If#x9Õ31ì=8¼Äˆ) ƒÃ!îÃ@ì/TÓ=-£ù8tŠJ¹Kó% `íÿ ?CTc²_»¦ä šSùÓr‡zàFœâ¸‰[0Bñ²…MSq„–”êÿ#ÓoH—ûÎ vÅ·å†ðFj£ÁÃéÚ^)|œã÷רA¥óÃë¿å¾ç9 Á1ˆ™'SJl ¯.ôÈWBˆðê‡At zSßÇ)<ÁóÆÇqÉñH)ýë”ù ¼tÙø¾¿­üJî€ïMkjü…b°æÑ·Ïñ’m£Ô­o6u‘h¢ Ö$›s¢,¿¬¯ßWÁâ°¥ö›á î²hº;6‘#ØVFe)Ð!‚+d~Óº'Ø&Á`Ë6zgŒQ•Û¢=cçéûŠW ƒòp¦¦P0ÁÇU Ñå0"-ê¹i£D—$س„”ÆS);Û¤& ó~û Ží’4dçNø”[¢Ù*šÐœ}Ø~W4“ÐI‡´š×ûî˜LN&ÞKf-¡ÌLv½©µô-9…ÇW]Žoä¦ÛíîCC8?l›û‘vHoÿ¶AÆ·Øø¼½ -ÙÛq—:ÓñNžèi¯ÞF L|Á±›ÅëŒ0/7©Y 75ýN–:®Ð¤‡$•à-îÀàvu¨Ú&¼[0ÓP}u§óÒa>„ÀÕy†NåŠÞ·ò°4ü¢y]ŒCË6=°ØÅ–¯ßüoj"Ú endstream endobj 3991 0 obj << /Length 2122 /Filter /FlateDecode >> stream xÚ½Ymã¶þ~¿Â¸/+–"‘z rr{ÙkSj£@‘ôƒ,Ó–ZY4Di7›_ß)Ë6wo“ùpgŠ/3ÃáÌ3¹áâ°Ÿß…æ÷ãæÝW _A‘²t±Ù/¢0 ”-2–!Ï›Ýâ'o×ì÷Ëo~€5~E’P%Çnp 4JîeTK?ÎXìÝûýÃÒuQNê¾5Ù‚Œ`8LbYçÆ¤,ˆÀ‚ä~PhϯK»né󴌼Vh«"¡¬˜iÇmæÏÞM-z0–sî•¶¡@ Ë<Ñ—-uœ@Þ _û±«†FvÊ,[²Ü{\&‰W6m¹mHjÀVŒõÑN˜*ŒÐG´°Y¢•ÐA|þZ¢ä¯õDqPÄñUÔÂ8*ší °3ÊLõ±L"¯Žåéç0 á_äpDR<Ìì*»)°­€sUô[ÒÏlÿðõ¤S£sOØ€ÿ´³hp¨K<–"õ†ò¿z»V”ùmºÓ8PS4Cm×M÷Ú?‡œƒøÏ:˜¡ÑQÄ¡Ty5_Ï}Xæ\O„ÀÇ5=¶×v5Á”_$£KwÊ-ÄiêýGTzžÏæ¡Ë„R¢C뇦lÛgˆ´Jø©dÛ ë+øÆ¨Ç_Th‚ÅQêÑt#Bz{ÿ§÷ ÙD QQ•£¬t’ƒ( @{TX;PýøHN{…&äy²)ïjƒO¤Sv–ÝjN€ge¹]jKu†Ð¨ùÉH†`m¿Õ›æA”NgÉ”K ÄjF—j0WÜrÁ¨+Í8KÇõ§Ïž³èØÕá· ]¯@e‚ };ŽÍf\á'Ì·oNȽ®fqŸéÜÊåFpâ4a³^Yfš> stream xÚ’Ën¤0E÷|…— ·ðb6QÞ»(ì2Y8¤’¶Ô œÎãëSP 0ÉH# H®òµ]ŸB°'&Øy$þ%Ž‚I¦DÎË\±LY® Ãê}ôñ,ÇgÚ±J§¥åÜ,l.÷2g'mtï²–.EÓUÕã*Úœà n !YõˆÖš› ­eɋܰêÝÆ¿…™¤ZÛø\Ø»n Y×·‰ñÁ? C&âºm&} ñÐ$ÊÆ¶¼Ž¢…wBKñà‡·ós©°…䮺 ¤/=¼u= ƒGƒT›,n)Âd|4‚fÎe.ÌgšøX;:­¾¸KD¤“Vs+þ‹{ñ“û\4]Uý w‰ÜZ—š+»â~?sÏòøÆí²-uàhœ•ñ«[Ò{èv¾v†_)µk–#»Ž²‰5Æ‘uºÆ›‘ëÂ)ƒýì½CZ¤Ü')v ÂØ»©‹s¾¼‰ë÷Ÿ{s¦,³Üæ*/\ÜÈ©d–Ò’µÒÅÖ|”à endstream endobj 3981 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_heatmap.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 3999 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4000 0 R>> /ExtGState << >>/XObject << /Im0 4001 0 R /Im1 4002 0 R /Im2 4003 0 R >>/ColorSpace << /sRGB 4004 0 R >>>> /Length 1524 /Filter /FlateDecode >> stream xœ½YÛn7 }߯У¢ŠHÝ×·$Nì:Þ-Z ŠÆ­ÛqÄúÒ/©Ñ\´«¹lQÆÎbftHyxÄYƒ¸ Ä—Õ»e¡¤RÍÁh|}ýUü þX½x¾}y"îžW@•ŸïÚÛ§›ÊíÍé5_õâ¯ÕûB‰_V .éó°‚äîj5îz%NºŒôQX#Ñ-£Ú£Ä0£’1:kSŒ€FZ$8ጠF€““Ÿû"rù0… U¨šÛ ¬T0j”"q@GO×FAF=…¢ëŠñJz¤C¬•ÞOFe„”_º>BFy­ TˆÒá*GG§ã…ÊIk&Pœ=%)|!jiÆËI(´tDò8D%u­žm¥lt‰‘ª@Y/µšòe5µ-#ôÄØZ6(‘ù‰’¯¢^‰¦µ*SlÆæØö"Ô*p§U}¥œ£µû¾4}ÅZ•9{œs­°‚2ÄÞç¹²ìR÷í¢,±·Æyγ¯ <±·VeލÁTP‘Ø[íÚ–½š}y“yH´ÕnF”Òï‚Fõ¡Þ] hF5ö:9£æTÃ{®´Q%jZ58:å ÔœjäžÔEçU˜^¹5«†«e]á¼j$]¢æT£é »CÔ˜jt¾RŸàޝ9Õйkœ.PãªÁ| õ±a|á¸j0amÚCM¨FH^,T|M¨FLy°h+¨qÕÈêi 5̨qÕ:¦]ÁW|«FpìËøPAM«ÆnW"$jT5òí1}È·çç‡ÔÓ!3«E)A}kQsJà ¸5§ +š5§ÍþÒîÎ-j^ ¸z6ï³µ@ RŸ•Î+A³Gc‘Éù!w³vL‹šÒ~¤¡`Ö„äõ8Ü[Ô¸8ÅOÆî£¦”@CVú½çšP‚vs°‚:L ZÔ„¤š<•¾&”S„ÚVPcJ°ðjôs²íßUÚéª?¦÷© £Åö^ÄîÝ(Ò)€¤‘Ñ;IÅØ>Š÷G››c%ŽÖù{Ûž#üýãÛïNR ´ ÇÄöru¾MLy°T25Q‘ÝÜ®¯Î/:S À‹íÃK@ÂF{;½êQߥ`»Ø6p‹}tN/ŽŽ^Iî=K.Ç·y{ŠkßÙÂè—†ÇÝÈ ayfSç››ëî9•‹K iJY$’p+'C×ë>]6§Ë{&[JWWڳ׃XXž-Ms‰€hXõ“É‹cØâ•Ñ'½I¯–›D~ùFæ¡Oûú-âíºçšXLÍÅD ¼Q°­õ›[¿ÖbX4V:Ø©h}¨‡’dhÇ ºÅÌÏf|”Æî›Áˆso8læž¾Þ7°¥³+0Û5¥\7$½yyÖ“=,ÎPS3­y_ìk6hfâÒRSMH†zÙ4 xñê {VêʼnB"%Y"µVYÎ^ô!ÙÅOÇš…Š756tuq=ˆH-×>“~£Šž÷96ôýÉ9^öi¢)¢5õ?î()¾oc¥jXÆ»´01K>‰Ä§_Ÿ> ÖžÏ??ÿù\U‡ª1$Î’™ÎØÑ§›M-gu0å—üûùæô¿JSû™ù5“Ä‚&Sâ&I@ÁÑhA[˜•6ì _V4¢Ðƒm3º¦êî1YÎOØd8Óßóü«%ŸmÓ]~ñúQ‰³§Õ»‘²ö?ùôCý´9¢¿Y›–Ê‹û2CQ¥Á‰¡‹½…¢ktq·P’ƒ\ýÅÚÖB]h·r3Åš2 PºkÎsÁ1h¦ûû\ u ì¥3CðÓ`«¹&ðo5p(±¡FzQ#(HÛìÜPeĈcÊ­÷CÇââæÍ•øF,·aXõÐŒ•iæ $mƒÿ)¨ÿ) ú‘ö¨GÊ8 ®=ÿ,Ħ]‚ôÎCÝÑ-ÉçÅŒœñ~Is^,±üÃì`Is^,ñÀ¬î—4çÍ*ŒÂA¸4}ð`: ·YÒ‡Û,)ÂÍKºpó’a¸yIn^2 7/éÂÍKáþkí]ý)À~Ó endstream endobj 4001 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4004 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4002 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4004 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4003 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4004 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4006 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 3982 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_heatmap_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4007 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4008 0 R>> /ExtGState << >>/XObject << /Im0 4009 0 R >>/ColorSpace << /sRGB 4010 0 R >>>> /Length 1955 /Filter /FlateDecode >> stream xœ½ZÛn7}×WðÑFÑ ï—G_“¸±ëX*ZÀ‚&mÚqÄúÒïpÈÝ%%^v[ ´ÂŠ<Ã!9çÌp%F®#ŸÈ—ÍëeoBJÃE ž||ý•üHþØ<{º{~JÞ?m|IIz}z?6Ÿm ÍÛ³ÿ­!mîßJ~Ù0rïO†Ã]oêCoÈéä cr0Žh9pE8ƒ3Dh>pÓô‘ÖXô‘q9(N, '0‚ä„éAçÃfìn¤ƒ«€krf`¶²†ÁUÓl$NjU@ÑÁIý•Ñ8oš¡XÓAká*ËPRªå¡á8-Ê3”-{h '…ŵèa>/ãüG ¥p^4îg>/§WòÖÍI?–6‡cqý+r…3Ò·ƒ+{¨•GÙJªA”=48 ·%”fƒmzÈheì ê»\‰]îThŒyvÔ£ÀaÄY.S«‚›6%óûãw)EI9°¢/­M˜۩DlwbPõQ=³<aT¥á›>ç5n”•)¨Çù½U  *çGTˆ?ª3ÿºœ·9?®eD-å¼ÎP ·þ8¯)^#ªÁyçYÁ˜- êœ7È nõ!ªÅyØW/ά€ês¾4VƒóÐæÕâ¼AuÐÁ,6:œ‡ˆÂÙ“íWóežT] b{—óÊÄ\“Z]Éùˆªr>¶W9Ÿ«Ö˜ñ"ª­¾X»RW‚м4ÏËÔf—ó†…ü&2T7Ïã¬%ãªÇù˜K÷<¬sÞj•%‰×ˆªsÞX?–ÀXßGÕ9o‘í*fì Õà¼E*Î ¨:ç Æ¯ÀbnU缕¸ŠPuÎ[ãÙ., zœŠÞ¦¨6ççÜ“Åv7û‡]“Lg¨®àí2T[ &”Éb¾®-ÎÖõ!¶×”€ss^œýC¹A]%XÁ “‚úJêHá2T7ûcµ*­ÎPK•Àf¨º8á#Q鱂OQë”`DÕ•Àa¥¡4;«¡£‡%TC ¬ŒÛ{àaK ¢.ªjŒ¨žXDi•ÅÆÊìQ ”À%y½}%À3¡6,C­« FT[ F…3ñ¼:¢º•òKçLéŸ0¢Œ‹(%5}ÕÀ—cPW5ƽÍ@çþ¤ÎúI¶×8¿ð—‘êût7ÿ➬§WüUäF$»ÄM¿pào™ô®Xår÷@޶¯Îø‰ùû§Wߟ½¥”qgŽÉîÓæb‡µ, ‘Nå~u½©›“ÙŒæKÍ›œa²~¹½™—¯8¿;a“-ÉØJ—àƒñC—Ôb—„_#¦˜ßAoæä»;s"&SB»•iëEmÏ#!›a ÉâÃhoæŒ=~ý`u2;±Ô‘„ ŸÕÂìnŸŸv@ —û„«Ä™ñj8­Ÿ§gèbSÁ%!¼DzS—/Î'K`jq4qî+`C˜ÜöüÅéì’Z<;.üÆq­½’zC×—7‰Gty0I¿uÜ /®ÞЧüj^&./øDýSçLÝÝ(,ýùK6;§Øñ²»ZŸŠïÇ'رkV Ò¨]”•‹ííÍTËùAe|™æ¢¨Ü]C}3¼–âtv bké;Ô?RƒÖÁän\µ-»Kâ(´Ô¦ÂéZ>êÌíÝÉõÅe²ly|Àa‘Aº°Qlî¶Ó®ÆÏÉ_>«¢vòöL)è÷·nòž†M“þ÷påbˆÃ¦}|÷õñÝ1ñ^þùéϧ·åý*›ÒÁ­i®áesÀÆfsGo·o‹œ+¹`^tsx1#•áPÏB=8ÿ؞­Þiÿ°q?ÿ_·~|wþh©Ê3›Y3hJ Â±>p•¯ïóªæË*fxADCéŠçj-KÞ? å8ǰ/x/ßfnñlËéëg/(9ܼ®„êü‹ÿ\+¶åN›ÁiâŸàÆä·X|#”3Ï „./K"ŽQP<{èâ|6BSãâ—\­!²d ~\V5t þ­¶9Ö¨ƒÊŸø¢Î¸«Åˆ¨ u1éÀäòö»kò YnCúA¤6ªäîüÝÉ?ŸÿîD÷þî”ð‘sò+n}BŒ÷Ÿ ÙŽ]ü¿œ”˜»Äû¬ ”jp¢›»„û¬‹‚c—Jº„û¬‹ÃˆNº„ûÐ6†òÄ]Í}ÎÍÜ ]fwC—ÌÝØer7vIÝ]&wc—ÔÝØer7vIÜý×Ú»ù8Ù d endstream endobj 4009 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4010 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4012 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4015 0 obj << /Length 365 /Filter /FlateDecode >> stream xÚ…‘Ms‚0†ïüŠøù&Ç~é´·ŽÜÚ¢ÒAbŽ¿`µµa&»óf³›_óEœPlcŠ»´S·Šið»-z¿eOW±>dߨå‚h*&´Bù/ =¥ÿ¡5hM“³®—lp"…Í¡À/Ù‚ÁË"ï{{$æ…nëbfð¡j6Ahm÷•kºmµЧá+<œ¡n0ÀÚ$Üv º ¥…kÊ*˜ù‹'Æ?V„kŒytÕ;zò·³93È£˜Þn4:õ#H¦ÃL&~œô&} L¹M endstream endobj 3983 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_barplot.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4019 0 R /BBox [0 0 576 288] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4020 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4021 0 R >>>> /Length 3525 /Filter /FlateDecode >> stream xœ½[[Å~?¿b±¢Lú~y´×6`°ãx7J$„P@,$8Rþ>uééþúìÙÙÙåÁÇþº¾ª©™é®®ê)ÛåÕb——Ÿþò;ýùÓûw?[¾}²«1fÁß÷ßþÜÄW×Ä×Wox4/ÿ=}ñåb–œìòŠþüx²†Ëë“ü%?1'þË•ÂýúÝiy¶y°„²†ºÏ’àÉ¢_l­ktÄ[þ¶ü<\4kunÁ_vqOÿ´|ÿÐ-˜5úq æìÔ¸µn­i¹=…,†þét½bXs‚b ÔÄ×Ńà|Y½„†PÌj 3a~ J¯Ž;[!øãýZðŽ!Ç5 (l^ÜQÃ@ˆuuŠ™ìê¶WvÛ+ŽY,¦%ßÅŠ@l_kîò‘àâêí (DBH|3  )¯µ ‚B$”ʯ§ÁÑ J©D‚w,ê…Hˆ~õÃÉ‘ÚÆsh 4ÉÌx ÁÓ;ó±DÍÂ4ÞTƒHH†\'(DB±«N6„`ÜšÇsh .¬f<‡‘èýŽ—Õ RZóxY Á¬Áe )Ñj¼ÒØ—ÂXHi f¡P[P1k¡Ó L‘~“ÕP)¼M5ðÝTŒ„CŠ…ô›é)ˆŠå' *9|ê*—ü*‘.Ž*6{^Y{žÑ ³­:v]#«fÖñâìžoÖäÕæI)„5š]笡‹ÎJô’]ÝõŽ­Ÿu8•}ï\¡T2Û~t¯oέö~•KžYy Oïæ¢g¡®%Î:•ƒÒ®oÁ¯!ÌÏÀ¢ÒEï|æõƒJ†Œßw/Ól)¨”yûÚuŽ–OžTÝPÜ÷Ÿt"íóvßµêÆwð–´ÚI…bkxÀ5ZAyÒ¡· ·sÉ5geSVÝZ÷Cˆ£&Ú{’ßõÍÊæë³ûÎù¸º³Iš×’÷£õSf%º’+ûÞÑ gJãþ{‘ò£i–ÒÎã¾w4Yì¬C1b­:ZBy r”¼Øýç2=¨rãüÎÑ s¼ò‰£Þ®w)2}Z«u­ûkÕUɳîÝ….zGìbçìy¾ïzGË(LJ™¬¸]缓׈έuß7oÉýI%®1ízæiåxoL¸èX°k©gëΗ}Ïh Í¥`f5xŠ‚sŽ@³ÉìÇŸhÿ˜&éôœ/ºFëgNܶ<-Ÿ³AŠ˜]Ï mîóñ¡(âs9Ϩúx`¡zZ?9+…¼ë^ ­>n¿÷\:šÇ=¸êy}M›cÙn4¶º)TÑÃOûžZ:eÖ¡Êh¶z…s†@ùfÜßEÀxÞ¿å]ç‚;K¬-¸]ôŽÖÏœ"púhö#HH1¦˜žeÚÏ~- 9G ½.ïÇóY’@ñrc6¯L?KH2ݸ M\{“§4A”º7sþ<äyäþ"†Ùºi)•Ï”»r¥IJ$ö,hpÕCÞ åÀŽú20ô‡ÜóÆÇ)X岞9Ù ÈÈ!#^õÍyÕÒBó*Ë,yÖí©¾jƒ"¯R7nòiQ‹ú:ÐõAnxÉ9rªòÍSX vƒãHaÈ´¼ Q_†~—S`'ÇïÌ%$E0®¤Šº)œcòÑIäß0œ­£a¿=ÉnÃë£ì6:£F^øŽòcÃ&( ò¡‚B‘gŽ&C®rØäP_ºþ['9Ð6ÕdÀ™Èej¶ xHŸRŸrŠ/¦Lr9Or€‡ô©Pµž2,ñ™ †ãxÃÊ(H:Cñãbä…zªüdŸ‘ Q-gW ÃÙë`(¾cb\ÂŽüLåröŘ¹[ ÷ÙlXŽ“ `¸‘t€‰~ µ0äÝ\‘òX¦5TJÞVFæøŒ<Šx0±]¢Y9…{Ú=øIœt41)Z4 gÐÀPömm6tdØ@†ãS5Ži•ç /e6¬ŒÀû 0££b¢ßˆZ9=åÄÁ)5´|)—lXE½Îh˜‰“ 6AAÁé>%nPØÏeÃp" ÅôŒ¼™lèȰ z $ù9r¢â(øó.­X‘3}`æI2Úh#Ý2hõÒÔ·”I(r¼ˆÝ†•Qùˆe0ÃCWý¥¨”[®²9¦™"¢¤‡Šáû0ß1Ñ/¡@¢„Xʽ$_qú³Ý°2Ç `¤;ÀD¿„Zy®üfm2N|¤uÌyžbaÐB&÷¡Ø¹Îh6tdØ@†ãC ž/9È—˜$ÙžbøT Åü¦ódCG† `PìF’FÙÃ\6²c+VF‘»3[>D-h£tÀð´ñ&ž8QSO«ÙÖ +Cf.0ëÖ„6tdØ Wƒ&È…OžùÓTÖœQ0|»FÃŽÏ5&26ƒöú'ºtòLiùºaeTÙõ;£aΊÒdCG†Áð”Q¼°|Ø+wK šÒ¿†•á9E†ÇS`b›ÆÍÈi+ˆYªã¬êªdŠáK0ß1Ñ/¡@nê8”a¹碪o8ö9ÀCúT·x+—äž–rÉVFä4qœ”‰~ µr-ÐùeÆ$#IŸbøœ9 Ó•¢lèȰ £utàã¶´¬ §¥wgFGÍø Õ-€<‰¦ –ë7þªZ$qT¬ŒÄguÀHãìLôK¨SòäPnÇù¯ê›ññïv†‡ô)ö—(Ï­Ês¤à/'I‚•Ṇà;&ú%ÔÈi¢Ô*5½ÎZ»1nX™OØ¡˜Þº­“ 6€ÁÍ \TgM |ñœø5¬6ô“ö`4ìx;œlÈ؆—¢š9\ñýi£hX÷k`(¶’=  6#Ptðã¥ZÃSÿÀkxÌË Ó7XX ûa–»‘%ßÎðˆ¾§ˆ/‘Õµ÷Y ïÕ +#ñ^ ÁwLôI¥ÀWôØ+ð¾H>ðÚu†7[ŠÜŠõ#*ÚБaNRf®°…AŸ3>ÅÊ.`(¦P‘ìdCG† `Л/|•¶í.5܆•‘e£ Å´énÍIÍ†Ž Àˆr@ΙXà”"1 ® +ÃJ–<ŠiÁÄ8ÙБaû“ææYæFÈœø5¬ mû Åü=ÕL6td؆ÏüQ”G²xJÑ?§ +£H'Pg(–cT6ÚH·Œl%qæ^5í œú5¬ ÏgÏÀðã,Lô•¢@NáŸgòÅJÅÿh6¬ i‚†b;F³a·ÇÕlƒ6.Õéde8)Õ« #¥ú`(¦0ÅÉ†Ž ƒñ¡ŽÏn°ƒ²Õ¥Éñ%¹´Ü|¿ÔÞ°(?ÉušƒEŠï›Ûå#ûd¹ùñôâFìî*zV´h[MsTÕÉ5¹²¢ÄZUëz~ž\ÐfÐt+[y\©Ñ¤Þ”»öݾÑ+îrbbüÞm ½ÓUGþ{;5,ê”l¹w(bÃ"È{ƒ"ö+ùèOÄvE÷öDìV|ì„û ÇÐÚ [q‹M‘ìFë‚lR쉔¨ÖÙÄSO¤È[ä&Ç–H‘·ÈMŽ‘"o›"EÞ 79öCÂÙS¯Ü±[º»!át¡Ë±*ê.Ç^H¨»[!¡`ÚäS'$” ]Ž w9öABVØåØ ¹Ð&Ÿº !èrl‚„í®Ë±â{—c $NòGDG™µ¬=Xhgwàm¿ge /®ß¾¹m.*ó yå·??¬ËçÆt_¿|ã+[=L…+¿{úúÅË‹±ý²=_„û~ùÉóG\_Ûºú½}Ÿ{–ž>ÿÔ>ùr¹yuÌŸE%pãïŸÿùê+ Ù6–ÃÎÈ­Ag^>¡‰C¾¼þÙqgø$3âCýë³îÕñ‡â´ ¿s3Ö¥GÑJw¹²¿üú}IÇ h xÉ‹xØ” F®?¿rOóq}.ü'¼¯Çpñ½^÷YÖþ¾Ù°{ĤóšmÂÍ=ÿäÙq¯(»€^u'®í;wÜ .V".Á§Ÿ½ËOýaG$uwçúÇgç²×Þ§Ÿ;÷”-=.G=o-¹…­ô/ñòq’²i*iØ›—o?{½üay”;üg P| âÙÚ¼ÇÞ·ôww7j”C®Ðô¿ÿúö_?}÷ÕÏ_ß~wßá Ü 4~õ&Ħ¥­«™,Ÿéòhb½`æb{PÕþ˜äh®UÚü{¯™=oøhÜóæbƒSó†ÌTÿáÞPJÌ•ßo.¶h5o‚4|ßïÍÿ0O.-‘;Íøc¾4Ið,ùáíõCÓþwº&Õá­ºûç‹ë«ÿÓE£tëNýÃ7¿þòÍ“…ãçO_¿ÿÏû??ø?ž~d!>% endstream endobj 4023 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 3984 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_scatter.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4024 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4025 0 R>> /ExtGState << /GS1 4026 0 R /GS2 4027 0 R /GS3 4028 0 R /GS257 4029 0 R /GS258 4030 0 R /GS259 4031 0 R >>/ColorSpace << /sRGB 4032 0 R >>>> /Length 3666 /Filter /FlateDecode >> stream xœÕZËŽ%· Ý߯¨¥Àe=KÒv ’ÌY^Ä8Ž1 žùýœCRï¸íé ¼É¢§DJ”D‘‡ªŠÇ—G<~8þuûÃó~Žp† ¿JNîÏ=þtüãöéÛ?~ñâxx{‹xÿûíÃlþìÕͯ>ûŸ¶ã?·¯¿9Âñ—[<¾ÄÏ·(Ã}uûù¡oÇ‹e`égGŽçˆGný ùÈ£œWü‰‰á)þ7Mü%ýÛñÝû¦Κ÷Â;SÐÎK=k8o%]gMßÜ^YsLõl×n7¼R¸Î·€a'Я35' x äKž/Ã"0°6ÿGC&ÅæØÇyåÕnÐ ä4Î\–€AßÃÝ&«=½²—eŽB·"W=ûp+¢ØM¸\g,nŠ݄ñ¼¸57¼ ÖðªnS‹Áqœ­í)+t3Juœ¥/ƒ~MÆ8ãØk¢Ð |úÅ«TÛñ··âäêå󷜛/^ŧ[ÕçZ¼?6v4Ÿ‘Fç³qaÜ8s4P=3L¿ÊÙzi8kÇr•­kHúVi{’Î^¶n:cÜ} z0K†k7»L×Ûýp{ù{ˆU™Ëz‚*PîX©œ ×õÑ?ÁVF9r œ@<’y¡y€“kO\é¥k¨Ì]\OòYÒÖM\ÛÕw𻏯Ööi—êÞÙ­sAXÀù“(ªÛ24†„‰Šeì`LÅH˜Ž…•׃xtMo镢󰢩W$åZ¯¤WS[ÍÕó¶Z‰$(…ΰ÷èŸ ²³õB&ÑXH"}’h>Û“Äý©;‘ô­Òö¤1¤.]ØÓvß‚DzŽmíf—êÞÙmsi¸YIÝj=)Ì©© #$bÈ ÉxMbÕjïtê¥khç¸ùDCêÔÕ :û¤Ò6¶µ›]¦ëí¶¹ä@§H îu.ó &ž!R É¢M$ã!¼Ô¶ÛaãÖ5$}«´=ÁJç­+„eõ-èÁ,‘±­Ýì2]o·Îe´s€ äªüÜ?À†#] yI’O]@B _YO"’"θi:¢IÛÙ³¥‹ÉµÕµ ϵÕLÅ;ƒí˜ÃíÈÞFå9|ôO°±dÆ]ÂøS J÷É¡D±“v;ÐhKw"é{JË“BXºYôì[Hϱ­ÝìRÝ;»}Èš¼{áDÖà5k[‘ ÿïp¥Xã‘êØÿÒߎUÀX=Ó tpëOþßÊÚ¦MÔqöYÂÀYcà-‘^ðèŸ$––¹ ¦¤\2ƒBîéÊõeg{”„`ºÅésëI Û^ºR­®¾‰ô[Û§]ª{g·%rì– c´Ý`Õ໋üŒLJÏe…<ø7ýb·F2RÓS ½ª¨>èL‘¦ÀÓ¡½*ÐS#cZ«™§zÞV5Ì+ç<†Å.I9ê eWsÎÃZzµ5FÓÑÿ—ó, G0qëo9¥mÓ¦ïìû¿uw¨’ûoÞºž÷de#· ÂKsÕð°y+©|tí e}éN´xëz"Üsé /]}/ÞºÆÖöi—êÞÙ͹°„ÿù}^z…Ç’¿öÑ'¼#Wø¤`Å`÷ãÑQ‚b+: œÀ7Ç!7ùýÝk§«â?˜8"B³Î¬ŒÀ¬ W½€sS@¡Ðrf¶+rÍV%Ìvƒ^@©÷PøŽ‰ûžiÒ['à/òÍEý( [k Ð ³™ ½€Ò…% Ð hžíмÁß”Íl÷üÌ=W@¡_C k -n‹4Ö®èÆŸ'fú€À'ôõ ê@IÑó„N`Þ똀A߃]–Ì:ya½€ÕõS@¡°4z#­F*ôFZ‰7Tx7M-œÖ4õÒÙ`•É´AáÝJ÷×}Æ¡g ½ ÆL§ ýÆúæ Ÿð†¹™Dw[¥¼em•@'`dÀÚ}@÷ïk¾ÛÅìvQnXû»t¿™ÐÅU *Ô)ð 8ðx Œ£•Pî$;rƒ‡‚NEðÎ ­]®ùHqÙ:$–ERkÞÚã/o蓼‘&q¿’ÜÒxàªÅ Ü‰¾‘CYîÕ‰‹Ü€Ýª<ÊÁ–¤ð¼<ލ¬8’Æ7)q̯ÈyÃÂB2ÈøØsÞ+Eõ®[,rÿÁ •GŽ‹: ÝÊ+ƒÈLÇ2§°x®‰†H$ý×&·;(¸äÎ>"—K+'içe°VZ²± {L0#*.¤ )7^4K±™ò`‚îI|¹Hê&n4<ÁLÕ‘†ñÆ¿ˆ}pÙ ú0»‹þ…JLöÔçõ.«j`Å]jîjïPRLŒO‰ GÚccå’.©S€Q×&Fè‹Ø@‡ý¿DŽA:ˆeN‚¯ÄÍ—O¾ ¹XEë¯é}6"JyþS¥^bè»IQ…õêR¢÷Ì2_Ù%ÁM änç=4Kd9o¬¬ùB‹a†û_‚¼‚ø†àJÇ(p{YßI3àöâÿ‹…µÇä3Ú»ëÛÖ›ý]Îl³ÎÇìå5~Úó¡[´¾çKÿky¯Gâ;Ö¶×+¹ßºžôç÷zÓßKÜû!¯8ÇÞ¯„-¡Ûö“ní÷›çKíSà­–®§ú oª´õ§Ô²ù¯ú[jÁöCýQÎ{ÙþÊx?3^ çïé’4°ÎqÊû¼0õ°ÏSª…۴ά·ÇÄb%íóÊ0Òê>Ï/ë>_, ,ÉzÌxeÿŸñ$gßâ k•ââÒŽœ¯R1û-ž!lŠÿÌx‡ü#ñaÆÃh¯tg¼Ô×;žòÚµ¸xË÷³ÑÅcÄ«R\¼ÂFWb[Úù€©¾¤/˜f$ž[>á+½w¾‰dÛqç£Èeí;_EøKÉ;ŸÅkX~Ö|ùÆ´î|yuŸw¾”cçS¾Íókù–iXægùØÒôÊ×n.ñÑòyÄ~kšï#ò­ø‡ñÞê|•/Dì¯ø¿ñ‰ˆ|ß߈p{É_ÆGøV\×CùJd .ã)Ÿá%Ä ã;¼o‰¢¯|(†¢ñËè¶O¶WÉ‚…8ƒ2->£¨Ò0ø¢áÊÑèýV |¿qÓ•Ýñâšmßó3ŽU®'aƒåî+ŽÄ[¢UO7Ì2ì↼™MkÜ7¾cܰÈÔ↥ht7n¨ïT×dY95·Õrï\«ÉMæZ"䩯ÙZÃEt/m/pd/¿WÈMÊÕl/›TŠ{¯›Ëxƒï}¥uãnæKXVõEó5¾€ Îq$js¾:‚žÍéË#›¯˜¯Ë¸§¾¦ugeseã†ð•æÎ¹±pÉ ±L5í³J.¬¾oÜ\8]û¬³öyÇr_+$–µKëš59ÜÇ¢œ;Z¬B,Í>–«¤èbB¢rG‹…Xf‰3VÂ]46[,­á>Ö’»\.×KcόՌ%>–#Ö(w´XmPîg¹€\&¸\miÍåøËå¸!Å4—X.Bn.?s¶)9n(Ü5¹\GÊ0\.„¿(·°\ÉXís鸌X®Å6*·3n’å^ã†8FÊ%b[ƒç†¼3.› ðŠBj‡É ã¥\~rC+ܸ!¹¬ÌǸ!ßÏznH3d>Æ yªÜG¹!ü¥{n³äƒ¯É ó0nbÜ×ù2ãZ03+7S.Æûm™q5Ö>œÏärU^Øo®W¯Éý” Òmôäg~ø³?/^kå=kÝ—wØ¢Ãÿ–œ^"t¯¿;ÆúÐO~ }!7¢‰þöúñø(~|¼þáöùk᳦_)OD3þóúÕÎFŒzå#Yïƒ?ÝÙšÏwRV¨×;ºO;釆'¿~œf0x;“~ kI΂_ôòïßþøÏo?†iÇGoþüößo—¿ÿíWÇoŽðñ7Çë/ß5ï2Åÿ‰3‹L£Ë5bÓñýç¯>ÛÃ?sqžü¹ýù)ݨ endstream endobj 4034 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4037 0 obj << /Length 433 /Filter /FlateDecode >> stream xÚ¥’MoÛ0 †ïþ:Ê)¢>,븯Û0`C|[wP]'ÍàØÛ’æ÷ΛÑèlÀ¯HQ¤ùˆŠí˜bW…zF¿ŠÓª’u¥™­½mX{(~ÒVøäˆÙ2o]ÎMŽÕûƒVìíX|Á÷²'.IÅ,ëë¦X­c^¯€5[,m¤³XÚWÒaÍ-ûʯ•S?P c_—uÍÇþV´¥Qü.»Ž6ÎGÒã¾Àw%ða­ŒmãЦ«øvüE1»nè¦ðý@)äÍ=ž1W¸ Dù­ù€ ˆ€M[úMwÂHgùxS ø÷®=É÷,àwÍ`¥µ†©$8ÿİ@<峤KÂ2}ÐAû`ç<Er×ÅÓ!þ cÜ’î#2<ˆ¾;'ú]OîõçŸhu.IìïÝdgâiû~ÓQéË= Î|¨‘äÏ=<|Ô@ºþ ztÊù4PN†j ôfšXoÐ$@“‘€&m68f›ÌS‡Ì3y‰gZÍy&›&Ø›Ì3{áí xþ;°«µ,`{ºJ­ °2X,Ø=Ñx!¿^Q( endstream endobj 3985 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_volcano.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4042 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4043 0 R>> /ExtGState << /GS1 4044 0 R /GS2 4045 0 R /GS257 4046 0 R /GS258 4047 0 R >>/ColorSpace << /sRGB 4048 0 R >>>> /Length 2035 /Filter /FlateDecode >> stream xœåYKo]5Þß_áe²¨ë÷cÛ *U ‰­ªpiK«Üñ퓆6 —‹œè›ñŒÇã™±=×›çÆ›÷æ—Ý7Çù3Î:ÇŸÃòï×׿;sµ{|ýí³'f½ó@tfý^ï•ýôìöÙÓ¯‘ZÍŸ»ï_g~ÜyóþÞïœ<Ñ YE¤›F+‚ÚOY‡Ëº íÅ’ºðÅ.‘]í>Jð°7ŠJå0‚§3@K¦BÒ–”ŽÚ0*ƒ ±©œÒÊC‰JU9ÐÃZìÅ€6¹dÈ­¶# <œS LJ6r J¦5åb}%„¶dp~QD¦¥—Éot,ª¬ ÒÍ£…)ÀU6ÐÒT7!-s _ìÙÕn­lsÄ·‚· Ã–× ¬ ²µUô=Ö7VŸ¾ð¦ítk$JƲ`Oº í¥Æú…/v‰ìj÷QB®r¾`µ€Ä:L”+È;°¤ì1%}ë¶)ØK¬ƒ in9¬UËf«È€ô­ öb@Ÿ\6åV[õ¤¥cn“MZ&°Çá" ñP!pÖ‚©À`/gršÜ†¨r H«ž›H€Š‡\À¬Z ðPžS¸lÈ-¶%#Aoë&šñ°RÈ(S•¨ÒÁÚò@\g`é ¿ w‡¬ C¥‚D‚à;,„€>Ä*WˆœNÁH—É¥Ú¯r H+e]æUÎáKNµà¡<§pÙ‘[l=Îõ"bNëÖÒ#UO¼÷6:ûñ–˜âM)6.üН¹!;Ó˲P ¾¶†,=x‡nBZ¹ó»DvµûËäð˜ñxù:,„€÷/ªó ã4±tU ah 7HôW?iÕ•r4ö0䙢•€|S‚ZÃr«­Ç‰â‚5 _Ê#ŠE"r2&²/²y ½$§É‡K0ÔZ•H£X(‘V¡²±Ùä†nFóeá³]*»Ú}œE´®¤«ÜaC ÇCÝ«¦TLV¼ã4¼aå|7ªœ§ÅŒ sQ妩jMšÅ:§pÙ‘[lÅÅÿÛ†ä“sö_C-}½è°£7¿äÈ/aYæüé£H‚ðJÎÉÀíâóü`NÜ©9¿ûâœfø¼ ‡½Î,ï'"œqŽ$Ëý$cˆxqCÉ®’«oÐ1Ó-OÏÀ-ÔÌïÇ-×ú•»Z"×^5¶ˆ;šs›^ÝäÞܦU7ù£5·éÔ!ÿ>¡p”åró/t|Ý6Á¥¨ìMcpiþÚ\ú€Êß´—6 ò7]ÁÕG‹ú˜±ä‡ ãèQ¸{Ü{i Yœé6¯²w– …dSòî“FX,:wˆÎµ>´ÊÜZ®Õï·F0öpœÃs¤Jæ~rùámxõæÔÀ‹àäÃå¯ö?]\½}}úÒœ?¿iÚƒÌXæ~´˜ä#¶<°_ ò,ñîÅÉϯþ85!›“‹Ëß_¿8½Õ’Oåà ónÿ(Bè¾?CåŽ ÕBdþå?܈OE¬»”|×ïÞ^½{ónqõÛ?EÄ­“÷ÔÍú¥…‰vð÷(A¿Û…ÍSÿs«‘ã)kwkñ¯eÍÀªùú}x¾& JÀÃ>ÁÁ3*òïI‚ðL/JÊ环È*"Ýt3Ú‹%mP†],»±{½2ÜwK°QÜý¶äÓwÓ?>tKð]“6[‚ý«4Ü‚¯¤:ÜÆhÝå³ËEVé^·Ä|¤ YjÝ£{:æf¾ÚŲ»o»Å=([o­Ù=QçY蔫W>W´>9þDã¹Fþ•êôëë{UҰx£€–KøÄw6ëËw?üúá¶íòâú·ëÇ?}qöôn6îþ[mbt endstream endobj 4050 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 3986 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_isoform_heatmap.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4051 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4052 0 R>> /ExtGState << >>/XObject << /Im0 4053 0 R /Im1 4054 0 R /Im2 4055 0 R >>/ColorSpace << /sRGB 4056 0 R >>>> /Length 1624 /Filter /FlateDecode >> stream xœµYÛŽ7}Ÿ¯ð#(Âø~y…@""`WÊâ!€vYÁFÊï§Ê—׌«½%ZMz˧«\>®SžÖâ…Ðâ³øzx}ÇÏãÛ7?<nZ*¥Äx½ý𥙟^LÌOÆÿFñ÷áí;¡Äo-^ÀçóA+ ^•ïrqÖ _ß~?ˆ'=ÃÞIã„ÕIZ/l4Ò$'~_æ1*™b*1'SQKDÒE‘¤ñÅÉÇnÌÒΘ¢ ‘3f/³åŒZ9©kÕF:ÇZ’!Ÿ[ûì²Épp=ÎQ›$óä‰&9Ì ŒÒ(3Ï¥v^:ÏFî­Œšµ-ód!¶Î+i3ú‹JšÉúl1™bŽf1BTRÓü¥ ãd5ùK›÷#&;ø?I) 7;ú1Ê"™Ï0}&>‡²-ÔˆÑZº>DHd)‚É2îñA™’‰q>8¤X>À|rÉá±ò˜€³ t>ÎI?aÉq}<®#yóFÆîÜQ° ðMM¸³›ë¥Ùá2 Š]Ó¥ßáN_Ÿ0b’—qÂäKagÙ¯J{ÏßÔΚF‡9°n\S« \N¸£52ÚätæÇBÙõSކÂhSs}‚I2íp'Dô£ýÈk¢TîôjL<[k½´î`Å,ó){û$6g¥ßáNÔèÍ;b¼–iÊèÖLrŠÞl>PZ BmÎç@Õ&Ü?e‡š8YŸ¤ŸrÇ—ØT“Vâ'Á׸3òÚf ;jæ'œk±{Î) OÙ«ˆô©ÎGšÎô†±›o¼î˜¹nϵ¤a9ß0%{1?ŒÊo[ö 'þÛ„\)?AÓ«/f;„H@«V¡lò¨í÷ -ß–zÚmjª‰$œëŽÙ³%{4L1oK:ˆë-š™k#º™éš™kš™ëª™“ünæÔ½›÷…<•b|²¡VJŽ‡Ýž­¤¼y¢ …–'Wö»·´ódðêá§æÛœj½4‘‚r^Ú:g Wz’) ­ˆôè1ÖÆ¡wÐJÑ‹:CRÎKz-Þ˜¡,w«é ¤Ó ´/ê±´Q–Ö1NÕOº!º}yY¯µÒy? o¥ë3–óÂžŠœ¹ì&žeße/íõ`àU˜xbµ½ÍÆÇ h!î©\] ›S÷“ŽªáJÞsêRZ1×»ò~vÌlæX^­Ü¹¼Z¹ƒyµ®Ä¹iRS¿Zˆs;’[K@ q>9·uо8ÇÒJÚˆçÞtž ´çXÖÒiêiWœOE¢ƒV]—ix«“ …jš‚öþ±€œ¦)ß=û3åD¿™9ÑïfFô7ó\ô»y!ïÓ|®ä½ƒÈÊ­ä½i›'›e%ï±pÒ&’Oþ°žTA5Öå ´’÷ªŸ4+y¯IÊû¥¼;rîl ¥¼×îày/¿¥¸dα#ïå>& …¼—¢†¿Œ …¼SÙè ^Þuh+tÞJÞéÏ ÄË{éDi#ÑA˃;ù¡¨ƒØ“{iõlkÃhöXy¯%Z»<­ÎîÕŸ¦sâï…@.§óDpò~×Wÿ×çÉåñ—~˜iéô×ò6â9”dqù±ÌI<Ê¥>nïB@H—‘„—×âíƒçŸÞ»yÿÊ´xpõëí_·߉ˇg—ÅÕî³t°Öj{؃O¯.ŠËÏwŸ%(äü糋§ý_ekñâÆZT=ƒ¡€öA ÐÚ#/éj=@Mƒ? [Ñc¡SÂ}òáº<¹Í°&¥ÜÃÚ"¾ Áx¶ÛþýøÇk%¾¿9¼fVõø«Õq«mÉ> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4054 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4056 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4055 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4056 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4058 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 3987 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_TSS_heatmap.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4059 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4060 0 R>> /ExtGState << >>/XObject << /Im0 4061 0 R >>/ColorSpace << /sRGB 4062 0 R >>>> /Length 1188 /Filter /FlateDecode >> stream xœµ˜Ko9Çïý)|L„0~?®É´A `Fâ€8,ayD ÌJ|}ªlw·ö#ƒ¦G=®_W¹ÊþwusrI8¹&ß§×ü>9¼yvF®§Œ1’WßÒðù®2¼;‰ÿZòsz÷ž0òqâä¾×g`@^LÃo8()²ŸÿNäl€¹âD+*‘ÜQ©‰´‚ vä-ùv?FFÕpäZ†…¢ÎË)7Ī,áŠZ¼|Zë•ʧñØaúÎd gŒj߃ ,“Èq®©äæâú€0Q.‡$ü#ªV:˜³tÌ †ªî æž´ÞzÒžÂk˜6ÉIJŠrÛ˜“BOÆn!çê)O2ä« $˜¬§<ɰœÛB¸’j)_ê¤<úƒcIYOù yƒã"‡”­§|†\H¼‘…'#ê)_=ñ´j3ÈÚzÊó} þl‘Ïë)Ã’jX/‡q0º^S ÞKn=) e²ë Ëè`ff½ä6<]Onv¬žÆ4ìU_œÂ•ªÓç˜ =ÖŸ09YË ‘Å-Ë¡4T ǰbÊñu$“ö>n¢ÒW[ƒ¬ÑIç¶T[„\vyIµUÈýÑBW¨¶ 9éƒäÛ ÕÖ!dK9±¥:B”T_å2>SC% ;L‰ÒW_Šî/ü™jjQoÊNï+LÔ¨„)–qSb*¬-c j¨<±~Z•T_z¢8cýLA µGÚtOÈ©¾ø¬;ÍTK}_áîû'§Z¢T¿õÌÔH«¬ÆyÉT/Á-……=Öª|A&h¨U±‘,‡ÆÝRÈ;´}ÕÖªd/Š~$Qm­2 cãJW¨ŽVI$ÛgJ0Sm­ªéÇLu´*dC¥Ž®¤:Z•"Ô[êH­š©¡VÅ6zîe5l›x\!ÅÚ÷M:ìWÎkØ8YCbfrj¤k>tŸ¸ºrj¤k^x;׌êšµ!ÿÞTK×pFho¸È»ýDõumÓ%j¤kÞÍú›S}]kùj6[i¼¥`}‚ýSß³ýúà9?­Çðp|›“ì?ÅGÜÇ~yä5° 4Q«º¿%ïN.¾~øq÷áv&9¹ùçðßáô=Ù_NO÷ÁU÷ZÜH å_.vòõÕî”ì¯ Ð*ØI+üåéî|¦ÿ¯l Þ#HéáQ¤L`(΀Þ•×î^µ¿O JðáD*M!U¨~Ì’«Ûpå4Ø”p³ø¾OàÚjùûÉß·Œüu7½nTu}‚^wÖ’Ì5ƒlI¨4nÄ”¢Þ‡d²Z:¨`nýåÇ¢ÂPnDű(hmª¾<5PPÕ[5Gd–óÒ]> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4064 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4067 0 obj << /Length 277 /Filter /FlateDecode >> stream xÚ…QKO„0¾÷W̱(}в=úÚÞŒÜ\ìÒeI¤¬€ÑŸï”BÔx°Mæ›Ì÷Í£S pØþ ´HnØÆHPB0“ñ#o„åÏ,øáÎÔš¶²ûN*¸íÉ#Þ•KךéwÑë’d[­¡`¶àÊ6VLçØ˜ Æ”5<Ó=×¼B#’TjI¯(Z;_}“:T] õ§¨˜Î.÷ZMmïÇs{‰ÔÁR7%h?Å©s>j½¯ÛYœ¼”8rjñ™:Žp¨FW'©Ò9í}ĹIpÜçepãØ®D˜"`ã¼£Û.Táæ}Ï•Ú!ÿä&Úýùˆl+-Xf4a-¶`y±Átô²i~¥Þ•ä HÍqé endstream endobj 3988 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-geneset_plots_dendro.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4070 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4071 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4072 0 R >>>> /Length 409 /Filter /FlateDecode >> stream xœµSMO1½÷WÌŽí´Ûn¯0!ш»‰ÂAP#0²&þ}Ûý(-ñà=´ÍLßÌtÞ¼ ˜€-|°¹[×ÕÃÍÆãÈ9‡x/ÆwÎk2øb‹%pxffnm™ð¸e™E® W˜IØCcI-ÑXØç÷óΊ®…â(m¸oÍ`5’:3PFÈOZ3HnО2´f hQ£²åh]ýÀQµ>°ë)9BË×Ú‚ü~ÕµG 4 a®¡ÜÃÀ;‡PnÙ¤¬³ÿ*\PŽFtñYÿxÏ{W_ô¯On,ª«/ú×'?5ÓÆSÿúÒ UPêÏ·Ú3•›ž"4ä*ZÌŽ/ð‡ËtN\¢uoÐNÆ©DBM]Ë$uH¤öó$”K$›$I]B¹q”7ßðå’ôjª¿jé9] ¦›Õñ}5â0Ø=UŸÕp 嬥ø¿éMÚtmK§5ž´º$¦÷,‰”Ež$I]%ùvI*ÿWiî‰^±›û¢‡à¥ÿj”FSgð6)ÆAðìjK)P endstream endobj 4074 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4081 0 obj << /Length 1307 /Filter /FlateDecode >> stream xÚ½WYoÛF~÷¯ òb 07{“ œ­knŠØˆT @]´DIl%RåaÔýõÙ]J¢¼V èƒ =æžof‡4X4øpFÝÿ“³·7RL!5&‹@É æ ¡"&óà·0EŒQÞ–ó⩘wÙz ­Ãy™7£ß'?½½ái’Tsü4ˆ8# K,û÷å(✇Å;* ±ûêq)þ‘ÏZ{0Ë'\ð$td³:ÏÚ|ÞßÀų]w Ø#–K<a»Ê­yJ˜Ç%¬“Ì4æ-ómx ŠÂyüzëž~Ñ•³¶¨œi‹ª¶‹Ìþ-‹§ÃÜ]Ÿ/Aô´˜Ÿ;ëÃãfUÕí´Ì6ù9Aµ¶Ti@¼Iª”‹øÅ¥«…ýŸu›M^~Fw»rîLÖ&'1=½É”+GtF‰b;¿ž= P„íÅ="$D’õï<8‰uÒPOpc"EÿŒÙ¬:ç¦É>,²uSÙU× ¤ ‹¦‚Ào °p eØ6ÍtYWݶ?6Ö(gÞÀ¡]?ÊërÒÖ ®ó¶.ò§‘CÞ¬ÜbVA¨k uA7ÛÂUV€g@šIc aTºÄiëÎ6« ð,„—êBH ue NBå‹ÔÕßw@ÌU¸yFœÞÎ/£7÷hÅí§ìQO‡€Ð_Fp¤w Ÿu‹ÅE/«GüIžê-t%~2m!#WQ6m†Ë™;1U‚‹åŽèןﮦ”RsŸc¬ K‰ònɘËðöÒ¯«¶1 dL(4²ÁuV–U›™²õ0/ £tµíe»;—ÄÅöϧη7¯\Í‹ÅÂw>«º²õ]887ÎIŒæÉ˜1ë ¨»€b/Àÿ¦øÇx£8GQ’B+42<#y$ÈÄÍ·ÈuA¹úñ¿‘{„û¨Oý«ˆÏâ~층¤ì ‰Ó—Â{k>žmö$QÂhWGªd¨ê¯.+Û)¦EÚ®qMÕC‰ŽcÞ}|-*ž[½whûU=÷u…éÿ¶Z- ø (Ü¿`{ ¢hã) Ú 'b ÜøZ0N®î>1ƒ”0$t‡É!9gÒä®Oàuß3H”P’ð¤Ã4x”/2BãT"8¡‰‹5% ‰ã´I 8LŸ_¶üÞ\“4î¡/|¥·ãAéW!_÷äXħšö;­‰Â’†©P "’Ô[]ê„14VÌrh ŠHKSePl»B³É ®ÐÐ;ãðú£Oø3ÐÆ)xgB˜†—)Ô¦þ_ªXùªØ—¸×oÕÉþ û,3ïDLb7ñð«bŠ ZÃð(àýÃ/#Èûv £b…Qh¯yQ$Ã^³\_Fùß[˜C“Žª¼‡¡fØe|fïØO rË5ÅÊ75è8–£ ·ëbXÍûÉç_®¿0Z±§  ÓYÝF¯óo¯Û4Bó6wT°ÇÚb ~?ù²1Ní>p¾78Î8bÀc›¸dòxÀq=9ûØ\¸Ø endstream endobj 4089 0 obj << /Length 632 /Filter /FlateDecode >> stream xÚ­UËnÛ0¼û+ˆœd dø¦$=¤‰ƒ¶ࢾµ=ø!»d˵‚>þ¾K-eK–ë´MíÃ.¹Ô’3Ž8YN<ÆÛÉàjd4ñÌ[iÉdI`àdʸrd² “WCj¤IV›/*¶Ë¶×tHE’ýØî²ªÊË͸(Ÿ>qÃ_ß}aª?²M#q ù|ú”U7“01ü)«lÑ£Ík¦µ"R[&ü?ÑfûêÀž´Õ´O›LHØXfR mÅaMW0Žâ°Å3Ó¢À$¯Êe¹[WGe {í@Žt†E5}ÚZÜòFã?ãQ Ïdú]_~Øó‹(?çºòƒq”dµü Ö? ?qŠ ŸWã> /ExtGState << >>/ColorSpace << /sRGB 4096 0 R >>>> /Length 1195 /Filter /FlateDecode >> stream xœ½X_o7 ¿O¡Ç䡚(étÒk‚fX²¶Ùl`Š"pÝdKgkœb_$Å“t©íÙ[Ыù‰D‘É+¨sêN}î~zÙŸ2Ú˜¼xg›¯Õ/ê¡ûnýó÷'j¹î7j×õr$ŸÎ6g§oiwPwï?(£>u Îñw×÷¦Û~t§NŠÞiU´3ÊQG«œõÚù¯L4:Y«Ú•LÜ%ß©›»‚ѽ«W0Ï®•'ÐÉ«Uç¬ÕÞw3!C°:ô•.¸2Xç´ •ApepÆ“' ƒà†aðzH CÆÄ0XdÙÕ¢Œ“SÔ†Œ“CÔƒmLθ±È%í]cQÆÄz=‰ÈJC§…ì4ˆV'Sè; ÷]aØ0ŽF=¸#™:†ª7:’”h±/{ÖöIƒGWâÃs"%ÕˆC*GÆ€–ßꢣá€s>9È[€`à2l¼Qèbµ}&Ÿ7Š|¥G¯ã€mùÖ&èF\£Q2DyùŒ‹x%®®+½9Åù€y'î\µ;ŽL#”zFèâ|FKâFA0•Žjb‘ë¹yÇ蘪¬¡œ-º-Å>;ÓG»²ìÄîewƒü@Aó’)«fÕàÓˆ@5%&òûKfu¤h¤¢3û"—kͬy#pS¨Ù‘klÍæcFD¨y_7P©SÉ뀖ÞŸ:(Ò3Rz⣜Öʬ².Š\Jœº¬4ÿÍŒ|¢ÐÄ”,ÔJ¶O[€þùñXY£Žîë§õñ5?—¼Øëw€76æhÔ=¾_Ëã]ŸšÙt¡Âø^ñq’°=X؆^ûÄÂî`açf& ûFøÅòÙcÕñušŒF<Èdú8 M&£J/“Ðd0ªô2Mæ¢6ã÷ÿ¦^[ 0õdÆà#Í’=Fòäz±úëþúêa±ºÞäÐÎkyÕœ 8»¢ÀkÈ?»¼x³é¨Ý5jë'‡ÃáØb‡vžš8ö Û+ïi.ÈÅüÅ=èFǬ\ÞäwýôxŒ}J-–Ü>üvuûië»n?Nð!´k¾LÖ©‚IA¥<Ê:½L“ç›FÛÝyîH;zÌ'þˆP®÷ü1”ñ½R³o~ÎΦ:áhìñÖ÷4nloÁÿ3×`H”k4‹úo“k&I®}þ²xxºZ?-ž¾¬·Ýh¿$÷H²­¦+å|Öäk´Ùé5ôˆBþX üYä±’¦-™;ÒwC¡'ú /²‚Xwæ–Çže­[u3ÊÜr¶ÐÅ.‘mín&ËÎCHfÌÃw‡”¼CsÇ=Ë—ÿ÷„ú‹ÇÈJá½üáíìeF÷ÇNÄé endstream endobj 4098 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4076 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_plots_replicate_line.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4099 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4100 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4101 0 R >>>> /Length 1379 /Filter /FlateDecode >> stream xœ½X[o[7 ~?¿BÉC5Ýuôš –¬—Õ6 (×MÖdv¶Æ)ö÷GŠÔ夶çlA|ŠQä'’ŠçB‹[ñeøåyBI¥èã¬éþÜ_‰_ÅÝðÃæÝ'b¹4,*Ñ7ËÂ>maÏN_ãjï?%> ZœÃïvÐy»WÃî­qRtVºQ„(­&Žr4Â'­ûÆE%“1¢ÿ¢‹ûôqýoGPÒÛvõèd<¬XÖi5“«aÆl¬Ô±ñ™nÆZu`º Xå¤ñM€éN :S'@4 LsÀ™(“ê<"ºs9Ò¹N€èÎå0Ê4v.Ýyd“ô¦óˆhH^ÆÀY3e“–6УAg ŸÉNÀDˆ¾­Lv*g2†•Œ6æLÒFZò‹íŽ#&xU¬˜h¤1;¬ œ ¹ÑAÀ Ǿz¯—3 a‚°3wU¸:É€6?ÜHöV®ª^ªPµ‰W”c’ªèj Æ(’¢Ðó ’C,®€ôzæ®êù ³aªKº‹(hßô‰ÛôÔŠõ „\A*ý.t‘×9ãC+•/üS«"§³aL’I7®~²Íó[^Lc*6|’Úȡ،xÝ ÝA¤I­asÏ "¼Rmt:æjáµè¨N³Cd‡ÓÊçxA~}¯O U¿ñ!² m4þ¾ 2„B·{R+P;B§OtUoìßöEøŠ|S¡"0Ð×ýŠ•&ÑM†@ѸÈ×"SK”ŽQùáVt •mé¼¢1ÚUWIšíL-Ù“¼7ñ‹_¤;ñ{9\ƒ¼Æ¤9¾Ãën.­Qcµ|;¸“ì@,³¨•)V.ÓW="²U¥…ˆ°f½1H?«DhÞ³pÉÖë|%÷£n©-Xé3Òx¥Þ›\¼2%¸®r£Œ¦ê1‘­fQ^Ðx ‹ÔµP­f"‹òžÄeoH¯÷ÝŸög®¾Ü`u”FoéÏ£×¢ÿ¶þ¼]ûóÉa_Ñóìq‚b~-R#ò'“ÚÃEÀ¦«Í|-Ž~ûùÍé%\¸–Çb~;¼œæþ³ íýÕIПÓ¾ßS'nª·ž´Ø¾§2{Òbû–ÊüI‡E~q’Ñ¥Óæ|´ï$+Ù¯©f$ÓpÁÀb€‰ æ¤Ü¼•d é½ºй³òç—³Óƒµ ]>6í÷Gg7ïÿüx,ŒG«ÅæasüAÌÏýž­±ÕhFîÚv =ÊhCø6OV6Ác/BeûdekV|Tvò³áÙ)š³xPÌ­yÊ$~™S'ckã×1u2µ6~R'CkøÃó¿­ÝÖ@j=$ÑÚÒÂŒ‡‡ÂHnë¿VW—w‹õÕ¶€>a¿n“ÝÞ0©Yƒ†ÞM¹;{{ñjÛVûkÔÎ÷ …—‹&möqèðJqçY*æÏAkGİÊåÝë‡ûcèSâh±üãæî÷Ë›O;ïuÿr„! ÿÒaÈ6@ê–ò‘¿ÓÃt8ßöîØs‹Ö!b.¡ØZXïòK•蕳mîn{™X4€©XÊ7ÌdÆPœœ­‡tµ\ù.àÀM“õ÷>ÒÀÁ¶’dƒ–æq¸ÙÝíÿ'¬ñý°†Y¹ïk•ÖG_¾.î.7‹‡¯›]': ÏøÎ;Ï;]Â:²€/Ϙ׺âñ-iRùŸ!?ÂgL-³ô˜'âÂOøß˜ªËT¶MÒ¼bsdŠ®Ágjµ)’æ½™Ï~±nïw7Ä>35<*‡o.žR]ŸŠû;–þ‹†­ÌAf¹Æ¿ýéõ…>ÈáQ=,ä endstream endobj 4103 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4077 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_plots_iso_replicate_line.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4104 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4105 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4106 0 R >>>> /Length 2010 /Filter /FlateDecode >> stream xœÅÛN\Gì}¿bá!§sŸs^ƒ’ª‰riAêC!B’†t—6Yªþ~í±=ã»ËB@Eâ /ã±=¶Ç8óÂ8óÕ|[üú¸¿ÆÖÒ'¯þ|ÿd~7—‹ŸÖ¿ýüÔœ¯­Ñßõ¹ Ž7 ^ãj1ÿ.Þ½7Ö|\8ó~¿.\ÝîÕbûÖ ó´)ÃG“Ë@²WLðqñ†Šv˜¼7ú‹*îâ_˜Ï·Á)ô#ØkG áÎgØÎ¬®¸!g—‹c&ð.yì w‚`óc'` æ6$ò줨 ìÒpy´J‚•>Ù )+}Vú$7u"†‘,™<ÛsÅP˜€ŠÕµ°RžAMË»­¶»— ßJõmäÂ4$×å:zMÀÆbüi‹Œã­ñ) £ëÛû”‡1 œd‡œßåÂrA‡}ˆaÁÆ¡è#€JÅwŒ_v<±ˆ @¦úƒšYŸ' ÷ADš¿lxøS]=“ð’‘ñ’Qñ].{–‘A„{NƒóÍ.Ã5Á] PFÁ.ÖÎÎùÊÔù]"ë1?a¿†Òì}µMSm™«x黜à˜Â«•&CSXñ–ë5Ò(° ÛN!öNM–A+]F§»@l:0‰ @P;Ä.µDJ{–µ!>­+· ÓTC„]Øv®ÞÖÐ…l¾÷W nÜQÁVá# J%RZ€êV_•-R+@¤´gýŠ6•o¦«.µüô¢ü˕Ҥ½YiG(ÓúÛ_º›ù±Ð>=FhcþÖWüsˆsòÙLíE^?„öœ&xxÍÊœ½y}|jñ'ŽöМ|]<;ÙïJ¤Û“ûm§€û[ ƒcJ[Íæ´Ùn?ÃSíõÛÚ2L$x´þ½9Ú¹Þ–ñ R{£GzFÀèÙÈ@¯'ˆÁ5Ê»¡z§g>ªz=™š* í–…>òH©.ºx{,~AÑ;y^x§˜¿<;>ÚŸ²”œÆýîàùŇï}8„À1˳õÕúð½9yÁ!òø“n’M>k.u3)xÝ[ê^Rðºµ|H—9¨2ÅÝÓg>s¾¯Ï|‰Øz>¨Ïîa–MÙ&Ô ¾±)רM‡ÚÄèFðŒx‘ÓAzº³‡ö%„ÊìïÌâˆó.dŠùÁÂzˆÒ_jzxZgÛÞi³áiÇ·WÚlvÚñí6ê ¿{lj8›9›Û“`|»ÃË©àKí¹>[ý½ützy¶ú´É¬wØOmòDí#m×îøüíËW›¶Ú°¶þo!8~™i”0LÑÀsÊÊÜàÁ-¼ÃA”‡­`<Ñ·Î.¯N×WgWÿ¬·L?"¾pû·ž‚…Æ +ñÈßù)nQÝ€vuPãá}PhœÔVFœMx)cÿ¦:°Q aCB%5¼Çªð Td&ØVrÇ o³4ÙIf‚mo‹^Ä;Ó[õ»÷qÜÆäA‘póˆ×Ýöæå>a¸_øa:Àá dŸ°c€»ýÈñ©‘âïÝÁÕ÷Cè4ÌÁÙùŸ—œ^|ÜZaö C,Ÿ{„áѶÿÂìζÁEbï‹! Rë?ÃKcŽ·‡ûüß4Á|܉¤…„œå¹F€Š‡ÏB–,x|Zå‰'ÿã‘vy dügÈ^Ø4}ÛK]7&¼sM]†·©»i>ÇIÍÂ#ÜæÔ= ’;ÞãòV<ê‘6¡`0qBÙúäýÑR¾k{°¤·»ŸŽÞY„ky©ÂÔ×DV.ôoyýr?5ÿ [¤à endstream endobj 3972 0 obj << /Type /ObjStm /N 100 /First 953 /Length 1482 /Filter /FlateDecode >> stream xÚíY[OG~ß_1åÅ3gîS¡H ”4m¢©i›õB¶5^j¯#òïû±MplŒk òžÝ9×ï\fØ5É%¡„I?|!áù¢E⋤ùj9¾:A‘¯Ah&¡Á­ð¾0Q R,ÀXgðBÇ D5‹Xð¬'Da+†Œól)á‰e ,{’´ˆVp/FbÖ$’f™'Ô”% "«„U ¶5¼ãÆSà3°*Àý™Š‚‚v `Œ¢J(e²m„¥‡f­p Ê"TòJgÍ”„6–Ÿi%´ ¬xhgAiP‘½ÒˆÊÃLêd ?ƒzE쩆zå2ÀQ!Ë "ö™"Ëš ¢'@ áÃA¦¾ÖüŒ Ï:Íq@ŸMlƒsäŒe |.ûgÀç#ûl¡%D–Í KX; ”›Å,9"Ë ‰mpФ‹²ì)CÕLáÖ&V­Ë9Èz¥fªböµ6¶‹:sʰz”šS.ÂÀv:²÷& gr¶dg|ÆÀ gU–ð¨,ë«(£H¸Àêï¢e-¨:=óÁI¯ÁjΓaï±à)°,RæuàØ¢Þ0‹Þ¢PPXÞf’·EüxŸ1F…øu!t×TòÂ'ËZªçþ•DྀFÔ¸á E¨vü€Ò P: ¬>T‡ÀÙã¾ ‘$„bTEŒù/,üiOºØß/ä¡81è%Þ ùñÏ¿4¹^ÞÃÉ`pZ¼x±šÏr÷õ¸AøŽÚa'ö÷…Ô8òÝá‘ÇõU'®u½¬±Pž×…<€þzØydùB¾¯ÇídTÕãéàÈÏ~«ûMùª½' ¬IŸÂP9‚4&ÑTöFp<Œ6Ba‘0˜[!@‹Ÿvy„VàNÝðtóLÒäwD&­@&lL¼™oAßà»ÐÀX ר°L˜ß`T-µ5‰–áˆik8’Ú°PÑû*ö,ù߸aZ&Íe”÷#³#V~«d·Áê`T—]ÓË®?þ¬•6^–¼ÓNíA]Û¿uí¸éXy/^ÊËÏM5o'Ýå¤ÛËaõ'U=âUÛ3=Ú›ÙjùÑÞb| o!?L>uù–R!//xMòU9®s ä¯õàKÝ5UYÈ_†UÛo†çÓ£Á,¤ùæà€Ùûü8£tzÃÐ\fªòZƒü£¾Ž›oˇÍÙY ¼Úì}ò¢NÆ"yùï¤íêA}Ö ²Vö[ 07ò|T~©eYMºZVͨš\œ ê+Ù5ƒ~-/ÊjÔå§Q ˆ”U…TÈ~ãf,{öë×grÛ²BþƒòúáçÉð¼M.夓íy;¬ÿ‘UÉúÆ—eUŸn”IZ“Iz@™œN”¥L’~J™œŽ%·éür‹óËø^Âiî¶ù…“+Ùå)µbóçA5?Là–Oϳù¶åÜB—ùL{ßsë±T»Ö+«]›ç¹5Ë–^“Iý€2iÌÍâœ%íª{ý¡ƒç°ûR¨ž1f­—Æ ¼•¡*ïPŸÖÊÓRûÄfn~%°ÉÌýŽÑò„=²t7£±º§c¼‡áÌï_¢¹ÎüÎ%Ú݆³ ËÃÙ¸†3þ£§§³YÓÓæõ´M?°§7iÙåžtêyg˜UŠ]SEöU‘ +÷xŸ3ùÈ2éÍÊLú§·O¿á>¹ÀÈû¤íùîf4΀Ñî¾OjþÝ|ŸÔù˃¿¾Íß,ÂnÛ¦_±mú°m>–6 «Û$<½6ñ›¶‰_¬~G©Çõ½{õó¡w«ïHËõÒVõƒjCT¢ZÿYœÄ‰¶xÕó½®öXIw¿õ¾åõïöP§e¨c¸ÿQâÖŒ÷€FIZ}vJÏg§y¶ÂšL†‡“Iþº"“¤žßt=ºL†Õ™|2=ùJ#Õ† endstream endobj 4108 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4078 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_plots_cds_replicate_line.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4109 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4110 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4111 0 R >>>> /Length 2004 /Filter /FlateDecode >> stream xœÅËr7ð>_¡£}@ÑsftÅ©@AœØU9Pe “]'°¦òûé—¤Þe×^›¥r`ØV?ÕÝênÉÞ<3Þ|2Ÿ‡ß~ì?ã¬süI1¨ÿ¾¼7˜ëá§Õï??6—«Áâ3ú»º¬è“³-賓—¸:™‡W¯3ïožÁ¿Oƒ'u/†Ýªó¸˜¢M³'ArmŒ&†dcúÆDgKFÑÄÛøóá®-8›cß‚ÛØ ÷auf9ø¹ØÙWx1œ Að£çN p'ˆn´)u‘`݇L>ƒŸ5ƒ]šŸ¼²‡aeÏèm•= +{²·QíH`$˜ÐµâÏ¥@±x;й¸µÜðj‚1Ø8u#߃ߧ¾ 1¬¨mœÅàE³EˆÏ#Ðàs±1C|`S©+÷w3ËÉ6¹Šïr!žà„Åðò¥Ê˜½DLhæd“–Áø.cšm U†vŒö\”“Jâ¬ñ¾Øqì¢bçÙÎó” ÿˆYÝù#‡¬b:œùÁù º:S\›­Cû§hKj)Ÿ©X6y'§yÉïwršwlvC€ÆÑ„á)们²CQÜ3\D´D` G³DôE!þ@) ÊφçN5q„ŸÇCtƒr݈YÛµ¯g©†îæ­)Û¿˜²ÆøÑaæHr/õÊ„ÇÚÃáÅÚ–gtt; ]5éÜñ K`ãˆd3µ¬dôKãMvšºl‚˜Zt ^ì^m÷åðé}²c‘s»T ‹÷,žƒE« H—‡ „†…ݸÆÇIeR^ð6̬éR `RÖ)X¶Fø”­l>$[™Z­‡Š5)acÀÓoT2Q_\ÀsÌ<ò›ä Â¥ ‘G¿‘Nt,6¶-®=ÔȼòMôVßÝEEzk£1A3º Eë£B¡ú¨P´F*;©Ð×X ¹ª#bSm¥Õ¦ÞJ«Mµ—V›z/­6ÕfZmêÍ4@yÃQ›¡€ªiêíT@E!KýÜ\k§Øý øC.»Ñäc±ÙwÁÞƒiX(EN€¼šò9˜u3Ž#šLaŸü!°JEA0Î1£g –!+M†¢`ö”ÈC3Ë0Œ©Â*;Eõ{®vT¼Òe( ˆ¿óÔ™|$ÌTõVÇHQˆÇR³CdðJ—Ñ)vµßn±ž„¥^ñ˜ãÒÁÃS ÊõÜtIÔPÆŽ1¯@$›©y…§¦Ê ³#*›!¦fÝÏvU^m7÷¯0B*»zÊ—z%Øc–ÎpqÕŠl]€Æ“cÃOÒ4™·B$›¨ëŠÃrWy!KÁñ-bÙ¬»âÅ.áÕvË^‚£™£V°¾³c7OSÔ\Hâš ‘¾iªøDÓQåeˆe3µ¬ÌX"*oœ°´ZJS³îŠK…WÛ­»´\½¸tK“ÅÒç·4éxõ·ßt·óc~|ŒÞa_ï_ºÅ?…ÆfÎ?˜Ònäô!Ð;ÊÈXè/ÍÑiã±9ÿ4<9ßÏîƒéæá¾ºUÀÃ`¬.yÃYI;ënËLµ×¿6¾9è´¸¡þýögs|“Äc~Ђ^{Ðﯟ_M„€¨˜FŠIÿ®E†ìzTZTé~ÎÒ10W§g5.(úV^,C¾(æOÎNöç†ûPñûÕÑÓ«·_þ~{l`ª9Z\¬nVǯÍù3I‘°:uŠË׆P=tV¼žAõÌ)øµô!Ãñ><4f8‡—ÇL†ÏƒÆìnÙVc"ŸØò¹Â¸m›ÚZÉg›¢™=âaʹsÈ3Öd÷fŽiÆa™£b>XZCïžR»Ñé—RzØ$l»Ï­½”v|»Í­=”v|»Ë­½“ꤿl›;›;½_÷'Ãø˜ †žâП«‹å?‹÷o®/–ï·¹õú”’GJ7N|øŽ°¢Æ§§Ï_lSu{ÁÚù‡„˜ ^àÖ\ ¿#¦„±ãv|pFô ŽÖ•àŽ>½¸¾y³º¹¸ùºÚµ3ýL’ðÜ¿¼ š &*vâY¾ë»¸Ãtì¡¶b6Â81ñpÛVf¼8G¸?â[C.øa<ž\…èbņ̆Ÿ±ç6^¦vE©+#¾*7^ºe6Ù¹]QªnÁ‹]«íVÃíC·µøÁuÿ`‘? Û¯Ï÷IÃýÒËAôØØôC:Ú?8ý 2rú½:ºùr ö9º¸üëêúÏ7Wïv6˜ý²Ð—´Ožìú‹ËíÅ6BjA2G×Ú¥‰pF_á…1g»³}ý2p›Àwœ*i¨çä .ŽÐŠ«äŠ÷¥àó,?wü[º-Óˆ/4{E`Û#Ý^æú™^­š¹ï2wë#G Jjžiîk¨’;>àý~g~è–[O0™¤žlÜn¿·ߦüܶ[âÁ‡ˆ¸Qƒæ&AbJO?ýåås¿—Ã3œþ endstream endobj 4114 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4117 0 obj << /Length 384 /Filter /FlateDecode >> stream xÚ¥’QOƒ0Çßù}„º^)”¾.nF‰&¼©¸u“„‰ûø^9¶ $Î($½ëõzíÿ×lÏ»öÄ 8 ÌH®Óˆ)­9$À6ïÝã*ÁoH˜¸ÃÒiÛXÜdÊ®jïÿÓZ8Ö 'E—™·XÇ1ÓÜh,Û1‚Gša}ŽñlËžüg‹Â(VþêØ´¶ëŠº¢ù2o›²îiRïÈædº¢Ú—–ü½­,^²[o•/áqFýG§™ékþ¬3Í9ÓùJ:U"¾ètóe€?Jus'ÕÙœÌIªóTò>Šþ¼Ö6e±É{ëàECƒâ¼~¸»ïˆ’=6A(_wvK´.µÌ„¦ OQD ‡Xÿg$f8OEÃIÕ9O)"+> /ExtGState << >>/ColorSpace << /sRGB 4123 0 R >>>> /Length 842 /Filter /FlateDecode >> stream xœ­VÛN1 }Ÿ¯ð#<àÆ¹Î¼‚ *”[w¥VBÄÒ–­Ô߯s™w™î¥åa2òäœÄ±Ï8&8‚GøÙœoö€B¥ò`¯—;ø ÏÍ»é§÷»p;mˆ?*ãô¶ŸÞ LöNâ׿›‹KPðµ!8ä籡´Ýqó÷­Ø9h Ú|@£À´•£-ûÊE…Ö Çèâ2~÷«Ž Ð™zµp„¼8‘E×Á¤±Ú£Ó½ýÔŒz@èзí ÐÖbPì 0ªÃÖW@± Xìœd;æ³á­Ž˜¡³)¶É‡³-&àêp¶ pÄ% ÛÂa«Ñ’p8ÛÉar1[9g“Þ4¡ÏNjãbü{@1À8Ž_SZX%޲³œRØÚ RƒêZÔ¾ˆ…§MÇòŽGOYbÔÒM·1=K%¥»ày &$–'´ $Ëþ-’êå¥b¶=véd­Eoz[½"²M,ýã_Ö(_fk„VШkÏÅö,&ÓÛ"Ql&Ú0·FþRרˆ–Ó¥F˜˜fëP›Þ:¨ˆbóEûe‰ü¡.Q»ã@¦ÊuÀª†ñ=t³*”†dË9W4ã lmÃø±ÙÇ—R5'Þý•T‹í0u¾—jF5 ÃÖȱÃa~] ©X?ë¸2\1Õš×ë*JžùxºwÅ¡¦ ÅV»ÿ¦ ¥Ï¬ì+Ît•ù¹r%ËS™Ÿ«Vq¾w2*¦&Ô¤ŒÔq./ɳn–5S”ÏŠ )/g£!5’“’%ùÛþhomvú…ûbëàáæåûÍ6«¶ž®§¿¦Û—0>ê^ùlŽÁ¿Ú s8$Y¤jí3‚Xs\Q#“XÚ›‘5g¢ëYoN滜Ki$›ÉÆtH™lùÍþË7š­ý„è.Ò]Ÿfk;!»‹:_» Ù\ˆùY3!{‹:_{ ÙZÈ?i}Y-½,ˆæãœmZ¡—Çôzòãéîêùzr7î ö›ìˆ½ÉÄkOs›IYSgGÇC[ýÏQÍÂQMnÑc€-—Ú²óÙ‡“#ZgëóæЍ• endstream endobj 4125 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4084 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_plots_bar_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4126 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4127 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4128 0 R >>>> /Length 990 /Filter /FlateDecode >> stream xœ­WYoI ~ï_QÉE¹\W¿&"hŽÀŒÄJ¡Aõ°,³ÒþýµëèòLz“ ð0¹}”Ëþ|Ô¹u£þ^öSFS‡Vüùq­Þ¨oÃãíë§'êãvúh”<·ûtµÀ^¾à¯Qý;¼}§Œú4€:§ßÍùºçÃÿ_=¨“ÙA‡Ú%¢F£0¡6N¡uÝ-­UòdïÒÔçûž`´Çþ³÷„bÀi?ªÍàlÐÞ6zVM Ž:$!Pè.`Ó1vJw4£N¡ TZD§G/ Í»Y(âÉr féB ‡]Ô€ÂáB ‡Áj pw¸ÐB RÄ¥@¡…ÃÎjÂáBg‡Ás¶JÎ6Ät(NZôÿ&PI!€žâ×*)Œv6J<8£1:¹ 0QGT0&mC ±q$žÎb@ÞšMœÀ¦e2Ò} tFŒY+€v{JŽüÛWêg¾ @GOù p=6à<;>•?Í|Ll¾åfÃ8¬°a’Æ(l~·a€QlX$ïÉ ƒkN@Ðu,]èCãO3Ÿ`ëaÏFù&lN6šÎlÃd³ ôz¯\ÌØ2 #žˆÎÙ«ü©ó+à… ëòûf\ƒùýÕFåÏ6,RÎÚ[ng‹›7šÈµô˜q˜œØhÔ.Qh FKµTõËlCHX ˆI9öÀ5m•>6ZÔK—è‘tqÇFùÒmt‰D àÆc !Îb£EÕv‰ß:U5Q>t]àd=<>£n£ÖŸÕ8O‡|de¨h5zµÞ¨£—Çj}3ÁŸ—<¹óu~ßñäÊ'+éá°ZÚ†æ0ìÆ¹Ð(킊 Û«Í÷éúý·«ÍõR¸¸O\òHÜM› r˜œ†‚©³Ë‹çKWýÊSqï©Xþuâ;jµõæË?^\ÀC®~5ü§ä« endstream endobj 4130 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4085 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_plots_bar_isoforms.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4131 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4132 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4133 0 R >>>> /Length 1374 /Filter /FlateDecode >> stream xœµX[o[7 ~?¿BÉCUQÔõ5A3,AÓt6°‡¢(Ò.EØÝVØßu§ÇN/@NÂC~Eñ¦âR€¸OïûJ*U5ûóóNü.~L¯W¿ýr&¾¬& —JðçêKcŸÏ¶°gç×é­ÿN> %þ˜@\Òïýy¹·ÓãKOâ¬hPš œ—HšC>ÔF¢y`¢’QkÁŸÉÄ]øI|Ý·%-Ž-¨-å -'–“¦ h×èÅ4«œtaTz rÒ˜!Pé$°îÃ"ÈOLºCxA1{ Íìq ­cöšÙcA"ÛQ¥“€24.+…¤«æ¢—Áw~%¹@tk…dJíé-”è(‘^% ÊV-JD:M¨Ç¨dÀHòà,=”à »q ¥£DÛA*‡ õŽž}Y½‰±^·ϼPD‰ 4ÉÛÒ„ÄäX­Ò¶1øJjKô7Ò\u 2ÒsרPdªŽÊ_ >H0Mšä&Hê†ÿ|’0¤ÁÆ_t>Å›U›:PZËux ŠëÈ|¦#Ê«o“é0$è&à‚tž$È·Ý•»èÜ„ Zú8ð”6h¾p;žÖ×XñO)×#ÒŠè)?s~Px¸N³è앆`ŠÿfMG}Óup 0[RÒT’(4K’!ÑJß*¾vq8¼‡íÀ¥5d{ÌV.5à= ¯àÒøÂñ^1|”кïöŽ‘mT:L k ‹Ô· Í‚²KTzdWUѳ¯h`|ê«Ä'OÅŒ7Ùe…diÑùÕu”nÈñåEǾ¶!ERwlȇβ¿zjÃñƒ¿¿¯dcêŒú jÚ¦®tT;—ªÂ®NQGÝR>j¡'_jØÒ(‚ÁŸãf±ŸòL¤ª¢RoÏ|kÚexŒiŽÀ襂løüüÝõì“J?&(¶‰ý8ªﮇ;m§‚ý¦©²÷¨Û€»mÿŽ,õ¤ß>UÐ om<^¥7§Šz)3¥;ó+¿“UöÚ_ÉŸßп™˜rnœ.æÓϵ3Êv½Šý|TÞèþâtþÒ}¿™mKç­Ø43`àoofçOGÓ°jÔ@8¹øþù矟O…Vâdq»úguúQÌ/Yyø¬ CÕåk³Ÿ…*m4â£PãóÉè˜G–Ëh8ðÌrùö‡žYîî¸gv€[¶ö¥|óMiVjzò͇f$“ïÁ¶x¨<=œÛ1f°~6M*d02ðÑš† ~Ñ`«ò·%µ~Íà«\2ø·ªÁW þ©Šýó#`Û`ÞÝ °îÏBç¯1tÿMqòçêvù×âîÓÛåÝ6·>c=¶È+¶6`žDé†1¯xqsõvÛR/Ù*nlËwÙäh“¾ÿ”•o~½¾‚§,ý~ú‰› endstream endobj 4135 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4138 0 obj << /Length 271 /Filter /FlateDecode >> stream xÚ…PMO„0½ó+æØ(Ó–Âöjtž4á¦_Ûè ¸þ}‡-DÛ¤ïefÞ¼é t€pá?(éE Ð… ´”"K¡¢÷H¤kÁzMí²-< Z­žéî¹xï7½)¢äh äÂæ(¡hÉXŠÃA‚&D E /ì –ôH§Ò²'×QÈ*®‘Êi™Cb>y®,ûtcSÓ—‹»¬e›äÌ%›ü™ÇòÓâü*}е»¸ú£ìù[ñHsÇ–þjÂnö­ŸrÓ&eD)ÌdÛ7w͸±²šü¼)*OÝWÏY¬Ýÿ,?9* VØLeë*¬R[Ú[–‹Ôl»ÐøKzWD_5p endstream endobj 4086 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_plots_pie.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4141 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4142 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4143 0 R >>>> /Length 8547 /Filter /FlateDecode >> stream xœí]ÛŽeÉQ}ï¯8žy¿¼Ú$K˜ËŒÄƒe!lc<öŒ|>±bEdfeuWO·GB ,u£Î>{ïÌŒXq[™?}ÄÇïÿþîïþôð áËxŽþ(9©”Ë3µÇÿùñ?¼ûóïþþ¯~üøÕwï¢|&?¿û•ü“/ßóñ—?ù~Ûÿùîç¿x„ǯßÅÇOåßïÞE}ê_¿{ëáï?^/™ò³ôGìáëc†gšöóû½ã_÷øÍBxΔçÏ×C×Úx¶ôH±â~ߺXësæÇ7ï¾¼?a>Suù=PŒ½<[{ßç©?çøè÷Ïš÷ëâëÎþÌò¶¥<Ãç ‡7ˆ£=ë{‡ó±áæùãïl:øýàÕ¼\mû8gŒB®žÏÞ(&¹ZjS„˜ðˆú¬ž¡nIÔºwˆEgJÄR!ÖgÎ* ¬·g–÷ÌñÙÄþ,AÅ ßü4< FÙ'žŸ’Œ­ˆ8D—)F{¡8ðÝÀ¥”%‹"ÆiÏm:¢8ž%S¬øTÔ#PlP£†)£Øu‘B4k–ñÞjŠ(›(&ˆ6u"\ðrúV2Ð$zš'Å$wƒ+(”¡¤Ðñ[±F¡‚t6ðVÁ”K¦nʃB±‰M¸*g¼UÐùÕEiø4rdÉúP1.(æ*ÈK&.÷˜8''V”ÁÄT¨*rqœãÙ+©O©„ùÙìÄÐf§Ö©¢®o }"–F•冨ß}޼X$Ú.ë»ÅõÞW(ÿºU“-ûA-CUÖk4Qó²_²E(ðB“×({€uº¨Ã¯ò¥¾'§vXÌšº*šÓ÷ÄŠåöº§½<-Šˆò„µdU^rì­IÁ×[DÑÍ¥ 5ª-¸ªˆXëV$Åè—šU‚²•PÄ^¶ŠŠØâV`UùM½!Ž­ü¸¸oÓqäm8U!a™•ˆ˜+7:1n’2"Yße°"Šª,s–Ù€-¸±‹8㆙º6PÈ<Ã8ŒT}Ù2²F!nqÆ P² £nøªúën¢ ú©M¨Š‚ªcã9lŠÖ…±AUt2… ¹¢±9o@nZ°àú˜¾€àÿ-l³%"M6+Ø‹ØÌ(e= ÆiŒïÜB­ „9 DŽžT Qxkh”b+‹‹'׿LªÒ”±ÉäIT¤Ú1ÅÜeL¥Ñ&‘RZ×ïXc*‰šƒÆ8©,ä¨7ËÃ?§„¹oTÌ(–— KŸÅ4*ç7v•imÉL3Šq”¨jy¿«Tê&«{IœcÄ!¨ºÚ÷§.˜(wÊ.ÃP FE9&5œà÷ƒö˯k49O5ÙÙí}W í21h,É÷„Òl|²" qÕæcã W&íŒå|N‰_d‰䩞7ÊRì˜D'zõ¬˜ì8Ì®gÆÊE¸XÌÕŒ°Ñ¬b¢ø :D‘(~"z"YÀ(Z¦ó ¾¦BìÏé\Ä8"T2Ò}à5ÄO(tuÓ£yY[„X£óꈸma‰²/NX®u+±\ Á$fû~ ±…žöK Ú`®|•Á¾°t@Ô~©œI›œ"@öÔÁÞ´'6ó5|Ú³¢ÍZÑí4ö’es—¶¢bý%ïE¨Xú ËV—ÌÈʵI¬@=‘)›€pÌuQDD8®ª"Ƹ5êÜŠ.Ÿ"Vt;1åm&"*öšV—‘ÁÓ¶ÁÌHÃM4«š- ΊýËÀå¿bËþsÅÄ.x™N9zȯe¸Ã)ƒùµ¬Ñ&ù5nå°U § Ô ‡—ˆÇk@¹Ž—,lš(Ï=^R”+/)ÊU, €Ë@¤4© ÈK fžêZ´ñšãÖJñO3 gKQñO41R,¦§“¯&ѱÓ‹5÷òjÓ¢‘p¼>QnD"ê\‰êÇ¡ã•P(êˆðv´<‚åÔ!ˆ¨Qnt&5e.š[Àj4ß]‹‚ºÑÜK†X³íq/÷ÐHp)ØMUDûFÚŠ$ªŠ™t5cº·”PԼŭ¢Sã¶¥À““ãê-óV~UùÍ4Pš©Ûpæ IšYÁ4Ë6:„¼s›$Ÿ4·ÅB‡A#±Ôh×ì2üŠÃ©\7Z@î}ƒ‰&¢uc d-ŸA¬9R!Q ud­¾Îi"[6 B֢С$d­ªˆF>xa¬ÊyC°Êa#´~?o×ûÇï‘%¦ÿf¸wÀxfÚÎr+Û·@Îi»Ì—VbÍ3AÖDÜdÍ Ì¯aþáÝíAŽe{E¬Ÿ'ö.‡°}*Û¾=. uqûã©AýòÖÈ–Æöå³yA•­:“ Ó ;J˜\G!D91Maˆê¢ëñ‡(¶FELµú»ŒéÍ lÆ`8bqê¹£"T‰óŽ™ÄTµNbÕ°·2mä!+ ;VÚÔÉuMqVœ‡Z}ÜQ ²á´cDA7‹™ªS =¾ì–Yô)@™æŽM;K+remŵWÔûÞ˜øŠ˜ïxúж¯XüŠÔ¯8þŠò_æW†pçWvqåWfrå-WVó2ç¹2¢;_º²©+׺2±+O»²¸—9Þ•Þùá•=Z9úûøñ;f¨¢ö2Õaõ3ÿ?'ý_Ÿ“þ¿±þ_4Ö¤å£ýóà ˆ7) _.âCŒZÿlæÃ[ßÿ“©Ã<È&ÍôëŠÄòûÑ®ÿÀ=BÀ«+û2½Ç9ŸþÞˆ¡áÅ7à3FÆ{T†Ï{®^ùþÐ=>>;¼ÇcyÏ|¼ÔaûÜY©bÞ}¶ØØ¾÷6\lš-­.]l,”yÚÒîñÅ®9ýjF‰ƒâÑ!Œ`VôÝ@Ąţ¿¨íаÛhP„°»“ÇѼDÇ¢½M´,ÊÑúÔ´6ìÎ(äžwãT³Ñ¸ûªGÜmWdœ©í®,dm’Y¨iÙ=]ä Ÿ·|5E-»# ¹äÝ0V¹ì~²^?w»9SÁ»ÑCÛÍj<ßJHl2a^­n˧W'ãÓ¼5Ê59Ï»®™}ÚmvÌ'tÒ»ðÚ*»Iù×\ÎzøXmÄG_¿ÊÖ»1Ô@ò&@`΀¾˜œŠéê-Î>€¾Õ¶É ±M&ÙÆ]€~澩 ÐßT6óúbìa¶Í›ˆMáìá¸>:WÂî´Ò´ž>ÄAéˆu°Iåï‹P=ƃf|<Æ‹ÖH<æ£Ò>Ö|¡ñŸŽù¬–«û|Wu—{=ŒÍ°Ö«Ò^×z2Úë]9®Eßë zùЧ¢³õMB%u¹>ŠŒlté«È5ú,ò }/¤,{€|°‹ —ӞЫ:¸IÇiò~È¥—½Š\ÓaÏHÛaïÈûe’7U¶ NÒ™ÏܼAw,xTµˆ±ñ <Žqà™¬gÞ±S¶ñ½±xà¥è ìgáiUÅÛx[¹~ AØ8˜lÐ×ÙO¶¿8=Ž3/`Q³ï®,²æÝÔƒE+Âz~@Tæ½%ÑÔØ:†Š@s7µ¯|ôQ¸ÃŠz;ÕïV¢§9½53QpƒÆy¯%6íÞXýE5ŒxÑ0&ÓüEÀ©Ïƒ†!¦;ãnÃÂ4ÓÑ¥…)溛¸0Exïñ•Øc-`È£bTÃÎ2ªYýè/Ò¤Vû9¨©ìî´|>æÑ¼Fõ+½m«n­Ö7Ëz»3Ø”Xs@Kß}uŒ·Ïƒ†1­Æï4Œ©µ¤MØ:Q«§ù{˱•ÑLízM4aåÔ“O€â+XN7À…©m6. q׳µÀ<6—ÿ§:ÀC¡âëLx¤\6QõbçQÀäƒfªÍ€ÅpÊÁî뫺†}?tÏçÙv¾OU(Øï[ïïã) E{¼à_¤c>Jäüú|e-{îùÌ ¥{¾såüúzdE¨½^€šƒV³yd_ï¤4¡­¤ùn}IVévZ@é<ô 2ª}‹”ˆˆ‹6„²k?hE€êqÐŽ<ŠvZRRšÐ¦-1ÝÜ´¦TˆàN{J,z.Z”¼O=ìïüX´ªÔIÃrÚ•@}í- ¶ƒ¶•I7[x‚æãIû’/ÖróR)ñ µÚ~àšjáÀ;ù""¸…‡…×ÂKxètà©\˜N¼­¤-”ãxv¿dKþ—ìý“½t°d«,,yùH“­.±d+[,ÙªK¶¢Ç’­&²|hð˜Òd«¨,Ù .‡Ï/>·rÍ’­š³d+ö,ÙjA.{©hÉVIZ²š–lu¨%[™jÉVÅZòйM¶ØÒ€àZœÕQ<æpZÇ4 2^GΆ Fìàø«z„Uj×{îJ<6Pnްcî:>4Z5ØÊüˆÁ±x@cê¾›‘Þã©”Ža9>軘rôÝ Ðxîþ…"6û,”ó[»!8rðR¬Ÿ‡…!y+6CôÎ:¡Ý?8׋š‰8%²i ĘF k&GF8œ¿ÌvKv’Ù ÃôU9Dîf?¹zK‰1¸ V¶ŽÓò• ©frHGŒ™™óæd1pæ6‡l­_È™ÄUöÿ².,쉖µE­ý´j2:@©YÌœ´ {e ›Ø KÅú"Ú;×+‘ã¼rPøªâEu¹’k÷ã–Ž8,KlEï¿&"4ú‘~ôÜb1{IìvIΓüû@ì舌ç5öC›É݈´~¿É~jöñ$î„XãÃû¢[Ý‘I߇͗ætÙú‘`!fö{›Íà†‡ìK©÷ŽX8zðàAã‹ 2YœÍð#kÿTk×—Æt”Èf·ëŸFÞoÍj8Ú*¯¦¯2ñ=n”ð~væž„áýÝ¢À«‰A1ûQF·Y Ǫ{–ƒf%cŒÛg _ÄšÏëæÏfc8vÆ nežwf Ñß_Sà ís_Q£J&rÙ¨“„ÃP '+ ÁñeNf¬ƒöoÖšT59²FZ›ÉŠ¿‘x¨Å5â1×gN^ŸÍ?’H£ü“fãU~I6ÿ(óSHòË>xßhÔ2òW¯EÄçÏgসlx4lc¦¯Ï܈‘ÍHhÒšYßú™ø2ÈŒŒÖ%ÐŒ8«L|òšq±~(þ@^5`dà×·fTV³mJb™úÚ5pQy˜=f>Ï2hÅSÈÝkºƒÏ#‰½7>x/xù<‹¯ &è5ÜAÿJ¼GΚa:ã_ï£Üò‡›ó¯3ûÎ÷“ï7»ÞüÙ«‘ß3sÏÜ=³÷Ìß+s­Ü½²¯VþÖŒ[snͺ5ïÖÌKsoÍ~¥ù·eÜ–s[Ömy·e¾´ÜÛ²Uæø­vœ¼[ ·ói&¤rÔÌrFGF‚ i"#ÅìÏŸì1’2YKÛ‘L#WÏì¦íñZÐä® ‰d¹~“‘&ªÉŽ¤ÈŒ 6“ #åUk›ì¦MŸ¯bݸhó9‰‡U‹›©³º>¹i8{nŒ[Îù¡5ˆŽlZë>ÿÜh™§EÆ30Ó »–§™‘gjÃ2“Õ]£g(‰H —âÞLÿ"ûŸ¦¯ÕåážW©aÚÔ¤~GÖ~­˜´šL,˜}`½ÐÄðná ÌH ݯÂLöÙÕž‹{:t»ŒNæ‘G2>Y6{¶]ô$ Ï’,BýîÑ9d«ÖxîYž‹,8,y·Öjã–)Wç¦äùv¦ýþLüÎÔ_eòw¦WîJÁ]I¸+ W%â®T¼ªdܕ޻rWJîJÊ]i¹*1w¥æU%ç®ôÜ• »RtW’îJÓU‰º+U¯*Yw¥ëMÏöý™,oSL6•ÅÚqŸˆÇßÿ“©,©žVàt“wÁñ¾"³…q->pƒÎñêŠÈ ô£÷ø •åÓß;«>OúÇgŒŒ÷8h(Ÿ1vØS~óŸÞã±¼ž—zàŸ;•%Ù/o]&¦­«ì”OðÖgj,zk4 xް[§É‚=o­&IcgÚ­×*̱>awîѺM=°±g­Ý°ï»õ›zrê=³±`­ãÔYx÷Ö2d½Ÿµž‚ø[Ó©s§º·®!×¹[Û Ö¼Ë\É*ñÖ8äwë²R[¬µžºíеÖ;ävk^å´[÷z}Û­ýdÔoýãþã8w!q+ô¢@NyS ’¿N=€œË¦&`>ô@£.@NaS05oêæ{ÄM€ò¦N`}ôûq¯_>¨X_ÛFQ’­9ŽÂ€~”㤠èO ›úýÊÇ9Ð?4:ýŒÇ)Ðß7õú>Ʀ¦ÀzÞÔ•„2ù”Ì#C\_¸Q}ëSÑÆíÖ7n@ÛúX“××BŠÿÒg”O}/¤V,{`™qÛKI<†Äí©$/+ÓÞ¸“bÛcað¸ìUÞ7ÍÞK&µÍí½Ø°ð î=w¼àž¹'ˆ’Ë7¶Ýtá¨?áÀ+Y¯Z<+–Ü8ޱ߲ñ°F?'‰xY“”Äùý*õÀÛjɈãqe2¾ðº6¶%Ï+Û. ïEÿ­í°ìcû‹Óã8•£Ða‘vnˆ!~g¸mé@±Ö(c›ßÚn­ÑÚÑzM}z:`Gpc·n“iä­Ý4Ó ký—¡¼5œ& _Þ:NSw0­Ör’ô ïã­ç4ÙxZTTèÇAe™Ü³¨,“º¨,s0Ýu* zúu·Î¨³Ö:äZvë]£•º[ó+z±Ö=äFòcðûåqPY¦vˆ6•…G|l*Ëd#eŸÑyî‘SY¦ž²¨ ¿F­|ƒùšÇù Ô¡¹©˜oPcœ‘ÆôF¯zãE­HCÓÃE½H#³poÔŒ4" Óa{\+ŒÇaO ñÃÏ¥`áÖ©!ðPØ€èÔx¤7µ…Z§žÀÄ´©)ð(¥nê <Æ·eíøíëm÷ëºVÚÏ+ºm¿OQ(Þï[2ïïã)Ük»Æ›­ðíó‘;ç×ç+ó´”5ŸÜÖ½çT‹p¬Ùë•:K¾ž©ñˆ-_ï¤T«­ –ÔC_’5¾\ŸÅ§¾%nö_ú˜Â‹p`ˆ°–>ÇùBßWíÔ.È'õ+òd²E KVŽrêXâqT‹Z–"7:º½&F8ËžS&•ÍíÔ˜zàA2v¼…OÒÚ“B¼É$W/<ÊÉ©øÄ+lZ/žåÆòã7—o<,,Ç-¼,<káiÑ:ìÆ[tàÇÇ…å¹…×ð@ýÀóÊ ï«îó=üÁëŒîÓ¨,Êq<Á_²–<=g¡ì„%[aÉ+§1Ù K¶Æ’­À±äî1ªÉV Y>4xLk²X–l˜ÃçΟ[gÉVàY²€–l"—½€´äè9›ÉV€Z²¨–l¬%[kÉ+æ6Ù dK‚#hpêJ‰†˜zÀà A¦¡9‚–£€UJuø š¡ì 4tä] Ä…Fæ²û¥RxžÚ.@ª)Ñ‚²ÇГM³ˆêÛc-æ,¤št/bä¾ ¤³ Hý,–Å7›¼@H}̤^ ôÌfÑ&3æÏ<“¬dPU¸~Œ93·”hã±3@J0DË$÷ek…Bñ4‚™6@œÁu1P¸/Žï›ƒG@æqlkueAЈòd×­€îˆIÇ6AÄÈÖŠU„´}3SYp$¥æöfB{œêˆ¢É…§š0Æ–ÿ£Ô×çd1½µv!W+8fGpí~Ì ¢Q7Œ¼ŽøzDac+[enO)þ}k8q¾Rñ3ßfõû“Êb‚[ëc0|Áûq{Jòïwžé|üçr —m{BsÔéQí~¬y„lú,G\ŒÛ‚QEt¢é±é¡x–—vœ]n̉íý'ÉÌÍì/ñLÛYIHN~Õi§~éÑ ÙÕ"{Ç3-$QéžsWÄÁˆÀ@j…å”g;þq;…ö]²áW"•¥zYxê ïW#ÚiöU¹=§UO=6©*ôŸ‚¯É¨&Ž¿ÅŽ>ñˆ¶ó~+GœgÄ)p4j ý‡æ¨z=ý O¡éÖðA=ø<óùôˆ[‹ ÚWâçƒó¬ :¨4#˜ÿêTp°y‚¯ezæƒîBãçÅ©EÁk`…çÑp>Q¬ëƒ}à ”çÒ?"úþVÓ›áâCu§ÔBèKó ¥óÔDF˜#ñüèycÈÔ·Qx$Ê0ކ2õ›T nÞÐ>±ÎçèÊä%¾ÁP«âCõŒ9ò°_ÚÓ´c…£éÿä™|!y†]xŠ5yØö*Ï0•¼îñ†5¸ƒQÑ wÖ¤q’3ü Õî׈§6^ÖŒcØïŸx}óŠÀdM•T—ÁíѨ ˜Om€Gó£“`Ô?¬O`–x‹C—m;×°õ®¼ž¾owL¤rB_ì$EÆ;4ÈÅkÈ×W¯ùÛÖL#¯§¿ëe5ü³ÙCO› ºÕè²×à£Z7û ¼Þ2Þዯû"LD³çLÂñ¤U'lоšû”ÀQ /36â[‹Þ ‹g<ë}‘[þ05åuæpßù~òýf÷›ß#»G~ÍÌ=s¯föžù{eî•»Wö^ù[3.͹5ë•æÝšykî­Ù·æß–qYÎmY¯,ï¶ÌÛroËVÒ+žG¤›‰“EÒ³-j_o¤bF¾„8DnvÿæÕe«…5FjŽÄVëc ‚2"é½ÖGêQJ¦³úFi_åÆìâµ@;¯úûØñ|i•„ÜgÊ™‹ÏŸVoƒEVS E@eµÉÈjo²êõäFK$^‹+4EÐ"}6ý ö× \M¶û^_½öÇêuiÞm"Õ‰íǨ*Ö ãaêÅ#ù^ü ’ìöhÛ"‡Ûkæ6!óüùëêŽr›ãÊ|WÇ&­=†#s¾3ëdÞwfþ*s¿3û;ó¿+wåà®,\•‡»2ñªrqW6îÊÇ]¹+'we媼ܕ™W•›»²sW~îÊÐ]9º+KWåé®L½ª\Ý•­7=ß'Âò&¥äËëÏÏài`ò”Oã+æ ïø8¾ø9ŸD«qfʇŸ¿óã¯ä®1€é²êCÿRBúÇW¿yhƒ4¬*6­ñ+YA®ùöñ£¯ÿöË/_ýîÝ_|õ½ü^ssó?3Ão=üó§8òÏcŽû_þäœäú½èä`ýiòÿüyÖjE=æùç?ú˯ùÇýå’=~ôÍ?}÷ß}ñ‹ÇW?]ºý±9øA/ú_óï“–ö}ŽÝÅ¢Êëïn°Iþ9/$êphãÝ y¡1¾T Ê‘ÝkÜÕóo¿ÿö°ÀÏyÔqÿ?;ˆ"Ð.ú¨ÿzßsÞžû2slÜKÄ¿¸µ®Õ4Ç õñŸºœøwd²öúÔ¨þã_<$ûÑ?ýê÷_ÿá_þñë_ŸFõI£±{2™:RÀÏ—ƒy5‚—ý±C_ß×({­¯áÐלHëã_/‰üûJúóÅßûžCѽTéû å}iù1”h‡ p(Ÿ¡ïƒÛ\ŠŸ½#)4ý«ŸüÍϾüÇ€ÿ•>¦ö?ÌãQ›“ˆòÕãã§XÝ›ÿÞý7óñ7d endstream endobj 4145 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4149 0 obj << /Length 1624 /Filter /FlateDecode >> stream xÚ­XÛnÛF}ÏWè-1{' ´Z§ÜI hº0VäZbÍ‹ÊKçë;³»¤$—VÛ¶ö:gæììì Él=#³·/ˆÿýyùâõ©P³$LS³åÕLŠYÄâðh¶ÌfqHC:_P*’à­©Ì|ÁcœÎÝõàÁ¶¨»vþ÷ò××§,ÙGf ‡<öÒÎ®æ –àvÎâ î¡'A^¥EŸ™ÌM­p0¨»›ì6ƯMU—Æ ®ú¼ðËu•¹±uwuš~q^¹AÀ‰§q½T…›ïj§«¤{º²˜„±R ³Õµ™Kü§³“þÉ«ëö‚HtÂV…´ña;(^M{\ùœƒ*Î^o˜^ €†n$MMÛº± ÜÙ‚‹8Œ“È¥a"•C¬\®ˆ£Ì6]µˆ—^“o»…íuMŸú“ƒE…ù„ú™Âu¯Ü©¶ƒ(Ýa 8ÖW5.¿q¯|^­]x‡~gÖîð@‡±ÈÚƒ½´/KóqÕWY8_H&Á•À}êæ@ø+ìEhHkæo·tv;Õ8ÌçÎTÖ‘°WWÅ-¶„ÆG 4ZP¸ðmð+ój¨â!gÃiZàöüÿà… )‡¥5"UðAÖ;ËxèN&<‰8ÔÞÚ?^%ð¶LwÚµô0TÔÚ™mOqízhʦB„‚Ç3ʈ;Á„PG(Ï{SlrJEg4ŒaÿÝRrPw7Õ9Ehën^ÛH-Go@ý0[ílYéÖÀY‹$þ°wš6ÅxÂB*øC)g‰š¦X·^«ÆX_´' 80Oøá ôèSñ@…Dê¬M‡º¹ÿN§_ÿʹ— 9ØhL¡»ÜÝ5ç–{W ^ܚ¤ÝàÅWM]ÞkMBö‡€»*¿Î:c¢5ûF/¸`ŠBøvròA,CÏ5@hvÏ-‚­}ѹ»÷m<„.ôlŠ=v8WD‚ À=õþô£ £3döj¸4°‘¶¼õœÓçà‘{>C€óøPfkþ­t‰¼2J jvºAãðC÷³I&‚›Üvð¥AZ —™oÛ‘×în·¾Õ¦uãð€»ïGðL2rÓ Êm¨CaØ!‰L;1Œ$Š=*#ˆ˜zí¾sóiYR±m>ו·ãÝOSÁU‚s¹Š1Êâø  ü(¨âñ¨س ”<ÅRq 4"IÌGЈR5‚âø·ƒú7UeDî2FÕªÄ,UGAE’ì)’”–²o:Ó)Þn4¾¸€.íÃx™g^—¼­ÿªnJ;8ȼ¬úreàù4I‚ú,;~?<¾ÝþçïïO. ħˆ¹åÉûwç8Bb‰~dñ€ºù>…Å+—ÊÝwÁ¾ ¡v¾ÿ8þP+Ä£!ÄC!ä£!äC!Ô£!Ô½SnUx:ÛîÒ=WvtÛ^Â%ðá{y~~¹nê~;:ðÉ›óK›ûamŸ‡÷í~Jc-Ùè*oK7´Bƒn]ûf“»yßõy· ‰­†ËÉâGi|ÊÛ^ùㇱˆNmõ¼W*ãL;Ò­“…U½ Då[e¿[€.ÎÚÈŸÇ™ÜùZ²ÏÀX+O}m€À4Pž—Û”ÆÉ¶uOtÏYÁQI6z`©¯ÍWŽëH½C16’±@*M·±-lÁ }É¿ÿöî(®m=î8]{²„{"ÁíP1X©ÆÚÝ—PžÛXûª\«6u‡;4UÆ ¢ƒúåáݺþ~QÚ‡Çój¬¶çÑNÍÔ;àÅá×4»ËAëÔy9vçø ïnˆQH(©8T‚Ô?‡[~Y¾øí¾ï¿ endstream endobj 4154 0 obj << /Length 461 /Filter /FlateDecode >> stream xÚmSMoœ0¼ó+|4RñbÛÐc•¥‡J­zˆz àÝELÁìVýõµý¼©"$°ßÌøÍ G'”£Ç$Oêî9¢Hˆó‚¨’¢vL~'¤âœ—Ü-t“ÄÂáiä ݙ任nXæÎËv~©“ëPE*É$ªH–¤*\SÆHé+zÆ?Ó’cfœrÜ6“_Øžõ¥mÕPZÍYæøF‚BÓu½íÍÔ °?êÆn‹^v\Ìu/øU=<ˆ|gŠ J”n„àçñÒÿÖ;댒\ÊinÚ”•ø57§hÃhèì|ìË.^¦ðë}FgN§Õ¬^<ß@+QJ ŒRR‰˜W×ØÆ‘9w‰lK«I‰îÌÒ"ä :ºoÆêÏiVT×çÞ;PÂ%• Š}ZþéçP(ñd®ÀêôqwkAÖàæÚ§ÅÓ ¶!§ïôEfõdC b3­6œ×ô“]Iš —À“Æ­ùjûÁ#x€=80—¾Ûw¾öö x»£þ‘2‰_¶©û~”ÃËæ;‰: 寄ý`¦“^`½nóú-qÐòÛôÿ·Q(’3÷¾¤û®‹úpöNr_'ÿ§á endstream endobj 4146 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-features_2.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4156 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F8 4157 0 R>> /ExtGState << /GS1 4158 0 R /GS2 4159 0 R /GS257 4160 0 R >>/ColorSpace << /sRGB 4161 0 R >>>> /Length 687 /Filter /FlateDecode >> stream xœí—Mo1†ïû+æ\{ƟרT‰"H$q(ÑJ!þ>¶7ÙÛqR8 µ’Ý:~öñ̬3Up ¶ð}x³W×+_vÃÕîíõ–«A )%ðyµ¼Ÿ:¿†÷@§AÁMÛA%^åg š~|`5™¹À"ál'zи7ïàáà.Å\dÄÔ£qsòïv1‘ðyw÷Á¢FT® >Ÿ¯‘|ž<¡NÏg`ñ×®/ÖǼoÝÊÞ¿ô±æ×›±,•Nó³ñWþ$úT‚4¬ïáÉòçfóüëfóÖÛ៬A™|sŒ@{<ÆÌù³º_/Ü#÷Èýc®¹¾¤°–€Ïç¯/•n- „éb{Pñ´VA ß ~×õÄÑ¢[•ÂUl…ØV¥ƒ0”%‚²Qé!\¥:4¶qé!\¥:4¶qé!\¥:4¶qé!\ÅWˆoU:S¡*tÔF·‡p•*tÔF·‡p•*tÔF·‡p•*tÔF·‡p•*tÔF·‡p Â[Pê€ÍkÎ"Š©˜ 1­Ja*å½éÞVa/Ÿ‹—“>¬Ç÷3žIVAQÐb`ìQ´fHÐÂú N)[GW ¤¬pÈS}£±^Xbˆ3BV*.b*ZæS14Gj4´_sC32*ÑЄì q¤ÛøÅ†5F] £UnüÚ =†+jhÀ CãR"Ç.4çÉöPºÜÏIÒ‡}%¼¬öS†ÂaŸDlŸ‹ýœžiE jßæº™ö±ò/Çkz^ ¬žÏÁr“ñ_¬ÀT½´÷Ï›£öé´y:mzÆ‹ž=fI"ð¹hÕÝÔç)/ã×|lÐIy¡CîÓ×Ë×·«2ýh/Ýz2sJµO¯•’Çuëúÿ¤ÛŸÇð1#Ê endstream endobj 4163 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4167 0 obj << /Length 2017 /Filter /FlateDecode >> stream xÚ­XIoÜF¾ëWô%p—kã6Hrˆ``L$`ãhvu7c²Ùá"Yóëç-U$[æ8™ $Öòøø–ïm’›ãFn~º‘þùÃÃÍë·6Þ(+ŒMôæá°‰í&Õ™&Ý<ì7ÿŽòíN))£»b(¶;“$ÑŸ/uÛÁFEÃVE.Úóö—‡¿¿~«óM.òD'ÈJnvZ‰LeÌéáä¶;keTÂ[#¾ÕÀ¢q?Ï{¾¹åVgѧmGÅÉMU=_6mçO†Sqæ³_Ç~àUÁWU?uõŸb¨ZO3´ÛN£¶ö„žÝ~ÉÕµØîÒÄDÿÚf&òü‹Î-hÚîSu>μH¦æR»ÆñÞ Ð»GâØ5ÚµWJäqÌÚï«Ò×Í廊|qîyÙø¹';ÛTGŽíì«C×6¼:º³ãUA¦ƒEÙž÷ÕL[Ö`×௶»XÆ|Ý)̮آÿÀ #h«¢žÏŸªáÄúª©ê¢ã ÈÒ¹¾¯ØÏ“n ëvéZd_»>fŒ!ãì—¢¯O«sÙvp ÚôC™ðü'Ò WïÙHmÝŸñÄ‚žEýÜW½`œÅzÃÆÕh©È2oê\(­Ž£÷[Âw•{>iLfÆgÈ=žÑ)¶42Þ€e0I¿h• “¥3 Yµ ÒRä@I}uüG1tÕç2–ð«V˜ÆF¨Ô†7ã¹d/š4‰P2Z€…Ñ"ÕÞñÁ3Z¶yÃNÃUÁRËßÆŠƒ 61Àûªðì6`#›È(˜&ñ¦I ºü7È cƒ?’·\wMÙ/-ȨÆãÉ‚WÄ!g—Z!AÝküÝP•#¡ ÝÏ22B\€0ø~+»³¿­/'ƒ6÷ö– {«$yžƒ³ ±"ÏT øÛ -Ò$8Ä+^UFèÌ’¤K¸w‡b¬Cð!(&½Å Ôz¸Ï¦ÿqHÊ3kÀ`.¤N)»æÊƒñ{s@|ó|O˜ûv×Sb^ேWµ{tõwžk²8Õ"N&­oW> ­'hc êWøèD(¨(”Í+rØwRH”61ºIãäP¾Ç»©z½|þøpƒòËÚ¨86ÎAšXd©Þ”ÍÍo7"•RZ¢X,é*¼ç^¿kŒÙܵ7ÿ„Ÿp· Lw ®TA!ǦR©ÈÐ&ÛèÅšŠ‚£ý RJ¨ŠîCÝ<ÂbB9…Då"„€¼ÝT¼žRÐ4äYO®!U=CÑøµ½ëË.| #Þ÷!_(¬v¸>#w ó<uþ³æ8…ù.$ÿ\ØÄ'[Jž’䎭G- „Ñå<†~óöîg><Îaá°âçщw—¢êžªÞñ®bÎPQCJ„ÃÁA]Û‹+ ¼¬»<'@DˆÄêP´¯ o:ªä{®¥TÜÐû@•–ÎP÷­Š–u¢~æ»Î!g43£¯U ß½§ÏÙœÍksŸomI¾jŠî™O»¶&K. &{ÑITEÍ׋Íä¾dòŽŸu0¸Ç~a,Þ,yé¥AC ]á |åÍØ¬`Å3Í GS=ÁÓ©š1,‹Î“| B.ÜLÈ íÔ²¸Y• ¥¦YŽMèÑ¿Äv"!Çe´)>Q-î9…Û4ØÛke‰ E+é̃³W2F¼¿íý}I #ñ©Då–cª‚ªÉ© ·U±Ö¡ÙT¤Y6W²jæW:4c¡bM•ái‰.~~nÙH˜É´-øñfDWÜ»Á뾎“èWWúŽX[‚±—oÀÌö_ìpO  endstream endobj 4164 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-sig_mat_plot_1.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4170 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4171 0 R>> /ExtGState << >>/XObject << /Im0 4172 0 R >>/ColorSpace << /sRGB 4173 0 R >>>> /Length 806 /Filter /FlateDecode >> stream xœµVYO1~÷¯˜Gx`êk}¼B¡*R«ÒDêBUH$ʆc‘ú÷;¶÷ð†eCJ«(Ž&þÆóÍi 8+xdïûGÎAjä´’APN¡—ð´€°aªïŸŽa^1A{òµš7Û'“íÉÉ×ð¯…ßìò 8übÎé»b"ýÂFl38n)‹Šƒ¥³$Hï±PÍÏÛ8Žé3¸é|àd[B¾¾ôoù…D+ dÊtª‘×lR¤sèL¨åÚ¡÷5¿²•åX ]B·€ZÌ> stream xœÂgP`€á~øÁwîçºãpŽÓe„БQF²2+)#IQÚEƒ¦‘’(¢%#I)m)´µÓ’h‰MÑ¢×÷=÷( 0‘ S˜4ÉŠL™ÅÔ9LŸÇŒ(*1S™YK˜­ÂÜåÌSeþ*¨±p Jê(¯gÑk°T•Í,ÛÊ -TµY¹U;X½ µÝ¬Ñaí^Ô÷±n?ë°A—zhè£yˆMl6d‹[ u”mÇÐ>Îvcvœ`§ »N²ÛS蘱ǜ½§Ùw†ý°äàYt­Ð³FÏ}[Ùa`Ça{ 0tÄȉ#ç8zžcÎ]0vå„&8yQ6uç”fž˜yaîÅioÎø`qI¶¼ÌÙ+X]ÅÊk_l®a뇭?vþØ_Ç!@v¼S çnÊçoá„‹ŒëmÜîpA áâ]ÜÅ{x„âŠW^áx‡ãO$—"¹|Ÿ+QòÕø>”¯=Âï1þb4×£ xB@ 7b|J`,7c¹õŒ 898žÛâsî$"&r7‘{/M’Ã’ SˆH%RLã~QéDe𠃇/åG™<Î$úÑY<É"&[~úšØ7ò³·Ä‰9Äçð> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4178 0 obj << /Length 1881 /Filter /FlateDecode >> stream xÚ¥XYoÛF~ϯü" 0Y.wyIĉ EÀz(M­$&)ð°£þúα¤D™Š×ærwnÎ~3#w²š¸“?_¸æùfþâ·k_Nb'¼`2_N|5 ½Èqe8™/&Ÿ¬OâËÌö=ߺøçïW_]ø›ÙÂrÕÅñ¶ëo¡=¦Œ/f_æ¶NìûF•?ªJˆG„$`º:0Äy BÉâþ`®\«fýÙõÝÍî6[¡Ä?u¡o5ì #FŽˆQGðÜ©½ø´Ò7»™-]e-ô2ióƈ *r|OѯtF¡u{kòeèx*êÈ˶ٶMÍ:~ÜϼÈÒiSVü^.ùÙTIŠGß³bÅ;7o‰SZiYUºÞÎl8.‹EOДFržXîI× ¥¿7½ÐõˆÅXxU³NZéo`¥Q´ÖlI1óB«uô¶Æ·ÚZ%ÐÔ™q5+Œaz´£ì±¥’NDÃ$JÑŸ&+‰Áµ]7záÌl%¥5g­¾ÎLXKL…-.rX4|ºÔIÓVÚ …*³•&FøÝ` ×I±Ò sǦÒa²øÖÖ‰³Û¹ïZÓ\ߣÏ:ŸÂjÕn4yÙÚr,‰ÀåHŸDÊñ<Ñ‘›hÜm°KŽªRãbÕ= /¶kZ†u>¾·š_)&HÒÇ_¶U‰ÞÝg ìa¥x´æWL<óÙ•*oðëT¼A‘B ÈW¸OAÜϳºátÛP…ýµ£“¬ËNw 删Ob×€râ¨Öï#2f\ Xå©óãoQHRP/¤<[RWG°(GA/4È®.t²À/mÒ¡Ô¤Å/vYó«ïo÷Ý£ëÇ'¦ìv‘ðàÄo.Õ)"S Õ)J<§ù¤¡ s}1Âý_Œ“ÑÓÝ(5< ¨ûj]ó{¥¹ÝjSjÊS\ðTsã¸æíÜ`z·ˆh¸MÜë ä™\’q•b+xÝ—äikÖÅÀ;‰!ö=¸ƒ‹*د×ÑJ…¬Ö¥tjFt2Ö%©ØQ=@\QEY·º‰mÈiS‚ýºoT"RÂtÐú Î’áÒpPéU›'\,$z€áІ1¸þʮӬû‚~"©Ô ©hŽ¡˜¼´ mM„zÐeª(ƒAçøN<’÷“ü“]—K!ŠoPwç ·(’RI€=45ñªŸH¦ì6íJ^65µYBëé×ð¢lªŠ#.,·ß7cû•Þ^Ÿ8ZdËÑ’™–mÑŒô° x‹!¸¦àÒÇÃd"Ÿ³â0˜$ø¬³ÍN(±e~{;³£Ø“,˜„’ô³Ë83ûêíÿì‡á˜`èê7e£«ú@< ¾þÅ€˜úX|½Í³”º”½ñÏ÷‰¨T:JågX~t[í.}‡wöI”~ OU@ŠœÝÍ"i!Üy´É8 Ī܈ûn\´Øšã{ÎǸ'dèž?ç³0´’»\ÿdN „£z¶nÖ4¸X £¬ä'4úP5xðcI#<Aãi7¨‡ß©\ÀsºGK@ÄæþÆ0œòëÃÐ!Ô‡ˆ8vÜÐér§h£Çƒ‹Gùœ×£ öÿ óµÒÄ`Ôò[Vð“Óˆg4S#yNÃ’FM¼‘½>øe ÿ±‚”&F–é¸ù…þà9x¯.ᲂË\'µYR— tuÓ ÂrŒÊê‰Ö}¤hÌñ»ôE£Ûèë´¥ä.µ¦ât[êùÐyÇç÷»¿ åŽPÁ3šR˜ŽÀ?mJÃèøxé¹'¬¦yo$6k÷õuvG€YÞå MS où„w©ð™*ø_à´W&v'ûÐÌý¯ Ôüy–€§Œ#|R‘­×CÖȰº?e ÆXãgiôkìYZGYå V÷iVµ78ŒBe½}ÈÛÿœ}üK$2âqìD0ã‘\©ïæ/þƒéÕQ endstream endobj 4184 0 obj << /Length 957 /Filter /FlateDecode >> stream xÚVmoÛ6þî_¡P3"EŠR±è–î¥(Z´õ‡Û0¨6m°^&QIº_¿;’ŠWI½&Hx<òÞž{Žv¢$úu•„õ§Íêê™F-2žE›}$E¤xN“TE›]ôùôæÝÏ'ðÃâ5#Y¼Î ÎIkZä¸ Åañ_›×àqÍ-¤\2Ug¦,˜&ß6̓)ûÿ¦Å#QŸN˜£©±‹ gQŸj\²Uué“\„Yâ‘·å8Là‰+*r蘒X3ã’¼ºëŽmošC¼N•$¶Ò^èõ±´¦m†Êtªù 'ÚÆðÿ6NѺñ—·m³3î¶-²Ùc 9Msušâ<0Qk,ÃÄŒ ¶l¶9¤.m*sç}ñbÁW(㣩ͱì!´†¤9r…9òrDsi2ÏÑÝ,›ÝUÛ{¹×ÝÑlKë½Àݲñ]ߢ§³Ó^1z?½lšÁ*<·“ÂmZ¿sPzï%”äb3R¡ÜòÍOùæS¾ŒÜÄR¨­‡%*úvì mظØîý:¯÷Pe8À’œ£¥ :(ϧnö_<ÐåhF÷~3G÷¶*­—v­_›6(BIUés5…ÈÁVßuþÊÖjÌ…ÆkÉô±®õ‡Ï#d¼Pï¬è&_Ot6ÿÐȨä¬Õv¸6ƒýMÇnÿLdlXXÅ'«ZÛªu)"NiêZŠëÆòhþÕAí†Ré¨ýí=ƒ~ü•ΦôOLU³Î£ÛSŸ‡Å,Sœš BAe–ú”_†0Íõ_oiXcÀ©~_ûA7z@a;îñt`L€œþ•÷ŸÎçë«ÍŠD,b¹EÄRFó"¶õêŸUøJ¹3ÑMvAqõ{Šèº]½‡ßél=9]ϼúo2R´P C,˜*h’A œQ>= X`骶 òú£_wæþ‘]Ôeç7؊µ¢À‡- ­€“‡ã$H¹íÛa’G/ ¬^ڃױ×}€ÝÕå„2¦"0¡*¼Š/¥ í¿5¶:ñëk†g9Â&®öHm7œžãzX`·”ó|2)ûÃX‡æ#Mà|“›ð€„)ðûïr· Ã+à7`‚±zGI_ô€Ìˤþ »Àc¤-pû^;Ê{Çëg§Ô~Ü\Fò3Ô¸P4áð¹YÐ|"W*XÀüAÏ£Ê endstream endobj 4180 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-dist_heat_plot_1.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4187 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4188 0 R>> /ExtGState << >>/XObject << /Im0 4189 0 R >>/ColorSpace << /sRGB 4190 0 R >>>> /Length 806 /Filter /FlateDecode >> stream xœ­VKOä0 ¾÷WøLâ<š\y­v¤]-;#íq€YЂ ÒþýuÒ4m!hµ5•ǟϱcWÂ$ÜÃsu>ó9Üþürëm%Qýu»~LêãeA½<þþ­áouq ~WüÜWR0¾Uñ­¨÷z¹©à¨e¶F%ÒJµCK ŒG"ÆÁ/x,Sèj7¤(’¢[E$;Š‚)ŠEiUAzìÎÕQ„dËðp§jê¸'Rï43Ú ¸³Ú¢“7K•à—.™•Ï%q7h%±4*îæzwY•"K9}†>¿W¢8jU¬a8jt´*TB,”3â˲ºex.̸42qÈÆiBoaµ=±«ûêt\~d\{ô40FéäçHaBQ ÖxBgøê˜puf0 .Ëx÷:“év'²“éKÅw@̉?e`è`iQ»ƒÖxnsmŸ°yÛÄøv‹pºuP›~H-Š’K›’¨ãÙ^ìÝ]¿<]ïsÍÂÞÃÕöu» «ÅÛ8K¾´Ce¹ÌZƒ¼û±,QÉV9t6æØëhûçty\:£^K¦è¡[ßO ñfjXÆr´­MÕ †$>Tˤ'mÑˬOb§#DÖYŸÄ Ÿ>g"¥ykøl²ù"$,wŬoÅNïc’²>‰Y?£º"³Ÿ3šÊŸ{7;&ž;Sʫ茆›|çl¬¾ÊÆÜÎyZwÆcö?ž¾|”±è\ÖJõhu<)ÙÌ™Ûì癓Îü9,ˆsézƒNÂzSu}æ 9é(ó/è8TÇ}'ÿ}øu#àä©:IïÎÁV¾´yô†þZ·Y;ûk’¢M ëÌTkr(òLš¼·6hóL¼7˜(Ù΃}ÂA—'HÊ?9‡¾™ ‹%œÜm_¯×7c;ð…Ï}´Åô*Îs³d±ô’ü°l!Ä¥kEIò†z^’<€ðøp¾iäÄÚÐæ:H#7þt“®G·n®UŸnéè6ÝÉt¤O7A2ÝéÓML7Aztgw—êÝ{É… endstream endobj 4189 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4190 0 R /BitsPerComponent 8 /Length 818 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿûœ›snêt¶³gw‹Ýbww&vwÂÁÑqxä‘'Gp” ‚ ñʳÇ@Ãn¨»0êAï{’q/2éM¦}É´™õ§Ø|›f‹¡l9Œ­†³Õþ8’­G³Í¶˶ãøÓx¶›ÀöÙ~;LfÇ)üy;Mg§ì<“]f±ëlvÃ_æ²Û"íc*~B%O©ô•>§²Tþ’~¼¢Š×Tñ†*ßÒÏwTe ºVŠ_F¢æ½¨5µ&â·©¨3õD½¹h°–â•hú(š¬E³øk+Z>‰;Ñj/þ9ˆ6GÑþY´;‰gÑé"àÚµ¾ô€[/¸õ{¸„d$Ãà1ž£à9Òqއ×DxO†÷TøL‡ÏLøÎ†ßøÍƒÿø/D€#p)‚–#h‚WA¶²µY‡õøª ùFÈ7#t B·!l;Âv |"v#b/"÷!r?¢BqŠÃˆ>Šècˆ9ŽØ“ˆ=…¸Óˆ;‹øsH8„‹P^‚R‰WtI× º•>¾ÝDò-$ßAÊ]¤ÜCê}¤=DÚ#¤?FúSd> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4199 0 obj << /Length 1363 /Filter /FlateDecode >> stream xÚWÛnÜ6}߯ü¤,Z$%­T$R»ÀÛ,PMh‰»Ë@—­.vœ¯ï ‡ÒJö ¬†·á\Μ¡Coï…ÞûUø?_¿¡Ç=',Š3/’1‹SáåÕêŸÛ„aÙ3Ñ.çÜÄÕ‡JÆÞM³ú þƵ`TÌ´þ²]]ÝÆ±·aÙ&äÞvçñ$aNG"‚9ám ï/ÿK‡ ~ø:qäüLßÂt½ªsM£ƒV}¥Ž4xX"óu¿†ß§µ }­kZiõ±4¹êÝ©NUÇRw4PyÛt£\–$ìuíöîà†¡Õ[ÿ½ý8íêVd^ƲD$è@m˜ÌÀßH°$#û·ƒZÓ_éþЀm¿ ‰\Õ$ Å©7¥‰?tÚ­÷ }õ·cÙ´š©L¹æ¾j×÷ H½ÑÝBxž‚ç(jwCÞÔ…éMS»»¦%A¡®ÒM:/×A†þ¸åëÐõΠCÓéå^²ÔÈ4¤.ŠàËYɵ!è•©­OQè?™þ`Ð(™ù ø,„ ˆ|Áµ'¯‡/¡”ï! ŸÁ+»{ð8eé´9/Uù ¢$òß¡÷¹ Ù|^§Ò¿D \}æ^J–‰tÔå Áê¦g‚îíí™ë³pgT»*8ÜÜÎZ p=– —ž§ ‹ßŽBñ"ss y©)¦R¤,I³eP $ôу¤´PíH´‰“ÑÀ«ˆÁG˵Ñö¡‡ K$Úm3i=µöeMC3“ÙˆŸOw·ŸÎX-K㩚wC=ëc±œ#6d!´K·±®«ÝmÐ?ņOÚgl ï¤Zï©}ÙF€³ÐÎZóÍU~–BžÄ2_;•÷Ы¾ÛÆ„¼EþŸ–w×ÏíK„¡›ókÛ¹ŒX*NôÖA00Åÿ‘I(âLLE<«yºƒ‘ hh#3Гí‘ÐÄZ´pkÈö8|ÒÑ{Ú"´ ¯Ðë^¼¯½€8"&þp`’ÉbÓ¯ÛÕ¿h–e> endstream endobj 4181 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-dist_heat_plot_2.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4202 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text /ImageC ] /Font << /F2 4203 0 R>> /ExtGState << >>/XObject << /Im0 4204 0 R >>/ColorSpace << /sRGB 4205 0 R >>>> /Length 1390 /Filter /FlateDecode >> stream xœ­YKo7 ¾Ï¯ÐÑ>D‘(W;IQ-šî=A8 bÃë Ùýû¥$ÎŒ´ÖÈ«Ax ™ü(òI="Ù “ìžýÞnüyyüû·+v{$B°ü{¼}$ñõ®"Þ]ÿþjٿû÷L°Ïƒd7øs?H ì!þŠ­ ûõóËÀ®&˜µ\Iú‚qÜH¦´ç QýÃë. î¬+]$X¾ÁE,Í. tQd.¨¹×L ÇA£\Mø&'÷èà£7d3L ÕM 墊P:¢$¾…²ʹ RFJÖQF}©}D%R‚ša;¢:h•$ Ͱªd…FóÑTPõU›(\C!.Rhk®£j ®ã÷”ÂuԘȓÅE6@q¤ [>Í ¢Pú¹=› ¢pU'ž(|…ú‘ íLNaÃC3†Ôážda4Ž6¨SêœÂµ2IÂ(¹—çgF¢pU'ƒ(|õ$ã…  5)~Ba4ê±èy…­©*=ƒ(t¾çV 1¸ªåØU˜ þÖ@uÒ}ëy&25öÞUzçTÂÊ:ÎmS 7Pµ ¡n *I1•ð:ªF•ðh¥ÇP ¯¡®ö•Í:îåoÏ3û¯LÊùì?i VahLá1ÜØ…¸dûûáõ>˜|¬„áÒ`,s¾‰³KubÀ« ×§.àžz¾‡\i´×A€ÇnvbÓ°# Û/îJ[xTÈ‚³…þE(f÷Îö/BiAúîEÈ €±Ð²ïN\€±'‘F q1ŦTTy§zx”Hƒó……îE(¦VtLŸ¡0Êv”UBiÁô$ò´ Ö„”ÜRÎÓ*”zr‘ê¡°ÐG$¨Ð Ý«ÏTÿ*Œ»WA Ëå¶žH«PZè+è´ ¥…®l¤‚8‰¢‹I……îŽTL/õ†U0*$Ä–}…öçÒBOSœ¡0ÐWд¥…ždt>P ]4J<,á‰/70·¾ðL?aòé%oO"Þ¡æoqúò¥k>µû&îÝèØ»‹7wŸ~~ÿtÉ@°‹‡Ç_Çâò=ÛßœFÚ°†×dkÖäÙÖ” É €_ˆ¤}{½»þPMÿ[xµxkpí¸ ‡:̾ÈÌÅÝ_»ó''4&Þ®&´¬-zöÐÑÄò}ú'NÞ⬎y…Y†î0¤ç6> »In,Ç«Æ,OÃE 8^~&9 3¹ÃéÜ"OÃE®Ø2? 3¹n—ùiäýoš‰’¸(Á’?‡yý ŽàQ¯§‹œ†‹WÒ‹œ†³0OÀÎòi¸È1 Í2ÿ4œå Ï+fù4œåÊ=FþÂÏ)™’Ó„S¾®\_¹W­I-Bsoš«×{ÝœS¡\fs‚¯âL8uœà«_ÇÛÐ×3üjÉWáJª°Ï”ðjÍÿ?Ï<ñ+¼™;ßÛ”fÆÇû>:ˆËnë_g;?°N0^R!4-,¨ÀâíaXö²i}âÿ™åàâÀÅj§?¿üý Ø«ïÃÛ•Œm>Ô»øÈ%ʽ =ƒNÂ{@DnÍ„®nÜ-4ä·©î¹õJŽÐÝsI;s8´tÏ ÄËùÔÕJÅŽeZ9èQöxÅ}"ëfÇ^Ý}|¼ý²6ó3ÿÞÆ×{z–¯Þ°z0ÆKG?0¶›Uðè}¦’Æ… vl¡2•4.T´{Ì¢’Æ… JÂN<«¤q¡âdh2‹J'•p_rYD6Öm©Ì‘J©Ì‘J©Ì‘J©Ì‘J©Ì‘JÑæ7ük ßH endstream endobj 4204 0 obj << /Type /XObject /Subtype /Image /Width 1 /Height 300 /ColorSpace 4205 0 R /BitsPerComponent 8 /Length 819 /Interpolate true /Filter /FlateDecode >> stream xœ ÂL`àÿû6ÇæœcŽét:tŠíTìÙÝ Ø­˜ØÝ€„„tÃGÝGž݇œ ‚ ‚¯>{Ì„0ga1DXhÑû¡d9Œ¬†“•6Y ú0’mG±íh¶ÃöcÙa;èòÇñì8&²Ó$vÖc—Éì:•ݦ±ÛtvŸÁ3Ùs{Îf¯9ì=—}ôÙwûÎg¿ì¿%‹X²˜–pàRZÆÒå,]ÁÁ+9dËV³l ‡®å°u¾ž#6pÄFŽÜÄQ›Y¾…å[9zÇlçØ·“ãvqünNØÃ‰{9q'íçäœbÀ©†ÿSÚAJ?D #R¦Œ#”y”²ŽQÖqÊ>A9')÷)O“ò }:KyçHužT(ÿ"Sá%*ºLEW¨ø*•\£ÒëTjBe&T~ƒ*nRå-ª¼MUw¨ú.©ï‘ú>Õ< Ï©öi“æ }yJuϨþ9Õ¿ ¯/©á}{Mo¨ñ-5™ÒwSj~'šÍD‹¹øa!Zß‹6KÑf%~Z‹vÑñAtØŠ_v¢Ó^t9ˆ®¢ÛQô8‰ß΢×EôºŠ>7ñÇ]ô{ˆ~Oñ×K x‹Aßÿ~ZðmHt …€1‹@]M@ÐDHõ ‚ài™Y͆l.Bõ6a ¾áK±‘˹Q+µò5¯CôzÄlDÌ&ÄnAìVÄmGüÄïBÂn$ìAâ>$íG’’ ‘|)FH=ŒÔ#H;†´ãH?Å)(N#ã 2Î!ó<². ËÙ—}9W{ ¹×¡4ò&>ÝBÞmäÝ…êT÷‘ÿPð…OPø EÏQüÅ/Qò%oPúe¦(3C¹9Ê-Pa‰J+TZ£ÊU¶¨¶ƒÚjÔ8¢Æ ŸQë‚Z7hÜ¡ñÀ/Ôy£Îõ¾¨÷ÇW ЈoR4£1M24…á{8š#Ð…9Z¢ñ#­qhG[Úñ3í)hOEG::ø•ÎLtf£+ݹèV¢'=*üÎGo!z‹ÐWŒ¾ü)C9ú+ð· ÕPc°ƒµ€æ¾~û endstream endobj 4207 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4210 0 obj << /Length 389 /Filter /FlateDecode >> stream xÚ¥”KOÂ@Çïý{l»ìì³{Tƒ‰‰ÆÞÔC¥ !)øüîvP %¥M¶óèNç÷ßI9™NîþËÂÊ '˜Í%Qà˜1@F³ä#aÊ„«y¡e6©ïm»@o8“†ôÉS¸¿stW“¶Š^Io 5±ÌY¤– —Åã:„*ò’¾rÍ˰@F¥VéãÍËz±Fk¼X¡1ñsOk¿Í$O}c:û2ƒt½YùÏì­¸On‹Ÿ¦¤àÌ©K8m‡sWó<§Ô’ n»œï{·þó8Uä< éSJp’mþ™wkÒVÑ.¤"|8—Œ+³g!£0:ΫévZmÊý•_ÖÓQ¹öè¶…1xò1ŽŠD«Q$ÇŠ4I_Ò¨F虺À©°‡Ó£ŽK䗨亣€5Ï«$A3gº*U¨’µW)Ìq¡–PÑmG·h P$ CGBuå9˜£ã?Do q¡aabóT3ì B‹û¥=Ø4þ'J endstream endobj 4193 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_PCA.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4214 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4215 0 R>> /ExtGState << /GS1 4216 0 R /GS2 4217 0 R /GS3 4218 0 R /GS257 4219 0 R /GS258 4220 0 R >>/ColorSpace << /sRGB 4221 0 R >>>> /Length 22426 /Filter /FlateDecode >> stream xœí½InIr¸¿"–ä‚Q>Û*H@* èÁ"% b6Z¿¯Ù9ÇÜ¿P²”UdwµÈxif÷¸ÛwÌmÈoþ–ßþþí~ûËÿÞÒ{JøÓj¹þù§¿}û¿ÞþñÛ/~üO¿þåÛÇßòÃLo÷ß?$þÕ?!þáWÿѸóí}û«¿~Koÿå[~ûóç¿¿ÿ–½»ÿðíŸïúÛÛ/CÁZßg}«ù}ç·šÚ{You·÷‘¦Š¿ ÿííïÎOHï»”·û¯ý„ôÞëù éËO@㳿þöùPë=e’ÿðíŠs›ï%9ésAÉë}Žséë‚Þk¹.}.¨#¿¯y. mä4í)à|Šle¼w´×~Ÿù\òº Ìò^[\@ònáå1S£ý¾Ö¥“×=Éù½Õ란¾.Xå}ïëÐ×=éí½·ëž€¾îÉ£`N—  ¯ ö|yn¤í‚Ñßg_ êþÁm½×}nÈû–=¢TÎ-y]Ps}#. y]ð‹_ÿPú|û¯?úg‚ïDýËûõù§¥xkŸGøòá½½=¿®§·2^¥›±×Û~nA{ˆi <ÄL">ìÒý^gH·)-\5.u†Âõ÷œ£U'üRö )µîÖõãÛ/Ÿ‹Ûóÿý­´n-~^Œa<wr¢¯·çûêC„uô<Ÿçs–ôQcŽ„·ÊKÑü# ®½ç­:ñ¼OH© p·®ß…ú¥Lk¸=ŸqwõÉèÏøø<í²ìAõç-Nm;…«Ù7åÔ‹Ø[oü–gœ›Ï|¥Qý§ˆñ<µôÖŸ‡VX͈gÌ$a}õaÃŒ¤Ï4”GÂ[õKÉhï{®½·­:á—²OH© p·®ßŇP³¿64µáúg¾g›u’†Êñ̺%kXÐË8[]^ÞK?XRÞ6®&§¿¯t°Ý˜Ñ¶S¸:i¸5¹ôöEo~Ô½¼ÏçI>“OæW}8ë¹a½úƒÍí½§ì¹ƒòOðy¼öZHÞý6¨Ìo[œòÞöÁ>3`?m;…«Ù7åÔ‹Ø[ïïâµ²]¯þËrÆ£8û„öó°îJqj6Q~»ösgÒ‘—¸kë¦8ñçYtõƒM®°Úv W³oÊ©±·ÞlŸ7.\‘0ØŠSl¥h”ݪ‡zVáùy#KåâÃYûȧ­ KÊÛÆÕä$S;°ÉÞµhÛ©jâ}SN½ˆ½õæoyVdÛæ´j°Ï›Ó¬é\°Ry¨ç½ÈÏœ”§(ïïáØg'ù³ZKÊÛÆÕä»Ó-öºDÛNájöM9õ"öÖ¿åYnUÑ7ÖœÁ˜Ï#œF,Mò{ö%ž¯¿œð¾RòÞÁ1jf!E¡a]MNi¾þcÓ ¸ ´Ž) à‹Â|¶TF³äcÉç+çÙñõìj>™>ÛŽ’E¹f¶™!oÉþöPz[Äñ­E`›um;õAM¼oÊ©±·Þü-Ïw5ðv&<‹3ž…Åó]Ú}{ÞÇg˜1Êî(ïoW¿•’7Ÿ„ *ñ—“ó,‹ìm!öžÉAmƒÂÕè[rè%ì­·¾“çUx¾»çŸ²ùgÛÛ™m†+Ï?=9µ’(¼ËÅæ¥WßÒ ÔÓ6®ç™Óže‘°õ Sj®Fß’C/ao½µÖï¬×àb—œîƒµ×0EL§V…•)ô‘º KÊÛÆÕÁ)é`«mƒ¢m§p5û¦<4uì­7Ë3cûµÓ&åÏ›³|*}æÐÂ{S1woQÞß3·÷qäݶÐ%åmãêàäq°Ãît´=´L޾)M{ë­o¿ûHߊ­3?oÎs ·S{âÞ<£k¾3…ïsúx"ùô¥µ°¤ŠµÁÉf‹ ,¾5µ}¾EõM9õ"öÖ;ñíiàCFÖ"ÞÏ€S|ÙüìuŒXÙV×£‰à"¾æh ´ÊKñìšpÑ’Zñ¬OJ©p·®ßÅjëêÿ!ÕŸ £Õ²]ÃçÅØ¶üš¾3âYZ<Ë–EXG³`L…´øÀA‰¥Ý‰ÓÖÂMÛ1¨Õ©­‰ú„”Úwëªi»Úwì·°sÚ&ÇíºFùP0ýã7[s…©µc(¡¼cê%–”·­«ÓÍ€Øn&ØhÛ)- ö÷n jî¥?oNµpÞÜcºÃ(ß:…Oƒ¥äËWHÂ’ò¶quplŸ%löÏKmçøüÔ7å¡©co½¹ܾ@Ó޻ϋ±Ì&éû´êÔÃ4j%QØÕe<Êý°.°¤¼i\MÎ0ëg`‡m+¢m§bYÅ‘Z}Qú Á´†¤C09vx´+v(~ÜgÃdÙ¢´rûåû(bƒâz>8Å÷ŒÂf[eGÛYëùè›rêEì­·vN>:ÛÇYea §Ù¼f;ù†™×öÚÏ´”¶(Yf?òåúKªjR Ž/¯[|`PÛEóbôM9õ"öÖ[C0¿¬iOñó•ãßr£^_ø¶¿! 0Ln7 Rž“͉ŠïLp†Ÿ%ÛÝð¡¶BÛì›rêEì­·v_b¶•õç+gc8`Uk4ËdQÚÚT,yµ£³ÀUt59Ïî=l ÛNçD…}SN½ˆ½õæw_ì],Ï®ecs.†xÚº ùb?ï7³Lnži~ÚJi·F8CCÝaÔ¸nÃZíçÔ'¤¡žán]5bv-¾ ý|åøü†¹¸&7«ÙÑÉ… ‡D’oû) *éjr|Í'l™˜ßÐv‰-¯ú–œz{ë­Ïý™uŠï¦W‡c壤’!å Ó(¬Š²¿ª’©… *ñǨ…ÅÎVmƒÂÕè›réì‹Þü-­é÷-ãÈACÙ–¡ö\2Ü:žK“TÃ6Zòé÷]Ø©ç"“Ôáä؂Ɉm—3Y±oÉCSÇÞzó·ØŒŒáeÒ'ŽFFm MÏmÈvzQDy/¿äÝM·Â’ò¶u596y ;Üø¥¶GÇÔ7å¡©co½ÏçŽmÁ®ñ¹W¬ü·}zÛ“g#£àÔ2jcNiÇJ8]˨ÃxÞDáü¬S­:ÁϽΆz†»u¥úõ”É] ß‚Ú"h:ñkú2úóæøjÍ({šÓ‡œ°‡…¥P÷)Zò®s;Çvéõsµs|X?‘‹¶ãÄ.ú¦œz{ë­‘wKó¥}9~Œòö–›VwB+L¯;CʳNJ +ÊÛÖÕú­ù`»-ì£í®“Ôèò£©a_ôÖ>}~ì¾4ú|åØLð¼'fZµ±:µ²(|…ÛgrÊG’בa•8ˆãË£Àk4Ú.2éEß”S/bo½µÐêfŒó‰˜Ç…â,Jl ßÅ>Ô*¢´{mëÈ—| KjÊŠœá+_aý%ÚŽ#–è›rêEì­·ZÕO)í×ò·ÎÆi™išWqjoQX u,†(ø’‰ ªR;q è]‹8Û«ísPª¾)§^ÄÞzÓ´S¶šÐ´EÆ6ãÿœ8ÏI¶zˆUE¸ FuJ·k GbiqÏO!®ùšŒ­‚ðKÑ'¥¡žán]Ï„n¯é3É÷ºqžåF^>©Ú‹ðP¶ÜhØa‚Ò„^Û‘c¿*,(´­«³|¹A¬-7r´ J:_R—SSbo½uò‘ôèhÚ ŽZŒòA½ÚÞÙü z…ÝEñå†äE'îŽ%UdÚ Nvs‘°gY'æ4mEß”S/bo½¿ ƒïŠ£­õŨ6˜{Tó/í™"V‡i¶iYà|Lù4ÓO`I…jÇN‘…Å¢Xm'9Eß”‡¦Ž½õÖWQý±ö,÷¥à¸ÕȨIß œàµ"J'|iy‡­ƒØ.ËG;Wó¤xîƒMndSÛ) °ê›rê•äësôæsÉðÖÙ¦8fÌÛ~¶k_ÒÈn޶Ãä-Jç£yñ Ð¶N¨É1s´vàK§È>q@öMùÑÔ°/zã·ŒæŽu?/†Ï?{iìŽî[çs‚<†[(¾X ŽD‹á¾ÔÂ{ßÔªP`ÖRàn]5qÀo:pW+N·!ÙèÄ#s ×3‰ŠÝÚ8ò›3±¤ZìS‡“Rå‘y;mW9ŠFß”‡¦Ž½õæoyÞYþéÊ Nóì¡ìPÕ¾®ç#{ÞžžEaåWÜ UòâÞŸÂ’ò¶u59¶3¶¸AWm—0øªoÊCÓ\¿è­½HƒkW¶¹õóæßsÛÙ&²Þ}÷0’(ì†Y‘B>´nu,©§OâÀEX·ìFÛN}P“ÝŽ¼É ͱ·ÞßÅ$øo\}³ M X(áàs8Ö¤jn¦þAµ‡(Y¢F=òjËÒÀ%q²ŸÂºb´c—©¾)§^ÄÞzë«p{‹9UÚÇi°§® ûTóÛ¢ðæºJÈý¤8°AÕWO¸~Ù>UØG:¶Ý£û¦œz{ë}V±+ý|å,ìL7Œä­aDY¢4þ”väð¬6(íÅqÏžÀâ°Am¿ìw>rêEì­÷±ÁÑ缬°ÁÉ ¶.;®°¹j»ÌVu ´JëÈ»¯… J‡@âTO„õšh»Æ;¦¾)§^ÄÞzë{¾Šy–ž<ö¼8¶Ç(;[þ©™{‘Y^W˜œÌaЬ³’/?Ý6(Zí‚ÓlkØjFµh»Êp}SN½ˆ½õÖ;Vl$¯ÕN>oŽ/¹zÔªÕ_íüÜ”§!Rxš5r7™–TÔ\œ²¶Ùí¶Òé}Sš–ýEo-—['ž]sáo9³ÜfF)mŸ¯ÍÁ`ˆÒÂμ(/î+ì¡Ê¹º3pj,,·j{Æ*H}SN½€}Ñ›ûª„.ë´í0Ö³?‚yN –¾‚Ÿ!¥‡eÀÁs61qàv#,ÜnÔ¶SÔd·#§^ÄÞzË Ç³ÈdÃöç+ÇîQJØÛd·Ûix£YÁÞˆòrK\M\{Ä6 Õv‹£ õ-9ôöÖ[Ï%y °­|Þ·¯µa²×tÑ78Åkl÷'9|‹…%µb18yÖ „-ÚõAM¬oÉCSÇÞzó¹TwÈ´=óÁñQ¶^xÇŸ…†yj‚ò{WÝ=4侇,©¬Åüűý°°xõÕv8OEß”‡¦Ž½õ–¡tû N±¾§¸É‚ç8iá N¿lFúuÓ)³ K*Ëšrqln6ù¾_m§° ¨oȦtì;zŸwÌŽy§»,Þœì› >zÓ}ì­HS”ÞšÙŽ¼ºåZXR)Éîñ#ìð` µ W£oÉ¡—°·Þ|.O·½ûjÒ¦"ÎÄ)¿íé¯îCùH05h–‰ƒÉyØGlýÑ}ðâX£ÂvïPmwmà¢oÊCSÇÞzkÙ²=tÑœµåHΉH0å,ÄGLQØlÓמr7= +ªê»86Ê [|±«¶KXÆÔ7äGÓ’¿èý}ì¸öóÍÅ>oNñsà•ÂC¥´ðP´;¯#/²çôt¨|"\ƒcZÂ&_£©ít"\“ÜÎ]š:öÖ[!apþ‡'üçÍñW1ÏæÃ‹­ «b™ (ïïáÌqäôd'–”·«Éi>] ÛÜ5_m·pÝWß”S/bo½õ\²ÛŒF ‡@qÜQÞ”†}ÇÆ}M¢4ÕqäÕ÷HÂ’ªáx8¹lqg/µ]â4X}SšæòEï³ëxïô\ÄÁ½]˜ÂàláÞC”Uô)vyÀØ&_ävl›ŸÊrx7T½b¼1Õ~°ÙfÁh;ë1ú¦œz{ë­ð@H³Göysºï¡úÄÙݺ/|­]1u~ÂÜ|û‚UXRíì›É©Ý.¬Ï™Ñv=ûæ©‘¦¬£±·ÞçÜÝw£–T%ÎÝ·Õ>±w-n4—™&JÚÙÚKòíO^XRéøá§ôÀNÏi¢¶Aé·Xß’‡¦Ž½õÖñÉ„óç¶aáóâØ"®»{ºG7fu³ÛûIáˆcëÉ'8Ù×XRh§ÏÁ±I…X;RXÑ6(´¾%M{ë}Ž‚ÌCak§úmÊ;j”ùyfÿ I¡¿æc£är–TLÞÇ#÷ˆÍ˜ãÙvçIõMyhêØ[oE²ûÜìó‹8SÞ:Ž‹‹»¾.Êû³µW>ò…õý”ßQëjW'¥ƒíØQ³í‡`ê›òÐ4¥/z_a¡x²)°P>ëé¡™<ˆr/øK‚òwzW7S×KaƒÒi…8S#·kîÓöˆÓ õM9õ"öÖûø©Ð”‚ÁC ýAœexbÐ"hÕ8»9=Oˆ=>,ܬNn­pŸaÛ >¾½úФ[SÇÞzk+‰€Àá>Ÿg&8.zèœQ“N˜C¶Hî¤)9"ö„%…¶ýjqÜažóDmƒBÛè[rjºäå{ô>Ù €³G @† 0»3~‚EÐr0˜lÔÙý³%ÏnW–T ÝáØª@ØÛ9Û.Ƕξsô| /Jë[I¾š›)â—Äñäî5†mb‡ÿYÍ¢>øeíyäÅg6aI¥ˆ_"g`¶ ö¡lÕ˶A}P“ÑŽz {ë-Ï`oÁŽò§<ƒÉñý¨6Ã1Àîzq]HÁÖXm¦yµ7&°¤R<•Ãñ hÇ»ÅMm“ÒQ¹½C’‡¦ ¸>z_Ïqãz.0KU>˜¤ŸKÏe¹¿ %9U.NÊ;l”ˆ¶‡æ–è›òÐ4å/zŸµXÇ9eO±ëpöáZ,Á´É5Ä좴kùÈ—ÂGK*__pÚÖZ¬ÁXgöl¶ Jëë[rè%ì­·,ù09mOôys<—„YÌí-Ff®ŒÅ/)XÛaà’žÂ’ŠlCǾaÝ'$ÚŽ„CÑ7å¡©co½õ\’ö{Îà¸?§']³wÖý9³¯ÐAáÞyÞŒ_‘”βęðÉ$vÀ_“mãÏɾ)§^ÄÞzÈB3Í È‚Ûf<ÔÂ)Ý„GdO¢°Rìp-¤¼û¨*,©†GqÚ'lóŦÚnáÚ¦¾)¯ ¦Úù‹Þ<•€u|d›ˆá^“fWǶëYGÐìÂÏš[q(mŽDÖ6ú0žO¸d?_­&Ýõ i¨g¸[WªKLÙá¬FõD7‹.‹žòpÁ¾Â;‚õ‡Ò³p Ð*/%Ã~)peÙÀÄVA|@µCêîÖU»`šG«ÃÙñ,=|kÖ†­¦‡SæÚÚµwŒ‡½öP5ÅXʽàh[­ÃhÛ©j2ú‘S/bo½µâ*p0Íú-Çl  $̦•Z[VEH@!9,?ÂUeê'Ó¶°Éwjj;ÅNN}S^ä ëØ[ï“T„î½£ER‘Æ#8'&† "ñÇL¢ð$Ù¢¼ f˜XRé$ÇÇâV`íȧFÛ p5ú–z {ë­UýB:8_–}¾rl‚J[çáv–“üõ$…Ý’FQž3 ðÀ*öÌäxúŒÀfßuªí»RõM9õöEïs¶m¿ý™Jz8óTŸ¾º1k‡LM”fÄŽ¹2„ J¡¤âørX›ÖPÛ¤4#öyäÔ‹Ø[o͈ï18vH®¯#&õšÝi6ä8 6¨˜Éá¬F,g<¶}͈ì›rêEì­÷‰ùcv»$+kp,Y×®Úâ=–Gá1s^D©O%&u9bÀ… JÇâ`#¬&DÛçØB}SN½ˆ½õ–õ‰NŸß¾ùމƒċêXØ1æÜÞ(X¨‘SuŸcÎXQCÇIÇå…ín7UÛ=¢Ô7å¡©co½™¸f‡6)bt³6ttÖÝâ>àûÂú²ãÀÒ 'Xljh:·ÃmK¹iI­VyªOgHǽèz‚³j÷L‰ùg‘³šSÏ@o¹+Ü{…íi·©:äþSTDµƒ“qöMl^>™²mPÔÄú–z {ëMŸá‚Àx÷¡û¼î”4*êý¬é!Vá÷·!ÒŽH}àHeb<Œ²ç9Õª~)û„4Ô3Ü­+ÕGJŒÙåPxÛý‘7‚àžÕ¨¹-wÞ‚n)8’.n‘Äð Já<š@­F¬ú„”Ú4Þ”£+?„êvŠáÊÏ‹áfj‹áš×Ó9•!Â_ÙæJ»[³ˆ#–P1^ž?ªÿ‡Tÿßø»¿üÄlK#ϤI¢[G…‘PžD~Wy”sÛØ’›pý$Õ\yÈx6$Ây"µy^Ô'¤¡^*¯º~/m sòC…YbãïÒ’'K1ÊnRÚ8(r<7Ξ!Ïî,¬¨¬hâ‹c§]ÂÂ⤶S„«oÊCSÇÞzŸkŒþ»R¬ ®à˜bæG8³¬! Û¬ŽÃ ¢k4R0ÅZšj[[ÆÄu\9ؤkkˆÂÕM±ˆL±6úÁÞzkƒYàÔT#ÌKä"¶³rÚ´º;5Ñ=Ja^i%o°—Ûd]S˜—8ðÃîjû¸o¨oÊ©±·Þz.>ä5²"Ž'zðX˜p BŽÛmhú~Eräò6(¥ Ç3Ì–^¥lûò:eß”S/bo½yÌJ˹ï>/†çÛÛÍOBû`2¥ÔEX_;løÃsŽ”8]1'Ýõ÷Á6}6Š 'ɹ/ÁÍŠŽu‰ú &³yѲֽO€­gYQ5CwG´°×„ñÖS\ —í“kb¡|âðXR+ªfˆ3‘ÆŠXÿ'ÚžX©¾)§^S鳎ާj>ݺ£jÆò÷ðYYnÄTYœRR¦Rè ©,ÀQÖS ƒò†uõ¢³j ìôšVlÄ´Ø%¤P À…uøˆØ£éæÅÁ Sù&±Â´C}w\J‘.ªà¤Nò‡2bAõH:x²Ûá¡Æ¶{ä\—”SSbo½Ï7³a2Ú&8¢dÔÂAéÆx©¼›Çý‡¹yx¤=k`E¥“¬;8vdMló€&µ JcñGšò¸ûèý]ÌêJ‚2Gxª΀šÝ®é¥ÄŒZC”ß.&=•¼Ác’Ø ä©*ŽW lsOTµÝÂSU}SN½ˆ½õ–¯AÅKëe>oR„Uf¤ðõì® (yÌzäÌ}A,)oWÇý5‰EB1µ1 Ñ7å¡i-_ôÖT2’¹Pwô…c³±ÕØÀ€kÎeùuÇ=Éó‘o,Àˆ ªèjr°“;)µ=# R}S>”ß±·Þ~›ÏúæD‰Wì0,Ã#¶M82DZ!‚û¢ZBŠŽÄA×1–í~ˆ>'°UÜBy!H© p·®Š§C@ª¿|ÞÏCgT‡³¢L›SIå¯qEøäM•eKªG‹8 µªÒäØK¯¶[$¦Pß”%ítì­÷•”[Ò^Âb2SaÇð}èôìoL*,&ëÈr´KjÈžœîÞ„õ¬®Ñvìpê›ò*—7ÇÞzÓËk¹Ø.2˜ˆá»w[d7'ž%Õ|Ì"ü@`"›Ž~ŽùëÅȶΣÕjÖÚW}BJm÷¢+¿ †Ol>_Ï0H—W+Œ–,ÁjJ"\'¤î¢Ô£'… B¹ŸÉð—@8hÔjŒhêRjÜ­+7ãH65³|;ãyËí ·y|dzýµÙ ‹ðmó„ß<¤Óï"qAh‡M†ñ"n¸Ã[áŽÇ>)íräoùU×°¡o|)¥É†NÆ3$´¥ÄWÍMß¹‹ ¹xe1žµ@¢4Ù«™×ªÏÀU;øR«U©ÌÔ'¤Ô¸[W9go¥±Ì“‡¹ j•G…QžÛ,ì–aÀsŸQ^”P“¹ Hå“Ù ÀUÍó Dæræ"Ø[®fßÎ ½ûª·vÒBª»ÏWÎÄn`À1ÖBºÀ@aͽ‡ãò —ibƒÒ~Qw… ,BßÔvý¢ú¦œz{ë­¹þ)Eâ`qü ÔGwäó›(¶"›ö)Æ2ç‘8v„½\ÑÔ’E½fb 6³mR1³´#‡;¤°·Þü„ֆâäĘ6hÎ ßÉe¶»¹µŸ£iÏR… 1²Ù'bèHç0ž5­pž9T­vé¨OHC½÷¢«…gú¨ik€½8拇,¤5'÷Å«î±C ·ËKKŽ ¨Â*+W99Ë#O‰Mžj^mƒBÛè[rêEì­7moCÇê*5FFaÉ0&†±bbžzòÊKlÁŸ9¤ðž$ŽDŽRcd$/Fœÿ|µwG}B:tÈeGW-fWÔd¡½êp<3ä’›¸×‹ÝQBFέ¬,yIª3÷MåsµÊÈŒÀvä¾gÛ ´P^éÈW”’_ô>{׉@e¬\çÅ Ræ$*`‚ @Ÿ!¥6Àݺʇ»—³žº8¶mÉT |”=;)ôWò­d*Ž JÆlq|y$,VNjû,¬Ô·äÔ‹Ø[o®l³^ÏÁäÿ`l_l¯nOŸ¼‘,—«m…IçˆV¹‰##%á`Hg« ¸^ö#]HC=Ãݺ†+qш+F³•tƒ »¹+tg¨Y¤2ëŸ"iŽsÍDlAÄðŒÂÂùþ@­ÆD}:CÚ8îEWÞ}ØNWR¡•Ãx>– ;ë3é73Úl Âï"Í)õm¶pA¤¸ÔÓ 7}la«31öI)´!îÖ•ß±§Jó…)Œ‡±‡}~\€u¹YI÷_>¸;cGòþwž‰á‡Âù9¤ZcJõ )µîÖ5l #“êváY{Y쯪2Ód©nÊQê~±Â‘8u;‚ñÌã¡2[=u;ØgTõØ»u•&ú™´ÒJÅÍ…M#JÅM,@ÁS`cIùÖàPÖ¡Ò©¾eñôŽÄ7Y©í&-õ-ù”¥Æ±·ÞZu4äFjQÉêpV=¹¬;*Uuå]R%«<”—É卯-lPQÉŠe¶8Sm—¨durpïqô"öÖ›_EWE!z*‹SÃËÃ@‚õ)‚³] LŠìÄ‘¸'ÂÅCÔ$²2±Õz&BôI)´!îÖU‹¦m¦Ÿ•U´NŒ¢oÓÆMY¶ZµR7Zâxö“ÒÄ%…n[«éŽì¶>!¥6ÀݺžÉy#ÌMŸÇ 6Ar‡>|ÍYTLÎóÈ·Û&… J¹÷ÄqŸªÀzÐX´AeÑ7åÔ‹Ø[ïSSÁÆRÔTpNGú-?—7ÊŒå\@éÑ^RÉQLAXR-4ˆSá-Fl…·Û®:=‹¾«¼ÉF=Ø[o¥,/Hÿà9j?o’ Z¦û-§¼ÌI‰D½-Ÿµ0|qIìYj^Õ+À)=°e»mƒÂÕè[òÐÔ±·ÞÜâ¹£Es0™ž6…>ÄòºÏž‹¯Ë§©$„ˈ#Ñô5‰á÷T8?+V«U_“ú„”Úwëz R5lsŸgz°_†ëD3õ—i#äˆVÔY‘^3n;0c°íÁ·êœKÓ’¿èÍOÁ÷~èÀm‘8pE4«´°Š¥&ʵcÉ ‰%GÆâŒ­SÌÉ;ÚagPß”S/b_ôÖ„Þ•ÑY5Ñæ1Ã/ϳF#–ëæP¶håbšÈ<,ùRIÆzhûž¢-[t?XŸÖ¢íyÔ7å¡©co½•÷cÎŽ AÁñ©*gœoÚzóÑ.{:RÞßÃëÈqŠ*,©ÈtqÌ…RØŽœÂl;2Eß”‡¦Ž½õþ.Žÿ¨þôÐ~a”Ìq8|q’Òv¯lQ°qÙI9—Äy”Éa¹8býð7ÚŽÃáè›rêEì­77Lž¤ÀœYϘŒmcúöb"FL/Ô7‹n,ë éÄ28KOM w¦nÚ-U«SOM}BJm€»uÕ\Ôi³Ç&ãpèJë9Óü±°ìåãyÃÖ@òá»7aƒÒ&Cxo o\µ]c“¡¾)§^ÄÞzËÙŸe|æku8†˜&º÷å`ŠhåS, QŽ’ËÂ¥|Šâ¸QFØê7Zmƒú &Ü:ï|ô"öÖ›‡(d°"ÿµîï3Qìh{í݉S¯¥ygEð5¤ îŒÀ‘ˆÌׇñÌÆÄ-êf«+Ò^³OJC=Ãݺr5XTüœ!ÃŽqŒköJ÷u­U„¯Û*œ m8í.Ú{ÄXf©$®{?[í‘*€}RJm€»u…ú•a³(ßRpª—ÎçŸê×â…|H}øÕp?“¼û~@XREëˆàxîûÀzéÉh;ëð9ú¦¼({˜co½Ï†É3RC‹³Í‚©¦ÆE¦¢^g«ÏTÕ”35±¤æq ŽgŸ$v 3%ÛÇ”}Sš¦ýEï“£È]Ãý#8,Ì‹@ÃTwûUŽV`]’¼»g°¤Æ]ÕÑ9Ý-ý²¨/Û÷è›rêEì­·~ ¢†ô~Þ@”‰•ô@–#¸T‚BˆU|c×@,©ÈÆzql(¬çH¶#kôMyhêØ[oý¤,\YY?.Ž-;‹'ð0í‚Þk…Ø3)¯Ivݱn*•¸ºÃi›Y‘ÜàW޶A}P“±œzû¢÷÷±¶J0_­(Ë/­ê¾Çœàí‰oω]‚ÙLrßk–Ô9±ÇK«vø‘³Úq$­¾)ï*8³û½µ)_ÃÆ³Jqܘíyaÿ†-º=%üß7NCrFh0\‡TÖª28îؤm¶·NŠSöMùRlco½Oœ€=ÅYeYŽ›!Ì»¬Á=ÔbÔ–‡Y‘ºžÿ’OøKê”×9œ2¶„×[…«Ùw ¯¹t°·ÞL›µN5ãa<˾ѕ®z‚ &…ã‚ñ’b!K\\-Šá >á|-¨Vc©¨>!m²mîÖõŒV 3KäÇó“zÁvØ8¼~'‡¢J®';[!¯(ùA¬¨(”{qXˆba~=ÚQ+W}Kš:öÖ[¿%ûú`l…9ˆóhçcmŽŒ¯Y¸¶(ÍZ©9òwËlá\œåï±–ñuDÛ >¨‰2ÆŽ£)±·Þº’äM9µ][5[n]®[àH•›( /tà3°A•ãHå¬ë£u´=ŽÛû¦œz{ë­ß’Â6©únä ¤•qÊR$–6i'-F)É1‚ Kªžúnä ¤UX„»ªí«¾)O*FãØ[ïËW‘—²\EÞJT?HpÜZ¨Œ0›¨°Á¥#‡; °¤NÙRq¦çvâÐŒmÏs¨Æ¾)§^ÄÞz‡™zb4ªÌÔ ¨ªn™®x¬Þó}HäíÛH'£#‘WbxÎBá¼Ö€ZmšvÔ'¤Ô¸[W͈Hë¿r”;« óP±pžXV9‰g»}’{ŽÀ¥sq’Ç ‹šJjûÔ\Rß”S/bo½Ïx«´Çú÷a X—/J‹y˜Õù!%‚Ÿm(¥ÕCbˆV5þ‚‘—pÍãôÙ* ¾µ„Tê9îÒõ»X'þñîÿAWéÏ »¹R¦s§8Ó]}¦§VðÕðFŽ‚& Ã^Aäå*bI(®!N‡W±^ l»‡+–ú¦œz{ë-³O~fd~Ç×+Vþ´À‘Ì2;Ô™*Ï™(‡>Â’š‘ùAª ¬ŸÄDÛ#¦:õ ¹ôöEô"_C{r1+ò‡ŠƒÒ—uãÌ)-éì\þ*§Ì”ÃdL¬¨“†òpj ,,jûØÕ7åGSþè}ß…ç¨*M‡cþìÏÈLnébR¥Á—yà:ÒÍ”v°AéTAœÞÛÜFmƒÒà[ç‘S/bo½#ƒeaT|d°,Hd‘<ƒå„—Õð –­Šàþ:íº]_8qÈOJ€W}nf«5¢ÂÙ'¥Ð†¸[W}"nå÷lðúDȾ (Ï QFä(¼ÆHØ/yAfjbIõ(8q8–CXl±ÔöÙ‚©oÊCSÇÞzsäm¸Gf)†G™Ý†_o5bu#sH'ÖUÀ‘ˆK1Q©@ò®­‘•#ßáx9,b“>ÖP >õMyhêØ[ïsÞéN“S y‚ƒÕŒ,®VÀª"Ð¥óÎTŽùï…%5eÛº8y,’©í!ÛVôMyhêØ[ïcÝ]¼¯5¬»äxðXAV†æqŸf¢d¯õÈYpœØ "ðŒÔW¥³ÔvŽÀ3õM9õ"öÖ›¿¥'œ¦f{ß?o¼I;ªr øZ¸BåýYto>r¤¶*Ð_×Å)ë`™I¥(1µÎ…ÕwdZ¡¦Œ„;zŸ€ÀÌc¨äøHˆ¼›£Ês‰¿¬œªŠ¾¢…¼$eê6ì¡ä[*²µ ›” ƒšË·T}SN½€}Ñ[Ï™?FÑ8œªt#….·Ý©ÝDáÞMUÐqùòÇ#,©¢qìâ¤u°Y%ÿv…«Ù7å¡iZ_ôVõ ,>ºù¼9–ží…¤çtŠo©’į́9*ð Kªè|#8N›Òü˜Fmg½¿Ñ7åÔ‹Ø[ïSIcã°\u²È©¾?ÏLË^}Ånµ/|èͱìØÛJ>£„P mãêàäØâ¶8µ]ÂT§¾%M{ë}<’mÎîîñys"Ñ!O$l\ì<1+1nö¬[<®÷€TŽÜ1â$•AK8Ö-é´´z‹¾!—^)ÊœåÓ6ÆdÄ Ï«óysÍ^à-[!¥6Àݺ҈‡ôD£*äù0žÝÍÈ: ~¶AIFdSE‡Ë&E²$â‚àÎF _dç®j5â`Õ'¤Ô¸[W¾6Ž´¯2îsl)Q`ø}övþ›DXG++¦Ö¤Eqú½¾Ê‡‘·pp“a«Ç‹†}‚qÔËûUW%°;jEÎÊg#) jÕÆpwûî¢`8À†Zrl½… JÎÄɾÄÖ«ßEÛ9²m¨oÊ©±·Þ'ËfÅ„­Ñâ,Z½í“>MTlÓ‘{€À’š±<‡K™¦üµœ¶GˆVß”S/bo½5@ ßr"ëçÅén|õâoXÑ™á½#¹(-iw=òå‹%a—rÁ*ßëáäXdaUÛW¾Wö-yhêØ[ï+.gåuÇBË9Xž3ðÌb7wÄŽƒÒÒÉïå{ˆ%u²¸’SÜì.,—çl»ìSÚ }K½„½õ>^™*¬âðÁ¡çdƒéÈVH)ùÔÊ߃„®’gMÑöY*+%{ÆØ ŠØ†ÔJl'[…#×>zᙿè}²j3óSdrL¿ÌäÚx0ÄÌ×I”÷·°y |', ·2¹:µîL®ä°8©c§2¹*ËÔÉäê}Sš:öÖûœü&w±aôËaLO7×ás]qò›EðPÁÝx!…o?qAð„J ¿§ÄMÏ`« tªÑC:”WÛp·®Làç½iÜV‰áõE‚;ªÛ•VÃDÖl»àsO)\î‰#‘bj C¾¯’ˆ{ˆ§'¶ â XŸ”Bân]©>‹ípÅðÜút°-ž[ŸY%AxG,™ )ÌÔÄ‘ÚÛŠáçNÂyýBµÚ塬>!:˳¿ê; v2•’#Ã-ºá Ý­ýi7ú©TƒY€RDIG¢\¥ä*l†+ÎM¹j5ǺŒ}BJm€»uå ª"·ûPR1|à È=ãÀŒ ‚–žøÒØàHŒ81%Ã35 çÁ;jµÇ‰)û„”Úwëªé!ã|a„[ßá˜kÞD=ùîN¨^ÎdˆÒs-GNÛ±AÉ­Oœî®yÂzÊßh»k…}SN½ˆ½õ>ç"OÕô%G§{¨•n­¢´we,öªˆëP-NêÄ©(í:•(Òò§’H†Ó>û¦œzU•…=zkzÀhñ¬ dƒg+AƒµÈ&â5 ÜÙíÈ ÊÄ’Zaƒ;œ<Û'’÷£mP¸}KšæùEo- “,·ÌÐä­-á(j^ ì´MI|ù–¼¢|±¤ª,ÁA™%a‹«Õv‰(RõMyR؆co½õ\6¹éN"Ç«fyIì_¼0Ö¯ t§W?r–T:…“Àé[i¹˜l¾Ìh”žy¯G½„½õV1ŒégF})È%8¹$&ò°m·}¦…Ó°¶Ñ‡zÉ·2¾9v+Ý[¹#°˜¹ÕöŒ¼Úê›rêEì­7gæ÷‹”ÆbøYwÏJÛÝy”ÉdénaÃù iEàHD>11²×.%Î3©ÕH¦¨>!¥6Àݺ*ONQâpe—eGUâq/­œÎ-vOVZ»®#G©TaIÍÈ.-Î@æ›Ôù´="»´ú¦œz{ë-ÏĪ[AY~"â 7Úç¬àÈ _;‰åýeÄÉKc˜°¤zìµ§æƒm^;Cm·Øk©oÊCSÇÞz눪Å$Á uqP«»g†Qþ&fPqŒ”Ž|`Ý1ÔÄìj[W“£´¼8beM@4«ï¦ÜmÔ”yDŽÞ'ge‰–Ï›³p’ŒHœ";Õ½ZHá85’£²™°¤"ìü☚°§Ðl;œR£oÊCÓÒ¾è}¦Gz*)¡‰8SõÈl] ùÕË¥)l×#Gˆ°¤NB“ÃIù`‘°DmŸ„&ê›òÐÔ±·Þz. îž]S}pècµQ[mª¤ÓJ¢pŒ„”«”›Á&VT×Tq¼ARÎ|zÙ­$ Ï…}SšöEïHÍÎò|Ì)F1+{M:;VöšxΊz˜(öDÁ¦%SNfY ÉLlÄ’Ç”œRÖsgGÛ‘Z;ú¦<4-õ‹ÞWÜ$vTJ#'Žxì"VN~ ZäΰN´G^á†B,©y¼ÒɃƒ°ÃOÔöˆS"õM9õ"öÖ;6¿a–ŒiÃýêm%ùä2ªŒ8÷]³ÉòíhëšY¸ácš©K8÷·Þ•s™©ÑPOCRl‘ˆ#Q*†ç5®ØÔ¦VKT=`ŸRàn]Ϲ³ûÛäÈI!†ŠŒswQq"¹«(;Ëû'͹,©9)ÄI®³°¨Ö§¶#£MôMy Ï ñEïã;Ǽ¬S~MIy\m­á‰_½P²QôfÛ:}-n¬•¼¸IXR=j ޹ ‹(BµÝä›}SšæüEïpÇ~~WÍþ­}¾0¦ûJ?ìšÝãmº' .Ÿ/ORÿð„ BÉvÈðX8?ÐU«‘êR}BJm€»ue šŸÚÑuú¿–׿à ùY'å+u3Ê‘¥iíP]+ò‹“óÁú­Ž¶ãQDßM û¢÷1.ò­èa\ÄJoxª?Uõ4ïf\"d\l!íÞ/q$"à0Ê\·Ôj×sTî& õ wëz‚:¦„¢­Tp6¶R™“ÄvŠ¡ö ¿³‡Ü޼À‡Ø Êµñ‚däƒõ\Ñvä"ˆ¾)§^ÄÞz+åèôóÛÖ¢%Ž'Ëæþ‚Y×,V åEÚ‰2j~Ów:M+êDŽm"…­ˆúaÛ5,Zê›òÐÔ±·ÞÚ®WX׊æðàT·½Œ†¤Õm/¶Ý¥î(ÁCù€±¤JRÏMØìþÚj;GªõM9õ"öÖ;,' §¨²œÜâÁµ^ûÀ«¸täLjQä¥#­¥Eu‡ñ2Ÿ’ļtÀrò|ѹk¨Zt(êRjܭ뱜 ü\Å€Šã®Yó~ñÏÚ- t»z?r®.ˆ%•#Tœä‹=a=#r´]£oÊ©±·ÞZ"`±¶pî=œÙà ¯b¸)x1Aaù†ØHÉñš T8÷’SáÜK,Ž8Ôv ‡%õM9õ"öÖ[ÆEšZg8k% &í°ÓUmש³äE B޹WØ ¢Î9Á¡ÄvÔYbÛýÔYbß”S/bo½µý@Õy[ÈÉ).8fÆÝ-ðÍ)šÀ•ðc£â½ä# êû¦¢Î 9žP+°ˆ‚VÛýlÓØ7åÔ‹Ø[o-´¸Œó5ØçÍéÊí¨{SÝm›¹”BaË‘oeTf>É>Ô¶®&ÇöÂVeƒdfä® Ùì»*u$5uì­÷ÿ­ÒT Nr¼H‚Ç`ÃDn1£ÝEù½«XmH^à/@,©Ó‡c1ÂNŸZÕöŒ©W}C~4Mõ‹Þ‘v±ÂŸ°GÚÅ wD«ÒĨ†fÛê ƒ_ÞѿҼ0\UmMwbª„+öÔj‘ådF\Eí¡ p·®'Jwã_EÂÅñ«,vÖš_~ØjqµfA…®ˆ’ÃMQXR1]+Š,¬[×£íæ;õ ùÑÔ°/z£ï†o¦|ÆÅÁ¼e>è8ö7`(l$|ƇoÍ%÷@üÀ’º|ÆÉIÚz;6Énœ»(\;“lÃ,’4۽ϔboÿ~ޜꛞ2•A’>«‰Ò”Òó‘£Ú©°¤ÊëœÔ6+—Ÿ·ï\Ì0éòÐ4µ/zkèBÚûq2ÆÎBÄ3VøÔ2Ka”¥¨ÊkXá“[úÁÑ‹ä4øJWÅ1e «`ì?בS/bo½5¥$$7;ÕƒÇÞRÔ`(ðl1ëš'N›ç<¹ Š å8I6(E~ŠÓÝÀ-¬Ÿ§FÛqÞ}SN½ˆ½õÖ÷âÁVöµÊ€-2ævø˜í»ÇÑ(½Óî“C9:„%UÀ}8y,NÔv ¶ú¦<4Íë‹Þ'YžÜ®z$ËkpæLQ ãþh¢t°Àr܇«,(´­«É±ŒTÄ6/*¥¶AÉ^¼×‘‡¦Ž½õV&0/•c²8K¹½rãØ˜›1”÷—J%9¬„%uŽTÇÞHa‡ò‚Í& W³oÊCSÇÞzWÙg)SçVžÏ‹c˨△ºü¬È¨gî"åý·»…ÜCÙTR>fr<œ°ærV¢mP¸}KN½ˆ½õ>v»„œ|ùdžÈ[–×á&Æ1Ä:Hލaƒ’/¿8H“Dlw·AµÝí0JèPN½ˆ½õÖoñÜ0öµVÉäxqOëÝþaãŒó=PZòÙì'9ò¹KªHr0 [Åʶ뉔aß”S/bo½¿‹ÌNJr\¼Úç+Ǽõ2"VK†I¶ê´!L¶Uv~šlÛ:Ø tLNF…5b3ªª±mPšG>rè%ì­7Å„³­;‰|^ ßN´¥Sö²r©Šð›¶™í ['5áD,m£4ášïAØj‹¼Wì“ÒPÏp·®ßśĤE=×Åðóq&8ê>:[ –!‚vž]CZáù‰˜#åÀyx§Zíá½É>! õR~ÕU&!d™Ì#J ‹ãä]Óó묲 *%̬½’W¤¯ –ÔˆÈ]q<ü+°ÝGµÝ#rW}Sž®`²W½¿‹7éߺú £ÀVJ02º 5¸¾tÏ3Ù¶rEÐjÛ¶ÒI /oÞšp$Ð*‡!ƇÎ*\[Ì^ÈZÑ9†¡>CJõ€»uý.î~ÇFÞŽŸcÊ Ýwcô„M-û0T·Ž-¾—€¹ƒ‰#1´ä9Œš穤Ôj—¡E}BêÕôªk¨?¡‚\Ép³k/2Mu?ÚCu¢aªûíR)†R1¼Üºpn¼T«a%UŸ“‹³îÖõ»xy¸Ì³5yu8ÃmËë šIò 3ƒ°ŽòïQŠR[Ä‘˜ $Î]ÕêÐVT}BêîÖ5©Ìì=‹ÜŒÅðè+ò £ÍXæáÔ›ëèÙЗR¤ö ŽD‘ƒ±î¼*œÇ=¨ÕˆŠPŸRàn]Ú驶ý¦}^ ω7‹"ZžŸmš%2QÎ6ÅÉŽÄŠ´‘M¹ ž­pÓ¾Gµ:#m$û„”Úwë*ëLÿRÑíâXÖB³§à[ÖÂ]U¡%ÊiÂ_NrøË ”^ÅÉ~–)lB`ÛNø¥¾)§^ÄÞz+˜q¢jK„(_sîLåéDFÍ* '©™Û)\£Ž *«7b·íôQXß2GÛ«}SN½ˆ½õæge¸oÖÐçÍé2§‡‹‘Æçðb±ä塼]Æf§ZøÇN 7=µ]Ã?F}W›Û9øxÑ[çá°í"{ÿçÅ™nÛ5Ê«‡¸m×N¡mÿJgÖv˜"9‚BÛºÚ9(UFìðcoµ ꃚèp®M‰½õ>¾†ÓAøMÇ|­flóÝSgÑò$*,ŽóÈ‹\X”ü&Åé(¾AlGa¶ÝÊ¥¾!—^À¾èý]Ì{?ö°W*jÖ¤Ò wÓÚ2dû–¥yAñb‹Ê (®ôpìæ ;q–ζç9kgß”‡¦Ž½õ–Ñ–úº"Þ÷p&bØÝ{»ÿ~aúÑ Ϙî )G¡aƒ’“¨8Ñôĺëf´}œDÕ7åÔk*ÿè­)©bÛ†ÇFE+0`S˜N1‚£œÂ­}y‘O¸cƒR¡q|( ,Ü Õv ÃÑ7†aé…aøEo}î I[¤äÇmÖöY1ÀÁh2€Ò'9FÈ7’(+ª /85¬§a‰¶k¼‘ê›òдæ/zk^pÈŠ$dÁq ¶QŽ—nI#‹ÂæÑ’wD‰+*’]sšÖíÝÑv¾mï›òÐ4Í/zŸeËFŽŽ51<ÏaGɦá)‘b„ïs†Ò†˜ÔO‘ȲLj‘l¾ÎÓ!ªÕ¤´3êRjÜ­«V]¨ Ô–bƒ³=§v‡mºyN£fõÁ5ZG»·°¤V$igz­aa½ŠQ´=cuª¾)§^ÄÞzŸs$ûŸ§´Jœ#9§ºsC‚×8*mØÉ޽˜ t2ä•R(‡Gº°¤Ê);AÖ½-¢í1»ê›òÐÔ±·ÞÇ•§Â0÷på!gá$•“mÅkܧ(½ô¥yÇ,NlPÊT$ü/……/žÚŽÌ‘Ñ7åÔ‹Ø[o¹Xud•÷丟7§ûò. ¹YŸ<¡ò2( û¾÷9!Â’jr ާø ,rbªí“3S}SN½ˆ½õ>îb~ŒI¿%8öú¦ª<|žã¿*k_QM™û\ÞP‘Ø Ò¹z#^Úæib»‡"¨í‘ ê[ò"§?ÇÞzGV¢†›1·²5¸ò4$:·^ öš®“ú•a¢~À‰¨"ã§„+¶òT«EëRõ錣ރ{ÑUNÇÕ稱´ŽŠäÜTøÝreÔfå¯ñÃûÈJÌ;Tp^sŽ8ÓÓQ ‹´~jû¤ýSß”S/bo½Oœ ã×4 ‹ÓQc®#´¿‘~ßDa51#~¹Oz?XR-†aq¼b]`«m/£í¹rÔ7åÔ‹Ø[o¥²,ð/õ Ÿ¯œ hC4gØ垪Kg(¾gGIw½)­7Åaº!b™`¨)šSuyZ”MãèEì­÷ =wLj¬¾à «ñ3ØT¬ël‘àV Ÿä†%¶*£ŒÀŠÊ:æ»8öª ‹ŒÈj;…“ú¦<4uì­÷I_ÏÀxÚêÄØyÖ‰jZ¾Vð|αâðþP}9ä[1й…¶uõ€©våÀ2ü‹m÷³k`ß’SSbo½¯Â!Å‹6«Þál±;iñ{,REáûܾӠ¼$8Ø0•yPò‹ÇË‚ »à#ɶA¡mô-9õ"öÖû»ØÈÛg£XâsçÌ7ì™.TÁ¸AJŸ»}}’w["–Ô ë•8x¿…eªÑªQJ¤¥¾)§^ÄÞzGŒ}Yéˆ$†»rÙž>ËÏ,Û3ÜP‡ì7½èd%yX`pj2‹Zå¥d”¸Êó fWÖÙ3û¬LÈ WÛüª«SãOSí»)_¶Œ4øûÊùeˆÂÂnùAò­€ý\U#~\œ÷;b}amÇÂ'ú¦œz{ë-ûÐ)]@ÓöáØÖ¦‡ä-زӦí) 6œ-b“Oì`‰=TTôJÊdnËsa2¤¶OH‘ú¦<Ê*8öÖ[έ̬5\‚ƒ 5æ¹ÆàWD@Œ% £#N.(¯.¬¨¨árq<¤‹X‚WÛQÃ%ú¦<4u¯·[o͈X£5?£û|å¸ [•Kiž¢0Ça9(9B… ª¼†K6¤ÃùªÕv>©mÙ7äÒ Ø½µa„Om÷9ìó•c¥4TX«¢v3SáV•SH(Kùò5½°Ae,§ù<&¬™NZ´ W…‚»¼«°‘co½5#"Õ™ùe+X13S=ÁŠ™™*jÙ¬5Æ‘#]«°;²ƒ(/8æœ.¬gñˆ¶#_HôMyhêØ[ï+!rõeB½"ÂjEf´"¬â™Œ;‚ÉsǧA9rJ KjE0¹8˜š……Ï·ÚžÇM‘}SN½ˆ½õ> ‘ÇzùöÅaf,l¶û@i×·-‡í’O_Ñ Kê|û‡“öÁâÛVÛçÛWß”‡¦¬«{ô>έ¶lžíعƒ3‘ouÐ%aÊ…uγ$î™'lPaç&'²Ên8Ú¯}Ú.ÇÎ;)§^ÄÞzk~‰œÇ‹i'ÄÁ76ª%33øŒÐEiÆðp@ÈgÒ;ÖÖ¡"ÂÅÉ=°u"ôVÖX%©`ß’‡¦¹ћ˖îV‚¾e_!ÃŽ*²GòÓ7Ö3ä%‚†ÅÕBºT*Ãp Ъ_JÆò,†Àu/ìÄVAвÙsH©Þböãëw±Î¨¹USŠ“Ãñ#OÏT“¯2ªp‘‚õÜs…Ü ]6(­=X=l»A„X+༦Ú&õAMìGKŽ EÂÞzâ߸ú•ÅKÔVc*¯øpâiQ•n¢¶*ÒíH çNâHD«ÃH5pîf®V£°ªú„4ÔKõU×c,ñ„Rž™ãó•c»˜„Ê6Õ IF­,JÆO_yN¨ì¡òYì9[&aQ‘PmGªëè›rêEì­·~KUen?.ΆõuÐV ËlY¢ÂrÛŽ^üÂUtuWBè‘þæj»œCSöMyÕÖgä/zk R`p<ñh‡³à*âÆJ¬8 ‘_ñh¶ØG޲æÂ¥x4qS&lU†ŒTßîx4õM9õ"öÖûd4ÈX7ùL“³Ü>±Pf໽J 0µv¥w9R  Û•²\YcÅ™¾MvºYUmÏÈ«¾)§^ÄÞz+§­ÿ0¯i©”çäL7KY~äý° ÿ‡õŠ–›Ø4HΣbÃ@'u‡c¿UXg‰¶#Þ%ú¦<4uì­·Œ‹ QVT%»gKCŽfi¨JÃ7ß”ò)c}š‡ZQ•X$€vª¼/í)Ô÷ŒDIå`o½Oæ+ÏL±¢ž¤8È Z¼èƒWêJZB [ê*ÿ(—W38¶ÊciŸ«Éñd5’ôhÔ5ÑQB¿5uì­÷ ¶ñ:I.Áá–šá5¬}ÉКrG—z™è¨™ÛÁ’J'*+8¬Tãû/dqWèÍ– D„ßPšÖôEožWuUmg(êa<»Ï‰ÝÍòÐ<Ë«>DøÉÒôéŠÒ‰ŒqÀÁÏJŒn{Váš½êjµé›RŸv•¯õU׳ãhðWaþöàLd,…EsRæûê¶QQ>™çXQCY܃ã5;ëU–¢í:Ô7åÔ Ø½Fdk+;ƒ8Ûë X™V{Š…[ÚC”÷ÇúŽ’O»„…¶qup,Á6±ËaÕö g[õ-yhêØ[o}"[ÃCÖr *¾¡ Ú„óGq ”>Iz+o|)e,©H¬|qR9Ø„°5¶‰•£ï¤ 6jjؽÏçîõë Ù Ž‡]En2ôœõµê±n¨F.­ù`ƒºl!ar »tlFHfcp`ß”S/bo½eÑ*þÎN¯°ûùÊÈš»à†ëv¤ kS:ƒõa˜r,D„ *å¸Ú9^2&°Õ'oµ]ã¼U}SN½ˆ½õæÊ~ §@±êóbT‚žÁ¼¢ëò¬ÝRDñäj•”n8çG¢(»ÜaÉ8ê=¸]¥‘EËÇ K£sªÏ< ª'x3jOQa;¬GŽ-©°¤Jl•'åƒõ(†h;ÇVY}Sš¦üEï“M¼"þ„ŽÇ]—Ÿ£®¢ê㽊Âð’ü³£¼¡.5±‡’›Ÿ8 ů€[F{k{îsÞŠ¾%§^À¾è}|³•“3…ov:þÿe+Vú÷#ÊíÿßB‘Š$‘ýøÿ*#ràÃ/¬£í¹ÃÔ7åK' ­}Ñûøÿ³t½ ‡ˆÓ|o—"ŒåRBÊlPø$‘€Sò"/…ÜU™¬D¾®r°±l»œØöíœÐ« £Ü­·~ 讘Rg#‚Àï$ªî²V(õ·ê‘£Î°¥2¬â *¯°¨«¶ç ÷ÙzŠi½PªæEo‹L4k$ Ç [ÕÏIÜDFÇy*JLd}”ix„%uÊ|‹ƒÂú·mŸ2ßê›rêEì­wDûŒ0Ãgž öb©Ùî…;ÜV{ÔDa"Ié ‰>ódxŒ˜p¦V£T«ú„4ËÛbìW]­«a}Z­‹lÞˆ¯eÊe_'p`}GÉQßQØ ê¹záÁŽz°MåÇõAMö>ò¦ Y,}ôæŒXTµ„µ6Äð²6³*Ö)#G_ás6‰”¶©šAÄà0J œ/ÊÕj¬þÕ'¤¡žán]~ÌÊ\¾Ôü|aFÃÁ8C1|E–YlµÇMaŸ”Ràn]µ©¶ õÌÙÊFHŽ×'7sÅóBe:jeQ2u´yäþƒÀ’ª‘/äpr>XwF¶#8%ú¦<4uì­÷wqö–‘™ÜžUz'ÇeF1u¼rǑѣ¯Õe"y‚÷ôˆÄ’Z§Ð{pÊlŸ*äÎÄ5Qè}(YËCSÇÞzÛoùů(oÿõÇo¶!Ko÷ß~õ¿yA‹ÿõí¯þú-½ý—oéíÏ¿ÕHÄù|ŸÏs]aÿðööÃ7O;mYÛ}x#Ùn̯øåo¼ÛçéyÇuY—ãù²wüãÇ?~ûÅ¿¨·ßüÝ›e©‡FøÚ–òûyÞɽ‹óùö'ÿý/~øÓ·ßüý·÷›¯ÍãÍç×Û!äÏjÞ¦ÔxÅç{µæÿÛ¿ûáWÿLûû¹VoÆÿ>+ŸÓþòo˶ûÃÛÿ«?ù÷ÿý?ÿÓÿøÏúôùö'ÿð7?þß?þé_¿ýæÏ­»§¯úÓ7ÊžþŽ'Ä›Ç,eÏ2´%÷'ö›ïvôú° Î+¾\òÍÎ7·Ñnœÿ‡o?\ |½•®ÀÿÖ%²H&¯¶Š.Ÿ&=`saƒûå’of´°çõý¥Ë¯w÷§»ôrxñݯ.--íî&åu‰Ó›÷]òC(þ+Ïߟ¸Íñ!à-¯8u­–ä ¿ýÓß~{4øË·ÿù/úïå-ûÅÿé׿|ûð—àyqî¿/¯Û~}Û6^6»KÕíñö*ÿY½_äÿ3Ò= åw„N784ÿ\h©°8øÑ éwCVÔÅ6äïØ§=¿V?ô~$zEð4~õÃÏzWlÐÌoÿ-{oÿá›ùXWp¼ä[䔽…Z‚VCLò’/š†)yäú2^Gë#¯Ï`ì{Ovò’ï‰S'©ç¤É—7ø_åvŽƒ"˜_Aá£3u4Pü2õ˜ÜKz—“ èÏÿ,Ê‚ãŠ?»O+\bÑ@¶Ÿú,~—Ñëë"ãçL–p pW%Óá/~•J‹ß«Ç«›?»zÏZK¿û/~õ“Âo{ó¿(‚ûþkŠÔ¶TýÙñL÷Ÿ¶‚òÉ'‘¿ûÿò¶V`º—× ÿϳüèoò7ÿô§ofÿóóù·gòûÿHöT|cºã¢ÿ}ý‘ÿÜû=XÕœR±‡å¬÷7_ŸŸ–×èô“kß>˜#ÙƒÙ^¬dÊ[8Øí+‘:º6ßžºäË%!o1ÆÿÞ78»Åôw¿Á¿Ç Y78{PþϽÁ?¹~üY7é[Ï ýrƒŸ¯Õm_. yñê¿ä[¨»%Àøoðï±ÃÑ 6Ûý³oðÿy‡ðÏÝ`+.Ò® úå#ñÀ¹Á¼äÈýÈñ§V ¿×°õ“2ÃÛÇ„×î·mœþUç¦ß¦M^zF÷6ñÿ·î“‡}ÙÿK·ùíÿÂCiù endstream endobj 4223 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4194 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_MDS.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4224 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4225 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4226 0 R >>>> /Length 1313 /Filter /FlateDecode >> stream xœµXKo7 ¾Ï¯ÐÑ>DÑ[£«¤@€mw‚7AcÄ)š-п_R¤$Ž=kÏÚîÁ³ ø&%}”­z§¬ºQO¿¾ÌŸ2ÚúïÄÏÏêwõ}z}øí§ u}˜,,%¿‡ëƾܭ°w—?ãjVÿN>*£þ˜¬z7“­îÞOÇ]OꢒvAy«‹U®X³ò%èd7†øþ¤¾ŒŒ.Î)ùÅŒŽ~¤`î¤@Æ‹×%ªÛÉûYËä·iÇl[¢önð™®$Ê`zøëi03è8½[¦‚Køƒlë“Î¥ó™”-˜êD Šö¡ 0)¼‰XÍ&À¤t±Ø”QðÚå‘‘¢d:DɈ%ƒcEɈ% Y{áiˆNû¹ÇK” ×Ì:ÅQ"¥@ ºø!@¤,™³Ú™Q2"¥@Î:ä!@¤¬©÷:¢3) ‡'Y'öúýUÚÂÙ.O¡RÞ9 ¢’‹3x+E'ØÎëe!tŽº®ÒQÏ~ðúèºLUÛ$Í+YGÛu ìrßmEÒä»ñ9.Ö•q_OõÁœ³+ðu®Uâî*VB),µ‡PôkÚ¼ñÄ1ã>Œ}¸\w:—ƒÓ\ãÎV{Óôˆ «$J 3^7¬p.Í*U”|6.…Gz2VJµdé„T¿ E©Þ]¥T#,VÜa^€h IqÖÁ×8¡dL#0¨dP‰’ÛM ²ZEyaÆö°Á°U"P”}2—ëz‹X1Õ‹ý‘-þú-PjÿEYÛá£~ˆö6i 53}ìoÕÙ×_vçj3½Ù“ѵÝòˆQ‡'6dÔÅT›¾Ù].Œ®õå±H)G¼ØÀ至·_?ýøëÓ¹‚ Î¾]þ9œTûwè"­Êã{]ƹݳ‡ȳ#-´Æ HŽï"á²Ì·’vÆ­`¡f{öÊhkD 7(Û[Í6m·jÃu˜ç‚Ú 6²NSö€?64åîYÖGÌ7ëÞáñ¨4P”Y­r;&. rð;$.rð;".ù§lƒg¥IX늶¹#/íX¼½Àa»/aXÀnã/PX nçK Ûø –ezæIt§ÔI­„Í{¹dÜKåíÇ(zñX^ppí7ÛD‘4ùn|Ž‹ueÜ8_­·ù)c Œ|.eð²Æ6_ÝmñÆÖÂõ’æm­]áFk×Fÿ­­…ãWßêbÅáÞÊë**·ò%[ÛøÔº¦ËTµ-[ WB1ëZx¤n›(ÙÚÆç¸XWÆ}¼µO{[kmžÑZü‡G0ÛZ»:óÖn{ß®·Þ&,Zk¢¶¶—¨Rzù‰’­m|j]ÓeªÚ–­5oª® .æa»R²µÏq±®ŒûxkŸòLâÖƒñ¬¶ö @°ŠÝ5€ßGÞD½s^Êžœ­|ÀýÏN¡Ä³½û}ön§ÿ‚“tÝ endstream endobj 4228 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4195 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_PCA_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4229 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4230 0 R>> /ExtGState << /GS1 4231 0 R /GS2 4232 0 R /GS3 4233 0 R /GS257 4234 0 R /GS258 4235 0 R >>/ColorSpace << /sRGB 4236 0 R >>>> /Length 22918 /Filter /FlateDecode >> stream xœí½É®.Ir¸¿Oq–ä‚·|ˆpØVA*€€RY@/B ŽHµ6Äj´^¿Ã¾ÁÜÿÃÌbfÅ/j‘禙Åçn >˜ÛPßþü­¾ýýÛÿúò—ÿgÿ{+_K៣·íŸúÛ·ÿëí¿üâ·ÿå׿|{ÿí—ú0ËÛþ÷·ïÿê»ï÷«ÿÜùö¿¿üÕ_¿•·ÿþ¥¾ýùóßß©èî?}ùᮿ¼ý2ìýëìo½~½ë[»¯ízëÏ?£þHþËÛß­ŸP¾Þ­½íã'”¯g_?¡|ú l¼¶òu\o_z»¾–jú¾|§ Úóî{] z]Ðók-ëÑqÁ9¿^Múˆ:Úøz6ˆk=¾Þ%å"÷ æ#º×$· Z»ã1ù‘û×øZǺ€äÞÅËcæ/Ç×s»%$×®s|۽ݲë =×-#½.8JýÚ¶[&:.xìK_R»ºGÿzœëŽÜpÁSÏLr¿ày c=‘Ûýy s=‘Û¿øõwêíü_?ÿŇõëïê÷KùRÎúú]½½=ïtü¨³Å ò±1ž_w/Áy|-ýí>¿ŽÓÄ{\úÜ¢–Òñõ‰Vu©Ï;`\ÏÉ­‚x§è“ÒT/p»®ï_~ù\ü¼ðÏ{Ûîûk/P1îçm_ã­ÇƒxžôŒoCDtô0æLéõµ×Ä%ñ´ŠKŸ¾ŽC¸ Ê­VEàRôi©´!n×õ›P¿Þ=ˆãþzP_Œ:ñðŸYÆCÁ#ñŽKŸ±êJéùu¶Ä`«¾”Œ ÜÔ*‰w)ð ,µzÀmºJýùÜŠñÖN}o§}}>³:¯€´ç® ÔssE¡³y=åW‰~Œ5…¶qõâ´saK|âÙ6(¶­¾%OMÝõæo‰/äù6ÊóÏŸ²W b<ßTynÁó@:Æ9ÑW|À-¥G¨o\õð¥`ÔøÊ{¦½ž­‚x§è“RiCÜ®ë7ñ!ôòô÷<‘çëKHN±»?3ÿù`®o{¯5†3QÑYp®¾äíkŸ +ªø{Ø8õNl¼PG¶MŠW³oÉ—¦}Ñ›¿¥õûëy?¿¯|í7~Kržoõ|kG‰çÔ( ®b*úkÇóç’7ÌÃÆŠBÛ¼šœëŽOÜØ Ÿ¬Û&ūٷäÒKؽ¿‰×*žË8ðZsž© ‚º9ÄŽG»Öb¨…þZÿÚî%æ¬caE¡m_ Ný:¯…}¦‚cµ ê]š oÉ¥—°»Þü-Ï Ú;g–Ë @1žŸý×ÄœvܱT;» ­êZIé³?—D»|)%–¼Æ•ظUZ^3¥Ò†¸]W?Š3®îÏÀ15‡›ƒA²>‹çøÉu?st›_ËeŠ·k†b)¿ps…¶yuržÑ,±`³mP¼Z}Kžš»ë­ßòì9b,œ=¾¼s|­Ôy‚š±ÞxÞÈjŠ+Œçk¸–üŠÞ+ª{|KN‹·+±-†Ÿl»yˆË¾%—^Âîzë·Ô“Ãàýµqc±qžMl­#ÆÌ^ê¾L¡¿:9]I~Åt•ؤš~¹9××s‹A¶ºmQ¼zx¼†üô€ ì®·†áÚ±Y.GlU>vΉ†ž}&’cäÓB­¦0T²Í”sûc¬(´Í«ÅéPÛØŽyÃmƒâÕê[ré%ì®·~KqC1lþsÚ×ÖAÅJ4†îçŸ2s çÇÙ ×¥–_ñ$VÚöÕàÌmÆŒÍn»xš}K.½„Ýõö·c¤xF~éÛçy!Ÿ÷²—˜+0?ƒß³­.—)¼gKÞâÛN¬(´Í«Å9â‹M,¿.· ŠW«oÊ­±/zkýÞcßbÀÇb¶ ÏJ»\´Í Â(E+í3å–ŽØŒ'­âÒdÄ6¸ØMœn•„–úѧ¤©^àv]¿‰…ÖÕÿCª?¸ù}Öï•Ãëb<«¶gýëЃÂ,ÞhÌx1ÀHZ±²%nU—ŠqÅZO¸>cµ¢VIÄ¥ê“ kÜ‹®ž¶¯1bçUnMÛÉy¾ žñ»¶˜:ïø®Dqj½ãÓ³üÙ¿#±‹ÒMN‰ÙÛØg÷ÌÞn›”'ùèÛré%ì®·~Ë3l•êíáÇ+發‚:¹xîe {­™òz]KÞ<„›T½sH=¸u}öÆÆ¸reÛ¤<¤b "9õ2v×ÛÖ©;~X‹•–SæàQ&˜ç¦•§£ç h·)NG…›cÉ+·ðÀ&…¶yurê¹°#¬˜Ùö°‘3ûgÓ´žŸô¶©êé¶àYµ)SUrîNÒwè˜4.S6>µ™òx 5±‹jëjpJ4“ØSÛ.iÉsß’K/b_ôæo‰Ý( “?EŒx+·ëˆÍDÏC¾NXŠHD_CŠ…T{âH°U\šŒgÅ$ܳyf<µJ—²OIS½Àíºúµ*±³Šaè1çŽA(¨ÉéŽÏ¹Æ^K}Ãly‹=`bE¡m_-Né ;ù«mPæ½ä©)°»ÞÚüÕØ>·g½\8ò.Ƴƒx:{ž]{ÖÖm¼Ý=¶c"°M㋤G<_ã’(§wt`ŒŒ;cv« p©ú¤TÚ·ëê‘wÆN0¾¢C @sflñ±©áíz~rÕ§KÊ#o=—üŽ+jäÍ5ïRbÏømÙö¹¾!õ-¹ôv×{ÙúóxÆ‘¿Åœú4ŽŽ5.ìûc,$•6…ºä&bcEù[ÌéÐÇØ]ÝvÏßâ¾%—^Âîz{“!g]ûÇÎáº`×TX.‹Ì™ 8–ö˜™RÞcK¬(´í«Áák,×ß%M¥Ç§g]ré%ì®·7Gì8¬(ÉÆ¹s»Îg iÞ>VÛHâí=Ž%×fTؤd&1'^µ–ØëöW2§)o,k]rêeì®·FÞ¯ÝÌ…Öb<¯j¼›œžŸq3^ÍÛÆÈéÒéÍIà’ÐBËŒ+šnb)¥Vg.´Ô§¤Ò†¸]Wî5v829~ìœÓ~Pz­â¬øÊ×JÎzåky¾VÀæku¶¼Z¯U˜¯|­z[mƒz—&z­ —^ÂîzûsÇ Öžõä9Ôœ›Ù€ÍvÜüÈ&lÛ¤Ò5–ü‚¥ÜXQ—mòÉÁ}N쌱6Ûe»ú–\z »ëíEã ^œðw-“óLGõY¼ÏHTìœI¡¿°ú×%¯ø6ŒMªö¼úæÀKcØïÜö‘ö=÷M¹õ"öEoý–g“Óh8¶MÁœ »ÀCÅ ûPa38nÌÀ¤ÐßY0CKvË‘XS#m 朰 {Âfà¶Ï´)¸oÉ¥±/zës¿ÂZÖK®͸â×?ÃÄÁ¥Í³p~F l oÛÈb!1SZi«ÎD®|ã™jŒñz¸Õá÷Ð}‚±Ô{p/ºæâdð¼ô,^œ °†3@Ãöà!ž±æ†cŒ-Nb “ôÀî4@T[iÍ(1‡õº[¡Å ú¤TÚ·ëª7©pKr”üÂÍ©ñù}=ÔóiÖÂí)<íÂI×rn•ŒUò çy¥cI/ìCÅ6Lm“z—&Ñ·åÔËØ]o¼çrçKüWlÍ0ç€v5¦)ŽŽ' –ŸÐÎØ¤ÊºœÚ‹“ýl»§w€û–\z »ë­ßrv Õ€}¼rž¦ƒŠÇ;¾ÉwŠ¿ÙwÓò )c“*ëêÉi8Æ6aŸï ž©Ú&õ.M®{É¥—°»Þk‹;iï<Üâ‚ƒãªØxÂd#6¥—)/†Æ±äVtaE¡m^-Ž.{âPÆmƒòö¹WsR/`_õöBkr›yú€pã\ÜOÀ¥m`À¯Xp‹âbèæfQr,Ö›”“s„‰íq˜mwfß’K/aw½ù[f皰źìã…ñ¬<băÄjz±`3ÕÁI)Ç„KBë?3jÌÓÆaÉáVA¼Sq¦´ç’µ¼êê ¼~a¦ýØ9 öŠŽÖúóu=#jíèL-5Ð%å'üŒ…¶yurÚµ°˜É³mPïÒ}Kžš»ëí½F‚¸ŸÝâ´ëXìÜðliå„×)JÄbÉòAwaEu¯’“ç—Ä6Ú„ÔvóB9û–\z »ëýMØy/ÉŸ±üØ\4¸èܼL;=ƒ|k)=˜Þ8ádì‰è¶O¿©Ù·ä©i9?éí£fjÝÖ†äÀo;¨Xd?Ô3†ÇápÌW¤|Ô£ºåFucEu[’ÓbŒIlƒWŠÛnéµâ¾%—^Âîzë(¤Ð ~Å0ý±1°Sy>Cõ¨´ §ßÄh>] )Næqy6XŒgÊîÙƒ?ãªZ%ñNî™ÒT/p»®k'8x–ÜkîŹ'vcØ ÃS ¨ë0彌è’7GÎ}.ùEó¯°IÕsmëœÉØ ᙇZeß’[Ýõ^6¸Éï3ËâÄ}Ü÷oœð5«)/†úLùaY‰]T]K§›KÄã^XüeÛ=‹û–\zû¢·gDžÑ=Ù°mTœV¤Êൠ.za¹0}[,)$ïØÎ+ mûjpÎXê%öÄq¿Ûåãwô-¹ôv×Ûp÷«²h-ΠFÇé–·] íèpÂÛÜòA·HaåùÚœ€ÆðtÛ üF¢oÉ¥—°»ÞË?1Î%Â颧"8=n ü ¨˜¯ãršò¢±ô%‡¹7±¢šm!Éá|ml±(Û®9ê¹oÉ¥—°»Þ²6È8£ÑÇb´#_øl=“FƒÙèY>=‹€]àFÄNˆ…QÓ8µÏt-\Å1€Z­yÞ >%Mõ·ëºÂp`‡áæcçÌXÊ_ „Ë…GÁh¦èpÓ»Bò›ÇXŠË\œ;%ca¼É¶ÏåG®¾%—^ÂîzÛ wø¸ÿ”Ÿ†8<}è%,ó ü±#øm˜âþÀ'kù £ °¤Ø¶¯ç ' c/Ü|·MŠW³oË¥©°»Þ~.øÑpÁõs§òÞžp.ˆÔ‹PÌ£šò½+sÉüh¬¨²ž 8±Ø»±pÃ-n[Ô»4û¥äÐ+±»ÞÚï6¹ÉÖtá5§ÁRÖhuŠÕil³”H {Ò&weÉÎh¬¨š.¼æ`aX, ²í’.¼î[òÃK@`w½ý[Z g½[ç’Ã[¨˜€~a¤hˆ{Åþ:",G]bE [ç6N|(Æâ ȶÏ4(»oÉSS`w½ýŽŒ™½–_Srn>ËpªÆ‹X,è#Å÷€oåh:±IÙÁœ¹¿±1Õö\~Mê[ré%ì®·žËÀ\kgÅÒ&Úŧð9ÇèûÓîÝ8ùIŽy8±¢.[-6N= ûX¬‰Ù¶(^}ÐAYòÔ´žŸôö²åd ßíïÅœ «~í°]Ü5/S\ZLKK>L.,)¶í«oLÆBZØ8n<²mR¼š}[.M…Ýõþ6v\Ï«ölä{¯žÞ“#g?,ßú³ØSD|¼d¤üÒÇ‹f9–މµN§ [°ÓwÛ ü‰ oÉSS`w½WX<ºØŒÖfA=“VPãDXVï¦ØFÅ”×xq5uæ‹b ‰="V!Ûõ.MÐ7å֋ؽý\Ð ì,>{3ÞT¸wÜ;h± }…M¶ny)¿l[ö² ÇëMsp°›ØŠ³5·]s½é¾%—^Âîz¯%˜¼{Ž‘K0¹BUö0i[Š‹ž¦¼¨*}ÉoûÒ{Ûæyõ)·£’Øy3¶™m“ò)ÿ"Å>+¾õ*ŸôÞ¢ºÃÉhäÌœÉ'á<9˜{/¦¬Ý˜)UoM¬©‘K0sðá&öÄÎÓmŸ¹3uß’K/aw½½ãª\¼#ëã•sñ!Ü¿ƒ"z.ÊçÉXÑKÞ1”›T[Wƒ3h£v`Oã¶AåqF]ré%ì®·KC åyøÈ!9ˆƒ‰þ¦pÂÖgã17˪øp"ˆÓrÜÂÄŠZVÅʼnh;ciWvÛËîì¾%OMÝõöYµ¢Z|»;§óôY±Bn~°÷‹âyrçbWòÃãÆQÕrQµ8åZØÊÓgµ]ó”Þ}Kžš–ë“ÞÛQ#ÈZ_GAä òjÒ;+Qל¦ò(¨.ùíìÀ&Õ|p$Nãqª° C€Ûn¹$rß’K¯æ£Ø¥·~ËwóØü5=—Å #ÏCÝÜô„yý¸±"…þÎBÛåáÛÓ»(LÉ<±<¨rÛÃNÐÙ·äҋؽW4h?á,•a%ÉAXÉ`tmAô¦82]qô™òËŽY IUÖÕŠQThHcT"ÂFÔö±ÂJ†# !—^Âîz{[ÌC³{¤ÏÍâ †bhyút[¹Å÷ xyÛªqŸÆnT©yõÍÃÛ~.ìÃm¹âqß’K¯“þø»Þ΀5m|CZOnÄÑ#ñîŒ!jÜÈæXœÙ—¼ã­16)­*“Cgc²“mgpPö-¹ôv×[.v8¯ìýv1"by ¸£ÆÚ‡wBDô[ïšÒëDáH°U]*Æ3¡÷ì>Ã5­’x§X4Ršên×ÕŸÁ_ðñÊAd‹\µNìåVFʯñy.ùÄ]36©Í£¿pPea‘4!Ûî»[kK.½„Ýõ¶Ar2ç×ʰ81]ÇVóbZ“R_S}E\Žå­`ŠvQ¶Ÿ˜ÃéÚXæ?pÛ+?‚û–\z ›>—Þë¹\r­ù\Ĺší²ÈDÁ°ör›òs™cɧCޝ¶Sö62ö‰Åm—ô6rß’ŽWv×{-[`µ¸òÈ8³êñ^ÞtÒ+¦¼´x¾ì”Ëš"¬¨+Ÿ‹=ÆN¹í™‹O÷-yjZÛ'½ý[Ž|²þ-â ƒ?‹¦X=íUÍè­©Ön`³|b‰e¬¨3ãõ§×…å†Êm×ʾ%OM{ý¤·‰ŽøaÈú¢wLœgŠ¥ú³•ã܇ä îËr°‡Lù„k£±¤Ø6¯çÂR]؇ÂÛ&ūٷåÒTØ]o/'‡# ǘsó3ã¦ÍtO¬Ó—|lÚ–ßpÃ1–Ô•6³äÀÞcìu1F‹m_i3sß–KSaw½uQ±XŠ øS̸c´˜¹à”?;@àØ ÓyŽRœ'âò d1žÉD¸8˜n•.eŸ’¦z­¾êšÁ‰',(Öb\ð5+\ü>‹ƒ 8 Á^ÄRlSŒK¢fÜ PÍ8[»Õ<ÕvŸ”Jâv]=ò6š–ºˆ’ƒePrÓ +üÓ‚\x‹GÞÃN»ÈXa¬¨žV¾ÅieaŒ3n»¥ñÆ}Kžš»ë½lö‘"¥é£f‚ôƒºi…/—)[áç±ä8–N¬¨3}Ô'–çÆtÂSÛG.âÜ·ä©)°»Þ+Š ù¶Îܘ,ÎÍh­ÉȈØxÔQ³¤Þ5Df0Ëáúؤ¼11çÀæÂØLn”·—è[ré%ì®·7Œ\„Æ1KÕ†19p ç’U‡6'墸ÁXê=¸]¥~圚þfÀƒø„Ûª¼ž²ÍÝ™ Ê=¥H˜lœˆô$0ÁUÆÁOÀ­¦û¤TÚ·ëúMœ‰þQý?¨úýzûñ¸™{™~@'Ò-·iÝ4Úƒq–|»ÏûTRN¤38”…¶Z¶*B¿tÔ”^v Ü®«Ôð¬¹Ó]Ž |9#nÍÉ„š÷·Þ&Ô‘\}Bzs%Mµª_*Æ3v‡ƒ·Z¡gŠ8>JS½Àíº~/ÏÕÿCªÿïüÝ×8¢ùøî¸i´ö?áqÙÐ1R§qšqG2Çô.âp 3X1âv´n½³Õîfî“RiCÜ®ë7ñòDÄ÷Á̼J{œœŠâÂ\ÞÜ 5¦)oÎû±äQþŠ*N{lw‡Æ8 rÛ¤Þe‚@ÖÉ©—±»Þ[BµÝÓ^Uâô͸hx¤_Çiê]ÛÑpꔜ‰^Œ5Õ3›ÿ┾°È›œmgZåì[òÔ´ôOzÛ«j0åó1;!”u̘mq"ûì%L¼¢Ð߀ 8å7|7ŒudDÂâÄ!€±°öeÛ= 2¸oÉSS`w½ý\nCO#ç¦OÍM]µù>oSÞœ·sÉá|fì¢úºúR†Ü¾°ŒØsÛ+¢Ï}Sn½ˆ}Ñ;˜t&£Ó L:w¤ÉÍ”ìz£3–œƒ2#—¤p3NÄaûöbDªásçV»7Ëî³;‘Ë‘¸]Wîˆ)†eC§‹ƒtÈßkæôºSþ$Ϻävlc“Ò.9Üé [n§š¸SïxêµäÒKØ]oÅÕ2Ã_ø"rÉjF‹S˜q"fd(ADd l!Ÿa)vàÆ‰¨6q,Fë‰CU'·ZlâpŸ”¦z­¿êúML'GkÆÚ~lŒ¦tÂȉ‚˜ä³ç9ñª8r¦ôäinSúâr»U\zæYïL‚”Ýj¦wŸ”Jâv]סÊ`¾{àšsÂ8zá£Cˆzu]¦|L^–Ë­\XQËeqj_Ø[·ÝÓ×}KžšÖþIoÔ˜G;¿¨Ó¼V:1u†Ûã.в9¾µ%Gv›ÄŠª~x'Be®·]½–}KžšÖë“Þk®¨:/\s…8òC´A…Oí¥|45ýùÄSÎJÂ.ª¬¹âT周 ‰ÕÜ6)ÏãL¹ôöEo?—Óóhsš’äÜô}Ó¬K™Û¦(Þ;xɦüâLÖ¾AT[yÙ=íFYX†Ó»í¶ž¹ún~æW_Ø]o[YáÖˆçè¸Zq*ŒÖEùV1ÂÕ‚ˆ6Q´„"T3åê]XQ9nœ0Z«° µ-ŠW£ï”§¦Àîzk?™_ºÅ"õã…ñŒŽÌ¶AÅÏ&àžtìëÎ Y•jJ™sO¸$ª<¤Ä¨1ª‡Ä÷nµxåé>)•6ÄíºúÜñäG;ûÇΙX/×Áébb´¬ƒŸ+(ŸþmÉ'üQŒ5ܘ܋¤Ùöé3ðì[ré%ì®÷†eEvžs:]»mÞNê^=‡aY½/ù†…=m÷vT¡9Õq§²|‡w•Û®é}å¾%o6~»ëýMLèávÐAÆ»'qä ‡²Òý’VæÚÚÞáp? × ÉK<+ŠmûjqJOlG‡n›®Vß–§¦¥ÒÛnHj¡4Ò;‡;Ó‡<Œ½]ðn­[°r$¦~=‰µû‘S¸3¶pת¶ËÚÕªoË©—±»ÞþÜ Æîç]v$§ò.HÏH¼ðY€?IùôKÞjÞXQÅ{”‹)aã\Ù6©wir^Kžš»ë»§8öÓ?ÅŒ+´¹éÔ3*ý¦Ë o‰î”ò¨\837ZÉxô0nÄÀ­ŽÜh©OJS½Àíº®¯áe4\˜(9“Y8,Lã˹‚óãe¸–üÂLnlR^ʘÃptcŽî¶{.eÜ·äÒKØ]ïe,L³KÀ¹èRy‹#–x"'­(/´pç(R¥%ÖÔ\Æ’äèD]w]Æ’«šòB }K¤i`_ô–ƒWud•ÎÍÀ~1¿úuSøÜ&¢¯«3”»ËQK }wødQ王QFâ°€t«™hØ}Ršên×5S8Ç·?€ùxaLfÄoè|þ¹h?¹¹ÃÉRäp2. t›$Æ•xznµøáºOJ¥ q»®™1lÁóp"3`•°•Æ)wd €mVDtã=¥G@‰ÈâÅ`EàpzëVó€Ø}RšêµùªkÚŸ£ÎÑ}:£®#ÞÑcHö‹‰ù8LÈþ\kJµ3!.-ÓW^*ÆóK;dÕ–3Ÿ­Úê“ÒT¯¯º®ì…Žè7ÄQNUÄY‡µuSøÖ¢±{É÷ìäI-tsP%-±ð϶—Gºû–\z »ë½6È}ŽÀ‰CS#‹ë…E+L… 1Iy#pßKÎTšÆŠBÛÞ’œ™ ,±¾Ãn»¦o±û–<5v×ÛÑÖ¬—Èœ?¯œ›å¥°†Q uRSè¯3W åÚ› ›”žæ¦>I³í’FO÷-¹ôv×[_8CÏ$;úxa\ø¨ÃUÿ@nËÉvúlGOé„'²pIèñ™ÑbÐ4?Ø­V?;÷I©´!n×Õ‚“|8vj“aêW†Q7:w"éeŠ·+Ý!‡ÏVbE™cÞæ.6¶3L^m÷Ìwç¾%—^=‹ëÌÕö/i:»éŽ¥Tæf`r<õFÃêdEF0!ƒ…¥ÓÑiô,Ràš’˜›qÚÓ‡ž[¬EÖŠ Yè”~]uÌîÄíº® K$f޼Hhù’òÊ›|®¤½Ý©Úoz²ö¾°¢†#/6NÌÆÆ²DšÛ>3+¬û–<5­í“Þ+6RCÍ4‰˜sÑœDçÛûb@ÝÁðítwGì¹ä'е+j¦Idq"äߨÁÚ?‡ÓeËç»Kžš»ëí ;;ó¯}ìfþj8ÿìÊÝÖ0ÁŠâ¦spÊá,›XQY))9Ìíf,œ˜³íÓ'·Ù·äÒKØ]o-§ŽLÁÉõˆGXâ4D‰CQÂyC—ÿR‹5ND·eÓŒC“q-önµyÝï>)=2_èxÕÕ' {aÖ“ùxåD ”Á·÷‘ècšâéÜÁiXr†¦›”Š“$‡E«Œ˜þÝöÈP÷-¹ôv×;W¶át\Ž[Œ«¿±TN?pöÈ:Y"´²0bI±¯0. 9)šcIãÆ­fê÷I©´!n×5—†·ŒO‡—†7½ h¦99€<3o¬ènZï]ÃŒ8¥.Æ™èy’Œz%9wÜjóKç>)Mõ·ëªÝ6ÇEp½Î*ÅÀÔN ±'DÜ×ó ØÓ‡XÒïX8§çâÅè%qGÝ*mÌšÒT/p»®ùòTmx»_1&6ÀGXQ.0!¡—›aJéN,\ŠG7£é-®êýD«ÕÖF÷I©´!n×5m±_éÓžûf ýfõêŽl7<µEÈÖû_I{ZÃFÓ>û‹Q{â€îV‡ç÷IiªWû«®¶ÈõÌb¿‹&ü¨\aÍt|ÇÏ¢¸‡?hØ’ü ÑKؤ\ì×l{0½Ú>Vú›æô¥.½„ÝõöAÌ„®u*mœÁ£—}o°ÄAÊ9Lñ°äŽa1å(tؤ2^Eœ†•Ÿ±ðJȶ39Oö-¹ôv×;m8uê®Ú±¦†A¿6Þ¸9!«η(í<ú". …:›ÑdA¹y~ú¬JÝju±÷I©´!n×ue@h W(^4%g²î´²)ÂQMqasaL±ürv4`“*«T&82á ‹xŽl»Ø!û–\z »ëí™Tdbq¾ÉÅAÑÿ½Ý,: QœM±HùÁEؤœÿÇœ‰óÆND-¸í™Q î[ré%ì®÷r ‰¸†VmÅIŽÎ‘ýë-îSËaН1Êò¤¼Ó¸-¬¨ŒÜ81î[0¼ºí²RÍ«oÉSÓ6?éíýjNÇÙüéü¬â â7’‘)>ÊM\ty™«E&ŸÌ#®DøÀfÚ{?EsN¦EËDøQ3ÌmŸYSÌ}K.½N§\[zgLÂÅP‚Ò“ Æ3ìŸ(¤t)1ùÜo[^–³ótŽÒæÂ%¡º¨fÔxiŒCÁP·ZlÈrŸ”Jâv]mêtëÞ굊£z­(8/ïÆŒ•—)[§ê±äé½ÒªOæ¨qêþŹX'Ü”¥Ê_veN©He“rÄÙ&6)§î7†šÄÂ8“mg]¨ì[ré%ì®·|†3÷—V†fà„Š¾¨œw¡|»ZNz"“1ØKœ‰\šüÆaÅçVsAè>)ÍDeîEW­áÓÇ{YÿÅÀ›ûNévÇbÌÙÞdý¯tĤT‹8âréPíd<‡—Ü­fz÷Iiª¸]Wª­G–°ûØ9•«âÎû†“òðqÝÔ;®>™Qr 2Õ+j 9×ºÚƒÐØ+£>F7õ.M”÷fœ»¦Àîz{Ãtбp¥%\œ›90$Á´ƒeÐ!r¥%Œªr}É'…MÊÙ?Ìa cvJn{dö÷-¹ôv×Û§2Ó/¡FÛä`Ø jt¨‘O¨—}À ޾ÈoNŠÊ1wãÀGPXŒ«Ùv»Ù·ä©)°»Þ>É(ô¨þF’C›JÃÆ%($â¨ØÌ,Ú{ÖhÚrî3VTM¨Å)uaéÞâ¶K:ôºoÉSÓR?éíßR™ùþB;‡VÜBQ{—;udÕÎÒ!±wmÞê¾VTz'%ÖÙÄi¹Lå}ªK.½„Ýõþ6ÖVûà¨Ï㵕8£`}TºëE2À‚3#Qéš0–hbI[-_q.ÖÏ"ö¼ìöm“Jׄ¾äÒTØ]oÛàà®§„þ;gÀ1íÆŽIý¨ë6Å3œSž%€•å6N8‹ˆlûÈœØî›ò¥)¢·v½W¼@+*’Ê~ìäÀ‹ŸEM&}úïaŠ6¿ÊÀ"ÉbÝŒ5ólÍœAwcam‘j{,[¥ú¦Üzû¢·'9ÜÒ4º±éL™‚´6ƒ™œH`q2‡ ¥'º…K¢ä¥“ËÇggjLžn5-¢î“RiCÜ®ë6ZÑ[H‹«äÜL:Ã|Å×íô4ó4•£U]òîâUJX£$¿çÛÀ™ÜR÷,7ßWÛ3 »oÉ¥—°»Þ+·×M;ÃÑ3·—jÊÆ0RO®ù¹s©ƒ–¦#Wä5kÊÎSÚYÔ²¨n DrHXV&wÛ-çºoɳÞ,°»ÞÚJÁ¼Õ$'gÆ€¢ 3Ê–!;LqpAEᔣ obE+Ì#9­/,w²íc…y¨op–žôEéLl‹ÌÿÈÌó±1.¤’½˜Î ©1oì€D¼ó'5¥7V@‰˜Î£c¶Æ!Å­Q»OJ§ n×u™Üà1ßžƒcá0„…Mü8¹ß®ôŸÏeÑæ’ÓåÌXQ«‚úâÔka‘[4ÛnÑë¾%OMëõIï þSRïšÁb„Qk¢XùÇæ¢;[¸2*ž‡÷!=¸P .‰ºâ%ô¬£Œ+ñ‚»Õâ÷I©´!n×Õ ].™Üècç\ÌìË”çÅ̾tÝ<³VLR±ÊœÛcMÍœÌÍáÆ’Øã·=œ| û–\zû¢÷²°w$eñ[EƉÅlܧ²UùÔÌg|Ã(c)N·ÁV})õ2îÀb©¦7„_&öi©Õ«×«®ßƲðwÿy÷Ÿi¨1¤£ÇÌ‘>¨IòÈ2ýLaÑ6)’^èÞrô“XQGF™ƒ…Gb±ðȶ{zJ»oÉ¥—°»ÞŽ-QXí‡É‹Â1Ëf(d¡Ô{šBm:^ò˱ôÀ&åÃds. [˜Om—•"O}[.½„ÝõÎKœ=wo[Í@Áªû´³ÅóãïÁ$y—ïiW‹ðË97íhq¬XLúY<Ó²q¨—ìV›w«î“RiCÜ®«ÖáÌ]YšÏùÌ€ßädÖKfVÅ[f™^&sfJÊtšÂ‰È(øÅ¨3qØQ¸Õê¼ûc©÷à^t]ÖU<<´æ¨Xk£¥Òm/ÉÎuçÃ>sÜ)oÅÙ [YÔ™¥IÌASbéxë¶\‡»oÉ¥—°»Þ¶=¶px{gª5Ý:Yà³7S>­C.$É“! +jÅ™ƒøçÄrƒ¥RIy,mç’_ŽÊ6)kgR$–‘¸n»¦yÂ}K.½„ÝõÎm7\o Å`2ÉA—ÅCÅ C# 凜ÒR8yEf¬äb”j\”\žn•.•›$¥©^©¯ºÚ2Åôî㲟äÆ7¨p›ˆ7­…‰âGÆ£Ö #”årŒ]Téy58“‡9¢@¶=r‚uß’K/b_ôÎDó'³ðj\ŒçKœÍùe˜u>rª×¬‘4a‘°á|Æ%¡QHŒr+·|çÜøÌmj•„ér¦´: ³Î/]}êW8sÞ.¦¼qÂ.Ú¦¢ÔKÍê‹<™kÌ·#yjìÒs•‘骢ØûŒm×m“âÕR^òâ9Ø]ï¿tñ0¸z´JÊVW[1ºJ^WSQƵäLÎblR6ašSí$la´“Ú.¹å¾%—^Âîzû¬†5B™,ücç0Äß%©˜z¼\sçXLùÙvñâ'û–\z »ëíÝ íEÍ­ß'¼oÂ?€ç¨á™‰š©4-_KÞ|RlRöÜ1§Ãve,ób»í¾<ÏÔ·äÒKØ]o[?‘‘á>«IâÁ°.~q3Mq5a¹³ür `“² ÐØá;pþæ¶GžÏ¹oÉ¥—°»Þ+¡Ðd³93¡ÂD¦ùé\OÞ:Q¼MùüqœKSFbEެÜ8µ.,CGWDçésÓŒú„<5UÂÁ¥· µ>2 "9<‹Ñü7""iAìtFB'ÆFË9Š k*c!6NcËS1·áÙ7åKÓÀ¾èmD­â!ý±s}äšï¢mPQa>y=2j rE” +*“k&‡…zŒE g¶qžÙ·äÒKØ]ï ¨ú6.¹¶8ám‰ý/ê­WS¼ÓÝåP!?¸&6)—\çºi'öbÎ&µ}­™U}[N½ŒÝõös¹ì-ªRx9-YZçF…šÈ`y\¦Ðßɲ>’Ÿ4¸ »¨²®<›GæMaO¸í3ã Ü·äҋؽ]qbÚ ¬(ñäâÄ긜ƒ'ü1Ì:ïãP¥"Éo®Å…MÊ3†9ððN,|º³í’Ù~Ü·äÒKØ]oÿXl°;võ qzœBVÆW!u%µ»NSè/Ìq-åιNìJŸ5’Åy~¶žÙ·ä©i`_ô^ÞÇEµÁýŽ%gʶ/«íþJ§íµåÁ¼a–~çÜ©Zók>èTw ;xnÐýÝ~ÇÔ÷ð¹B »ë½|4bE73!èÆ¹éþÂò)l5 ôÚ÷€9/-o,¤ lRþöÍáYœ±Hø™mgBÐì[ré%ì®÷Š“R)‹kÅIÝ´c ~}wUŒÂ8¨ÚMñèåàq¬äŒ5VÔ‘ªÅ /uc»ë××nʇ@ÇXòÔ´žŸôö\y1«UYsåå¬Wƒ+ߣxm?c_Ågö%g„†°¦Ê>WŠo¤°×í¹² Sž+’ò¥i¯Ÿô^N'+Ê{[œð+L}ÜóÄ8u£wQvr@6lÉ+sÜ ›”Ç1s`#I,úÝöÈqÌ}Ë@zû¢÷Š_;yº}yÿ’ÜNF•énî_f3•;’kÉo¯4ϲ¨ií6N ;`œsÛÃöÚì[òÔ´ÎOz뷜þmNgeýOúxúEž°îˆâì‡cÛ”_´ +*3AmœVvpfUÛ™ *û–<5mõ“ÞzÇN9æ šÓÇÎA;ê?Paõ?a\Å/@Ê'3< ;ï)kG%§\ Û`ïwÛ-ÏÜ·ä©i¹>é­#ÝÉ”K80øXŒ8ý=ƒ›[+Q$&vß$pøzsX¤Á Æ‘Y:s1žaL¸g¤VGžÙ«OIS½ÀíºJý›é˜šíÄft®¹ý¬BFqòw‰Gu¾÷VÆ_g"Óx›5 q>7%ó’f½£û6ÃÚ÷¢kæP‚¿X³c¬=žÞ„]4Ü$ ²œÅLṪ))2o'"«Ô,Fx- WÊíVAÈF†>)Mõ·ëj3=ì1!;ÙÍ℉&Rkœ¬ªT»5R´*rãf9·xÆ&åd7æœ8ã4öÄ"ÍmŸ¹ˆsß’K/aw½WzM¸  Þ8±™©LFá£Ëò5SœÖ&%Ÿ>^¹ÚJq^œðce,3Z¹íÓGÆÙ·äÒKØ]oPLúw]N둜›%çšÝ ¯æb´¢8ˆ¤S4ä|IŒuårÜÉá¬ç}*«íé´Ù·äÒKØ]ï- ½¸ûÇÆa‘ö æáî•箢¼Ð*sÉYtÐXRÇJ‹e ¼Ë’în›Ô»4™Ç’KSaw½·°H.¸5¡'çÆ1Eœ„ÐÙ¥ðŒÿ¸M¥ëÀ¹ä'7„ŠºÖr#9q¸C,¶—Ým‹J‚¶ä©)°»Þ[&mnê{“ŠƒO1ÒÍTލƒyµ¯n ý]Ò@ò™>Õ\A"95>úÄÂ})Û®y¶á¾%—^Âîzg¢«°q\ÌûØ]kc°¸pý qìDæ€ •¤Ã óóH¢Ù­r1¢`­phÕê†Õ§i©¸]W©?qnÜ‹s,F$ƒ#Ò?ówŸ$ÐòŽˆq!#‰p‹pn2\Š…kX«Uh•}JJm„ÛuUjƒæ ŸÚ}ˆ1Ôz±XÈDL«R1’€N¬¾.éÉMq$Ø*.MF/ÆÅ"c¸U¸´;Íè›zÛuÍPmÖnÆ z—rCæœ(ô6L`±Ð\#¤ÊwA\&¿p¥¹dÔ;q‹-µÚ³Òœú¤4Õ«÷«®:e……^lV>ë€8OêÈû8Xº¡gjÉÃUK;« ×]A±À‹ñl«„k·W^‡ -¶¢OIS½Àíº®´IJ]ä s¸?è «ìƒ£³bü útεœ~cE­ s©•Xõ»íôï¾%—^Âîz¯s‘ƒ­÷šç"âÄ’èf°^`xvaíÖIG¯KÎ Bc“r :sºŒeÖX.¹íesß’K/aw½==¶^Ž+9nóˆúT1TfÍÒïšLf[rä¤O¬¨t”IOE^¶]2¯û–\z »ë½¼Âg¹~¼r.. [Éb±Vß¶ÙXÐÉWòÉ$±Â&U×B²r 7±á:³mR^¶sÉ[¸e_zû¹TDGÖ¾±$g²–wc餯"w5å;}Î%G"³Ä&•‰XÄi¼ÓÂV&ZQÛu%bQß’K/aw½m©YÀÂv«äĺ¬Tú*¢Îr$QðcÛêÔÜKÞm#žÇN•™WË:«ZØE…Æj»z¸Î¾%_”õ“ÞrɼàáqW;o™Uät˜ÓDX^&0ÞÓÁ^ÒÊ¥p&Ò[ DvW·šÞî kÜ‹®ÞqLfØE¹·WÎŒRÇÍxp’©çí#ân#ÇM3 åCAqÄ.ªzçbAkbciѲmRl›}[.½„Ýõ^ž5'M§c¾ÄAÝ*Ô@5»*?‘óªjIÎÃ@cM-÷.sp–›XÝörïrß’K/b_ôöñ7 ÷å¢èɹ¹Ñ™.Õ›ƒÈ‚wšÊc¤ºä70no›úé¶yurâ-#V‘Ój{ ¬Vß)OMÝõ^É*='U¨79È¢Šzê\ÅÎÛ¢hâ?´,¹JV+ª­ZâTÌ{Æ¢:G¶]W-õ-¹ôv×{ůuË#ã×:ì µÊͤ:…»£‚¸RžÂZYrTâ2–”ÚöÕ“ÏeÞÆâNŸn[Ô»4¹®”[Sb_ôÞÜŸ8e*B'9Ï‘aEqi]”NS¸wáÂÔ–¼3Ÿ¤°¢ªãt’ƒE`b vEn»8T'û–\z »ë­½Èe•>3`‘»ÄÉÁâ|‹@Ív 7ž67ü±…31ý¡,Æó®7â3p«Ã_‰û¤4Õk׫®~­¸>8W&ms:KÛ ÅNfÊž\iœ+“ödrËYÓXQ+“öâô²°5Ƭl»zS•}Kžš»ëí•ÊÁù¦ãS+&édæŽeõiŠ/ý`‚É'“KŠmójq.>‰BEj›”Í8Å•\š »ëí•}u†[¿Åœ“æ–Êá…~¸wã`²ütïÆg؃ӦElg nrâÞ‹ô^ÙvÏçâ¾%OM{ù¤÷#©Óø¶b$¹þ=¸þ=U/¡3Žq˜òjøêK>é_"¬¨4ßmœ:{¡ ´Û&åÕ°L•£íš»ë§:-ÐªË D·GdYžÁóD؃ú{O)‹ '¢çªëöZîº×°êR«Í«.÷ÙtࡃëzÕUêw×Yº¥~w©¥(Œ{p…Š<(̽*®ÒÓåŸFI"³­,Ƴè2îˆ5—[=ìé>)MõÚ|Õu;7a®J) žâ©.Pœ¦|îS´äµ0…±¦®e ‡¹ª¥ÓœÛži wß’K/b_ô^yAºÒ×Ì "ò…œT^Ëé$/öì+L4iùp¾˜1wʾ@æ0u‘±¹DÕv_¹FÕ·ä‡_\`w½óT*>úzÛ¤"FCV”ÉM\Ãæa*9eÉl9\Izâ® wúñ9[ލ)-\ÅŒ¢VIèTêœ)•zÄíº*Ý cÓ`áú=9“–²JƒÀdÁØJcÁô튅Z¿–\ŠÊìºÉ9i’öDrH·}Ú}K.½„ÝõÎÌ?Zhªæ›È¥wVî:Q–g'"d\tAGãtêÇ’DõöË ÔK4)÷ÜjñÞË}RZ²Êã|ÕÕ[)ZúžÕ¼sH-Î¥4'Rq#4þy¢¸ÝA HʸՉMÊ9¤Ì9‘ÝXø"fÛGærß’K/aw½íU&ÏÃÓ†ÞäÀ†WyN$I?ŽÌÛ¯9ü ‘ßr0VÔiûÁƉ*Æ1„eÛ‡7+Ù·ä©)°»ÞÞ®3ÚxfæŸä°rÀ o”X[†ô`õ™™‚sK^]ì'°¦2óÏÆ©ÇÂ"³O¶™²oÊ—¦}Ñ;-'>p?m9ãFuž“¶‘Õá[1!ˉ&æyLjÜ"ZÕey„q8‡s«yLç>Á°6À½èºEŒ<µøØ9&¶Ûù .ZNÚiÊ·+ÆÉŸÛ®_šʄ¡æÄÆHìC-Û&eËÉy/ùåˆ!`w½—ƒ_eЍézq¤o˜5š¼%˜û©UÇkáŠt¾×’7ÖmVÔÌ€ÅÅ‘KßÍ 6Œ n{dùK÷-yj*w¿¥·—ìÃs†³å˜s1ã ó ^³á°0Ûu­E8 ·Y~¥›[Ô\Ùr’ƒl9—¯-gÚù*³å¨oÉSS`w½W⃘¼žYrÖL|ÐXï/œh/Zy¢8cƒ+Ú1MÙø_”ß…9¨‰Ŷ}µ8åHl½XÅm“z—&Ñ·å©i9>é½È ±§“–UŸ ÇN¡Ö ¬pén‡).›Íó7Ì塬¨âß²qÂ…NØ 'în›Ô»49¯%OMËñIoõÀÆ[â¡)Åœ†#£à8@©Ì`¯¦p¦üÂ÷`¬¨!a'|‚ÜöLÏL÷m¹ôv×ÛFßÉŠF‡ÓS$gËaŠ-Œ w¢ð:Ÿ¦ÒŒÛ—\»Was§{-£¯81‘‹Ãçl;Ϧ³oÉSS`w½·)…{Ÿ³®)…y¥Ïøäo™Ìøß‡)O¥/9â+ê\æâ4 [H¶},sõ-¹ôv×Û{Ä“µ†ëˆnœ‹SÊfuЧ¶LSÜÇÑRn9-åÆ&•Õ+ÄAùåÄž¸ýnû\Õ+†ÊJYz »ëí)åä#ëËÏ:9H©ÆPçã  ÎÀ ð8–‹ÎäË%ù䉂°I•u58Ó•°•~Ôj;ëµdßÕÕ¡¡—°»Þþ^$3×Á‚9<863ypp°dö\ Cv,g8±¢Úþ4Ži±^1–n{,¸oÉ¥—°»Þë`!jæÁLNsÁúy€Bõ1úôÔ¶ª“Uø¨[^Q±KXS+šeqJ]ØÂêcj;ó`fß”/MKý¤·ò‰ íé _Œgøf‰%$ŸG½ôÙLÀÂÎaQÒáìhKB&73ZLfÆÁ¥Å­¦Ã‹û¤ôpäQàv]í+ã Æ|ìŒêÖz½@y`ÕÍm<%ü~Ê•XSÝNì'n§± ÷­÷¶Ïá©£ú–<5-õ“Þ+AÉ_ç Eè\Ù+”úÒy]ÇУ”÷ .P’‹›Á—*ЧPêYݶ¯§Œ…¥VèãJ}Kžš–ñIï:dÂð0œœÉ—Ê£ûNC!ì«QXå•%GäYb“ªk½YxÞŠb…5ïLqÛ¢Ò¤9SN½Œ}Ñû›È䄨߂eYVhJŽ,ŸU[áÊüÇÕ”ý1—üB ³±IåGN¸ò‰U’µMÊ3b=—œz»ë­G1¹Ó¸íHGîï¥â¾ñÎ<#Gø Ÿ&d1@ÚJ™ŠZ8Õ¾½YŒvfAad1e«"ü€¯”¦zÛuý&Þ¤çNL†]j9²yÙS 6äK—¥v™vÎ;¥5ȈK¢¤Mµò>ôK¸PãêjU„lK żzjÜ‹®¶1F6ûðnœHÆs2jÂÏ-¼V─-5Ì`9³ ›”SЙ‡´ÄÂ.—m—ÌBç¾%—^ÂîzoÒ¿sõYÞì΀.2ä)å"yÒ0`ŒfBcK»Sz3Ù‰èèbŠIÅ/\úÊÍÀ1±qÈ·âVåî“RiCÜ®«Ôg”áÌ(3à±p Ú¸'s ÆßeÍ%›¥È7iœˆ4z.Ƴä3†H·šO÷Iiª¸]W0Q1 i«FL§KjÔˆ¡©ñ*ªs&p>Í# 2&Ýj‰1ש·—jÄÀz©FÌy˜ØÍ¢—jÄônÜ‹®6ÈpM·ŒKGu/UîÔ\,.ãRXæk]òÛ©|€MJ ïäœÎ×_Óx”m§q)û–\z »ëíÕPÇzþÂØõ±s0¼5å¹7xTS\±0µžå'ã)…UÒ™Kœ 7cçÍG¶Mê]šÌsÉ©—±»ÞÚâLñ`wúxå\\ÒMÞ[œ‘,Ò4² úÔo>C}a“Réät0¶óÔTm÷LØä¾%—^Âîzû¼¹lÏ*Ía`«›;ÝË›‹Êcê{É;‚{8ŠÏg•æ ÀBb´á¶WP‡û–¼¹t°»Þþ^º—%Ãñ‹â UJ¸ñ /Æ'ÖiÊFF­€ W‚IaE]y@oÂß‹T)Ùö´Ñ/û–¼»Ì°»Þßļyo"sÞ¼z½qnfŠH‘‰³ÃÈ Î@¤øIø I~Âcì¢ÚºœIÿaa.ʶgn•Ü·äҋؽWž¾“«1;v“cç쨔ۼ¬jÞ¦hÆ;h(β\ÊÂÒ8¿9v›Cçlbí¸Í¶wÇnöri*ì®÷ W+s|¼r"Äù>\£"|fÂNYMñ 8+V<˜.ma“r^]sJŒÆ‰EXJ¶]2²È}K.½„Ýõ^Ÿ{¼¯‘nâÈÏœ›““ œ7'¥ƒÙøï)MõJ}ÕÕ«®’«r¯º’ébsÆElLëðsÙ ·-yçUؤ\×Ä&Š5–+·½Vî[ré%ì®·ŽŽ.&9ì¶,ï¢D"O›÷m—2ª…žBäD19¨EªÔEyP5§ã•3Ç‹n:Ï1Ý1¥R À…×§ÑY£Æ‰Ã͹è3ék{ùC9‡)¿ìa%°œ•§Œµ"ËÌaòocpà¶W@‚û–\z (KoO%HžÜY·ó㕾 ©UQk€º.S4Æ#Ø0åHâšØ¤²l¢8{2 –Ú>Wš,õ}Ò_Izûª÷ò »ö=¾VœÁ4`Ì€wá\1|¹j1Å©‹Ù÷,¿´ ¬¨5-N Ëú?nûÈŒ:î[òÔØ]ïÌ|“òÛŸÅxî,KbÀ)†"|âÌãÜ9œJ%¤Ó‚KBCƒx…cRGµJ—žŽ éáÐÁÀíºúˆi˜‡]<9‘_±Vžñ`‘)"S)ƒ6œ [μÆ&µUõîL7Q?žªh˶ÏU•^}[.½„ÝõöÉý…ÃÀy¹|Frn¬qæmOŸˆú¹˜‚?ÉB›†ä°‹kêÚcàÁ™ŒÜ9ϲí™Û}÷M¹õ"öEo‡Î"V›^q&Ó,væ3Œ˜7(ùc9Û[F%Ÿ4“;íè•9Γ'ÂF*û+Û&ūٷå©)°»Þ+Êü¦ïšÂ ’ƒ\§ˆýæ8ŽèŠÎüi[ôEç©åо8VTãNNåÐÖ}âÙ¯Õvõ }K.½„Ýõ^¡šZ':£ 9tYìÅ9ó 7ÏÛïÎÈRÞ¸2¶y錂‹Sgb »ªí’ ˆÜ·å©iŸôö·û Rkz4ç„Ëb…1éŒoPaê Å³,gŠ-cE>ÄØ8±3¶#ǹÛîR;%OMÝõþ&6ðñI…ýotçèJ΋òC 檻øÆ*hdzÓàà#•|² °¢2½irÞocìcn»¥ýÌ}K.½„Ýõ^á<£Y‰T2 áÌD&Ž#êiB‡ª0q”¡r­&±‚sÄ@VZã9ãV38Ç}‚am€{ÑuEšž¬´s{¡%Îɽq£©¡“Uå#I½k‡¯Å ä´ ÛÆ™,'LxÆ2ˆÛîËÉ]}Kžš¶û“Þ+·2„ôUçkå#¹˜q‡E½Q?F¹FŽôcø$ǸŸXQ}Õù§±V—°u¼VÇ´¨oÉ¥—°»Þöc­p·¾Ž¬µmrþÂó”ϹúQ¨æ%—Ç,kùá03`E™ñ}qbÝe,Í"n»gÆw÷-yjZÏOz¯XÇÂúm¯q.¸Ï–ƒç{·3ûãTùN—¨rò½•|ðýVÔL—¨ÅiǸ޺íaŸ—ì[òÔØ]oG¨õtvsn'½Æ(2;é ì¤ç(2E[J>ì¤ìH'=½‘æ Î=±Ìpã¶[®ÑÜ·äݱÂÀîz¯QµWœ ËøWǬÔè%¹®ª¢BÌ…Uéîkù`•uaEõÌ…e‚&–Án»e.,÷-¹ôv×{s8dL½ó›sÛŸÛ¸%˜úD߃››:ÉoW«;ÏE]™/xq}Kl™ö#;OSïÒ亖<5mí“Þ+÷ñÍ·t¬ÜǪO† Åt}²¸içŃí—lÆ×Xò›Y¦§·'Ê9íõíâ„+±±4§ºí3kÓ»oÉSS`w½mß.®ÖzjL6‡ecŸñ®l•K[u ½é „‹É{VTËŒfæ ‹RbÛ•m×Ìhæ¾%/.# ì®·ç—Î ¨‘+Hsxð2°d*^Mm¤oz&3Sjn9™XÒÓñÇ•D†r.³T”£f«‡—iî“ÒT¯ž¯º~ à¨c5d¶qô88¶ª|ª½x³jßÕLáiwNä–£(@bE9N/ND‹cÛlûÈqÚ}Kžš»ëýM<Šçꇯ%³Riƒn>¯g°.LüqÇí% ™çÅTõ”^ˆ…NDOçÔdDštáà•åV›×Åî“ÒT/p»®[Ôìsõ¹’öˆ#[ 2¨HÊÀ[Q¶†˜åžM,©s%í1‡‰w„=q*ë¶IÙ6}[.M…ÝõöoAê,ã•ÝÜìLƒºµá -ö¼LÙr«TŠ#™]bEõU\\ìLÛpÂá¶Û*.®¾%—^Âîz{ r2¦9J?vs˜ž';󛞃æ–Ã奛ßɧOjYTÏ¢fæ4Ÿdê ŠŒ§n»Ù›}K.½„Ýõ^¾Ò—¼‰|N•œÉ ò¡‘/t¹Mñ,é²ÇMc ¼r¯Ï¶SyN%ÎÁ³¦Ë3×±ÚîëœjÚÇréuØWzéí%ÈM›|ÍB·æ4lÀg¡/ )ÍÊ tËB·³r“-yc‘4aEÕ<7‡…”Œ-ج¸í’©>Ý7å֋ؽ½ÅåR²§#JÎäÆòâ© >Ô3¢È}Kžš»ë½ª†£Ý«@a¨JÀ׸†y·:ì=è>)•6Äíº®Ç`bôÌV-ÎíŒÓ•¹Ò•Ú©±­áÄ)È`c¬¨ke«9N;™ZmÏ•­Z}Og³}aw½½æ…A2ò1«®58pÍ %gábÕ\qx“n ®ýjyg¹[a»‹ßëjp&Sc&S·ÝÒÇË}K.½„ÝõöçÞ]¿½éŒgqn掫ô×@b‡ƒùÏ•øád¾@És ›T[ù UQÎC‰²߫힖 ÷-¹ôv×{ÅÔš|GÆÔš ™[¬Ð)䦽M)TïeÝáúæàp—…ÕV}®ä”{a+í,ÃiP„Å}WÇ•KÓrÒ{¥â²ñ×LÅ V‘7N‹;|ƒŠÃdR´:ìo$¯Hø`¬©áкÓÎ…Å–7Û>sêuß’§¦}Ñ[+ûÛ‰™uFbœîÏÛõ1"ëEqi DJü‘ÒÊ=8p&š·ÝfàðÏ8ä_r«ÕG#î kÜ‹®~­šS^æ,"ÃsY­e«yp©2j9‹N¹ ùÁŠºÖ,"C{e0¯ÛžkQß’K/aw½×v½ñ RŸHrǃ O,QhúÀ®¯Ä§E…RN÷>cE­Ä§‹©óÅav¶]ÒÝÎ}Kžš»ëíäŠB¼ì+Ÿ–Ù:%iú<è´@ ÷îèt´”ü`ÑmaEeâÓäLXlea.·=í+Ÿ}K.½„Ýõ^)Ö"Óäq8âãÜt Œ)ì`äÀóOLX¤pï"!±äIöŒMªÛ¿\V 1>²ÙvÏ¡Ä}K.½„Ýõ^¿å™G;ã>^9Ó²Å*±h½›òo S­å°Ð$6©º~98HIiìd^pµMê]š\sÉ¥—°»ÞkW/ƒÕUrW1+â1½ãŒìV…;áÒMyŸƒ’å7#>„½3Jeí„ʼn¥€±ˆ¸Î¶ÏµoVß’§¦õø¤·V“çHáùñÂxæ±É Ýt ób)ðÛ~ùóf¥·ýð—„6µfÌX«[Mó«û¤TÚ·ëºòU:J:ó9(OÔ¤£eXÔûtT‰3à¹ätc0v¸Ráµ ]ä„û¥±Ø^fÛm¤9Ž%OMÝõöçβgLþüñÊôôW -˜åά8± Ýç’¯;ƽSöª3§Ð,GìuÓhƶI½K„oI.½„ÝõöoiÞzw}/ætTÞåqjP§âº)÷×Ë’s×d¬¨ætóÉÁ",±Õ¾h»._ õ]í‹!#À,Ÿôöî‘_Ü=3k§93oN—vˆa6ÜŠ©w™–”’ò›1ÂÞ.Öp­«ÅAÖÎÛÕŸ‘µSm†Ý·ä©)°»Þ(}ÓåEõBc"¶÷ »LGE“ÚM`ÝZéæNiãy+qI8[­ðQ%ý¦VEàRfÆ$ÃÚ÷¢ë²uMN ³G;aojhÔÝß¶Hû°Wj‹½šõDmÁö'<‰UàŽÚe[WKžšöþIo¾bÏÖhíûØÈF2°¿S í ÆŠ°·¢§ôÆ0$œˆL((Æ€™[¸l$judfõ))µn×U®þÅŽ1x͘1¬ÜÕY8ŸönNÙ©\ôá¢TSJ—LáDdñæÅx¾UãàåVOŸ˜¸OJS½ÀíºzBGÉ›V‹ò±q¢êxu1EéIS†Ò—ú ¸#@ʱ{N,)¶í«Á¹˜˜XZ\Ýö²ÈºoË¥©°»ÞßÄÙ[¼/ZjœáÙœg§SÙ P®/Œéªæí Ï,šrÍL¬¨,è·qZYXn(Üö*—é¾%OMÝõŽßò‹_×ÞþÇo¿Dz¢ò¶ÿýîWÿùá>ûÔÿýå¯þú­¼ý÷/åíÏ¿ôÎ…Ò0H¤šþ‡··ï¾Ä:þn0ļ‰<rnáŠ_þÝ>³$:~6.oa@yÞBtüÛ÷üò‹ÿøPo¿ù»·ÈùFø‡4Š¯Òžy]o¿ùxû“ÿùßý×ò§o¿ùû/ÿá7Ÿ;¸Ÿ…éÓÍ32ÇKú£;¨ÉŸ¥ˆ;¨?ÐoÚl÷[Ô ùq=üÕŸüÇÿùßþéÿùoúöÜ„?ù‡¿ùíÿûÛçýõÛoþü{:œÏ®"‚0½o?ªCœñ1ûÝ?ÔaÍŸÞú÷¿bñn#a¾ÛzMóÅ®,¯Ó;òðž,ŠX"æÓ%_P]6J¦"Ø?|ùnSàó+þY—W+˜´ÕåIF‚~|ùt º¬ôf{fý×.?¿”?ÔeØ¥"Zq—R!Ä0Õåv ~uØù'òy|o—ù–þ`—íµ½ËŠanf—ëvÉÒ?×ç.?¿¶?Øe¼§0!ªK¤ùë]ΜŸ.ÁE-\¸h½vùùÅý¡.K¼©8ŽW—XL¥q!øétÙ×âYOw©±¹áÆ®¿ßóþæØÌŽ¥ÏœA§ªúÛ/ùö¿~¯ÿ^>à_üö¿üú—oïøºJ¼ÖëïË—|¿~È ƒ«Û¨a¯ŠéÏŽ}Pú—‘ñ¦<ï( íÇBä§÷„–Ÿ†ì7Ò`2ûÜo̯¾ûQ-¦Ôúö÷_*zûO_:²fƒõÑø@IÅ Aieuh‹E.¹_Â×¹zÉn%,òŸò2ü«üÜeŒý‡R|CT¿,,Bá˜H]J¹ÈMñmÉI.yxØà„r‘Kþ¯þÞ‡ù)ršÆJè§½¼õ(Ø4'ôG¿¼¶ƒ&òÇ0'ÍC‰üÑ_iØ"b³šÈñ}ÌOb>/NÔ R±A þâWõû´øY=nÝüÙÖ{D}^Øöèwÿů¾w¨ø]ßÔ'E¸^Ùÿ†"½³VÄ@=òHm5°Ízæªêÿîÿä}í²N¸^`öÿ=ë¯óíOþæŸþôíÏâþño>þö·¹ ûù¿R=HuPQÊ_äý¸Ÿ±¤íQÜ–¿'Çú¿ùü½Ø¾ï]„üîqþ`^ùÛ[죢±^葽!ÂÕ”ŸûÓ%KŽú}¼úÉ7¸ÃF÷ÓoðÏXÂûðìþ±7ø{—\?ê3íºÁ¤_npÜ„²Ý`]’òÐxþ~7¸!ôO¿Á?ccéܘñcoð÷n~Ô n8¾Z7˜ôË n(ð¹n°.Iyo^ÀüìÇþÇÏ¿Á?e_íŽý§Þà׭ѺÁá xm7˜ôË ~¶ƒ×±Ý`]’ò ®ßçGš"Ôbý©7øgwtƒ#Îó8ô þ—·ø?pƒ‘?ª¬,z¿ÁqÄ'õO—,9Î]¯åj~Ö$÷Ó[¾ÁÜâÿèIîûL?êOøT­Lúå3—ǺÁº$å 0ßåg­l¾wÑ:”¢jfúÝÖ¬ÕìïÒ‡~4ÿ¢±ëßLŸ6<î½Z,ÿÍ(·Ç…Wƒæ¿•NŸÿÜêüoÖ?+ þ3£ôïkÞùË/ÿ?Ÿî7 endstream endobj 4112 0 obj << /Type /ObjStm /N 100 /First 973 /Length 1603 /Filter /FlateDecode >> stream xÚíYKs7 ¾ëWðغËHOf’8IsH“I2Ó´6«µ£VÖºÒ*ãüû~ â‡ì•¬X™ŽSå`K‚ àˆ]2:)­È­Œe!Œ²øá”uV‘N˜÷Q §$„Už´NùèADVÁe9Aq 2Ö¨ #Ö*£³Dë@%/)#¬ ‚2ެP¬ …$TTÆ{'TÅ"Åe¢– “I–±…ƒ† ÉŽ@‰²ÆDe­hkL•²<“PÖ΃Šy+ëµÌ´jXv²Ar4{$G'|øq:ˆöåŒí]EymTÎ’ÌzÌ:`ƒÿÙ`ÀeWÊyÊV—°ƒÇ,‘µ]ôYöŠQN -Ù!@^"á T±ÌœÄR‡·Ywå²&Œ#9ì]ÈË£a0/|bÖÀ°QÒFÉC‚ÇMòcà¯a¾?ë zÃÞh±4³òN{‘ž$D  H¤Ë Ïr„†,zã@>f>„”QN€˜òIg>¯‚8RBÉ@Ìk$”bå…;ZPI¸ñH4²P&x ”S!€d±œ×ÂMSæÓеXÒÊQ5ŒPdĉá.ÊüI±­!Ťe%¢†=‚¢;15q ÌAqÃZ“1;Ñng°’˜³vˆþ¨³ëU”ÀT´VäÑŠ ½*R> }݃$‚›‘³à 2™ÁÞÞ |2mªnÔNö«®Q?íÿó V­8&|0(_¶Ã•sïFÝ3oÔóiuúqTÏÔ«yw:ï0õzÚçu3•Y*\a|Ù«•¡ƒ‡óöï>Ÿ6ª|ÖNºAùvþ¡Ë2håoÕ‰ÌÙAù¸š5£Ê_›ñ§¦ÕÕ |:©Ûáhr¼H=Z½™å‹'O„}(Ã$ÇW6:_³y!¡ü}4y4™.§÷GGGÍ´™ÔÍL åÉh2Ÿ©Êæm׌›£Ù‡Êa Ìf£òxZ}jʪžwMY¦õüähÜœ•Ýh,mx‰^fDû ­°úpiÃoX¶2Êœß\¯Ý†.f´’®|+;yºi'oïd§ûŸboøùq;.%ƒ…W–?=ëž¿í >6¤tA)®c0+'ëj1¹”g®ß©<ãÝ툺Ë2>. ,=¹DÞ2Ñ–¹$ô´yÁ{Œ¸5q÷¨Vr­äÝ«•aÓ+eë«BS¡ G·3z¦Â¾Ñj.Œv+ ’Wò†¸¯ Y%ïM{ª“¼7k¤:qoÝ Ê¥äúÞé\«b×ð+ozm‡_î¹ër¸û]€ùk2×rɾj”Õ5U¯òΉ=E?ÚÝMhÉô&´dw.¡E·aB[bD ’7ºd6`t¡/Z·2éÂ&Ú UWÓÓ®Õ— ©'åoQz;È¥ž~$ñ·‡­ÝÈÉ7µÈ¡@íäÒ¦eºÖY’+ÇÛYéV¾¶1¿†—%X-_ÀW4¨=H’/Åq»ŽÕ}IVÇÍd/¿ þod7iVïÖªæµLi]/»Nx_«+¨|CøÎBŒ{“µ?<ùyÒñ’,þ¥¡xš endstream endobj 4239 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4196 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-gene_MDS_rep.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4240 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4241 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4242 0 R >>>> /Length 1872 /Filter /FlateDecode >> stream xœµYKo7 ¾ï¯Ð19DÕ[£«ƒ¤@€Mm ‡ (7AÄ)èß/_ÒpÖ³ÞYo|ðØ"õQ%{óÊxóÅü³{ó¸?ÆYçø“bP¿¾4¿›o»ŸnûùÂ\ßî< :£¿·×ýür…}ùü­æ¿ÝÛwÆ™?wÞ¼‚Ÿ/;OÓ½Þžzg.†ƒ©ØLô¶y&ok5±%[üFïÓß™OsζŒþbÎæ8‡àöB`ãÓd«37»&ë¼_w—Âö ¤ÛÌzÍÛTg¡gØ‚ò, 4 Ôh³—ðn„J¡ØˆíáÏ–_H-09ë,À¤1ÚÉ !µÀTmˆ³“zŠEHDÇ}Õ’Åf£^2¦Õ’%g뤖Œiµd)X_Ô L‹@mÃ_¦´»ÎY¬“Z G[ò,À¤^W­›æaR §QR D5lB*@iÂÍS|P¹~w”S¸úå.4Æ»ds1¹ð*ÎË»lS29A³2qM¢Õæ6¸æj×c‚¬²(dÜ]/Ù) «D°(Ï)\öFô”¯×» Ü©°}!؆;uj=øýQ Þ˜l„m¼ƒ:q‹Ø/i2ÙcJWž…þF‡j¶%v^A€D‡þf{$Çô„•…u,F{ü7ÉÑ\ÂcŸXGùÇÑ9ª‹54ƒ©×£ÛåèJ´N°Î™ìÍ–bJ¶òÊUN¦ë}'УR­oƒ;á6ízBU•бŠ ÁŠU&H”ç®xÃzÚ×E¨ ƒª¥-C£*ä˜Ãi…J¡ö€Ñ*€QnÖåNSΞâé´a½NU¥ØÅzH@ a«B\³­.y#z _%ga·8› }Cí9»7Ê¡†6á¹SÄܸÑ#ptU šMXÔ²ÍàL©%:Çäü€[KtE¶YZFnÉ¡ëmI³m¢®É™›F†_¤»ô›ã®~Â’5Ù©Bµ?Êqc¡Ãò?%Û8î1’i©}B<üTp·DŸ-l¡(Å¿Î|HÔ<ë E¶YZF"Öœ¡¸ôŠm¢XZæ¾ø%ºÚoŒûâê@þé%Pæê“ñ~ô?ôaŽþ ’Î÷h®n̓Ͽ^þážš«/»Wlt­ö1š)'!@¼õ £k%çˆÑĵŠsaWÿzqù|Ï×µí}Ä,´˜} 6P˜Í.½]ÛJGÌ(ZPu"4pXƒÝ·O^~þðýïO „ûäëûÛoÁùwæêÕ˜f-sMÙ1mÀÉƒÓø1 ,6éÏß»móý ìåÙ·u´ÐWójþ.bnˉôž1ááŒp=ƒŠ©“`ƒ²Ñvy«vˆØº…X±È¡6²NSŽn-vå1³^uA8Ö 4änt»º÷¥N”¸£Ù]ô¾3ôº‹ÖwæVwÑù"ÿ”48/Lj¢C³¾Ž–š3VuÔ½h°UC=øº¿Výtç/ÚkÕN¾î®U7Ýù‹æZ/Ó™;!f<ƒÃƒðä—F¨û åíÁ':wfíS6‚‡3;†¥òö-ýqÍ åí1Ghù¡Ä.”W·àñ²åÄpÿn(Õ¾6ìlj?_ûµ©O˜FÙ~¦¦„l‹dðxþÐDakŒó¾<ø¼A¬½5fQÅÃÓG‡ý¿oüðuÃ6¬‡J7 èÛû›·‡b:æ¿Xƒ«Þ4&6ôïÒ}åóêé¯^qV:ê»W`]½ ·ƒ4öš„„©x£G2ÞY#4døÊ—¸ÎF(PX˜¢Þ0ÓÕfðé 4t…"Û,-#‘Úñ鶉bi™[øâ—èj¿±ï\‡ù S„Û®CÓ°;+Áü~âÐB†· ÚÕŽk†víÒ°Z¸xƒž†®ßÑå… ¸ocù™ÒÐv>C×u…"ÛÚDÍÐÍõ°M”†¶óÅ/ÑÕ~†öMj‡ÚhøÏŠ› ]½aÌЮ½nl…öVÐÂÙöå哾/?SÚÎgèº.Sl[C&¬T]_ݰ͔†¶óÅSÑÕ~†ö—²m(8û9н¢=Úå-ﴋל­Ðú`Ë´€ŽSh8úòzº}öågJCÛù ]׊lkha ‹›uqígÛDih;_ü]í÷QhOº ´ŽÞ]Ï€_GjÙíê Æ í¶çæUh}ƒvÙih}“Ó3ðIª¹/¿P ÚÁ'膮Pd[AëáÆì+§§Ø&JA;øâ—èj¿Cû€GÖãÿ}òYÐêi·µQkïHªZyLß mð¥LC[åôäåÞ&ûò3¥¡í|†®ê“WlkhkÅ_]·Êéɶ™ÒÐV}º]í÷=mÔéOoÚšðò¹ í:óÕÛT©øbŠ—Sýþ®p¯ºÏ ÈG>€î{d/à¬k“<­k}//wZßBϱūñ#Ï ™=µ»ÏÊç>K¾Ùý¬ì endstream endobj 4244 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4248 0 obj << /Length 1333 /Filter /FlateDecode >> stream xÚ¥WKoÜ6¾ûWèЃˆhR%±h ¤iÄiÑ´ö¡@SŒÄõªÑc«‡SÿûÎp(­v­¤‡Ú0Ä!çÁùæEóà>àÁë+î¿ßß]]¿Rq Ó ¾wû@%AçŒË,¸+ƒßCÍ’]$D¬Âw;‡¦ «±êÚj'Âö~÷ÇÝÍõ«Xšé4NQ"‘3™{o£ÆšvØEqž„E= £í+Z†•ß7ô™»ŸjZ~î&Îñ`F¯Ã´´øà,l}\d+ÏQ•¶ÝÏXí½ÍåÞr·§ï=¸c[ëw?UãVCÕTµé‰°ÿ{; à=ÑǾ{ÏeR[†x8Ó”xÜ2Éý)Æg°T1xc‹»ú¤c .Ó[ZÔÖô­-‰kßw mƒ(-J3:,'Btu¬ÁM¸Ôän…ˆ»h1 —«pI®YžÆpiwÙbxAø¼çŠÃŸØˆ°,_ fÃÉô†þœ)½pwJ„¦ù‚ò®ÃþÆŽJ„Òƒx][Lò•Š(‘œñ,õaPÞ³Sî=µšH–år¹¥)0m>î” Í=ª•KH©SpÁ¥]¿ïú†vs`9BPq¸pÀ‘黩-iÝØ²Ã8”>U¢T J§kW…¼:ð,}ÚÅYhvÎ(äO"Äl1 ËjM[xªÁ$ûª BãM@éG—œ‘wõ ›ÒîÍT¢’ W”ø%#°¸±í`Ûèö`ÚS÷V†Q¤hMI–Ô™ü™ö—SQC]LHìzÊ\B¨Ý|™„ïúªë½¾Ž¾ëÐÎØ|m„b¢]£šC{ £”þž°¼ÐXm/HÚwÉàÓ°ì™Tº39 ß‘zâp8 øÒpSÿ­Ë}wXQƒêˆút¨Èñ.7[7¤ÏšÐ¹C7aÍ—$»tG~›ÌÅ{ ¯?@2 DU|…Þû&tªx%?ƒß~üùÅŸ~RÓ¨0M$üA®ÉÊÌ)¸Zm #n uÁ%cwc³X‹ókC0T–%aì¾Ò“P.û®t¶Dõ ‹/˜xŠý¢p3Ç%¨Ùöïên$Pÿ}Ýhq"a:IÎm=Çy§5MAø>x9~6 X*ÕÜç–½ (ÎÅÌðõ†Š˜eiþ¿5d—ÖÞe€‚žÀ§S€Ê`&ÌsnjûëlÎ.ey²LlÜwyÖ4§q \~›´]y\ }?Â*,Z[nLI‘¢ÉìbLnGÁÔâDE®Òð/‹stS†w‡Ùzoµ)¬§–û/í‰#$ÕègbÉ8e<½È\ßI;Óµãœ\—šû&…}u_µ¦&j…’hÇów´cêÚÏ7Gî^8ßO=¨ôbô=®µo™\¿'‘†& ž 8["±y³3—/Þj[¾¦3œº*Lcëûpo s¬F6£õ}·òƒÍ·ïPg‚qDÈë^îQû”QÊýw!á%÷õAJä…I†¯Œ[;nx¾†WlªÀMxÎæ¹O™Ÿ‰Öÿ> /ExtGState << >>/ColorSpace << /sRGB 4253 0 R >>>> /Length 1907 /Filter /FlateDecode >> stream xœÅZKo7 ¾ï¯ÐÑ>D½5×I-ÚÚ@AIš  œµ“öï—J£Oëñzf½N;kî|)ñ!вQ/•QŸÔ?»_¿ÝG zäá…¯ë÷êwõ×ß~|ªÞÝì ý8(|Þ¼«¯Ÿ],¼¾xö3ÿšÔ»W¯Õ þØõ’>Ÿvf÷ÓînÑ;õtVÐ=feý¨cP&xmø‹¨¸RǃìÔ‡6‰AÖ*|ò$\›Ä°7‰2zrz°êóÎŒƒ6®ÒW»‹pCÐÖ7@¡à’ö B ’Ê#„n?Ò¹ Í€ÞEåõh@e¡Ûx6ü{ Y£]„@p:d €t Í€èuž­ö¹~µ“÷ÆÐ ‡(4"¢ÑÖBh@ “}S¤gri²·ˆrž~‰8°å¯«yØhëjš’÷ÁCôÈuèæ–É,ÈàH1”Ð RÈ%0®1d§M?³öä™Yvƒ¢¶1Ú$4-ªtLeP; מË1~OÀ]ì…6 pÃ"{™ÿD=^ÒÙA…ll\Ôb®ÐH¤Q¡!ÊL.nS¢L転6y ä„q&°µš8¡@N• 4ÆÄnÑB7/”å®i-9iĈ¬ïk€@1 LRJ¨ïãÎËÂìÎÞx.½xÍmw>0ã“‚Ðßi•J°;Ã2Ûw¾g Oˆ:ê³ia÷ —Ò:({6°sP{ØHÀÆA}}~_U$ë€w¸É@íÙ™iÒëÉ8›h¢CÖÞ*ª­]š¬ôñ—‹j'ú ¯¡¢>ŒÀüçó‹gë¹ÃTÀÏܯÎ^||{ý÷ÛsEÐÙÕ››/7ç¯ÕåËâ2o°Z ÕêK#,…úꢽ¯•P­ù°0:¥É,èTrœÍlÎ|Ì=Òf|`¢êó¤6ÛÿlXžÅÄ3d.nù`FG¹.ñàô°:J$>ö•ÎZV>SØ~÷^ËJ 3‰Idʹ¶ Üážû<}ßGŽ bîóô}DÔ>Oß÷ADíóô} G´¿¡°ŒtÔ2µŒâƒêZ[fÃýT¹ÃVn*á¢)Üf³ìè´ •{³ìÑq§@¸íðXŽ4Ÿ°ð˜ .0Ÿkûs."ê¹¶?ç"¢žkûs."ê¹¶?ç~+GË:xeƒ›ëH½ÞÖ›7¨„w½¥'^G_FÜn•ëÂÀ!+¼[åfË÷™SrÔ§÷/7µç{ÚîÚvÚcå}½¦ínmÛûù–¶»´…÷õ’¶»³…÷õ޶»²ý¦~Õå¯m&2Ü”ª¼f#//…¯ùc#ïè¹×(¼î‘\cî¨ÁÕ`3Ü|Ø] ÂûzØÝ ÂûzØ] ®5ü:‡ØocuaL¿¼Br@úJ%[¼:û— ® ÎÞ\Ÿ«'tØ9ûø¦–`ïë¯ €Ø'  O7g¦ÉN‡«¯Ë2×èw_pó~R|K5&×Я É ÒL>ùâ:®ˆÃT E©úÞ]}½ùòþzɃWM@Æó‰+'>‡æòì'Á°ô/÷ƒ,gF¾j§Ã¯ç ¶ÐWªµ$תëíÍ:u—nÑÖ©ëF>å6u…>F]òÇé_ Ö¨»pÁ¾N]+—o³ºB¡.Wg9lr†®[¾N]ÒÒ ®ÐºGDÍRÂ÷:ÞLÅn5ÑšIä2ÑÞê'=¦DÙÜöûÞ)‘N6Þj?ì³û ÜgO endstream endobj 4255 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4258 0 obj << /Length 1696 /Filter /FlateDecode >> stream xÚX[ÓF~çWämu3ÌýmJYTZRV¢Ri‘×q6ŽÚß3sÆŽ5‹Ô<Äs9þæÜÏÓÅý‚.^=¡ñùËí“§7Š/#NÁóv»Pra¸%T˜ÅífñWâˆZ®ã*Y–+Á’<+>P!³¢[Âì´üûöõÓîŽ8͵‡ ‹³D؈ð[ï9–´õ>ÇQ–¶y{½\Iª’—š¼ÍÓ&[r›ìò×ö©Ÿžpr·\Á$•ßérx«Ë7Ã>79îÛSQÝãâ6O»#Pã¬Û¥ŽÒ&"^euµ)º¢®VíŠr^‘åJ3“¼m"Çûº©,>ù“òò´´"¹öªÂ{mjþÐÔmsÌe“´ÂgÝl@‚ NÊ¢íâòÖ?]rŸ/YRžav:‹¤u|¿ÛåEƒÃ žÁ6Qs°·­#Qq Àý¼ä&É#Ð ;ˆª˜KÞ{qrÜÛä±ÊG×f¨~ Š®áM4£P3©L/…Hà³ÆÊÚsö”õ,º–¹§‚0£¦HëHÈš8#¬'Ô„QdD:‰T^ù:y^Db:Beœ(k#âŸ@>c‰õ˜ØÃH?PJgø £žæõrå4p¹•ü:s“`mËþŸ%Ǭb-ëîwùפ¼¶è9ƒ\äõ Û ó ,§ø¸/>‡d‰ïójN}Ì€Íì`‰9Æ õ«ÁS#!uù³ÚÉ™ªÛ>y ))˜Pëi|{sïwé]QFê`ü>@Ї\J(Œ"%3MêÈ+xöYÕùFNó›‹> îÌÆÊ¾¢(\ò¿/W†%oæ<²béà„ódÖÅÁÓ¤ì ¯Q¸´ÚÌå M¬ÔßOþ½ø´³ñ9fJC¶Ð|lœ´UÑázOÖ…jƒ† W±\4[ØÇݳo^!Y(ß^d|Ò¦+²c™F´¡DÍ K !5'ˆ R ú Ñ×”$†_øZ_ú¤6É.ôX)q%k ð¾ì'©ØdòåÝ.–ùòŠMÊ‹#â||ÖB'¥à%ÿ7TPïÒôéOCFpƒÁ±{ñÔÇîpìZä#ŵ}Ú5ÅW\ò_Šn‡;çÆ(KK\ja š ³…ð½®ÆíóI£6Å·Ðõa{!.ÈkøT±Ûçý›ÀÛ#‚*KÔ¤²©/…¾ÃÌô~Ï÷Ñ=ÏúTÖÔmÜJËéƒGäWÔUÛ7"Í„VŒÛG˜¡«JÐÛCá¹5Þ‡8~qFÅÍÒ4·‡ ¶_çÝœ¡-azÈÀÆœ3NÙÿäêy@¥ˆ´jâø€'ÇÖ’–Âyl[†Š%bòÐ-iyæÕôãÊ;/¨[ô.ëIü}«Ó‹`»<Ýôo„¶–%øì jÕ*Ý‘c6†ö»õGä%¾\¿ð(£¥›â E™¶]‹«!Ò{¨1SþñöÅGhÞ¨öο.JüDH*­VˆH‰â– -|ûh< á é˜rsâÈö2·RhÊ{d!˜–ÈÂ_µ*™–ú1d(Q@§&<ƒ FŠ™A‘ææ™3cœx™Y@¦øë‘‡i¯ z&z9hO´á$ÕRù©”’+ endstream endobj 4266 0 obj << /Length 1865 /Filter /FlateDecode >> stream xÚXëoÛF ÿž¿ÂèË€¥ê-¹H6´[Ó¥]‡l10 m1œ­“}˜©N®“ÿ~ä‘'K‰Q C€Üƒ<)û³ÝÌŸ½»ðy|³¾xy„³ ðV Œër–ij,Ì=?ÊfëböÉYyé ‚0q®US¨f·p£,v´ªU%:\$ÎN6R/¾¬ß¿¼W³•·JÃeù37Ƚ(gQ¯›¶ßK<“gζ­ë¶¡ù׃Խ²+Å#ˆßIWoEµI{xÍäÃ}'µN‰FTÔ <ÎiaîùNÁÌ74|ö£¸)N’ùÐQõ{š^9½žj‡fKéq÷]‹â*®"§oi4“i¢‘iR0qƒsøáŒñ/] ?ν…Góç"Ðá*töbfÎ7| ¤ËT}_I°V-$õ² NAäZö{T+wŠ%ݘ£ƒ$‡÷äöN²Î›àŒ‚ðúÌ2Û犪²Çå#ÎÛÃÔ$ª@õr§Wå#Ÿ¢o| #ǰjü¿1:cä ¡-YÜžíP·º7.®ØKÓ”=“j''F'7ÃÕ‰¢/7õ m&ÚåHÞ‡£"¥%AÞH %Ð-‹–Í¿ÄUî(>5XG\–SŒÕ#îíùîЦvÝ‚ƒa8=i:yŸ•öâöæ·Á‹å$TÙ #•bg ÒÚCUЪ0Ç#«@ä”­u(¤þ+šxšã¡ï!çø 7¬¨9n.ÝUUC }ö{(Ë%jˆ$Ô²¹ } ç´}*Ñ“xÌæâ¥;F‚À¹­Úïø—U»ûØ"©Wë¥Þ·Ç·]×vÑé+ܾ¶7°øt|»¾`âÏȑԋ“Õ, 2ˆ´`¶­/¾^x™ïû±áM Éžã—7uÌ~n/~‡?Ks­Pw$• 9™ed~€–C –F~æù‰ÍÑÄF7Jbg½ÈÁ³÷´Á³>§5:Y÷´8Å 0ÙÀ‚© ç&tpÆ&y’û.bEG räeyHÚ¼ÁtŽÐÐ¥8T=dB˜OpÄ0UUѬ“ý¡kh.høé'¢w Øìiˤ<Œz,„UÇi-ú-éÞÔ'ÜágÖm§ o•À´ |çt;âä–q²zœhPÊ#¯‹Baa‚dð%ˆ½ ö$>K)à ”‘ÁäÜ!$¡/•ERæÃ”Ï 7ZĤ§ lö¢ÙJ›Š™{d~Ûb¨ TÕv~õÄyñØyæÉ4o?‡ÿ=‡›™û›’€wNÞcWÍiSqÔÆy°A°XAà¼þõîí’ {4Šþqˆ‘DëIý*D/¼²5ËzJ÷h+·Í?¦r x/[¡Ñ2pÆù3pceiŒ•Rj°<±sв<°³›~©GZTìæJýÃ%‰Ö½Z²k ¨ºÛv”Æbl{”IÚ‘G`ÏÏñ¾çj—üæ+/ôWÿÃÕkS@ý9hƒ¶Ycîì;i‹Ð~Žt迺ݡæºN'†V@Óúd£ë¬ï…f² ·@”¨’–Ÿ8}zj*†L‚‰ï_¦Â˜—6ÁMKžÞ`=L›=¼j‚qVˆE^÷Rç"ø KÓDføâê;Ñ=Òö¼™ÓþÙÆ9H@fÝæ&™É’ž›jÒlmô¹ <ŸTâÌdš¼a=,Áb8H'’6 cxCƒtS¬ÉÈ™1ß™†ö„ ;txóp¦‘AH žˆ¡…ýeš$Î ÑèbÝòlSMr#Á^šP;Œ;>3V)q(¸ZL>Hµã´4ߘSJøtÉ·Ó€ávü[¦ÕŽWú@£{Û·ÝT=ÅHŽõ]N¹šœªÑ™¢Á6ú+“ñ M|ÙìÌHdšÝ3º{QØÕ¦ïÔØ ØVæIJÇ¡Ÿp–ß;ÓÆ–ЃdO\7ô^·][ªJ^º[ô Þ”øþÒ_Æþó¾-=ß·…—.ž-Ï´‚ It4ƒÁnCOâɇ3Ý É”gÝ`ˆí ’>¶ÏÚAÜÖW×'NÎnœTÍqÝúŽýSúÂácŽB?#Ä(³·ÞËFËÆ½ƒâß`0ãÞ)]‘õ<""ß "t#6ÊTjè( êÔæ€-‚&VÌ¥à˜5ŒôõƒûbÛµZS$gðMçSlÛ†z$D ˜±8†/L ¸P+‹qÎ1_Õª'ptÀŒËÓáã™öè ÛLåv·l&KŒ85¹2Á?,qÕmÇ`ÊИÍ&,6>׺á3#œ<ÉŸþLZ¡ãJ endstream endobj 4262 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-similar_plots_1.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4269 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4270 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4271 0 R >>>> /Length 4934 /Filter /FlateDecode >> stream xœÝ\]¯·q¾?¿b/mÝðsIÞÚˆ 8M“FR  E±S;>nc)èß/ç“3{^I«×î¹È…_yÈá³Ë‡Ãáâ–ZÞ{Úò(ûŸ@ ûHi³¿ñ}úÛ7z…°×¼^!œ^Œu?ÒöøSÚsdñû‡\¶cÕ³¼H-ì9¬X^ä–ö£¬X†ü'æã±·a$Ù4dzidÓ`Š{i¦A’×%Í/×,Ãcì=ód©¤c¯ôMb¯{ ZÏ¢yÞ~4}€EóÈyöp9ð75ì(j(å¦vSi{5µ:;´Š™Ø§Ëü#39æ½39ƽc¦§½6Óç—™fŽŠdÍ$Z ÍÔobfR¥66Ó*¼Îú39½o $ß&ô½v6säf“7G‡®R3±õ½eþéb¦ôÌôôô¥¨µeæî§6{j°™”àã6üÄ'3“Ãö§ÞöÞÌ·©‡PŽT§™ _(‡Ã}›‰µšžÊuOݘs4o¦À*Ã÷Ô1=†ýÄè)–™6öq2SáÃç6hÂä‰5ÓOhàŸ[hÚaͤ˜‹ãDײùÄ]ÊÞL3½uk¦÷=ØOœ=™Ï%ÃX¶fŽ¿cry™©qÏÍ ÕYX—‘f/ÒÝÈÞ#WãAeDÍO}wg‹¥vzE0S{áu6“ZÜc³ã{ì‡A[‡—&?1Sëº53ÝF°_æXhF8ÐÏà—™Ýb?ð±G;¾çˆ ÎL…~d3ˆ&ã«õêº; 1ËL˜ó %_44d’3-;ßG5h*|«efºžÄL‰ðjuŽ|ó±îÉ7ª'_èŽ5ëfÜmKÇØCgûhK"Ì u˜”|uuÍ(½†§§oeÕ'›¢+Ú–§¡d~ÅÒT¼ÔPÛ$½f$Ð6×3.Öu¸_?|3Ÿ=ƒ«ç‰äÑ–t˜¥c/{NHÄ9ZNé5>~Lë'íëÒe mÓÓ\2‰U—îô"mÙF‰žæ¶¹žq±®ÅMï28x#WÁô‘a›ÓC«è$æ’él+ÀH’ŽN5UBÃô4—dðΪ›`ºÓ(ÀÃÒ0Õ2$Tt€é¤h¶Üš/\·æ§)‹[$YnI=q‡uEBÛ–[} ê ÛÐ6J–[\/¸H×ávÜâèâÑ–$˜~¸!iaÓX%Ã-­Gî¨.KhÛp Ø}4Õ èÄ6I†[ZϸX×â¶ÜÒÀi̾‹ÜÅ9Vpú2# `¸Å%ÌÖT nÁ{æcéÆE[·¤–!¡¢ì¹Ea™åÖqÀ4#ý;øšµÿI²Ü’zâëŠT…öZRÄË¡n&/ǶQ²ÜâzÁEº·÷[rZ¿50Fß1Ž` {P²~KêÉ/‰.KhÛú­>èÎøãPn±dý–Ô.ѵ¸ß’hzÔ½5q?ó çŽêü•ˆ_"M•ŠŽ()Á¯¬º x.¦“ (i˜j*:ÀŽ[E¢gS2C˜Cú·ÀÜS¤ÿY2ÜÒzäŽèŠ„¶ ·Jh0†D7Ìo ¼eÉpKêé:ÜO¸… [S’ â4Üšk8í)¸…õÌ&ÖUnMÛ'nõ¾¸5 ÔRn¡ä¸ÅõÊ-Ôµ¸ß’%–”9v%‚CgçB‚õ[T"~‰4E"ÃÖo幂^~+7ø®²˜iÒÜ0×2FTt€·x÷hK"ÄnÜ¿@ƒ®ýÏ’á–Ö#wDW$´m¸…FÕo¥£Ëc`›$Ã-©g\¬ëp;nñâôÑ– \oPÿÆQ´ô?K†[ZÜQ]–жáVlæLÒ+ØQÔ6I†[ZϸX×â¶ÜÒu÷*8 ’û€õ“E$X¿E%ÌÖT nÅÙÀ\q³.Dî0Ññê…Å-©eH¨èŸ¸uÐÅ”4ˆ”[bfåV·Ñ9r‹ë™M¤+ҡѹ”T‰ÇP·À\ ¶‹Ì:Ú6Õ ®*qàÂí¹E Ë­#šX>ÉÄò,YnI=qGtY §X>Öabù8×¹+–gÉrKê —èZÜnN\Ó‰à‚˜¹1})뺰¢sâ•ÈœGš*é\¢% b ååÓö0EH}˜i`oQªÇÆ[µ![8æ™ß¤¬x‹$oI=ÅS¬+Ú¶ñV­ù£n!¦±m”l¼Åõ‚‹tn?'RËΉ3ÊÕÎK0×¼Å>ØÌk}Í‚¢ËÚvsâ~Tu+¼ É=´¹9‘ëëZÜŽ[’¡[;’ºxº¬ëD,·¨D¸Cš*¥S,sM^ëÄÙE]" †[\ËPÑöÜ¢üŸå$ÓÔoå©z¨ßbÉrKê‰;¬+R•ˆVKŠä(P7Cd¨¶³ŽÚ6Õ ®b#{±m׉”Û´ëĹÏÊ-ˆ’r‹%»N”zZŠ.KhÛ®çª;…¥›iÚeÛ(Ùu¢Ô3.Öµ¸}¼ÅiÛUÑUqØ“ Y(A 6Þ¢§¢ñblØÆ[iI7uä0™&ÁÄ[\KHÑöÜ’„›ÉAÄ=h,ÒXýO’ËAp½æ‚ÆòlÛrkΠCcyÂò‰$Ynq½ %]‡ûËcÂÛÅòƒ‰å+Ë£äby®çèuYBÛÖoÁšiå·æª²¯üIÖoI½®1Z=áöëDÎå¯LËÊr­C™,æºDµºÖÃ]¢¦J‡zÔµŽìËoÁ[«ß"Á®©V—®½zÀ'n…3· ã·€‹[$YnI=s'9n…3·¦QÃ-hÐä7Æ™[\/Y‡á¸žr«ŸýÌ=Ù̉Öo±äæDë·T—¥³ßJÝú­Ô­ßbÉ͉Öo©®Åíü–lð¬‚ù1v!CX+{A(X¿E%â—HS%4lýVÀ ˆrkìíPn¡`¹Eµ `ËÓö‘å'7sÐxz’3v·I²±¼ÔS¬Îº"eé=-Iên„øVmG‰µmª\¤ëpûXž¶Æl,/¾bùùŽË“dcy©§X]tYBÛ6–‡YyÅòßY±¨W~ ÞÁo+ý…mJ-ÁëÆi‰ÕÅ$9  rÂ:ìΚá‹ò©¬Œ%&P“„´D@“†BÏ?±Þ„P$Ñ@ÿ¿øÃu•,ÈS’¡ËD¡%Î,iP§VÐìÒƒ"®ç$éŠÔe¢0INÌc’á U®žláàY“ T¿’¼!°p?I2äqN2”å˜æÍË1‘tJ2äå˜DW“ Ù;&¸–c£&X«º”_I†²“èZÜ~ÃÏ…¬Úªã}»´2˜,¸ CÞä Áh¶¦Ù° ¨1ƒ±ŽÄåX­ËªQ"¹¾öŸYÑöÜ¢S'–[)ÛI/;é‘d¹%õÄÖ)É^¦–D;é¥`'½Γ× ®h'=±í:`Ðr«ÂIíß9¶Žµ©C’å–ÔwD—5 Ý–[!êÚÔ™Žhmt³ä:p½À¨ý„Û'°ø°Íh%M޶¼GÍ`’àXXbRVi%GɰK`…= ÕŸ7©i̤ǵ àS@uœý¸ëå·J·~«ô³ß’z˜šõ[å8û­~¿5Ã/ã·HrU±~‹uî·p»Ú¢©Ô‡Ü¿y"î”,·¤ž¹Ãº,ÉåhI&Oĺ ÒÂj;É…¶ÍõŒ+[/&¶ ·äÙ*8öxHOtǘË-*î¦JUb$-)J n†³ºbÃ-®eH¨èŸ¸UeÅazí0Üjö  IŽ[\¯l:¢eR=q«@ï©n†Þ3Gë‰[T¿å8áöÜ¢³w–[mÀKÿBÒkq‹$Ë-©'îˆ.K}m/sÉŒU·¦·H²Ü’zÆÅº·ÖùXá*hSJÌÜ!—cŽxº9‘K4GMšGÐaByéXn‹il°Nµ `Ï-:´h¹ìf4¤?Öf4K–[ÁnF‹®HAR„šdp›ÑÃmF'›ÑÃmF»­¶-·è@¦åVÈèï¹§4V“$Ë-©'îˆ.KhÛr :£,Ý€ý)¶ƒö·´ÍõŒ+˜­iµm7 ‡ìãÊ"tÉZ?‚”L@T)‰,Ñ$B0é,6ì6 ;lé†aìo6ÙÕ örV¬è{nÑIVç·f¯™$C´/EÀ™DA3IÒe)ë8-™W¼5—ñ†·$Y¿Åõ‚”tî“ߪ¤ÿ€iö ãñ-Mãñ=\¯~ɤȶó[…¸Çº™Òl;Ë‚YÛÎ6­ º··t?Dü^O÷CXœ Îoa‰ú%ÔÔèʤ$¸¤Ëª}ð¹kå vÃj#*:ÀO’£¡Ÿ“£ñX¾£Ò™MŽÇ-­×äh<–”en7ÉÑ—n„ÙÛ$Gcö~‹êWr4Äî'ÉÑQ}r´›Z ­Z,’£ë€–êjrt¸Xœë€Hë€K.9ZÍ-Õµ¸}r”O¥kAÂQË]<—5Mƒ",·¨D¸CšêņneI ŽYõy8žÅ%êp‡IµŒ`x‡ŸzOï³—ö’Ûœ7û‹÷ð¾˜t{ùÍ6ôNþ ˜3:툫ʗÛ'1|º½üîáW/ÑòûTÚ‰¾©^×Íp@-G̲îeå©5•KÂÔ³(«¶ý8znŸ€‰õûô â“û{·徜»>‡—Ý*u2_—s·çV½Þ–s—çV½^–swç þcXð“^Töhª±WôÌ<©vWôÌ•<©w7ôìküD¢ŠøLþÐçßþîÅe¾Ì™ Ž€©îýêÅç—™Z„çªüÇO¾øöÏ?þ÷Ÿ?EÛ'ß¿zóöͧÚ^~y¦Þ‡Çê­ë1 %F…äXÑ;5qo^=þÏ÷_õëǯoÑÿ#Ú3ü‹i{ú… aÞ‰…¿øÝ¯³ýb‹·š{?9ßyON‡¤¶5<» »x·¤óÁ—pö¯ˆqŒ<ÌÌcŸ¾ýñÓéÓ·O^½þÛ·?üõ«oÿòÎ>µ7ŠñvÞú¥—!Ûv`ìÓ¯3`o]X}ÿ€… òö1ÁP{ÄshóMXþ~Û^|$Ü<'iXƒ^‚{ãbì%¸rÚJàÊíË;àΨ¶!®À½u÷Ü BòYá’|\ØÐ×àÞºè{ îáß‚Kò=py¿ð Ü[НÁ-7º.É÷ÀÇÅ¡vëâò5¸pÃÜ 5–ï 0.µ[¤¯Áëâd‡ÉwÀÅ#0‡Ú­‹Ø—àòbEá²|ÜãÀeèGÀu¾¯ÁkÝf†Ë÷ÀA_¿8Ôn],¿·6SÛUóÚv{®¶ážnòm÷çj;e8€åÚí™ÚlÚ¶cNÏÓ6lN7ϵXŽgj{NÔ5œÚ~¦o'1’çZlÏõÍ3ÞVöm?Ï!U~œ¸6žÉ§Âæwv\‹)?SC=ßöÈÏÔö÷ÑmÛ9pAƃµpæþ>'ž¹…ãxy°ðÅ“ÝR‹‡¾E²JR©e½„§mÙjÒøܦÔ<Ö3Xoí|ÿLžý€V Ÿ~ûëÙ¤zïÿ¼aÔ endstream endobj 4273 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4276 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚ…P±NÃ0Ýý7:CÜ;ÇŽíAlHÞ(CDÜ*RS‡¸B|>nÜ "déÞÝ{ïNzF8Â#ÃrE Ý ¥È :ï#û` ¢Z7í"­{Wbó4* ÷‘½ä·jõz´¾¹zçÙf«5á ø=±Âj Ria­ßÃ+ß¡Æ.ªêF+î+kyœÊ@XðP§Ê4Æt¾tš§aŽÝ|5eGö¥"ca»Ó«ùçЇ¾0ákšCJC<ý8vبcÕ›þó}›­tà„ke»D‘RPks`IÂ]²(úµûàÙ7;ß\µ endstream endobj 4263 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (/tmp/RtmpNIgyCZ/Rbuild24dab815c21246/cummeRbund/vignettes/cummeRbund-manual-similar_plots_2.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 4279 0 R /BBox [0 0 432 432] /Resources << /ProcSet [ /PDF /Text ] /Font << /F2 4280 0 R>> /ExtGState << >>/ColorSpace << /sRGB 4281 0 R >>>> /Length 2810 /Filter /FlateDecode >> stream xœÝZ[o·~?¿bmÝò¶¼¼Úˆ 8M“FZ  E±S»>nc9èßï\É¡|d­e[(ÀGÎÎð[òãp†\¿<]üòjùõð·ÿ¯‹[㟃ùóöùò÷åÍáOWßÿùÑryuðÐèû{u©êÇg'ÔgÿŠ­eùïᇷü|ðËSø÷êà©»o7w}Xu€±®©.ѯÍ/¡ÆµÆ%¶´fÿD·¶û‹?dX^Üö nÝâxwíع÷½1„5z•_Îä°Ã4y<ë¶ú2˜ÇOm­ÛxšÅáÍÃk¶jð°lºóuõ°Èø@ókq2\G‘RÈëMukl]/¢y 䶺ñ€ˆæ˜™a~R¦ßPh˜¹£ÊZÝð›ËÐJ¼¿­É‰—š Øoy# 9ã%ne-Ûðâó¶†bÜä´Æ$n2<¿älvãa¬œqÓÊêÓðâ·ª£îeûâÓ{^Bã<¼Ô]/-à„°Gë¡$D”Ú„&(/:ãK[[<á¥äf¼$W×­/1¥Õ™ñm[«ŸÜ䆿 FÙŒ/,ŸÖŒ›Ëi³nÚ˜ì­&™&}d\€Ej¦ ¸èÍÐh²rÆeb ¡iÜø¶F;Û¾ðÚÒ±)@~§K‰^*¦-õJá%sz€s†Ç§¿d ÑC(z´-™B@®8ÖÐ:¡IºÄ§‹Ã¯úâ‘{j«ùæ§¥˜‡m\Ó6|“DOkߢ\l;á¾<¼€ç}(‘dõM<,Ð ô© •ìËW¿ÂbRmÀ¹;È+?Ê ¨Ý†Ú–ŒOɼzž¾¯ Eˆ]O„Q[•È·!”¾ ÛÈ{ ø&ÉpJõŠ‹m'Ü–V}s @ S!ÃÔë>D •j‰8j'Bé ”†¼æÒí¶µ´î•„A+iP4d7ah%ÛÖѶ4ŒÃ2µ>;¤¢O– ­TÏ´Q[•È·¡•GVÀÕN+‘ ­º^p±í„{¢ïȆU ׉mÜ‹lÞ$J©–#v"Wç–W—»$fµ{%ÁI´‚†í,Vˤž_ŒšÊ$Ÿ(ŔퟅÁ$ÕWÔNò:˜ä#$£Ê$œ2I„Á$iP4d7a™Ä©‹eô¸m}6!MH±Ï6K–I¢¦ˆ­JäÛ2 0'7l¦Ý7I–Iª\l;មÄY™aR­4B<«0[Ÿs “TK\;È«aRÍøŽj·áJU¯$&‰VаÅ:mušcŽOœãm'QޝéhÐø'[–hy3;œ&'Ò< Uí°’è^Y0[7¶›°^‹I”¾Z&e˜t?b’·qƒ¥)&±^˜"¶&BÅ9&UÌ+{L¢Ä¯Ç$’¦˜$ú…ò5Ü“´4ë –¢:«P÷U§s΂a’j‰+bÇ{5LJ•–3Û¥‚¯¯™kÑÑ‘>E+ðØÎbb’Ö£¡á^+ñ!`¥£Ñƒ“DËQGìD¨šÈiCÁ]Vì ÉíüÁÄ$nP4d7a˜$ÌѶÀžÒÓïa¸ôô[$Ã$Õ3SÔV%òm˜„…P‰Ã6âpvß±ï…Ú·èÛN¸'&Iuv´-°½ô¨„RëD$æ®'¨­JäÛ*BhiØ@TèI”H¶ÄS=—pb«ù¶%^à­\m9‹É–x¢W\l;ážÒ)=˜ ‰²mNm@€MAϰH0é”h9a;È«I§ (À~ v޲tñê4–kŸnäâb7aÓ)>ñ²éTIh¯)MÙÌF%’M§D/é’ØªD¾m:U“Pl=X|{]u½oÑ .¶pÏ´âÓ«Ö©©õÜG$K+Õ3mÄV%òmiåaËÌÃv³”eÉÒJôŠ‹m'Ü­ô rHá‰f?òx\£GG^Osô`‰µräÄv,°WC+L‹´Þ£ãD­÷D0´â…GvÖ‰V|jX• ŸÐÄÂoî; †R¢eƈäÕð)oôb—ø€½’`ȤZFÃvëï(1×ãé.7+žÆBUˆc÷j‡ :b†Øðÿ÷:GäŒKOl2®øËš'J_$ ²±øñ§^J>:·7zÑá]Þø¥KÇ'0üËù‹¥õ D> ÁŸP±TNÁž—þárþêðÕ9ùý aÄ4çªlléöšÂÊÓè)ô³i·µ¯Ö¯¡P"ã÷ýÛÒ÷®7ÊNõæÏÜÒ½iÇÅŸ½úqïg¯Qÿ13ôI¯!¡¨ñu§½m4׋ªžnÍí¢ê§ËFûŸH¢šxÆäçóåwg»¹€¡.Û~uöx7!$ø:ŒxðäåOoÿýÓChZ¼¾¸zwõðÇåüéubݾŽN]Zu(ÞÏXXö‰Ò€‚‹_äêâøŸ×ÏŸ½¹8>?EîèÏtòGÓ·k¬”4A}=>ùîëo–?,þTw&ç,`M»\ôaMyÁ„ÖT­š¿øì£a©,¯½Žã¯¿]¼y÷ìêÝŻ߮nz3ûM]äŽ_~ v ûwÃÂ ×øw~‹[ /t*âñzžïgzK¡Ò'ÑéKĨ ‰ò‘.ééŠãØõtèÓmEÊZ±ö–mÝܰMT9©o’øié[ô‚Kl-îSÛÎGLÜ©•³Ç#» Æiûöë=4ÜG??O¶¡HÏ_˜¡Ò')SÞ½}–—ÿzùæ—g/¾1¦ì£!ÞÒñχiøø¦o?nÙ÷’ÃT ³C¸™R”—å»ÀÅMzçR;õ]Ó>¸R.ËwŸ–'¾ŸÚ7Ò8à²|¸®à±Å¸§¿ÓÚ×ÓIî€Ëò÷ó¦x¹büÇ_¾}üÌá·¦¬Ÿ©ïeêÛo÷Ô7¡´¹ïr²ìý}ìn~î»ÅûéÓµ§¾aMÜSßÔv­ï|O}ç„_$ؾÃécŽ/Ð7¦o[þ=õ’L}‡ûêÊÔç¾ËG•ÃüwøãQ¨ù endstream endobj 4283 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óû endstream endobj 4286 0 obj << /Length 1524 /Filter /FlateDecode >> stream xÚµÉrÛ6ôž¯ÐÍÔŒEs§4S7î¸M:i¬™ê ¤@„J€Vݯï[@Vr•L—ÉE|xÞ®hÖ΢Ùw¯"ÿ}½~uu—å³8 Ó¬Hfëf–g³2Y†QZÎÖõì— Žæ‹8Ž¢à²•ÔZtÒ vþëúûI ¨XÍVáªH ÔÊV s‘Äá2^²–ÇôœÊ$Ç2˜ï»ù"MÓ@ì÷½Ù÷J8‰ˆ,Økãì%«º–Ñn+½@ß;ÙÍ“2pŒéå^« Øë5cJkZ›y² LxF13ðÁæyRvZý!_¨[hù„²R3áîýï¼ÄÊ ¯x+üj¨)lGWoýá·Atx¹SQšù)Ö 7XÖß@H΄S€›ÁÝ{Ñ;U Zô|n$Hö’DŒ‰¨ðž-ŸZÅùã‰c,»p¾È²$øy¾L¯`+È9W¯ª-k>¸­²g®Ý Ð3õlÄ ç2ÞJöÙÏÞ#m†¿vh[ ôÏ<ºÈ‚–o+8úˆì¥Vb£´rãõ@äzäDO扼_Á´Ù‰òtÉ-à7€D9',FVD]¢LGççÉm•èXjá¥üDl­,ûõÌ£'wBáY霫®åJ»°[n&”5×wó8Žƒ›·o.þyýåÿ¡þn‡ÝN~Ø ¤C’MIŸeAg0e|8Pwë?ù´!f§Þ‰ÀVÕ5f#ÂQ’wfQcM@!—epÁ”©Ã.±ŠCÁE ™E0‹ã,X“÷­:®·æÙkàÈxNÑ Õ½H<ß—ÂØ±b,UMqæófp tƵÁo°=²÷6+l&H‡‰à`€€¡Å²ð†"¿ò+›Áó¶è¤N3äR1ú1ΰ€hÛ^¶ÔoðÈ•Þ?ó rº•ÌO“jØ!yLÄ8è½PRgòp*žƒK0û@ZbNÓë ‰ÆÁÐcŠz?&P;ñ jß‹J²h3â&ös.$iýu—KêŽV<5CWQtøØKÈl,ªr´-²2Þ@¸ó<ø(+ç9)ŒÈÆYŽN4“H"U/µâ>†Ô©áa':µ‡Þéd}Õ``cyÔWB;ˆ¥¿·¨3þ‡á×Õ¢÷ÎeÛ>ì¤Ûº¯þÊ»Åv%|S’@ãñß\U‚›i5ä·¯ù ÕÑOÕÓ4«¬åÕ`¿$¸,*+1e£2 tEò˜ã0Ǽ0Ï8„´6é}¦ìt^Ç}ÃzÁß™àG@Õ/³à’{ÛÇÛÕ]ž½9ƒM9‡MÙ¿º—¢¾šF+TÑ}²,râ¦Å(s:™±wÂUŘOðL (ò­´ÇZ£ÇÚÂã¿vòÀ~b fþðŠj?<ü„v¾…7+÷BŸñÖå;z ¼DÞ9)¥ùòr¼ç¹áU^QP>³Qó6œMr\˜ù{%ÌóÝ¥o ‹¿;•„d­÷}~ÿfAÀGQ ØÒz¹”®¯×Ø\¾˜öq:ãøt—{QÀã.â\rJ゘˜×jçÔÅtL€¡¥ŸUûR™öÄü׆"¸»!–:§¾(Êb¬D2jX¼eVü-qÔ Žv<Øzofà ¼GÐ…¶£âìà—¿+ëüÿ>õÔ†T»=ú§wÿíÔ¹ÆôÀ'%o?fT£½ùŸüßIHO™þVö²ÁéWùA´ÃM“G·Ð§ pm!Œãê3ÂU™²ýYrÂõfýêOm˜ endstream endobj 4290 0 obj << /Length 812 /Filter /FlateDecode >> stream xÚUKoÔ0¾÷WäVGbC켯´€ ]©Š*wãÍZÍÚ[;¡ôß3ãq¶U¸lf¾yz^›'C’'ŸOòøý°>yÿ©¬^fEY‹d½Mª2iD›åE“¬ûä'ã<]qžç쫱iÁÙƒIWEݰ ïgåÓ_ë/GoàªKº¬«EžÀi¾W‚g-oÉÛµàù+ñÜ&P ÊߤDkJ¶™¯ó¢è5þâf㉺Ϋ\eC†~Á]ý<…¼Í:Ñ,¯sQE­çA›¬Ä£äG­éõ¤­ñàŸvp6]‰–õó&æõ;V¹GâÆ§„òó83,ÊQù,]UuÍÖ;å£ÖƒG¢&y—І¼``ǙݧœEÅIïÊÆ\¤/ð˜ÚSguS#‘uUEï¦E^³CHÙæQNèƒWlÚ)’QYÏå$³þ– ?ê)Š{ÜJ¯ ñ²hÙÕNQ2í´'jùZ3>’w¹‹.åŽá¬ŸÞ!Ù=¥°Ô*ÊéÝžÜl¤‰öXš–Eýèýs -‡ÆÑÃkzøUÚA¹(˜t‘x@ÖÝi3 PBv$ØË+bNHÈÛq1tP O6TRµéÕŸ£™×ƒÁÁ,1c3…B€þVúI¹ì_;²¢_qøŠê?väìÅbèROõĤ‘5v"âÔ©ûY;uJì´“Q0(£ntï¡3¢j¡¡vkÝþˆ4l}yy38;žaÖ‘ñÙù%¢Èt Fˆf%³Ñ÷³"6„=†6ÌÑÖ©­rÊlÔ‹6Æ* Ó¦NÔqy`ÁÙ…A°b[¹‘Á*Ëvò0êMq´º8÷¤I+†Ð1;dä085€z¿¦L6ó~¯~ÜÎ&Ê´¡o˜Txê?‡ôQ “%jóv9Äwã·B$å¡5qìjÁö7b3…³Qäìû¨Bœ 6~v‘¦F"%Ã1©!Ú–€§r#JôÓ¥EHœ¶ŽÌÉN¬¡)æÕï®WŠlH¼WtA 3ôÖSwj<ÄƒŠ‹fãžâí ·Ôê~YÆpYpÛðŸæå%BˆŒó"YÕ¹ÈÊ<®~Y¼Ðú¸>ù %fÍ< endstream endobj 4295 0 obj << /Length 1544 /Filter /FlateDecode >> stream xÚ…WÉnã8½÷Wøè$KÔb©@qœ´gœedg€FOC dÚ!¢Å(gùú©"©xi9sñ"²kyõв›5¸ùbéïËå—ѵë l×t\Ÿ –ëçÆ$0-gñÑØÄ6;P¶\ñ†²œÍ¿–gÞ¾mmïÛÛé…ž²•ýŽÕêdüžš¶ú‰`Ä"–oØ~+l3ô4ÐCNźª‹¯Êð5ð4ò]c›9/ÛWcS¶{TXH¹8tô1nË’—eÒ–+VkìÇÍÚRh8BL |VæËEF3´mvKEÍ_Õ–m]­ÚLžÝhÈ[Ó6}n\Σì²½±7=U¥¼ÊÒ–£}¾¥ic@¾âQŽÏy:Êy§9m̦êƒGÑä/}ü¨mêCLdç#g#yÝÒìAÕ/@5ñ9œl™ÖQÄ ?¯2š³¯rÅ3 õñ¾ZþiÿÒùš$“å‡é7†peò¸0—×F€$»¸|÷x;ŵx6ù6é å§³ÇZÎnªÄýÉÍå…1vÜ@žq?ŸGËéop{7]F1ü ¶î˜.ÑÍt¡Vq£Þч<Þ#?DÓø“0#æÃ=Ptuƒz³1ÆŽ }:Ÿ>|÷5‚Ñ›öƒ¼ßN£Å£Œtz;½[G«÷Ì®äúÝrv=›DËÙýÝÞ¿ƒj ^0eó^•L³**XÍ3´§£;ö’ü¨êç¾ØÄ{V­´ySµuÖ4o²G+ö}» f‡-{à‚fOl¥v§´Ñ @Xz¦Ö|=òà”›šƒµc»á°AAEãBé­àøíË}tûÄ3Ü>Áß+¶ãk´X՜ͧ”XQŠ£`â©Z5ºÓ¥ó¿GX‰'V+óã`·OÌB<¬¾wf–·Õ:!²‡mBtm1k‹‚Å)ˆ,¹î¾±{ÛífÇß0ö%Š…¡ÙjQk_rúgئON€ü“¶»aeUð,¦²o!0òðôý*ÃÑr%…àŒk]ng€…8*@ÇG,Ùh ÷–‰ªn £·Ï uý¶¦PéÂÝA©—Œ¨™$ÉÝ2‚‰ÄßÏ;m¼Íf›W‚$r¦I•ûxñ÷œ .ãôësÉî JYA&€bg2–àD…?d˜®:Žì8ÕÔQ_%-X£{CvŠ;ì†7-µMY‰cºaë)‚ð»^p†añ¤Ê«ú²f/ófrDBkÕhW¼¢[žÛÞÿЬ Ð•B[eÆ,L¿”uM›kFå,më=q>ù5­w’û¶ÄƒÏÀ ·­ŸWÕK +Äû”]˜ÿÙ=†„Èn%Âï M8…‘ nŠÏ¸µË„$¢j B2,$ÓŠŠ7HK“ás5ZˆªÊ%14¤ƒáˆ+ž´’¹9x8M>gJï²Rò „uóâ ŸD‘Ã)JÛ`ÅÏÏPµKöÂêš¾5‰•+,\‚6P0¨˜¬ä¼¨ËyÖBžiwZºîx¸ØRÙ “§$ê€^œ.ç×pGlsÚkxºvÛ _m@uˆâR—tÒ%}›¿!¯U¥CíR]")_À’eöß ˆs¬|‘º{mÊ‚•ò|)pêÆ‘ó5ËÞ²œI<§¯K÷öy“Uåšo4d³ÈÚ© ¨.ƒ4èGêòû`îI†[.Ðu° ÛŽôçÌÃ_'¢›A¸¯`ØÉòض¡Ê!)c(a÷ìÌé’¾â ëȧJä8º~ê ªë:Ûè:N—û¨q£‚K>—W)ÇQ%§ŽÔãïo²ÄÓXýá:šÂs7Þg_ ¨£hžÓ”ÁMz“XZîû èŒ?Ä©lеÝÓ’ …ˆCfÜÐež¦Æ·­¦›Ñ!r²f;£?ÅîÇí *¶O¨‚È—1 ¼0ùn)’É—ùñž9ºuÚ¿æ×6Çpk1Hh~YtÝ#“éòËŽlÀ– endstream endobj 4299 0 obj << /Length 1046 /Filter /FlateDecode >> stream xÚu–ËnÛ:†÷y /•…X‘¢DiYŸ&Á¹EbŠÂ %ÚaC]@Ñ=qž¾3é"ÒJÉù9óÍEÊ6§M¶y¸ÉÂs»»ùp_䛚Ô%+7»ã¦¨ cõF°Šd¹ØìÚÍ·äϿߦ+’ÿ´{¶{FŠÛ”&„Þ¦UÍXòŒo®3;y0 v9ì|ßý7¤”’º(¢Ld²yë&4ÜSo–Ë“­šÏÒâº4FØÌK’-ˉ ÷iû'œƒ“·i]‹<9è¡“n*àkµf_{+DZÕvòÉQHä¼J>)#/ªýhg‡.ûŒ°5µ‚FµÓÐãIψ!¤¼®7 fÚsP§Œö‘ñq°JŸ@ÁÛWiUoú^¹½ yJq§^ö"">™³(%ñ ç"±jrø~< f„Ë*‘lo:µS´¢ebižUóÒI‡Éfk<"Ý“ê•ÕM¤K¯tOÎ×K† )_”)#Öí àŽw…p?ÔŒê'Õ ®·ôh­`ʈ¸•N¼m夂-!xòÜM¡˜–²TF¾¯aXœžoøžÝ± %ÍÖâ‰h¿~QlH3GŒ3–Q#-HÔ~g%”HwrV÷'8î^¥‚˜F£{µTpQBD²íh.xß,‘‡¦Þâtã½6ê ²4[qGD²F:§¢b,Å{Ð|ÉÈrÁ‰ˆµU:œñŒ֡ࠣ귭œ0YÅÿ½ˆÉ‘­ÓíeRF5~0ùl`±0P‚ƒ‹3¶ b«1EÄ/½vèGCR}²ºÅ÷»Wg%Èä‹UdüÙîÁSm°ÄrŽNqÁxòtî:iõ›jï^ñÀ Ó©=Ï×ú«ŠÈ_g7< Ó"< ¨yú•«ö9ô±Õ¯ONzXè™o-ß 3& k‚P¶¬#®©»¨ŸÒ„>g8}ê/²3HˆˆÅ¬U‘3Ÿq¨J¹Z5OOXœ'Ñòð«#mÝ;eÇPE4åqëœ|[n‰:2mŒ†c%¶„gjGi±~çÙÃV¬¯DÏ0‘Œ Mð»'[Ý<[ø49 ‘¥a.KE¨Í8úŒø›ã×WÞÁ·-rå‹\ëÈuìO@ަUæë¿ÿ@pµ/)lÌæiá?üïý YD üÙ·y¨„Æ6ÃÁwØÜKÑÐ,r­rîrî}øZc×Z £cn¨Œ”iž­¨EÎ?Få#óÐÌÃÉ“}?8éôÐÃè‚:ÀKðÄÚWf6̨aœÂ(ÍRÊæ ´¦ìÝU·{œÕªâu:7Ò¨¨ÈHüh¬¼ (ÌsGéõoÂHH_¨äðÇ•'ß=<<Þ=íЋÐà׺÷Æß?tŒ ’±MÊjA8¯ç xñÎänwó C0ˆ endstream endobj 4302 0 obj << /Length 119 /Filter /FlateDecode >> stream xÚ31Ö3µT0P02Q02W06U05RH1ä*ä24PA#S¨Tr.—“'—~¸‚¡—¾PœKßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEŸÁ¾Ô¨o€B¬Â@ø €a—«'W $o&| endstream endobj 4307 0 obj << /Length 164 /Filter /FlateDecode >> stream xÚ32×31V0P0SÐ54W02V05PH1ä*ä24ŠÅÍ¡Rɹ\Nž\úá †f\ú@q.}O_…’¢ÒT.}§gC.}…hCƒX.Ofv> ††Œ0`o`oàgàgC(¬€Ã@ø+É ÔÁtBÌ™2™ùãÆ@Å@;e€v³30s¹zrr»¨2­ endstream endobj 4308 0 obj << /Length 164 /Filter /FlateDecode >> stream xÚ32×31V0P0QÐ54W02T05PH1ä*ä24Š(˜™C¥’s¹œ<¹ôà ͸ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. 00X0È0ð1ð3°7070`|Àø€áV€¡ ÊÁ¡<òc… „:˜Nˆ9@A&3`n`oàÚ'´·hÿ.WO®@.ýÎ)V endstream endobj 4309 0 obj << /Length 124 /Filter /FlateDecode >> stream xÚ3´Ô3µT0P0S02U04S01SH1ä*ä‰(B$’s¹œ<¹ôÃ,¹ô=€¢\úž¾ %E¥©\úNÎ @¾‹B´¡‚A,—§‹‚ CÃløßPß`ÛÀ†Ì Ì Ì ì l | 2   \®ž\\:Ž endstream endobj 4310 0 obj << /Length 124 /Filter /FlateDecode >> stream xÚ3´Ô3µT0P0SÐ54V04S°PH1ä*ä‰(B%’s¹œ<¹ôÃ,¹ô=€Â\úž¾ %E¥©\úNÎ @¾‹B´¡‚A,—§‹‚ CÃløßPß`ÛÀ†Ì Ì Ì ì l | 2   \®ž\\M¡ endstream endobj 4311 0 obj << /Length 90 /Filter /FlateDecode >> stream xÚ3´Ô3µT0P0bCS …C®B. Ïȉ&çr9yré‡+Xpé{€O_…’¢ÒT.}§gC.}…hCƒX.O›ºÿ@PgÃåêÉÈoÎ9 endstream endobj 4312 0 obj << /Length 101 /Filter /FlateDecode >> stream xÚ35ѳ0S0P0Q°P05T02UH1ä*ä2‰(šƒ%’s¹œ<¹ôÃL̸ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ÿAà„d *@6™ËÕ“+ )£ endstream endobj 4313 0 obj << /Length 94 /Filter /FlateDecode >> stream xÚ32Ö35T0P0T04V0Òæ )†\…\†@AˆDr.—“'—~¸‚¡—¾‡‚ —¾§¯BIQi*—¾S€³‚!—¾‹B4ИX.O…ÿÿÀ—«'W Sü˜ endstream endobj 4314 0 obj << /Length 287 /Filter /FlateDecode >> stream xÚ%AJ1E+dÑP s¡É´{ {Æì… +ƒ ¨Ka…,s´€˜+ô²ÓÅÀX?E/^èJþ5N—“ïýàÏ?Ž~ìýëš?XˆotòòΛ™»G™sw+¿¹›ïü×ç÷w›ûk¿ænëwkß?ñ¼õ¦QOÍQ°'w&(Ô6‰ÌBÁfj2¹ã2Es¤«D‘§_üœ¸»P endstream endobj 4315 0 obj << /Length 158 /Filter /FlateDecode >> stream xÚ½Ê1 Â@Ð/i<‚s7Ëb‹Á-­,Ä*ZZ( =jŽÒ"8Î&°“aü?㲉Í8f«ëRž¦|´t!—hŽC ‡òL¹'³c—YiKƯùv½ŸÈä›[2ïõó@¾`@DRãWÌ1*¼ÑbÐ(ÃŽ@Ào*ˆHÛ£±í»ÿ5øà)#©;héiK_-ÛY• endstream endobj 4316 0 obj << /Length 163 /Filter /FlateDecode >> stream xÚ31Ô34Q0P0bSs…C®B.c ßÄI$çr9yré‡+˜sé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]þ7Ô10°ÿø¿A¾¡þð;†úö 5 ÿÙ0ü`øÇþ€ñˆdþÀð‡±$Ã@ùþ@IJÌ¡Éô#Cýþÿ $—«'W Õ˜gÓ endstream endobj 4317 0 obj << /Length 178 /Filter /FlateDecode >> stream xÚÍ= Â@…Ÿ¤X˜&GpNà&à’Tb·´²+µ´P´Ääh{”!eª¬›%ÚÛ90|¼Ÿê©t’¤qì^%ðfh†ì!üui…ml7€š6ô iz& endstream endobj 4318 0 obj << /Length 202 /Filter /FlateDecode >> stream xÚ]Ͻ Â@ ð”… ¸*ÍxWm±[Á°ƒ “ƒuTtÕ{´>ŠàèP> stream xÚϽ‚0ð#l·ðÞXÀjÂD‚˜ØÁD'㤎]¡Æ£ðŒ µMÚ_rmî9^,‹¥d/ß_Ó=ÃòÜÔ©-íÇ퉕@v&ž#Û›Wdâ@Ÿ÷÷¬:n)CVÓ%£ôŠ¢&­µ0j ñIÑñ`õ”sr6Îö› KÍi>9é­­„ÈÌgÌ 'ú´Ò+­ o÷‡rî*ƒ4—+·ïàvï¬îžðT™m endstream endobj 4320 0 obj << /Length 223 /Filter /FlateDecode >> stream xڥбjAà9ÈÁî œˆ{wl"Vç¼BÐÊ"¤RK‹„-äÅæQ„¼À•©Ô;A¬m¾bvf˜Ÿ“ÁÈsžŸRöCö/¼Jéƒ|ŠI[ї冊ŠÜ‚}FnÊäª)}~¯É³1§äJ~K9y§ªd ß@€ÓÑ¢Æþ lmþ9°ü¹˜ÿÐ%QX‰@|ц¹Hú5`$âÆ£Š{Ü_½ìÌ;kµ»Aï1µmÕ;£Özÿ4KšëšqÍ«mŽ„Ð…áO@¯Íé #"P+ endstream endobj 4321 0 obj << /Length 175 /Filter /FlateDecode >> stream xÚ35Ö³0U0P0bSS…C®B.3 ÌI$çr9yré‡+˜˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿÿƒHþg``þÁ ÿ€ñóÉðLÖI{0)ß"ù!äÉþA2@"€HFLò$†i(6"¹„ýÂ…7Û#ùåÔÿ‚üÞÀ .WO®@. àm˜ endstream endobj 4322 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ31׳4W0P0b3S…C®B.# ßÄI$çr9yré‡+˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÁÉüƒùã†0i&åÀ$ɆA²ƒIfi€L2 “’ñüÿABDPÔ ™pd`lÀN27ÀÝu„ä“ò`²ä_Æ`¿ÃH.WO®@.ú_‰ endstream endobj 4323 0 obj << /Length 158 /Filter /FlateDecode >> stream xÚ31Ó30T0P0bcS…C®B.rAɹ\Nž\úá &\ú@Q.}O_…’¢ÒT.}§gC.}…h 1±\ž. ÿà˜`þÁÀü‡ñC ˆ°r ‚N°¡ì ‚HH ÂDT€ˆ ŒÿÿÃ0*aÁ€© A0A0ÿ { —«'W ÃS¶ endstream endobj 4324 0 obj << /Length 219 /Filter /FlateDecode >> stream xÚпNÃ@ ð/ÊÉË=Âù Mšñ¤þ‘È€êŒ E $"õÅÜ7©ÔˆÔ…)á“•å7øì“?WÕå|Î3.ù¢àêŠË?´£²ŽÅX®íåñ…– å÷±@ùõhsÃo¯ïÏ”/oW\P¾æ‡‚g[jÖ ø }"H;·¸69 ð!ø‚$ß±KÒp’ìWçRñf $L¨_Qü±WñýЛú?ªNÌ`¶ª7Eu2m;iû[ÍåÇŒAóâ¬Ù³ƒÞaÐkøØE›†îè­Ý\˜ endstream endobj 4325 0 obj << /Length 123 /Filter /FlateDecode >> stream xÚ35Ò³0V0PaSS…C®B.3 ÌI$çr9yré‡+˜˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿ`ÿÿ„dþÃÀðŸñC½Èÿÿÿÿƒ‘ô´LBü‹\®ž\\Íohz endstream endobj 4326 0 obj << /Length 103 /Filter /FlateDecode >> stream xÚ32Õ3Q0P0acS…C®B.#rAɹ\Nž\úá F\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O…ÿÿ?óÆ€€öBÀåêÉȉ%E endstream endobj 4327 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ36Ó32T0P0VÐ5T06R01UH1ä*ä2² (˜˜Ad’s¹œ<¹ôÃŒ,¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. Ñ@ƒb¹<]êÿc†ÿ u†-€ø Á? @\ÀøƒÁ‚ùƒûöÿ Œ¸\=¹¹˜Ž7Ø endstream endobj 4328 0 obj << /Length 221 /Filter /FlateDecode >> stream xÚEϽJÄ@ð W¦0/p¸ó&ñŒÕÂy‚)¯²+µü¬“GË£Ä7Ø2BÈ:óOa±?vv‡ù¨«³‹K)d§§>—ª–ç’ß¹j4.,´§WÞ·œßKÕp~£¯œ··òõñýÂùþîJJÎòPJñÈíAb Ô-«›™È…d"ÊHæ)làÍd07½™’y·°ÁÔDUÕ÷l4ôÈùœÌíŸüfìu¡NÉ£šG/‡¾fHW&™0Õü/-°ƒ~µ7¶s£íëƒîžÄ¸Ê×-ùc@kï endstream endobj 4329 0 obj << /Length 217 /Filter /FlateDecode >> stream xÚ33Ñ3µT0P0b3#S…C®B.S ßÄI$çr9yré‡+˜Zpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿ````ÿàÿ Íÿÿ3˜þÀÀ¦00îÒÒHô| mŒ…îo``HF¢Û00F¢›qàÆ ÌÌHtÃ6¬t  mÇ •–g0@¡ùPhö°ÒÌPhÆÏ Xi†ht ˆf>¡AWÃÀþáÿ ÆÿÀp…Ò\®ž\\°ö endstream endobj 4330 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚMɱJÄ@àYwðæ ¼ÿ ÜD“ÃÊÀy‚)¯²+µ´P´½‹Zú>Š©|Ž«¬SIŠ%ëÍ®¢Å|03åîÎþžfÊ”™¥^år+ÅtÓCåqy#³Zì™S±Ç›Ul}¢÷w×bg§‡š‹ëy®Ù…Ôsõ=ï¼£ÆUk …ñÀæ½ù󭥯kúíèSO£Ž6Cp\«†NZšF×tÜÑ$ÚSã(¢Cp¬žé$úAÓO:Ž~Ñd æŸˆ.ƒ?&-°´¶àý¯#ÈQ- ùhTO endstream endobj 4331 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚ±‚@ †KHºðôô¸ÐIÄDŒ“::htEGáˆÚZf“Ë—k{íÿ÷âh:O(¤ˆ&–bKQBg‹7Œ$Éé™VNWÌ 4{®£YsM±¡ÇýyA“m—dÑät°±È mÀù¼™^TAå5 p¸ÐËq:€\S?¨üÊÖÒ¢^“ò·U¾„²‰"äôÿq> stream xÚ31׳4W0P0bS…C®B.rAɹ\Nž\úá &\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O…ÿÿÿÿ`ÿ˜0È`üÁÀþH0~?€ÃñDÔˆz¼D\ñ˜`£À†YIJ¤„6ó ñÿÿ(ÁåêÉÈ´ÐZ¶ endstream endobj 4333 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ}α Â0à“ …ôï4¶R…ZÁ‚N⤎ŠÎöÑú(>BÇ¡5—ÁÂñ ÉñÿªQ4#Ÿ&4TŽ)é¬ð†Ad} ¦îçtÅ8E¹§ B¹6Ï(Ó =îÏ Êx»$…2¡ƒ"ÿˆiBu]çF JxtJèå¬÷fEÁ6£YpV­êï¾—ã2]>wÙ^ca{µundv3û½ç¯E»‚-YÑè sžîryÕgæn0q¸Jq‡Æ-q… endstream endobj 4334 0 obj << /Length 212 /Filter /FlateDecode >> stream xÚMËÁJÃ@àÉ!0ó:/ »K¢¥PÔ æ 詇â©õ(¬E!‡bóhy”_`nz(Y'TQ†ï2ÿÿ—Ó ?eÇŸ{./¹ºâ§*WMŽÉú™æ Ù%—Žì­¾É6wüº}{";¿¿fOvÁ+Ï£îœIò~ œÈ)r™!“FA‚ üã¾~¼«½ª£€³Q¤ò”`RêPë#KcªÓ\gFa4ÎwýÑìWüÓê ÕbТ 0ñ³Ëú)÷úB@7 =Ð7b†S. endstream endobj 4335 0 obj << /Length 141 /Filter /FlateDecode >> stream xÚ35г4Q0P0bKS…C®B.3 ßÄI$çr9yré‡+˜˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êÿÁ(ÉÀ€ùG døQ"- dˆ”€@¤ „<"yp‘ ’ap“ò@Äÿÿ $—«'W ÀO endstream endobj 4336 0 obj << /Length 172 /Filter /FlateDecode >> stream xÚÕÏ= Â@à ƒ˜ÖBp. ›5?¤b·´²APKAE;ÑÍ£ä)-âDñNñÁ¼aŠ IÀ>Ü×ùF¼Ót¢0–PÖø{Ù(5¤–š~43¾œ¯{Ré|ÌšTÆ+ÍþšLÆUUº•ýêZ`ôt^€‡ÚÆ_ÙÄ`vÐî@"Õ€#Ð6R0w  Y¸9äÙƒÌÃÖz%@C zEHÑ endstream endobj 4337 0 obj << /Length 221 /Filter /FlateDecode >> stream xÚeÎ1jÃ0ÆñÏbx¼fË»@")‰J¶@š@=Ú©C ’ŒRÚ5 =—ÐCø=;’]"•ò†> stream xÚ]‹; ÂPEo˜Æ ˆo6 ù<‚Á‚Vb¥–Šv’'غ¨tnØ2EHÑF‹Ã…s¸:ìöXsÏg²öyãÓžd½·>e½£8%w!܉hrÓ)§-¹ñlÄb^ÊgEiÂh§ÉѶ tP"ÂY~‰Ð…þqädXµ‚S(¨\!º(i™PCÙÕ‘] Œmð¼©ë½j7­Òª¬SšÓ þn1ß endstream endobj 4339 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚ3¶Ô3´T0P0RÐ5T06W01SH1ä*ä26 (˜˜Cd’s¹œ<¹ôÃŒM¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ìþà ~ÁNñHÿßÀÀ~žùûÆ ì?jØ?0Ô1°?`°©“ 0‚L @èe5ùÈ¢ ?Ø÷€ìåв±ÝÂÀø‡ËÕ“+ ùÛM· endstream endobj 4340 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚÍ1 Â@ÐYR¦É œ¹€nv6 Än!he!Vji¡h'q¶GÉRZ¤pÐÂÖâ5ÿÃÿÎLÜ”s¶<6lgì  ^Ðæìì·9œ±ö¨·l ÔK‰Qûß®÷êz=gƒºáá|¾a à9€êGt)¤‘B(P¨D ´1ü¡ý‰• P²ªB“ʇêKù|P\xÜàÞ0> endstream endobj 4341 0 obj << /Length 180 /Filter /FlateDecode >> stream xÚ3¶Ô3´T0P0RÐ5T06W01SH1ä*ä26 (˜˜Cd’s¹œ<¹ôÃŒM¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ?€XN0‚ò þ@¢þÇ Ar?˜°ÿ``?Àüƒ¿h²<Èx{:;Q'þBÔ êµc€™,ß¶ˆd/߯6ÿ0Ôò~0p¹zrrò¸Y endstream endobj 4342 0 obj << /Length 174 /Filter /FlateDecode >> stream xÚ]Í1 Â@ÐR¦Ù˜¹€nvƒA"Ħ´²+µ´P,$îÑö(!¥E n¢…ÈðŠÿ1±ÄCŽXs_±q¬x¯èD:qeıþ,»#eÉ5ë„äÜÕ$‹_Î×Él9eE2çâhKEÎ ÐTðŸ76…0=„Ý Ó¦AËÞúGÓ4À¿ò+ìÄ áYa|#¬ïþxÕx¼€Ð‚f­è •›8¾ endstream endobj 4343 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ32Ô35U0P0b#3s…C®B.# ßÄI$çr9yré‡+™pé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]˜?0ðÿa°“c¨±gøaÏø„˜ð0?`ÀƒþÿDøÕØ?0Ôÿo".WO®@.y?B endstream endobj 4344 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚmË= Â@à' ƒ H2Ð$®Á&ðL!he!Vji¡(¤H‘£ ^Do°åV®#*ZX|3Û´;=Ž¸Ã­8aÝeñ&¦=éXÒˆ»É{µÞÑ §pÁ:¦p"9…ù”‡Ó–ÂÁlÈ’Žx)O+ÊGŒ îr¯ßœ¯ªÒ÷ª² §Wýï3É=TUÀ»4ÜÍ hâËðœʹ³tãCÙ°PZa€ô×3+eßGͨ_Õ5¨jîd4ÎiNÉñB@ endstream endobj 4345 0 obj << /Length 146 /Filter /FlateDecode >> stream xÚ3¶Ô3´T0P0bcs3…C®B.c ßÄI$çr9yré‡+›pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]Ø000ü‡ü ‚"â8ü¿ý8óö{ŒØ€ˆ ? Ä8q€VÿÆ? ÿÿÉÿ?&¸\=¹¹ þZP endstream endobj 4346 0 obj << /Length 118 /Filter /FlateDecode >> stream xÚ3´Ô3µT0P0bCs3…C®B.C ßÄI$çr9yré‡+špé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ØøÈ?€@þì h€ýÀ Êùüÿóÿ—«'W =!45 endstream endobj 4347 0 obj << /Length 145 /Filter /FlateDecode >> stream xÚ32Ô35U0PÐ5VÐ54Q04S01SH1ä*ä2´ (˜Áå’s¹œ<¹ôà -¸ô=€\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ü ò öÈ âìþƒÿ›fÈ€ý@û?ü `ÄðCž¡ÂŽÁþû.WO®@.t£?Ž endstream endobj 4348 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ3´Ô3µT0P0bC 3…C®B.CS ßÄI$çr9yré‡+šré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ØüBþìT…üþÿûÿËÕ“+ "Â: endstream endobj 4349 0 obj << /Length 164 /Filter /FlateDecode >> stream xÚ3µÐ3·P0P0bS c…C®B.SS ßÄI$çr9yré‡+˜šré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ØÔ3°`øøÿû? ÿ7¨°gà?Çøã|û†ŸøØ0üoà?TTz€ýCu€¡fà(þ ÿøüÿÇÿH@).WO®@.š`\ endstream endobj 4350 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ3¶Ô3´T0P0bcsc…C®B.c ßÄI$çr9yré‡+›pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]Øüc`øøÃÿãÌøï1~``ÿ">0ü€àÄZüÿ0üÿ'ÿÿ˜àrõä 䉴MË endstream endobj 4351 0 obj << /Length 157 /Filter /FlateDecode >> stream xÚ36Õ32W0P0RÐ5T06V06TH1ä*ä26PAc#ˆLr.—“'—~¸‚±—¾P˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEAþCýÆv ÌøØØø,yæv`QÆ5 ?`øÃB¦¦dó7°`?ÀßÙ ²›ËÕ“+ ×v?X endstream endobj 4352 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚÎ= Â0ð'·ô}Ð$¦ ],Ô ftr'utPtéÑêä¦pÈ:v( Ô¡›Ëoø¿OeL‚F4ŠÔ˜” ½ÄªÈ¥‚"Õ–vGL5ò5©ùÜåÈõ‚.çëyºœ’DžÑF’آΈ €}Úì»o øôJ`ÔÀJ¸30V@â óAñaÑKÚ}Ư/áæ©€ÕþîË¥ÌÿÂ5ø¾ÿ ŒÃ6?p¦q…_³Qn endstream endobj 4353 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚα Â0à  7ØÕAè½€&i í µ‚ÄI…Nµ–Gé#tÌ jRêàæò ÿ÷ŸJ&‘"A¥"•t”xAÛTP¬úÑáŒY|K*F¾´9òbE·ëý„<[ÏI"Ïi'Iì±È ‚fð0)03JÁk%øÚ/!¨=aÍ ÌàKÐór<ÿ¤ú¥;v¸Ž@ûÆõ`íÔØ_ZK¨-nù˜í‚ð­;pQà? S endstream endobj 4354 0 obj << /Length 124 /Filter /FlateDecode >> stream xÚ32×3±T0P0a3c…C®B.#c ßÄI$çr9yré‡+sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]Ø?üoÿó^ÿŒ:öuìêØ?ذ?`€¢$#þ ÿÿƒ—«'W  ¾1R endstream endobj 4355 0 obj << /Length 169 /Filter /FlateDecode >> stream xÚ%É; 1Fá?•pÛ©œ»Í$:…(ø§´²+µ´P¦ÒmYf)‚H™"x _uŽô*Ë[î¶}.  É–)\ÚÿÙŸhR“Þ°-I/R&]/ùz¹IOVS6¤g¼5\쨞±úd-yvT"4h<ªŸ, È"2cA.®-^I@¡¢ÃÝa”¼ÐIüOÀ0‰hDù·8' yMkúúÙ;¥ endstream endobj 4356 0 obj << /Length 138 /Filter /FlateDecode >> stream xÚ32×31V0P0TÐ5T02V01TH1ä*ä22 (˜Ad’s¹œ<¹ôÃŒ ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.O†zEŒ˜Áˆýƒü†ÿÿ?3L8$ Y0~0`üPÀð#Áþ—«'W E‚;G endstream endobj 4357 0 obj << /Length 139 /Filter /FlateDecode >> stream xÚ3¶Ô3´T0P0RÐ5T06W06PH1ä*ä26 (Bd’s¹œ<¹ôÃŒM¸ô=€Â\úž¾ %E¥©\úNÎ @¾‹B´¡‚A,—§‹û† ÿÈC þŒ?Àb4"Q æ ÌØA߯2ÿ0Ôÿò~0p¹zrrµMs endstream endobj 4358 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ36×32V0P0TÐ5T06S0²TH1ä*ä26 (Ce’s¹œ<¹ôÃŒM¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ÿÿ0þ?&ø0Ô1°?`¨ Ì @Dã†Áðƒá2QÃØ%옠„=;gƒü=pâ`¿#˜? Œ`È`.WO®@._x3× endstream endobj 4359 0 obj << /Length 195 /Filter /FlateDecode >> stream xÚ35г4Q0P0TÐ5T05P0²TH1ä*ä2± (Ce’s¹œ<¹ôÃL,¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ÿÿØÿcÿ!ù0`üÁ€ùÃöŒÉ ˜â `$ûF ([c”üÁWÃÜÀðƒÇ†™JÖHȱ!Hy igÀσDö00È'°Ï@"o00-þ€J²7B ?ÀÀåêÉÈqzGx endstream endobj 4360 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚÍ= Â0ðb/ ôÀX#~,ª‚ÄIÝ<’£cŽÒ#dì Ôò#ïÛ{'}ÉðÜHS9f|e7DÜa,Î\”l·â†l—Ȳ-Wr¿=Nl‹õL2¶sÙ¡sÏå\š¯i^’ ¿¤ƒ ¤‚ò¤jý"ª5=[ ù€ä LtSøÕ1i=A;ÝLR¬º$ 2`D{ÈxUSZánLãÿð¢ä ÿÇ;6 endstream endobj 4361 0 obj << /Length 204 /Filter /FlateDecode >> stream xÚMÌ= Â@àY B. 8ÐÍfƒ?‚?` A+ µ¢(Xñâ™<†eŽ`iÐY“ˆÅ|Å{Ì3ͺoÈ#M5iߦµÆš€S“W«-öBT32ªç¨Â1öÇ ªÞ¤OՀ暼†z§â}ÿâ&p'ØÒ™€ò ˆ',3à÷œT0±¸œ%Ó‘S-ý¸1îµÀyðê?")°Ãv8C~á;YÒÒ²¥b‹EL׎¸ö‡!NñW> endstream endobj 4362 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚÊ; Â@…á3L¸M–»'„@Œ` A+ ÔRPÑ6ÎÒ²”,!eŠà8“âƒûø³d‘åsêœ.ùšÐ“R‹ýê—;U ©#§9©­»’jvü~}n¤ªýšR5ŸŽÏÔÔ\Zkf(Í % ´ˆ1á!&h1BË:è¡Ã; 2pðuZgFŒÂHo&è¥ ;i¢NºTº4pYˆŸ›¬µ3Ú4t ?»"6 endstream endobj 4363 0 obj << /Length 163 /Filter /FlateDecode >> stream xÚ36Õ32W0P0VÐ5T06R01QH1ä*ä2² (˜˜Bd’s¹œ<¹ôÃŒ,¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. öþ``~PÃÀ~ÀŽ¿AžåØ@Ø,Ê~ ¬ÿa`þ@ F6«ŽýÌ.º¢ä{@"  w‚ÜËåêÉÈ•ÑQ7 endstream endobj 4364 0 obj << /Length 116 /Filter /FlateDecode >> stream xÚ36Õ32W0P0bc…C®B.#c ÌI$çr9yré‡+sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]xlj˜ÿ0üÿÃð§ĦúÇPÿÿq¹zrrí-É endstream endobj 4365 0 obj << /Length 205 /Filter /FlateDecode >> stream xÚEÌ=jÃ@à'T,La]ÀXs‚ìê'XEÀ`Ë`¸ra ‚$¥Á 6¤0öMGÙ#¨L!¼ž !)¾âÍ{LñøOÙpä\–ü–Ñå•db(^÷4oHo8¯H¯äJºyæãçéôüeÁéš·›55ãjùÊa†1R[!颅rÒ¸ª¿ýˆÿœ%㟒 ÒÀB~qß@$³X&JêDꉜŸÄ—èaà`¢&¶hÐŽ—zïfâê}çѲ¡5Ý‹J# endstream endobj 4366 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚ…Ì= Â@à,Ct/ ì\@7b* À‚V"j)¨(XˆÙ£å(9‚e 1ŽØˆÅÃÌ›uÚa—}ޏpró& …‰,}Ž;ŸËzGý”̜ÄÌXÖdÒ ŸŽç-™þtÀ™!/ö—”ÙƒcU®­ª*¨ê)â.rx7ÀÃZrY‰zq…² Ú6dòàæ€[|ÔÞîß.âñ£”l!Vò»‡ÊéiB£\[©¤&³ QJ3zÄ@à endstream endobj 4372 0 obj << /Length 192 /Filter /FlateDecode >> stream xÚ…Ž1‚PD‡PlÃØ èÄŠ1‘ÂD+ c¥–m…£q@IAˆû;“WÍÎÎL0›† vÙ xólÎaÌgnäû¢ºEãét¥4'µgß'µT¾áÇýy!•n—ì‘Êøà±{¤> stream xÚ…O; ÂP±lãÜ è{IüÄ* L!he!Vj)¨h-GÉ,-$q̃´ÂT;ß…ÃñL­NuihuéÉ—›V'Ç/2OÅì4Ĭx“®õqžÅÌ7 õÅ$º÷Õ$Mô |€ ¨,G\ WÂ{¡ûFÇ9úé^Ù€"J[|š¼ ¬µÐîrè’YÁ"Ö±4nT?…”pGrjݬc_e*[ù«ËM* endstream endobj 4374 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0U0Q0¶T01SH1ä*ä26Š(˜%’s¹œ<¹ôÃŒ¹ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. L@ÌÀß$äAD=ˆø$˜ÿÄÿ€Ä?€Ä ‹³ÃÅíáâÿáâ?Å@âP¢&VVÌŒ.ó.ó.S—áG—;ì&.WO®@.n=Þ endstream endobj 4375 0 obj << /Length 162 /Filter /FlateDecode >> stream xÚ]± Â0†‡Â->‚ÿ˜ÄK…N…ZÁ ‚N⤎ŠÎú¨>‚c‡bMN8¤>È÷] çy’°ÈáÁü GGbŽÎÂO%ÎT2[0“YFK&¬p»ÞOdªõŽLƒÝS¨AZZFý¢HW 2"ÃòL}¦¾Tß©oþýï»­® ËÐ"І¾Öº?¦ endstream endobj 4376 0 obj << /Length 114 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04WÐ5W01T0µPH1ä*ä22Š(˜™B¥’s¹œ<¹ôÃŒŒ¹ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. õÿÿüÿÿ†þüa`üè?’›îçrõä ä—5ez endstream endobj 4377 0 obj << /Length 116 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0VÐ5W02W0µPH1ä*ä22 (˜™Bd’s¹œ<¹ôÃŒŒ¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. õÿÿüÿÿ‚êÿÿc`¨ü¨æ`°›ÿp¹zrrléI endstream endobj 4378 0 obj << /Length 104 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0UеP0¶TÐ5RH1ä*ä26 (˜A$’s¹œ<¹ôÃŒ¹ô≠ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êÿÿÿÏÄÿа—«'W *› endstream endobj 4379 0 obj << /Length 116 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0V0S01T01QH1ä*ä26ŠE-Àɹ\Nž\úá Ææ\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O† øA-Âþÿÿÿ€øÿ4‚Šv@  Ã¹\=¹¹emH™ endstream endobj 4380 0 obj << /Length 136 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04UÐ54R0² R ¹ ¹ M€Â FÆ0¹ä\.'O.ýpC.} —¾§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹ƒüûõ?€ðÚÿ‘ÿÃÿ‡áÆŒ?˜?°PààP—«'W ŸÒ,5 endstream endobj 4381 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04F †† )†\…\@Ú$l‘IÎåròäÒ pé{€IO_…’¢ÒT.}§g ßE!¨'–ËÓEAžÁ¾¡þÀÿ0XÀ¾AžËÕ“+ ‰;“ endstream endobj 4382 0 obj << /Length 157 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0UÐ5W0¶T0µPH1ä*ä26 (˜™Bd’s¹œ<¹ôÃŒ¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ì@ÌÀß#äÁHÌD؈:Q'þ€ˆ@Ì&> f0ñd˜82î>3Ñ dfâ ¸™¢Dp¹zrr@Ä:Õ endstream endobj 4383 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04F Æf )†\…\††@¾ˆ –IÎåròäÒW04äÒ÷ sé{ú*”•¦ré;8+E]¢zb¹<]äìêüƒõìäðì:¸\=¹¹{-= endstream endobj 4384 0 obj << /Length 110 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0V04S01T06QH1ä*ä26 (Z@d’s¹œ<¹ôÌ͹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. õÿÿÿÿÄÿ °‘§\®ž\\ºâAŠ endstream endobj 4385 0 obj << /Length 103 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0W04S06W02TH1ä*ä2 (˜B$’s¹œ<¹ôÃŒ,¹ô=L¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êÿÿÿðÿÿÿ0 âs¹zrrå$~ endstream endobj 4386 0 obj << /Length 117 /Filter /FlateDecode >> stream xÚ31Ö3µT0P°T02W06U05RH1ä*ä22 ()°Lr.—“'—~8P€KßLzú*”•¦ré;8+ré»(D*Äryº(Ø0È1Ôá†úl¸ž;¬c°ÇŠí Èl ärõä äÇ\+ß endstream endobj 4387 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚmÉ=‚` à’.žÀ߉1‘ÁD'㤎]…Ä‹‘8p n #¡~ $(}úö­ëL<ŸL²å¸6y6í-<¡Óvf{¶ÝÃÅšÅ\¶(â]Î׊p9% ED‹Ì-Æ4 ð•Óžgö&ëÉ{ô¼øâ!1îå¥qƒú?µ\ÀÜ P˜ùCÁµ#ýA“dZz–4Àu ×,iºÔu8‹q…/ÂaoM endstream endobj 4388 0 obj << /Length 190 /Filter /FlateDecode >> stream xÚ}±‚0†K:˜ÜÂ#pO`iÀ‰1±ƒ‰NÆI4º æ£ðõ®ØîKÿëÝùÓd¹Ê0FM•j\i¼jx@½˜%\îPPGL2P[ê‚2;|=ß7PÅ~¤K<ÑäL‰•s ´Â9×óËy|¥9#l K#‚vÓœ_ó[¹Z²½äC„N Ò_‹¦C£•èFôŒÏ,úa8è—‘[NÔøXT®®þQ­€ü÷âŠÝ endstream endobj 4389 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚÏ1NÃ@й°4¹¬—QY AÂTˆ (‘A‹ÃÍrÁå 3AzšWÌJÿ_¤ãæ”kN|y¹9á‡H/”–v¬¹Iû—û'Zun8-)\Ø™BwÉo¯ïVWg)¬ù6r}GÝšÅ3J•~ ZýôªýT™Mè¥Øa.åˆÊ)¥œ- ™oö̤Å/½ó`t™œÝÿ˜þRôø27ÈäVÖ¯½ifðöƒíh·¾hãÛ`+-·Rû¡ÔÑÒìNç]Ódvg9 endstream endobj 4390 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bCSC…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿÿþÿÿD|?€bØ0ÿ ÿAD}°ò€ÿÁ&> f0ñH0b!þO ¶ƒn%Ørv¸ƒÀî³?sóˆ?À>û æË `Ÿs¹zrríÇG endstream endobj 4391 0 obj << /Length 147 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b#SC…C®B.c˜ˆ ’HÎåròäÒW0¶äÒ÷Šré{ú*”•¦ré;8+ù. ц ±\ž. õÿÿÿÿÄÿ Øæ Œ„ † ‚ƒ`|$€lthv›bˆ)ØŒ‡6 ¢Žä£ÿQ Ø.WO®@.ÌŒ‡r endstream endobj 4392 0 obj << /Length 145 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bCSC…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿÿÿÿâÿHìó"ˆ Á€ƒø$`@±ØCLÁmQDýÿ ÿ!Ä( ,ÆåêÉÈæxô endstream endobj 4393 0 obj << /Length 227 /Filter /FlateDecode >> stream xÚÐ=NÃ@à±\¬4๬¥PY AÂT(PR$‚ÖÞŽkÍ ¸7eŠU†ÙI"QÒ|Åìß{;—Ý5袥ùŒº½´¸Á°ÐaC]8®<¿ár@ÿHaþVÇè‡;zß~¼¢_Þ_S‹~EO-5kVE*#TòÉPËŽaa¥'\¦BÙƒ°û‰«oè¹Ò\Qéõ4÷pf<á¢`2éß”²Oà$‡Ì˜gãßëíµúD> stream xÚ31Ö3µT0P0b#SC…C®B.c˜ˆ ’HÎåròäÒW0¶äÒ÷Šré{ú*”•¦ré;8+ù. ц ±\ž. õÿþÿùÿŸñÿ?cÀÀ€êÄÿÿÿ±4± Nàô%—«'W žˆ‡ä endstream endobj 4395 0 obj << /Length 108 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bc SC…C®B.crAɹ\Nž\úá Æ\ú@Q.}O_…’¢ÒT.}§g ßE!ÚPÁ –ËÓE¡þÿÿÿÿÿÿà >ÿ†Áޱ¹›ËÕ“+ H¨X~ endstream endobj 4396 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚEÏ=nÂ@àE.,MÃvN€m M,ñ#ÅE¤P¥ˆR%)S€B‹9QPr„ø.]¬lÞÛÈ¢ØOš·ÒüLÒÑt¦±Žñ&c&ú•ÈFRf1K~|þÈ<—èMÓ™DÏH%Ê_ôw»û–hþºPÔK}O4þ|©…3EÓµ¦s|–Æ@F öÄAÖ¤ÃØÈHaÀž8pnÀ…\]Ï­GЈ-8¶j<ì\  8hP÷Ãýÿø­žHF¬é–=a…‹,oËÚ>“U.k¹9‰s endstream endobj 4397 0 obj << /Length 123 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bCSC…C®B.cs ßÄI$çr9yré‡+›sé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿþÿÿ€L€Å˜ŒÁN|Œ?ˆ êÿÿÿÿã?*ûÀåêÉÈé f’ endstream endobj 4398 0 obj << /Length 177 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b#SC…C®B.c˜ˆ ’HÎåròäÒW0¶äÒ÷Šré{ú*”•¦ré;8+ù. ц ±\ž. õøÿüÿÀ ÿBü`°ÿW$þð‰ü{ª1ˆy Ÿ‘‰ùŒ0¢Ÿñ1Œh†í͇ÄqÑ|¼F¼‡ï™aÄ Ñ𕨠‚l¢è·?`¿!°—«'W ±,ˆ endstream endobj 4399 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚUÏ-Â@à%ˆ&c¸Ì 迨¤”„ P‚$ޤu½Ö’[GEÓev›¶ æKÞ1Çî»hÑ8º&nL؃-;CF¹XïÀA_ í>¡ôpŠÇÃi º?!å—&+ŒRå"c¢(ɉ(§N+˜ÆµGÍSroˆ‰›‚W\¯Š‹"­àЬæüÏ ¦+éÕtI…–ðߣmÅ›h5|Ö ¸üˆ‹¢dXB]/†qsøº‰| endstream endobj 4400 0 obj << /Length 170 /Filter /FlateDecode >> stream xÚÅ1 Â@ERÓx„Ìt³Ž)R-Än!he!VÆÒBÑÖä¨9‚¥EØq™Š†Wüßü7sžæe”ÓÄ”Ϩ¶xAæƘ‡æxÆÒ£Ù3šUŒÑø5Ý®÷šr³ ‹¦¢½¥ì€¾"h é`,ò‚T¤'ÀuID ˆ§x¸/„ˆ¶Hÿ ¡øÙ÷®î9 ƒ›Zª¯šëpéq‹o¡lª endstream endobj 4401 0 obj << /Length 174 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bSC…C®B.cs ÌI$çr9yré‡+›sé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O…úÿÿ0üÿÿÿˆø"þ3Åþ70`øH؃þ@‚ýŒ`?€#^¬„ùŠ^°Q`Cƃ-YÉ ²œä fƒ€² Ô$êÿ700€ F"Àb\®ž\\æ„wN endstream endobj 4402 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚÅÐ1nÂ0Æñ/Ê€ô–!ïÔ &HYj‰‚Ô •Ú©CÕ @°Æ9j1CäÇ‹KªÞ ’õìåû{iËŠs.y^,ØV\.x_Љ¬ÕÛœWËûÓîHëšÌ[KæEïÉÔ¯|9_dÖoÏ\ÙðgÁùÕ† ùƃHLd€ pÝLià¡'ÒîAi û?’NIû¬ iïÚ&tZÁéà0÷^gú±È…Ÿ¶X{c¹þ‚Y7‘öÉ01ÖÞñ¿<¶5½Ó ¯ endstream endobj 4403 0 obj << /Length 197 /Filter /FlateDecode >> stream xڕСÂ0à›jrfÐ{Ø::"#a‚‚ ‰€€îÞ e0‰XvtmC‚ùÄßöîOõh˜Ž)¦„Š´¦TÑ^á µ²aLiâOvGÌ ŒÖ¤FscT,èr¾0Ê–S²iNûf‹EN†`æÒY9†»Q‰¶3p‚qNÊNÙ3¼ÿ¶ßO0ïÉn‹ßè¶ ×ÄZ¿’J4½&}þ5tÊò›¦y+™A²ý ½-ؼ+Ô€³Wø2>z endstream endobj 4404 0 obj << /Length 236 /Filter /FlateDecode >> stream xÚu1NÄ@ E½Ú"’›a|˜„$ÕHË"‘ * D”H»$*â£å\!GØ2HQÌw€‰æÉãÿmÿ©«ãæT ©å¨”ºæDJÞsÕ ‰gõ­Ü?ñ¦åx#UÃñmŽí¥¼<¿>rÜ\IÉq+·¥wÜn…˜™åº2ûÐÌÌ4w„C0Mý€¤LúNÔéL”túAø ¨9ÁçÒ„Éa=tC¹6”8y€ÇF¢Ì›Ôa¥OÚ2éý/òaÁ<Ãô&ÄØùE>oùš¿åxv endstream endobj 4405 0 obj << /Length 124 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b#SC…C®B.c˜ˆ ’HÎåròäÒW0¶äÒ÷Šré{ú*”•¦ré;8+ù. ц ±\ž. õÿÿÿÿÄÿÿ¡êêð@†H0 zÂþÿ(Qÿÿ—ËÕ“+ +òT¬ endstream endobj 4406 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚÕË1‚@…áG(L¦áÌtYY +ÄD ­,Œ•ZZh´†£qŽ@IaGhôf'_ñϬ‹gÉ‚#}SËÎqbùléF.b27§+e™=»˜ÌZ3™bÃûóB&Û.Ù’Éù`9:R‘s)U*µH]JóíØý^‡¿w˜ŸøÂ¤Ôè¨%ÂH«´RQCôª/ê‰~ú´*hGo8‚˜ endstream endobj 4407 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚeÌ;‚@€á!$Ópæº,‚Š1q ­,Œ•ZZh´.FÇ5¸”\5šo’2ã¹s? ›šqòò98^Ñ}G›|ç»9^0ÈväÈV2#kºßgdÑfAYL{NöELi iÛwÐw?>Í,À¨Ì Ìʰ ]’ xB˜i ¿´LHäÊ›1VÞL0óJRþa”…¢Vèu¦èZ À¥À-¾òVi endstream endobj 4408 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚEÎ1nÂ@б\ MÃ<'ˆm ÕJ„Hq”T)"* L‘(i½–RøZt)¹G L±Úá±EáçÝïÝñŸW‹¥2Ã3ŸÉ¢”}ÉŸ\YVØÖ>ì>xUsþ&Õ’óg¤œ×ùþú9p¾zyì×ò^J±åz-NS={èÅkg`ÕgÉ?EJ €E£AJ>.½€dÝœÀôt &Ú¤JI¡0rÏî熻ÇqžMÎþ û›û5¬·.M_Íf…[݆{ÂG¨èZµ>’¯‰±_õ?ÕüÊW®Kq{ endstream endobj 4409 0 obj << /Length 192 /Filter /FlateDecode >> stream xÚ­Í= Â@à )Ó䙘ÿ"U F0… •…X©¥…¢mñb ¯a—Ò”)®³‹¨pØùà½)6 GqB¼Q@±O[ªÎSQ6{Ì t—&èN¹E·˜ÑéxÞ¡›ÍÇÄ9§•OÞ‹œªªA â‹î¬ì†q“©ÍÒÚÐð@# ~8 ©¡¸ôŽæÚØ7űÚdzm˜'cÈúðh„¢ü/–ämÙý¢:œ¸À“^[Õ endstream endobj 4410 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚmÌ= Â@à Óx„¸ ‰‚Õ‚?` A+ ±RK E[“›™£ä)S,;Îh%Xìûfæùh<¥” }å:exÅ\³T¿:8^pV¢ÝQ>E»’m¹¦ûíqF;ÛÌ)C» }FéËEÜ$ s­´àXBט^H”ȃ©ÁÃ@ž?|be¨®ŸàzY©E—ƒâÿðTZ_Õq×-`öRÅ!a~…ˆƒ„®K<.KÜâj/\ endstream endobj 4411 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚŽ= Â@…g°¦ñ™˜„Ä"•#¸… •…X©¥…¢­ÉÑr”aË€!ãN;±˜æï½GÓY‡®âg!ŸBºR¤³@[]/”òw%ä¯Ü”|³æûíq&?Ý,ØõïÝåLƹ©¿+ðx•ƒ“À—´€"Ò¡@±y‰Rx Œ-¶0ª±éþ~Ð*ž?¢uîmÖ½rç!0±ƒe¥æ] ÔEÓ`ç%ÐÒЖÞ*Åsz endstream endobj 4412 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚŽ1 Â@E¿¤¦Ik—9›°° Än!he!Vji¡h›äh%G°L2ΦÐÖ…}ðgÙ?of§óÇœêÅlS>'t#k5Ñ?œ®”;2{¶–ÌZ§d܆÷ç…L¾]rB¦àCÂñ‘\Á¤"iJzŒDˆÆ=á[5/”ÈjLAOåQ~Ñý‰ß¡@«B_ÕZ¯h4èÊJ—â5¡Î«µ^RMuZ9ÚѲuEJ endstream endobj 4413 0 obj << /Length 193 /Filter /FlateDecode >> stream xڕα‚@ à’.<} L— &Þ`¢“ƒqRG®â›á£øŒ—;[pqÓᾤ½´ý 5)+ÊHñ+•9ís<¡’^&¥|ìŽXLפ*LçÜÅÔ,èr¾0­—S⺡MNÙMC±€Ä  ÿ$z1Ú1Þwxï!"Ëûâ>ô<æôZ™iá&³N°?â>cíH ãRa¸ÊÉHŽ'c Ë:ÇÑ´m™¸O,Î ®ð —ºYK endstream endobj 4414 0 obj << /Length 201 /Filter /FlateDecode >> stream xÚmޱŠÂPEï’âÁ4ù„ÌìKˆ¬® ›BÐÊB¬Ôr‹mM>í}ÊûËâì}VÌ™;ܹ“ú³™i©“Ô¥ÖS=Tò'uÃù9&aÿ+óNüFëFü·â»¥žO—£øùêK+ñ ÝVZî¤[(²€ÂÐÛ f#2³;܃J>ÂPD´Cˆv@Z }•ˆ„‹÷c½C  ¤7¸¾Ð'Ð* 4u‘ö.æ7ú¹mp Ìb2ræcÀòÝÉZþI÷_þ endstream endobj 4415 0 obj << /Length 154 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0asSC…C®B.cßÄ1’s¹œ<¹ôÃŒ¹ô=€¢\úž¾ %E¥©\úNÎ @¾‹B´¡‚A,—§‹ÿû@âÿÆÿÿ˜AûŸz ñHð?°*;&põÿÿÿš4A€Åðk£aÿÿÿ[~ `1.WO®@.òÅ^£ endstream endobj 4416 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚ}±JÄ@†ÿ#E`š}!óšÄä”k.pž` A+ ±RK E»#›ÎÇðUò(y„”[,g‚²ìǰóÿÿÌÖÕÉzßòq¹áºâꜟJz¥º`;볟Öã íZÊï¸.(¿ÒwÊÛk~ûx¦|wsÁ%å{¾/¹x vÏ’€4¸ˆlnfxYé•DdöItÁ§S¶n\Å#7@efd=º`’El6X4jB*²`„éá¾fÀ}E_éh0‡íb•ôj“1SLÍ€,xÝ>v*‹Å!*:MÃö–Æ¢ó½:²?-y‰%Û§F‚Í@—-ÝÒ7ãè‚> endstream endobj 4417 0 obj << /Length 161 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcSC…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @¾‹B4Pe,—§‹Bý øÿ¬“Œ‘ò@dý ùóÿ? ùûÿ ùB~°o’äAdƒü ÉÀ$ÿÉ?Häz“õÿøÿÿÇÿÿIˆ8—«'W ƒzú endstream endobj 4418 0 obj << /Length 132 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcKS#…C®B.cC ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ì ò ØþÃÄ@òx@ýÿ@ü€á?×C1;}pýÿÿþÿÿÿ†A|.WO®@.üØO) endstream endobj 4419 0 obj << /Length 169 /Filter /FlateDecode >> stream xÚÍ= Â@…_°¦Ð#d. ›ÍŸ B Fp !Vb¥–жnŽ–£xK q\‘`eïÀW¼ïñЉ£~2â€cîé!Gš“·š¦ÎO¤j‰Ô .»m÷Oñë1üêâþdXˆ÷„ÈVîŽ|¹¢-M -è§úX endstream endobj 4420 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚÌ;‚@à%$Ópçò.¨H)L´²0Vji¡ÑV¸‰Wá(xŒ…[Æ_­Å~Éü³ó‡Á0ŠÑEŸ_ècäáÆƒ=’¹2Êb½ƒ4gA ΄Spò)§-8él„ôŒs˜ÃQ¹yÀ endstream endobj 4421 0 obj << /Length 115 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b e¨bÈUÈel䃹 ‰ä\.'O.ýpc.} (—¾§¯BIQi*—¾S€³ï¢m¨`Ëåé¢PÿÿÃÿÿ‰zÁÀ<Œˆúÿÿÿ7ñÿ,ÆåêÉÈî{\W endstream endobj 4422 0 obj << /Length 171 /Filter /FlateDecode >> stream xÚ½Š= Â@…·[˜&GÈ\@7!Q°1#¸… •…X©¥…¢õ^,7ðæ[n±ì8šÎȃ÷WÃÑ3ä‚r„Å9œAl&’ø]ö'¨-˜\À,¤c—x½ÜŽ`êÕ s0 nå¹Û =œî=Cê¿bq䙣Ò1 S¥e¬”ö‰K•vI'ì’ö‡mrÿ/)Tžòì8R`ßû¾‡¹…5¼ízfÊ endstream endobj 4423 0 obj << /Length 155 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcc3…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.O…úòþÿ¨ÿ$þÿ$ÿÿÏÀPÿD2þÿ`ß$ȃÈù@’Hþ“Èô&ëÿ?:ñÿÿÿÿ7 “q.WO®@.‹£ll endstream endobj 4424 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚ}Ž=‚@…‡XLÃvNàBL¬H·0ÑÊÂX©¥…F[Ù£íQ8¥…a†‚Îb^2ï}¹™KJ)*%³ K†w4÷Ò‹ó +‹ú@¦@½á)j»¥çãuE]íV”¡®é˜QzB[Ä_P¥ ¢:˜…ðá9o’.êAµ@9(¡dq%Ÿ»7@â'a¸ý/=ßµÓGÃ.^¬ÄTyhÆ ‰”pÁ A!\\[Üã>P: endstream endobj 4425 0 obj << /Length 200 /Filter /FlateDecode >> stream xÚ¥= Â@…g°¦ñ™ èfI"¦üSZYˆ•ZZ(ښͣä[.(w“€–‚S|Åæ½7q4HRYs_8Ö ù éL‘WCNâvµ?Ñ$#µá(%µp:©lÉ×ËíHj²š²&5ã­æpGÙŒs” V,ÈS*7;(& A‰]ƒt,¾à -À•ÇýGTÎÀµ@Û8×=ÓF–>¼®á ¡¯†¾$Úñ¼Ë_È¥÷ªùF­Ñ<£5½Þ¯ì endstream endobj 4426 0 obj << /Length 211 /Filter /FlateDecode >> stream xÚ­Ï= Â@à‘ ÓäÎ4 ÙˆVÀ‚Vb¥–ж&7ðJ{¯à Lig³ Z 6_ñBÞ¼Õq;éQH1µ¢.é„â­#Ü¡Ž$ )ѯO«-ö3 æ¤# Æ’cMè°?n0èO$éòÓ³!W© É¾Èùb Á|3à1³õP¢_6Äæ¬ri©Ölxz+=Õ>jO=®Ù]qÝu¿ôìªÊç÷B·V–ŸÅ´~…º[ëÎÿ)×DÅ\|kse8Ã'á·vG endstream endobj 4427 0 obj << /Length 158 /Filter /FlateDecode >> stream xÚ­É1 Â@ПJø—ðŸÀÝu£Äj!Fp A+ ±RKAEëõh9J¼AÊÁqc!Ú[̃™Ií`4-ØԈËÞð™m»îjw쎜{Vk±«y\Yù…\/·«|9ê½e_Hx’+5ÐCôÑ8´äÂ#‚$ÒRC®¡¹šˆ\õ¡ì¸ÿBÿ"¨¿xo<ó¼âõõIw endstream endobj 4428 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚMË1 Â@ЋÀ4!s7q5Æ@T0… •…X©¥EÁÊÍÑrr‹ñ,,Þ2³óÿÔŽg©D’€MÅ&rŽùÆv‚=ê×þpºr^°Ù‹°Yã—M±‘Çýya“o³YÊ!–èÈÅRÈùr¨êGB®ù7 }Kïÿ´D#"×eZS¨¡W¡ÿ!§ˆ("P÷B Ca÷£}­¢9ª6A«ª=> stream xÚ31Ö3µT0P0bc 3…C®B.cS ßÄI$çr9yré‡+›ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä€Àž¢þÿÿÿ @ü¿A€ÅH2…‚ù`€hàÀ ß €AþAý~ [@óÿ Œÿ€LxÀÀåêÉÈþ:B„ endstream endobj 4430 0 obj << /Length 148 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcc3…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.O…úÌÿþÿ`ÿ…¬ÿÁ $0ð()DÚÉ? õþÜÆðêdƒ=˜”ÿH2ÿcÿÏÀåêÉÈÄ£d> endstream endobj 4431 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚ5Í= Â0ÀñW:oéúN`ú¥ÐÅB­`A'qRGE7©…^Ì­×è êØ¡4¾Ø”É? ‰Âé,&žQ@áœÎ>Þ0ÔÍÓ[}pºb*Qì)ŒQ¬¹¢zÜŸévI>ŠŒ>yG”½•¥:ÅôJ•^ý›]ƒS |Á-,ZHZX:È^<rœ[CÂ×Á准’qÊz¤b&Õg¤aì¦QŒ¥À½†¿À•Äþ$›Lã endstream endobj 4432 0 obj << /Length 174 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcc3…C®B.ßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.O…úÿ `Ôðÿ?ÃÙaCÄÙ00~ @2?ÀDv`²N2~¨+þߎ ¿#Èß``’ ?Ÿ‡“¿¿G#«¾g``¨?øA6 Hû†@Rž¡†ËÕ“+ Ém¢ endstream endobj 4433 0 obj << /Length 202 /Filter /FlateDecode >> stream xÚEŒ; ÂPEoH!Lãœø£‚UÀ˜BÐÊB¬ÔÒBÑN!…Û²³t î@Ë!ãL@,ÞaæÌ»·µ{¸£¯Ûá¨ÏÛ™ lµÃfOÄܒ£¹©ZrÉŒOÇóŽÜp>âܘW!kJÆ‹/ŸLnRüQ;”H¡(Ô+€Øû­Üp{Íçh¼¯€/ O ¨.†êçê«oŸk> ¹¶´¬4¶ú…¥4Wè¬&F&ž”™äRŠ¢ª§ÚÑ$¡}¨xY& endstream endobj 4434 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚEαjÃ@ àßdˆ‚ÁzöìØ)ÍCšB=Ò©CÉ”dÌÐÒnÆvÈÐ×jé‹:tÍ&É=Žûîî$%ñÍpÄ!ø:ºãdÀñ-¯"z¥X£!—Znh’‘yæxDæQâd²¿¿}¬ÉLæ÷‘™òKÄႲ)—Ö³µ[{²v§È­õöð+ïðOPy5À‘ Æ@®²äÌ©¤äUíð·-Gÿ[ùÙ;z¿Êßàµ[*ö‚l”ãŽBÉ;¥v\ɼHer”;åSú¾H‹R §Z88 ¾~íKôÑßÍa{ endstream endobj 4435 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ}Ž1 ÂP †S2Y<‚9¯Å*B¡Vð ‚N⤎Š®­Gó(ï¤Ï¤c‡|?!?É'ãéœSžèä3>gt#Í”»Õ§+•žÜ^wrëŽ~ÃûóB®Ü.9#Wñ!ãôH¾â"Æ…ôPŒ‚¢x+š—"B I À/ >Š¡€i`˜¦$fà_£…$hŠ¡¨†¢Šj(ª¡D{£{-ÐÊÓŽ~æêb° endstream endobj 4436 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚ= Â@…_°L“#8ÐMLRØðL!he!Vji¡h'š£å({„”!qœ-–6ß²ó`ö}›ÄÃtÌ!'<ˆ8 9ñ1¢ Å© å»äp¦iNfËqJf)c2ùŠo×û‰Ìt=ãˆÌœw‡{ÊçŒÞ@в¶^m ´­…ו„û•W÷¨”x:ô däTLdOñ”€_Öû'¤X`–*ºw]!WÒ¢qµ½z¨‘º9KõUóïÐ"§ }}dà endstream endobj 4437 0 obj << /Length 141 /Filter /FlateDecode >> stream xÚ31Ö3µT0Pac S#…C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]Øø XŠí¸ˆÿ7001;×ñ¾Äójä‘Ô®ÿÿÿÁÿÿÿ?À0ˆÏåêÉÈÅFJÜ endstream endobj 4438 0 obj << /Length 222 /Filter /FlateDecode >> stream xÚe1N1Eÿ*…¥i|„Ì ð.›-V Ab $¨(U ¤A›Ý£ù(>BÊÑóÓ„,?kÆÿWíEw¥µ®¸kí.õµ‘i;¯O%/¶ï²$=iÛIºó®¤á^¿>¿ß$­n´‘´ÑçFë6Šx0ڄʬ ˜íÍŽX⌾T†~ÂèËϰœfGvÄlŽâgØ×ÎOÈ —˜À<|žðHTGÇ‚+î©¥µ§Ë‡D5ÿWôTŒL3ü*Ù¡¸=·‡2šÿÐþ‚½,·ƒ<Ê8hñ endstream endobj 4439 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚEнNÄ0 ðÿé†J^òñ @ZÚHH•îC¢L ˆ @°Ò>ZåáÆ§úl·ÀŸDZãTåe}Í9W|Qp•s}ů}PYkP·å|òòN›–Ò#—5¥[ SjïøëóûÒæ~Ë¥?œ?S»c„€Nz¬DÈDF‘â˜Mˆ&4=:4§WâLì• «hLºVÆÚšÄQ—5Aýâ1;Í,òw×Ki üs°Ä™ãÇ…à Îdw;«Ò-¯—y"ŸÍ§\Û¼>¹ÿí[z 3áVc4 endstream endobj 4440 0 obj << /Length 181 /Filter /FlateDecode >> stream xÚ•Ï=‚@à!$Ópæ.¿ bâ&ZY+µ´Ðh £pJŠëL±hë$ó%ó^5YºÌ Š(áÍʺÄxÇT²HN)Î7¬4ª¥ª §¨ô–ž×Uµ[QŒª¦cLÑ uMþÁÄ„B9ÓÌÆ›‹‘ñGÐ3aç(if ãMŽÅ( Œ/½#ì˜`Ëc„÷—V2öOZË¿Z;ý®5îñÜþtý endstream endobj 4441 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚ¥Î= Â@à‹À4{„Ìt³&)!à˜BÐÊB¬ÔÒBÑÖ,x¯’£xË’qFEÐÖæƒÙ}o“¸v)¢„ZŽ’ˆRGk‡;ŒSʱóÚ¬¶ØÏÑÎ)NÑŽeŒ6ŸÐaÜ íOäÐiá(Zb>$Ã\CÈÌßÈÌüǹ.ì5ïªTʺ)ñ7¢ ½œùPÐ €ù\è)'…ߘ'å-,e›ù$9óÒ‘• i«ÌŒþ `¾AƒYÒ Öš G9Îð-²c— endstream endobj 4442 0 obj << /Length 241 /Filter /FlateDecode >> stream xÚmŽ1NÄ0E”"Ò4¹ž @’T––E"Th+ ¤Ø´±æ£ø)S„ ãÍ“ü=3ÿuíEÅ5w|ÞpWsÉ/ ©í5ÔgûýóüF»ªGn{ªn5¦j¸ã÷ÓÇ+U»ûkn¨ÚóSÃõ†=6™Ì@! `dÕHpÑë³Îç³¢˜¢¢Œ°0g0º°¿p ã†\ÏF<'Ÿ"D´MÖbLz[‚Îë€õZj6]*7DEñã?°?(£j”A…LP5ãË GÕÔ¡˜µ(O•Y*GÒ@BRƒæ ›è þ5pI endstream endobj 4443 0 obj << /Length 183 /Filter /FlateDecode >> stream xڕͽ Â0à+Â-¾Þ hÓ NB­`A'qRGEÁÉöÑú(}„ޤzW©Eqñ _Èå~3°#ò) ¾¦À';¤Æ#ËI~š×Ïö€¡Cµ"cQÍ8ÊÍé|ºìQ…‹ iT­5ùt]ãÁ‘ Ù'é`œ010%p1ßà ­‚içBÆt*R¦—€t 2;nB)¼û½¢¦•×4㪙_T+~Ѭý‹.œ:\âãM† endstream endobj 4444 0 obj << /Length 213 /Filter /FlateDecode >> stream xÚ}O» Â@œ`q°M>!ûz‰I «€0… •…X©¥…¢­É§åSü„”Áõ²W؈p w»3s3Y:Ê'sÆÃ„³˜ó1ºPš»¡{¦~s8Ó´$»å4'»tc²åŠo×û‰ìt=ã„ìœw Ç{*ç Ó(¤Džˆ¼`D:„y#jAÔ BQ»SQ]9h@ø”¢9…׆mðÆ 3/"-PIÿoÓ™n•§ ÕªË×ÙñÍó?|ÉR3{¿¾‡6ÒnÚRûúæ}Z”´¡ëån endstream endobj 4445 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚm1NÄ@ EmÉÍa|HB’b«‘–E"Tˆj¡¤`í&G›ŽkøéHÅü 4ÒÓØ£ñnêóv+¥4rVISJ{!O¿rÝ¢‰²þ~9¼ð®ãâ^ê–‹k´¹ènäíøþÌÅîöR*.öòPIùÈÝ^(Ÿ‰(`)3SÚ˜èç¹1›É+-:%ô8p'?, ó\üú‡%ᔀ^Ê‚úH½"È4Ÿ)ÂM¡ñ©úP¨9%7¹Hiè/üŠ!©¯ Gó«dLºâ!n&{„ÁÈë•|ÚÒöÍ J™MøÞc_u|Ç_ž!r· endstream endobj 4449 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚ¥=‚@…‡PLÜ è²ÈŸ bâ&ZY+µ´Ðh«£xJ Îd)è-¾bß›yó6šÏâ¤3šf%gtÖxÃ0e5 $¬Ó ƒjOaŠjÍ:*³¡ÇýyAUl—¤Q•tÐÑ”àÔîÀg&Ì›ß}NÇr à5ƒÅr^± ÅaÛý2󆿶ã“Ê®ä`‘Õ׉iÿ`œ•»r_zHé&=¥¯| z)3”óWwøFHH— endstream endobj 4450 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚu1‚@EÇPLÃLœ è‚ÁÊ1‘ÂD+ c¥–&j´ŽÆQ8%…gd•B-^6™ÿgþß‘;ðÆd“Oý€\¼€öžqðÇ~£ìŽƨÖ4 PÍyŒ*^Ðõr;  —SrPE´qÈÞbt ÇLR~3&0 £è> stream xÚUޱ Â0ES:Þ¢Ð÷¦µ±ÐI©Ì èä Nêè è&´ŸÖOé'8:knh †ä@Î}7D%“YÆg¬X¥Øç˜n”¤ÆE¬¦68])×$÷œ¤$ׯ’Ô~ÜŸ’ùvÉ1É‚1GGÒ ³æxos «ï*!‚¯¹…ø¦÷~‡ÑÖù²ŽZoŸ(kÌ ‡²B" PõÑðqã>´.îÛ¶ø{€°xcA+M;úç–=Ä endstream endobj 4452 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚU޽ Â@ ÇO YúÍx­w8jotr'utPÜê£õQúŠ5I-Ôåù$±f2›cŒ-ZƒÖá)+GZŒv*Æñ™½Cã@¯Hí×x¿=Π³ÍÐ9îŒàsT/¥Ô¨"ŒkFÃ㇠ZFQ"¶Ã7!Ø\LÅ®{»kwÅ; #e´%ç(𮈻iõÓÇÜ›^/ªaTtY!ŸÉ)yçÉ@,=lá M>k endstream endobj 4453 0 obj << /Length 156 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04QÐ5W0¶P0µPH1ä*ä22Š(˜™B¥’s¹œ<¹ôÃŒŒ¹ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž.  ?ÀèC Õ10Ø‘=ƒ<50ðCÐvzÀÀ G!è†qØM„‡ÕD¸qXM„Dr 2\®ž\\&Š;* endstream endobj 4454 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0QеP0¶PÐ5RH1ä*ä26 (˜A$’s¹œ<¹ôÃŒ¹ô≠ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ìÿÿÿÏP$þà 0,ÁåêÉÈö•) endstream endobj 4455 0 obj << /Length 148 /Filter /FlateDecode >> stream xÚ=É1 Â@EÑR~“-¼ èäg”`£#8… •…¤RK EÁJ³4—âRZ„ŒÓ(œêÞ‘Ž'̨–Íi•ª<¨œE‹3æö÷ö')˜-µ³ CŒ[ñz¹Å”ë9ULÅ2«ÅUD‹¸CÒ#õMx‘fÀx¢ñi‹çþß î€,œlä õ‡* endstream endobj 4456 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04F– †† )†\…\@Ú$l‘IÎåròäÒ pé{€IO_…’¢ÒT.}§g ßE!¨'–ËÓEŸÁþ@ýúÿ!Äncàrõä 䄬e endstream endobj 4457 0 obj << /Length 118 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0S04S01S06QH1ä*ä2 (Z@d’s¹œ<¹ôÃŒ-¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. òÿÿÿÿc$þ!°‘ ¨øÿÿ Àb\®ž\\ÏŠ>à endstream endobj 4458 0 obj << /Length 102 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0"3#C…C®B.#¨‚)T&9—ËÉ“K?\ÁÈ’KßCÁ”KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓE¡þÿÿÿÿÿÿà >—«'W ²©$Ì endstream endobj 4459 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ31Ö3µT0P04S02W01V05RH1ä*ä22Š(™B¥’s¹œ<¹ôÌ̸ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ò ü ö ò ö öêQqC=C=2Ãp\ÆàÀñ†   \®ž\\Õ8æ endstream endobj 4460 0 obj << /Length 205 /Filter /FlateDecode >> stream xÚmÏÁjƒ@à_<sè>‚óQ‰iZ &…z(¤§BNMŽ9´$7ÍGÙGØã$f–+–ù`f`ù'ϯó³TºäE‡„~(Ù=iÝâûDEIѧ1Eï2¥¨üàóïåHQ±]³ôÞ%ï©Ü0ð TžÓù‚õõÏ‚ Ú¾QmÐ÷} WG?p…j2ü6µ€êNŽÈ`ÇÔž}Å}gvÀä‚öµjèPhCLQmŽQ€ÿ +àI.½•ôI7y-q¡ endstream endobj 4461 0 obj << /Length 273 /Filter /FlateDecode >> stream xÚu±NÃ0†Ïòtyß @¥!°ÔR)`b@LÀÈ‚ 5ÞúXñ dcÄ£‘¢çÒÒ‰ÁŸìÿ¬ûî&å~uD9Õ´WÓ¤¢ên |À²–0§ƒê·rs³³K*kÌN%Ƭ9£§Çç;ÌfçÇT`6§«‚òklæ :Aò¬P<Ê‹ÙaîÀ2÷Ð~½z`³ôj0:hoTн Y¡“,ílR7Ý"fSíÒ®_‹øÇ¢‡Åâ¯á°®@œ¾c9´ò1XÊ·£¼ôtíX Žu¿Æ(c¹Ar³°ˆâ6yÀ.ߟ!nÕC½Iœ@­ŒqqHÝf Ø`Wž4x?lÿ„ endstream endobj 4462 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚUÌ=‚@`6$Ópæ.?’`# bâ&ZY+µ´Ðh+œL9 G ¤Ø°Î nñ¾ÌÌKfÍâúQæ!Æ!^¸C”ÐîëUçdø£ø†®ÀÅŸ×x¶[a<Çc€þ DŽ–eI ëÛÄ™p?šïˆ×“éÄR󞬱§öÊ?ÜjÄ+ R¥ I}ëi*»qúèÔD!™jUÇ”T­¡©¿ÁZÀ~'dØ endstream endobj 4463 0 obj << /Length 222 /Filter /FlateDecode >> stream xÚmбnƒ@ à1Dò’GˆŸ @ C§“ÒT*C¥dÊPeJ;vhÕ®GãQxF„kû²D‰d>á;Ýñãòñ¡zâœ×ú”WôM¥õ¹µörú¢MMÙË5e¯ºJYýÆ¿?Ÿ”mvϬý–ß ÎToHˆÈèNî [`ÑCZ,{µÃª3ïVÜZµwŒ¼ ³™LæR¿D·Ã%Ú»º{F:™ÉlZY<ÀߨFãåÉxmãžÝéhÒÁîW£ÿõÞÆ IÄÇÓxLz©iOÿ¸Çñ endstream endobj 4464 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚ¥Ð=NÃ@à¹Xiš=‚çà˜ØB‘,… á * D)S€ µ÷&\Å7ÁGHéÂòð6.‚DIói5û3o¶X—k]꥞åZ¬µ¼Ð×\Þ¤ÈY\j¹šw^ö²©%{Ô"—ì–eÉê;ýxÿÜI¶¹¿VV·úÄ;ÏRoðƒÐN>`aö˜}x3 H‡”V½£mH¨ñâbŒ&oÃNúhà»h:€+T¨p²=Úüq::þϤ‹º>¾F›_²/C2ã1eÂyaÜ:ÄùÜèã#fœÃÉ`ÖÅèx–!7µ<È=c endstream endobj 4465 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚuн‚0ðkšÜâ#xO `âD‚˜È`¢“ƒqRG®À£ñ(}FB½ЄĤý¥ÿ~¦øópE.-¸K =ºzøÀÀçìšh.wŒStŽøèlytG¯çû†N¼_ç„N¹gL‚\kÐZ—ÖÊZƒ™o¤’-ÀT c Úš[£âçìÛº8RõòfÉÂ_yOwyö_¾ªµ6ƒ|pd‚mAÔ&²Â:©­•QV&òƒ£Ò˜¬ÐöëíP€®$> stream xÚuÎÁ ‚@àÂ\z'HÅ Á òÔ©CtªŽŠºEúh>Šàуh³kˆeͰü³°;ÂûSrÈã#&ä»ttñ‚Bpvd”‡3†1Ú[í%OÑŽWt»ÞOh‡ë9qŽhç’³Ç8"h¸re¡)¡¯‘ƒQÀ¨5“ñŸVzV \¿4Ù ¤0°i:“·uç“ûÓl3%üRk-Le00½µÏöåøãæËJÍKÀEŒ|ñ}xB endstream endobj 4467 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚ}Ê1‚@Ð!$Óp™èBBE‚˜Ha¢•…±RK ¶.Gã(’‚¸Î.ZHÄIæ%ÿψÙ$ŒÉ§)¯ˆ) èàEÄÙ×QgLsô¶$"ô–Ü¢—¯èv½ŸÐK×sâœÑ. yF •R 0ªýRG5X-ØXÍ NPƒSÏnil¡Ó•b“EOþÒ&¬4>ÀíØ=ŸÆöŸVgÓWªÊX³Ê(ßê9nðón endstream endobj 4468 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚ]Ð=NÄ0่4MŽà¹8!U¤e‘H¢b·¤D±Â9Ú%Gpé²!±4_ñžfü³jO»K®ù‚O^swÆÛ†^©í%¬¹k—æù…Ö#™n{27“oùýícGf}wÅ ™ ?6\?Ѹa@Ï=ü*Å€2¥€*£ :À¢ ˆ(}!½Wj¡t™Y¨W=-ó0ð‹Í|3á?*¹|ÿ—Ÿ z†clÞbó¾´`Q$9R “Š2S ³Ž¨œù}Q:¡Hq/“þ3@×#ÝÓ7çp@ endstream endobj 4469 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚmÐA ‚@à'.„·é¾4ZŠ´Ì Yµj­ªe‹¢¶i7ó(Á¥ qš§ 3üo~f‚ù4\G3½C½|:ûxà ҹ|pºb"Qì)ˆP¬õ…ÜÐãþ¼ H¶KÒ9¥ƒOÞeJ5 jPÊRÍÈnî|À-`ÒY€››s.°9Ä`6.°¯?•¾ðgÖ[÷êÂ@KÛ´Ö`UfíŠ lviÖ)¹À–üÊ¡™‚öÞJìæ¸’¸Ã/V± endstream endobj 4470 0 obj << /Length 156 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0b3SC…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ€|…hCƒX.O†úÿÿ0üÿÿÿcà?ÀÀÀ &pö`‚Q"êpÿ@Ä#˜øƒ`pì`â2Qì¿pOþaàrõä äIVR endstream endobj 4471 0 obj << /Length 239 /Filter /FlateDecode >> stream xÚUϱNÃ@ à¿êPÉK!~’@Z©K"•"‘ &Ô ZÁ¹> stream xÚ31Ö3µT0P0bcSC…C®B.c˜ˆ ’HÎåròäÒW0¶äÒ÷Šré{ú*”•¦ré;8+ù. ц ±\ž. õÿ00üÿÿ™‹1 ì`â‚LÀAȃ‰„=˜`ÀAÔƒˆ:\Ä?ñ‡ÁDÔ¡ÿÁÄ Qÿÿÿÿ?ÿQˆ ±\®ž\\Á˜[É endstream endobj 4473 0 obj << /Length 242 /Filter /FlateDecode >> stream xÚmбNÃ0à?Ê`é–¼Aì' ¤ª¢X*E"LSadÈ`µy^ÉoÀ+dc$¢–sŒT@•|Ÿôßù»89šžª‰:æšòÉÕ]NTÌ8ÑV4¯)[ªbFÙw)«/ÕóÓË=eó«3Åy¡nr5¹¥z¡°é ìzÈí^½ÅÆAHœ¿ ^Ù_öŸÑk¢O mb¶2ñ{Ë o)Þ¼IP¶X—’5•”`ÓÑj´5Ò†uiSyû½² ®9iÙ^ZÃ&­WÀ‹ÄÁŽW9ˆ õ+¿å§ûo w }:¯éš¾ˆ¢{{ endstream endobj 4474 0 obj << /Length 221 /Filter /FlateDecode >> stream xÚmÏAJÃ@à¿tx›9BÞ šFSŠ›j³tåB\U—.”ºjir½‰ä(s„én„¡ãË š…ÿ}ðÿ³šâ|2»à)ŸÉÍ$9?åôJÅ\z¨ÝÃú…–e÷\Ì)»–•²ê†7oïÏ”-o/YúŠrž>RµbÔµƒ·ðGx×+£$qP-Tô ªú8aÚ ý ¦Hñ«Ú”@\¨fñgm£{`Ü%íNGõP¸ iÛk,FÓû=pk0Žjluo-9¢Ôðþ¿m·Ë骢;ú[Ê| endstream endobj 4475 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ}ν Â0à+„[ú½'°ÿ‚S¡V°ƒ “ƒ8©£ƒ¢sóh}”>BÇ¥ñ.EÁ†ËÇý$$q4MæäSÄ;žQÐ)À+Æ!×¾”28^0+ÐÛQ¢·â.zÅšî·Ç½l³ ®sÚä°È ´Ö Ä,¶5yoÔ“ÚfJN©Ñ­>¾ãÕTåHA¶±-£ÝIÓå?”ò±6*‘°<”+¼º1­ÁvL{°ùµÔ¢yõˡ˷øäjÒ endstream endobj 4476 0 obj << /Length 244 /Filter /FlateDecode >> stream xÚmÐ1NÄ0Ð¥ˆ4¹8I±U¤e‘H¢Z()XA»ö 8W‰DAÉr„”)¢5c‡H€ÖÅ“5¶ü¿\Ö+.¸äÃU͵áCÏT•2,¸.ç“í­[Ò·\•¤/eLº½â—Ýë#éõõ9Ò¾3\ÜS»aXà½wÑ>:@æ~²^M€ê¹¤:ÌÚ_6‹ù¬;â~±qá…ÉLÇ ‚VrﻘëðÓJöX&{بäÈ#’‰Iz³c&ñ4ÃÍÿ~¸àg'ò¯.¿ýÑz¨w'©ÊÏÊ—¸ì EJsY#袥ú´}× endstream endobj 4477 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚmÏ1JÄPàYR¦É |sÍÆ}!°®` A+ ±RK EÁÊ—£å^a2Å’ñŸ‰‹6É̼yÿ‹«£úT–å°’x"õ±ƒ‰pÂ,ÑÎ\@Ç_³Ùès/*g.ù ù)¨&éÖL“ÙøOPëãv˜Y´µ‡ùÏì`nî ÿ,ß{à·ùOÄ›Mx±[l)õz»i²ç&µ$©vªX?zÎÌòEË7ü }„t£ endstream endobj 4478 0 obj << /Length 163 /Filter /FlateDecode >> stream xÚ31Ö3µT0PaS 2TH1ä*ä21PA $‘œËåäÉ¥®`bÀ¥ïåÒ÷ôU()*MåÒw pVò]¢  b¹<]ìÿÿÿÿ¯HüG#êìêÿ1Ô3Ôÿa¨c¨ÃFT0üc°a`øÃÀ€•`?pÌ`â‚L<ÀAðƒ‰8y0Ñ€LðÿÿdüÿL€Å¸\=¹¹7X^´ endstream endobj 4479 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚmÏ= Â@à‘irçºY“€V þ€)­,ÄJ--mMŽ–£ä–â8“mR,„Þì›d“gãbF)Mid©˜Paélñ†y&ÃT'ÝÉéŠóÍžò ÍZÆhÊ =îÏ šùvAÍ’–Ò#–Kª¸vÜ07·}ý> stream xÚU̱ Â@ à”B–>‚y½;m§B­`A'qRGE7iûh}”>BÅA‡âyM½ŠIøù!þxLH’’4PðìžÐ—Ôt0úF»#F Š5ùÅÜÜQ$ ºœ¯ÑrJ ELEr‹ILY Ù[¿A3š7¾yx…¥Ïä–ZJÈÒ–^ µÅyY\¦²˜ü‹Ç-nÕÏ-!ü‘vÜjËýÕQ8¥áÉÍäÿ€)Æ|œ%¸Â\0ok endstream endobj 4481 0 obj << /Length 197 /Filter /FlateDecode >> stream xÚUÌ; Â@à?¤¦ñ™¸ ‰«` A+ ±RK E[7GËQr„”)–Œ³Øh1Ìë/òÉtÎ)—ZEÁyÉ—Œî”Ï´OCç-*2Îgd6:%Smùùx]É,vKÎȬø˜qz¢jÅH€HƒH¤C,â10êã\ÀÖq‡¤ŽEÏÿqRc,ŠS4EB€è¨µH<,l«)®o ÿËðe@ä¡ß®±ú¨)]¢ôšîúX¼í!í¸£uE{ú³/^q endstream endobj 4482 0 obj << /Length 212 /Filter /FlateDecode >> stream xÚuϱJÄ@à_R¦ÙGÈ> stream xÚ•Ž1 ÂP †q(d°Gx9¯¥OA ZÁ‚N⤎Š®mÖ£x„ŽÒ˜Á!$!ù¿'3NØ*Φ|IéNYÐ>±Öç-KòÎùNÉ—[~>^WòËÝŠSòSNNT ȈD'Ò i!Š4y;ì‘·ÑGwp{c×ȃjCeè ß s»]Ø—ÊžZž†º.þ"US³“‚9©-­KÚÓ¦IÆ endstream endobj 4484 0 obj << /Length 218 /Filter /FlateDecode >> stream xÚeαJA àÿØb Í>Âä Ü]vÏÃjá<Á-­,ÄJ--mo|±é|y§¼bœ˜áÄC®ÈB†þdyÆ-Ÿj /;~ìè…ú•æ¶Ä2xx¦õDÍ-÷+j.µKÍtÅo¯ïOÔ¬¯ÏYó†ï:nïiÚ0Ùýêñs ü’#ŸV¾œH€ˆø…|ˆ¯Ä›œ¯Foý;sŠ+lqÎ…¤à÷Ƕ÷d,²6ª‚ɺY'=alp µ¾Œ+ù–‰Êè%ÐÅD7ôpë endstream endobj 4485 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚmŽ= Â@…'X¦Ù#ìœÀMX£XüSZYˆ•ZZ(Úêm’#X¦Œo[±Øf–÷æùa5•B&x#/~,§’¯ì+ÌEÓÇñ³†ÝN|Ån…-»f-÷ÛãÌn¶™KÉn!ûRŠ7 !ÒH”ë›ÈꇨÖ+UÊ4jôdcÞ‘‰æM¦µ-å­@l_ Ϥô"j‰~Ð' f& Ê”Ö74˜.WHÁe °Ê4ù½’©A— où \s`¸ endstream endobj 4486 0 obj << /Length 181 /Filter /FlateDecode >> stream xÚuα Â0à+ ·ôzO`RL'¡V0ƒ “ƒ8iGE7±}4¥Ð±C1Þ…:”ün83d3Òdäf”¥tJñ‚F“Žòq> stream xÚmαNÃ0à‹2XºÅà{H¬¦.X*E"L0"‚5)oÖG1o`‰Åƒ©¹saAõð ¾ÿt7;ž/¨%KGvAÝ)ÍNèÁâ v=ÿ¶4ïG÷O¸°YS×csÉÿØ WôöúþˆÍòúœ,6+ºµÔÞá°"à§<€ .L)'¨rfë¢Îù;‰î“õÚGpåŸaF¨Ù]1Píõ¢.š­ä;Á´a?2ÈyWL ǹGõ•9^ÖþÄjoÉó.G¥ò¤8Œ¸2T‰Já‘=ã"b<èXL’á-Ϋ(UM+®eÊýw1•ëÒEK[¼ðÙzA endstream endobj 4488 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ}Î1 Â@ЋÀ4Á9IH,¬„Á-­,ÄJ--mÝMoð¦L2ÎL‚ö±vY~ Gc 0äG8 q bÉD9ìŽðׇàÏy ¾Yàå|=€Ÿ,§È9Å ¿Ü‚Iѱ…ËÊ_­êª½ÆâŸ^cÞÖfì“8y/âû>Éß_[;b¥–â Psõ®fm]vÒ¨íº”¾V½i».¥o­VÚ·¥¥Ü[e¤Ú2‡™¼ ¹t6 endstream endobj 4489 0 obj << /Length 156 /Filter /FlateDecode >> stream xÚ31Ö3µT0P0bcKS#…C®B.cC ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ì ò€øƒ=2>çgÀÿÿg`†àñzÑp=×aÁÿ€ø&fᘘ„?Àqýÿÿþÿÿÿ†A|.WO®@.ïûJÏ endstream endobj 4490 0 obj << /Length 230 /Filter /FlateDecode >> stream xÚ}ͱJ1à9®X˜&yw×Ýl œ'¸…pVb¥–ŠvbÖ7[ñEâ(6W77V8±0/™É̤möf‡Rɾíö@fµÜÔ|Ïmcq…×w<︼¶áòÔ²\vgòøðtËå|y,/䲖ꊻ…PLdK?ÿ³“ìt4ýg1:üVuÈ&*Þ Ëw×#ïú¦ºÞ%è{"ßo¬×OÖpº‚($BòÁJ(D|p¤0hÚùÊðŽ®øšÍs^>Û¹3˜k¸•ý ÝðcÔ¤RýP5¿²¸y>éøœ·ZsY endstream endobj 4491 0 obj << /Length 154 /Filter /FlateDecode >> stream xÚuɱ 1 €áŠƒÅG0O`¯\opÎì èä Nêè èjûh÷(÷ŽblÂ-ò…?ñå´šaUŸ—Óƒ+”>·$?Ž¨Ø–ì*_Á†5Þo3Øz³ÀÜ î šH1D¯>‘1Cf$t c¡U˜Ia.…È<5¾ÌGa ¼ûD"JLKLü“`` ?:•RŽ endstream endobj 4492 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚuÊÁ ‚@`Ń0Áy‚Vq :f‡ N¢SuìPÔY£Ó7|;µÁâ4kuh¾ýçgd4ˆGôOÆ q¤ì^Í·=@’X¡” fÜ‚Èæx>]ö ’ÅC)®C 6¥èh¿[®¦Š —¨¡’}PíOmåwjØŠnì•ÖîØÎÖ¬¶ÕGe·¿rÛºµInùOsá•&yÅ?Í…_˜ä[ßæ*o©&+jIÓÓhò»‡iKx—‚» endstream endobj 4493 0 obj << /Length 180 /Filter /FlateDecode >> stream xÚmÊ1 Â@Ð )ÓxçnBVÁJˆÜBÐÊB¬ÔÒBÑÖÍÑ"^doà–)BÆÙÕBÁbÿFåƒáSÌøTŽù÷œ@ùžúêÃî…¹F•œó R/ðr¾@Ë)òZâ†?· KŒ¨6•ˆéA–}’c‰Eî-Û ol¼}´Á:X}±“·"jþ³&x±ûoÂvÁV$öGCÖëˆ* š~‡™†¼êõf endstream endobj 4494 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚmŽ1jÃ@E¿p!˜f°s‚¬ÄZ1®d¢"W.B*'e »öh{A¥ ¡É(&E óàÿaøíª-¼Ñ]{öü^Ò™|¥ºXär8}RÝ’;²¯È=©K®}æëåöA®~ÙqI®á×’‹7j$¹ô€•2©%32É« ]Ì„hzØdL²¦úsÇ×_Lÿä_ØÄY£t:wÌjh^Hù;„F´U.Úo%m¥Z”ö-è/LRz endstream endobj 4495 0 obj << /Length 230 /Filter /FlateDecode >> stream xÚuνNÃ0ð«:Dº%à{â„:&Km‘È€bj@°’¾y?BFiŽ>@U¥JÖOöÝùîÜò¢¸‘L—²È¯Å9Y^É.çwv™î/·}ãUÉöI\Áö ¶å½|~|½²]=¬%g»‘ç\².7B>š@TÅ*ƒvPU‰<ÜÓL_Ã: ØÑ¼¡y;§3‹ýóÄd4œÑÅ0 ½ã1õ¤iÈï{±•‰˜O¦K[¨lû£5LQB}!ѿՑßgìŽlO­4 b ó¦ûçÛ’ùÜv› endstream endobj 4496 0 obj << /Length 179 /Filter /FlateDecode >> stream xÚ}Í1 Â@Ð]R¦Éœ¸‰VBŒà‚Vb¥–ŠÖÉÑö(9BʈÁqvE‹y0ÿ3LªûÃÆ8àI3Ôî8BªyÝêŠírj…©5ã”™ãùtÙƒÊL@¸N0Þ€)PR+IÔFdêÆÞ’jIW¢ZÈE,×Î&´¬ *>¨„`…óîí¼íÛ°ù°þmôÔþ³÷´ú²$j¼üŒ¼åKÎaj` ¿†Uà endstream endobj 4497 0 obj << /Length 206 /Filter /FlateDecode >> stream xÚU1jÃ@E¿q!˜foÍ ¼Rd\ l¬Â`W)Bª$eŠ„\v¶Gä)U8ÿM—b3ûàí¼™µK­tÁ™ßk³Ð×Z>¤iyWùÌâå]V½øGmZñ[¾Šïwúõy|¿Ú¯µ¿Ñ§Z«gé7Љ}'8³„Îl€"M !#ÊT ‰pˆp‘›P\‰©`‰~ÀԅƲꌀE¢Œw€KÕ¸r40À€0æïâ‚ß=æO%›òÐËAnªRZA endstream endobj 4498 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚuϽ Â@ à”nYúæ ¼Ö«¢ µ‚7:9ˆ“::(ºÖ>šâ#tìP“C…îãòÑKm8¡˜ÆrÒ¥#:&xAk%5ÕÆáŒ™C³%kÑ,¥ŠÆ­èv½ŸÐdë9%hrÚ%ïÑåHD¥ÐëbæfþRú›¯A¡#´JÓAà©;=L•â—Vi„@ …&ª!`®”ÈnOY—õoò .nð îRð endstream endobj 4499 0 obj << /Length 178 /Filter /FlateDecode >> stream xÚm̱ Â0àH†À-}„Þ˜–´ŠS¡V0ƒ “ƒ8©£ƒ¢«Í£Å7é#t¬P<“àRt¸ûïŽËÔ8Ÿa‚SW™B5Ác P¹Ë‰~q8C©AnQå —n R¯ðv½Ÿ@–ë9¦ +Ü¥˜ìAWX·œ µÂÑ ²0ã-‹‡FV°_j,{üáÍâ€aý€Ñ—ÂðÞÿé\wî¸v‘ðpzQÃèI6ð&‹]+ endstream endobj 4500 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ=Ë=‚@à!$Óxæ.dÑ@ bâ&ZY+µ´Ðh‡Á£qް%gù+æËÌ›¼@.Wyò!É5Ý||¢4™gNó¸>0U(N$#;NQ¨=½_Ÿ;Šô°!EFgŸ¼ ªŒŠÖêš®³Ú~ë3§˜œ ⻂|¦ž°4Øš±4#\YüÀª¨]˜ˆgr¦1äõÄWOÕLÉ$ÓÇ­Â#þbVO˜ endstream endobj 4501 0 obj << /Length 197 /Filter /FlateDecode >> stream xÚ5Í; Â` à€ƒ%7°9‹õm`A'qRGE¡C¡GàEz”¡c±æokB>òbwÚÝ!›Ü—²ÜéñÞÂÚ&ë”QvGû¨Öl›¨æ²Eå/ør¾P—¶PMyc±¹EÊQÑ·( ˆ5Ò•;Š¡‘iÒ?Í’ä•Ä5™Ó-7€î- ÇÇ«y¾! ^P+Ì<§$r4¡+n ”„¬"©ID>8óq…?áUÑ endstream endobj 4502 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚEαnÂ@ PGNò’OÀ_ÐKH@b!¥`b@L´#ˆnˆ¤vý“Hý¶Þ0öe`¸'Ûwg»ÈßFJ)—SŒ)Óg†G,†’§šêÅþ€³ 톊!Ú…TÑVK:Ÿ¾¿ÐÎVÓ6£t‡Õœbö%71w%;Ã]Í®û:$δ &À´ƒ nKoW1ò]Ћp¿©uû²tÁF@ˆƒu¨°ÞFÿjü§ïM0ùÕ>ÉŸÔ)è” èÄN¼6ª²#0˾¢ jÜ×ñ£Â5>Ý[¦ endstream endobj 4503 0 obj << /Length 224 /Filter /FlateDecode >> stream xÚMαŠÂ@à )„iòBæÎÍâ´‰ày` A«++µ¼âŽ®ˆè£åQò)·®;»Áló±ü3ìüj:™-(#IorNjNÓœNPå6Íh¦úÑñW%ŠOR9ŠÍQ”[úû½œQ¬vï$Q¬éKRvÀrM`ºØèÈ> stream xÚuÏ1nƒ@Ð(VšfÀ\À^Ù’¥PXJªQ*;eŠDv m²G tØ Æ.’æ­4#ý¿J—Ù†c^ó"áUÆÙŸú¦4—aÌY:mŽ_´­È¼qš“y–1™êÀçŸË'™íËŽ2%¿'PU2µ|„þ (ßÚ2w(Ú¦E-zD6¸BÛðFå”{ íDØIÚ3ê?¯”ûmgDíŒj #’× Arf#érµÑNN,t']´÷cÉá^Þal о¢Wúqái7 endstream endobj 4505 0 obj << /Length 170 /Filter /FlateDecode >> stream xÚeÊ1Â0 PW"y€#Ô' MKU˜J‘È€CÅŒ X)GëQz„Ž U‚ƒ€ Ïòÿö8eSŠIÅ<Ò e ž1ÉÉ5ß—ý rKIŽrÉ5J½¢ëåvDY¬ç¤P–T)Šw¨K@ô1c5³ ™0|2 GÂÞAô¼w=ÿý œ§/t:ŸpZßÐi|‘óø©­m¬µí—˸иÁI Pt endstream endobj 4506 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚmбN„@àCA2 À<ÀÉ™X‘œg"…‰WY«ÓÒB£­ðh<Ê>%aœ™K¼Kî6ðegçß]B}}µ¾å’k{ox½â·Š>©®´.­´Æþƒ6-Ï\WT<è*í#ý¼S±yºc]Ýò‹ny¥vË@6CG'=D"ŠŒº,2ùdíf‹Fzìé-måý©É™Áé1º:šƒð;Ý_w1Â|4™Ìt4³hæn7˜öµ¾)ñxæñÜãM> stream xÚeÏ1jÃ@Ð[¦Ñ4'ðJ–T¨±@±!* q•"¤JR¦°±» ë¹’n+¨s«.*„70‚,̃ýË0³i²Èr‰$C¥™dKyyωf‘^õáí“ËŠí³$9ÛG¤l«­§¶åÓƒÄl×òKôÊÕZˆ¨hÁYqžb~ÁOC~O¨•xCH7Lü-…VhPjeÞLã hAØ€‚&j¢Ψ\ïœ5Ó™ØÖëÿcîtsŒÃ·|纚ñ¦âÿþ*fë endstream endobj 4508 0 obj << /Length 224 /Filter /FlateDecode >> stream xÚuϱnÂ0à‹2Xº%{â˜D,Q*5C%˜ªNÀÈ@Õ®uÍâGˆÔÅC”ë™vaˆ‡O§³ìûoQÏšGªhI† 5†N¯X¯¤YQ3ÿ»9^pÓ¢>P½Bý"mÔí+}~|QovOdPoéÍPõŽí–À2GpÌÃ=¾AΘ&ÈnÄ òè<ä?ÜCžþÆ Þuj„Ò«…W=AP!÷BzÙO²P½ÿSÜðBé%­í$”ë¤bpR«l°J–,³Laî ã´œ•øÜâ¼p. endstream endobj 4512 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ36Ô34R0P°b#CS…C®B. m„@ $‘œËåäÉ¥äsé{€IO_…’¢ÒT.}§gC.}…hCƒX.OöòìÔÿùÿÖÿ±ÿ!ÿý—«'W áš( endstream endobj 4513 0 obj << /Length 173 /Filter /FlateDecode >> stream xÚ35Ó30T0P0SÐ52U05P07UH1ä*ä21Š(Àä’s¹œ<¹ôÃLŒ¹ô=@\úž¾ %E¥©\úNÎ †\ú. Ñ@Ãb¹<]@àˆ`|"™‘I°8;É߀D‚µÊ#‘vH¤ ˜¬A" HÆH$†µÈ²7 [‹l¡†µÈVÐÊZ¢ýÉðÝZº/~ki¼kÀ$—«'W R6N` endstream endobj 4514 0 obj << /Length 96 /Filter /FlateDecode >> stream xÚ36×36Q0P0T0´P06T02WH1ä*ä2² (XB$’s¹œ<¹ôÃŒ,¹ô=€„§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹ÂÿÿÿÂ\®ž\\Ï5^ endstream endobj 4515 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ33Ò32Q0P0bSKs…C®B.S3 ßÄI$çr9yré‡+˜šqé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]øÿ Æÿÿ€9ÿ?©úÿÿ€Ä~0ÿa``Êü«cRòÿØ:ìÿ€5ÚÿSõ`”üÿ†ÿÞÿØ)ö`Šñ˜R( Cþƒ^ ¤yÄPÀø:ô5>ŠËÕ“+ Šc endstream endobj 4516 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚÝÒ= `šMÞâúN ­vlRk"ƒ‰NÆI4:—£Õ›p„º14}>´n]t|ü<„Éx˜Œ1—4Á4Â} 'àÖåô5±;B®@®¹rþ¬Õ/çëd¾œb ²ÀMŒÑTBˆ Ÿ¸õˆªŒ*7@w"#DI.Õ> stream xÚÑ1jÃ0€a ‚·øÒ jR'YbHS¨‡B;u(™ÚŽZڭؾI®â£ä=˜¼JïIq‰ÁT`ø$/ÿ“V‹«ëµIÍÂ~«ÌäkóšÁ,s»OÝÖýxy‡m É“YæÜÙSHÊ{óõùýÉöáÆdìÌsfÒ=”;#ìÒðkTÑNUç„ÝDö3’8L¤ð4£1è¤裵>+*bôùT)ôÑ?£dÐ C~yE}ˆŽºQÂKZq¾<Šš¥¬8ZµT°b+Ρ1ܼÏ×nÎ N”¿q÷Aªœ(ºF».äÀùgE¤žã…¸$ <†àAéÄñ‚óGÅ.!Ñ šÕP¼Ï/X-Å{Uü°­«£wÅî¿‚ÛáÆÁÊ’ endstream endobj 4518 0 obj << /Length 306 /Filter /FlateDecode >> stream xÚÅ’=NÄ@ …MÉÍ!¾$)Èf«‘–E"Tˆ (‘AKr®’£äS¦XÅØ“Ù,=S$_> stream xÚÅÒ½ Â0ð‡Â-}„Þ˜ìÇV¨ì èä Nêè èl­ÒGpìPz&±M„ˆÐÉ@á—„$åÓ$BgüK|Œ<p8äs9‡3d°-Æ!°%_V¬ðv½Ÿ€eë9ÀrÜèï¡È‘ä°øxë©Ô)Q©TóÅ”ïxÔô²©íe¥4ÈG¤ªzMÄa)[¼"ei=šAikÊëL¹ôM¥!çCÕhÕ×ø.TC×Ê#³¦igÖ^w†£o¶êªî´î¾J„-ã$äŠKH…­We¦N'Q<‹6ð¯?K endstream endobj 4520 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚÒ½ Â0à„…[úæžÀ´[' µ‚ÄI'õÑ|£ƒìµÐ´Ö@ໄ\þ.ôû]Ô=ô0âÖƒa»:Ô›=Ä)È%!Èi> 2áéxÞŒçcô@&¸òÐ]Cš ú¶ŒuãŘPŒq‹Á"p3q%ŒÚÑ«áÒ§™ÎÐN°¢€¾ðß(WUyxû¦9ø³8¡ ëÑVÁ6q¯Ã1 D„=¸¢$Ø¡¨•D‰÷/À$…|®±ßd endstream endobj 4521 0 obj << /Length 173 /Filter /FlateDecode >> stream xÚ37Ð31R0P0b3S3 …C®B.3rAɹ\Nž\úá f\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O…ÿÐ@€>À`ÿAJ3Bi†z(m¥å¡4?”f‡Ñ 43š+ÍøF3| @3€hf4;”æ‡Òõ`è+¢h˜z„~vö1’HƒiP¤~ ‚ærõä äœÏ endstream endobj 4522 0 obj << /Length 300 /Filter /FlateDecode >> stream xÚÍÒ½N„@ðÝP\2 pó ÄX‘œg"…‰Væ*µ4Q£5÷&÷*< °åÆ™`¹øQ{ù±,ìÜÌ¿,OÓsL1Ç“ Ë3Ì/ð)ƒ7(r^L±ž<¾Àª†ä‹’k^†¤¾Á÷ÏgHV·—˜A²Æ‡ Ó Ôk4ü#gÌ«`Id ßKD-XûHT±ú…HžQìd[Ïë;'Ûøë¥n—ü1‰ªÞ“ÕÆi/jœ®óÇ{;_…ã÷ƒZŸÓöX\‹?b.®´ ê¿«QÙ_äËó%þ5Üt×õIÿ¥ôs&µüAÚÉciÇUÝ h’NËN SµÓ¤#þvPHDH‰&‡4MÎÒnL˜Ï•OÝ!“è|&%­Ig]‚«îà ê¤ùr endstream endobj 4523 0 obj << /Length 149 /Filter /FlateDecode >> stream xÚ33×36T0P0b3#3 …C®B.Ss ßÄI$çr9yré‡+˜šsé{E¹ô=}JŠJS¹ôœ ¹ô]¢ÆÄryº(ü‚ „hû £4š½?Í£ðÓò8h{4ºþ¡¡43”f‡ÒòPºB3ÿÿŽ×ÿÿÿ¤¹\=¹¹¯½¢a endstream endobj 4524 0 obj << /Length 286 /Filter /FlateDecode >> stream xÚ½’±NÄ0 †sb¨äå!~èU ë1U:‰H01 ›€‘sîÑú(}„Žª;¶RÐ!F:$_þØŽk{sqVã ×xZa½Áõ%>WðuÅâ k»yz…m åÖ”7,CÙÞâÇûç ”Û»+du‡ì³‡v‡Î¹‚:—>¢˜ö‚H%Ï0„èhâ}ÁGOÉäàNÄhI¢öl+÷­›Ñé"‡$§>ªx$O‰‘Aâ9Ñ3Hà:ƒ7¼¦ICc0C0˜Â” üdÿæ4rªGðËZƹ3h醥AŸ¡°:wß*¯½8,´;$Á¥qQRrº¤WEö¤½g‡Ž½{ !“Љ̳A:>6@ ÃøcòhÙ°Áu ÷ðž¤ö} endstream endobj 4525 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚ37Ó35V0PasC3 …C®B.3s ßÄI$çr9yré‡+˜™sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒ„ñÆøcüo€100ÈUòƒŒÿ@ õ  ûPˆ3øúÑ v,ŒÔf [Í=èn†ûæ/¸O¡~0”ñÆ85 †)šˆcp¹zrrÚõÏ\ endstream endobj 4526 0 obj << /Length 355 /Filter /FlateDecode >> stream xÚ½’±NÃ0†¯tˆä%oÐÜ @š‚ÚFª©‰ •`b@LÀÈ‚ )•x±n¼F!cËÇÝÙ ˆ¢ŽD‰üù|wv~ÿó³“ìÇ8Åã,ÇYŽÓ2ólfŽŽq>K÷OfUšôg“^rܤå__ÞMºº:Ç̤k¼Íp|gÊ5@D;ЇÈéùPÂÐTÈò8àiB¡Fëb’h͹R+Ù…$V­ÿt¦=x]ó¤b¨í#ÚöÀ/O{ˆÔ²ƒî‘hz(üy©Ý‡*€ý«PýÀý'8Oæ?˜höeé h¨R‹ÚªðÎ+k\„ýÐjF m«v ïrq…]ÀR®1q É5Æ´`ÔrgŽa'Û8o ¶ÏÖ¨`Û´‘j8Ò5®Ž4ôé± 0´{àV¸Uò0è̹ðì/¨üAEú † þüVÜÚ‚¹(͵ù3( endstream endobj 4527 0 obj << /Length 305 /Filter /FlateDecode >> stream xÚm‘½JÄP…OØ"p›¼€yÍf‰‘aa]Á‚Vb¥–Šv É£åQò)#\î83w‰.x›Ìï9“zu¶ªhI5–t^S½¦—Ò½»j-Á%]2Ïon۸⪵+n$ìŠæ–>?¾^]±½»¢Ò;z,iùäš<àH9àØ0w{‰1‰àÛcÁ]Ω<² h=òQŠ=6 zh¾,ÝŒ$üûýd˜ˆà1bŠðÐ׆«ا¨#X«êéÉA}Éëă¼ÞiMËÖ©¥S¬Ñ-d§ÚpíAÜiÈÌ$ r¢ñÉ0cúðGÖÝ‘»Ò"Øyäž*\ެŠå'¨ªÍ5 ‰Ðš?ŸÛ)¦ÔœhVVQ¥»nܽû÷ó× endstream endobj 4528 0 obj << /Length 378 /Filter /FlateDecode >> stream xÚÓÁNƒ@à!HöÂÀ¾€Ò5Z5!%©5‘ƒI=y0žÔ£&áÑx#Â:3»’/d¾¿-íþ”:;>Wr!Oä‘’JÊå…|VâM(EñB./ÍkO¯bŠèߤDtƒ¹ˆÒ[ùñþù"¢õöJbº‘ø¡G‘n¤Öºƒ¯8ýW·tx@NC¢­8Y™«ÀkccŸUÛØ×%€SÛØcUS•$œÜÊÆFýðS¾Æûy(wPAâ¯Áßá£RÀ‚©pXi¨V@}ôjH-—DqL ³jymVFyK«ÑÅV/ŠUÒ5¤¬/J/ÍjŒÂý¿{HÃþLe·©ìÅ‹2+Wó™‹ÃrøAÑ0' ' ¾þ">5×"®Sq'¾<ú7¨ endstream endobj 4529 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚ}ϽNÃ0ð«J¡l¬ü¹³;Ta?ùìûpÛœ7k©äBÎjiÑÃkÍïÜVb»¹Ì7/;Þô¥­8Üj˜C'Ÿ_o6÷×RsØÊS-Õ3÷[¡&Òå±0’Æ`Q·Ð0‘|T*õM *pŠÓŒ_¬°·ÃÅ2ô $ŠL‡o1ÔJc4|îÐåÝœŽä~82ý;á eSz™ñéºÒ)<Æ8`¯ÍŠN9y{ƒÑ2Êhà›žøål¡— endstream endobj 4530 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚÅ‘; Â@†7¤¦É2ÐM4ñÑ(øSZYˆ•ZZ(Ú ñhà̶Ü"8ÎÆP+q›æ±óÿ3Íz­ ‡ ¬ú¶±ÙÁµ;MÐÃV‘Ym¡œc€sd4ÁÃþ¸ÙŸÐ9Ä…Þ¢!Š8üˆ¾Â~Âúƒè̸¥Œ+‘fÜ’^Æ áÜke˜ÄÙ"eš,®”æŸˆÕ tŽÞGd?ÀË„bú›$UÊ5â“ÒŠflì$*lóÞÍMgnó ´C¦JÙæhVÊ·3Ë®FÌàiÔp endstream endobj 4531 0 obj << /Length 214 /Filter /FlateDecode >> stream xÚ­1 Â@E'l˜&GÈ\@7‘E±1#˜BÐÊB¬ÔÒBQ°’£í‘R¦gEì…áv>ÿ¯™'SŠÈÐ &3!3¦cŒ4#£Nq›ÃÓõ–ÌõRdÔùŠn×û uºžSŒ:£]LÑóŒ’> stream xÚÅÐ1 Â0à”…·äyдÒ*N­`A'qRGEçx¯ä ¼‚7бCéó=q(8‰òÁ ÿŸv«ÙŠ1Ä&]lwqÁ†Øy,ÖÐËÁN1‰Áy 6án»_íûÍpa8‡•‚&:2)Ñ™¡BztòŸÊU™«ÇUN­ËÇ+æIZÔà^Ü>¡àj©‹$qÍ©ÂÆIMîMRÚ'*ùmseÿ c¨ÒL@… ÜI 9Làwn¶i endstream endobj 4533 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚu=nÂ@…gåb¥i|Ï’eÅÒYâGŠ‹H¡¢@T’Djûh>а¥ äÉÛX ÉŸVï½yšyñÏÞËD¦òä%¼J˜ÉÁó™C€8‘0Ï/*v[ ÝdvÕ»\/_Gv‹¥xv+Ù¡hÏÕJˆÊžˆ2Õ†(Wí ¨F¢ºO†¶öFF›l@²Ä&¿%`Ý}b —ÝÈzdüeL,¢>2½¿Ýÿ°~dgygL[41Ƕ¦³Š» ÚÖhKy“êJ BaûsµQø óºâ îDŠ endstream endobj 4534 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ36Ñ32V0Pacs…C®B.cK ßÄI$çr9yré‡+[ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ700ðÿÀÀPÿÿãÿÿ?˜ÿ÷ÿaàÿÇÿAþ<ø$ìADýÁÿ‡áÿ0ÁüH0 ¤ÿA6b#È4oˆúÿ@ÁåêÉÈèü®  endstream endobj 4535 0 obj << /Length 281 /Filter /FlateDecode >> stream xÚ•‘=NÄ0…ÚÂ’!sH›´––E"Tˆ ()@Ðß`¯ä£ä)·ˆ<ÌØ‹Å$Å'ÏÏ{ÏIן5-5tA§ç-ukZwôÜÚ7Û5¤oßZO¯v3ØúžºÆÖ×R·õpCïŸ/¶ÞÜ^Rkë-=ˆÔ£¶ð„/ÀqZq€gÞ XŸxÂqdWŒjï£Ip‹nIU¨ì¤iÿÀ+ÂÿñW%KK"5²-CiÖKìŒ #;–A˜ 58©E,˜ æ½k΢SvàYlK³ S^`‰%*#ÃGÝÅ4dP€ãã”ɲ€1ê:¼^.ei³À¥üiþ‘C–¨žÌ%ý>+éÁ^ öÎ~ÝèÈñ endstream endobj 4536 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ33Ò32Q0Pa3 ²TH1ä*ä25òÁ\Dr.—“'—~¸‚©)—¾P”KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓE¡þüÿOb†PŒF±ÿSöÿ@Ôÿÿ€ÔÁÿÿ©ãìÿ©ó ò ê>ÿ? uBýP?Øÿ©(ÔlÔ¡Dýÿÿ¿ùÿÿø(.WO®@.Jå×m endstream endobj 4537 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ36Ô34R0P0b#Ks…C®B.#ßÄ1’s¹œ<¹ôÃŒL¸ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. 5 Œÿ˜ÿ7°ÿ?Düÿ #ˆ P¨¨’¨?Pÿ1ÿ?ÀH{ôp¹zrrÙðD endstream endobj 4538 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ36Ô34R0P0bc3K…C®B.#S ÌI$çr9yré‡+™ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ê0üÿ‰™˜qàÿÿÿ7 c.WO®@.„S—œ endstream endobj 4539 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚíÑ? ÂP ðˆC!Ë;Bs_ëZA,T;:9ˆ“::( n>'Go qèQz„ŽJcªƒ¸îß—dûÚZ£E5eÚuj¶héâ}O²SÆò°Xc¡ž’ï¡Êu4¢Ýv¿BŽ{ä¢îÓÌ%gŽQŸàh¬@åÌ&àŽlJ2§æDxbΪ…çÔÎUdÂK¬ ÛØ9TùŠ»`Pá+XÜUò.<¼˜ÉS*ñ“©0y1Æß ÍŸoò³–^Š_ˆƒ'øøïü# endstream endobj 4540 0 obj << /Length 162 /Filter /FlateDecode >> stream xÚ33Ò32Q0Pa3 eªbÈUÈej 䃹 ‰ä\.'O.ýpSS.} (—¾§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹C}û?†ÿÿìÿ7€¨ÿÿ©Æÿÿ©öö€Tƒüæÿóøÿ10þŸ¡ö@¨ ìÿÔê6êÀP¢þÿÿßüÿÿ?|—«'W ã[« endstream endobj 4541 0 obj << /Length 213 /Filter /FlateDecode >> stream xÚ¥1 ÂP †#B–¡¹€¾[¥S¡Vð ‚N⤎ŠÎõh=JбC1&¶ÕE\|>øóó’?ádäùäј†>…c &tðñŒA$¢GÁ´éìO˜X4 "4 ‘ÑØ%]/·#šd5#MJ[ùh‡6%·y=æ\0`..³ªYå°€óßAK<ý@\À@Q‚#6·§-WQwˆu©;Sðwð ÷?ñkB·KƒnÏú•¾ÍÐ&jÑ×´…„–ìùû1³´Áa®>7k.ˆs‹k|]Åf endstream endobj 4542 0 obj << /Length 227 /Filter /FlateDecode >> stream xڵѱjAàY,„i|çtïôN´Œ‚Wbe!V&eŠˆÖç£-ø>B|„-¯Xÿ•D„ÄT±X>ØÙeçŸíuÚLéJ+HÞ—,—×”?8»‰ô²¯ÒêGÛ¹äÛ)öÙϲYoߨŽ^ž$e;–E*É’‹±P鑪SݽêT+ðé†(5OTÓ@u%ƒBMwF=p§±ŒºoHý-euŸaø~ÏÿììÒnlÞ]£Tȇ`1æ)†6AâÆ¯bXiú DAãŸü O žñ¥ÜÆ endstream endobj 4543 0 obj << /Length 161 /Filter /FlateDecode >> stream xÚ31Õ37U0P0bcS…C®B.cK ßÄI$çr9yré‡+[ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]êêþÿoüÿàÿÿæÿþÿïÿÿHôÿùÿ¾ü?æÿûäÿ1þß"~À‰`‚ÿãÿì?€ã ÁÀ€L 7ñÿ?Ðbl—«'W n endstream endobj 4544 0 obj << /Length 223 /Filter /FlateDecode >> stream xÚE1NÄ@ E?šb%79Âø0;Úì"ª‘–E"Tˆ (·AKÜq­%GH™"б´4o4ßßþv]_ä+^sÍç™k{wüšé6[í{¹T^Ž´o(=òfKéÖdJÍ~|½QÚß_s¦tà§ÌëgjŒ8êU•ʇ R:EZ Ê·cªV¢ÿG@­‚V‡•ŠjçU'Øø„3r¸Ø¹Ó–½µ—£å:ªÓ ¾Fg ñ¾©u·Ð1Ìv¥Mª#†bj¿2;Ý4ô@¿* endstream endobj 4545 0 obj << /Length 173 /Filter /FlateDecode >> stream xÚ31Ö35S0P0RÐ5T0¶P03VH1ä*ä26 (˜™@d’s¹œ<¹ôÃŒM¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. Œ°ÌXv8Á'äá„=ˆ¨ÿ3ˆàÿÿÿÃ,X  wˆ'€þüÿùC=„`?À`ÿƒ¿Aþ<Ø7@ïÿÿ ¡ÿ? ærõä ä ,t endstream endobj 4546 0 obj << /Length 166 /Filter /FlateDecode >> stream xÚÕÊ+Â@ài*6Ó#0€í6ÝÚ&¥$¬ … (ŠD@@/G[Ç5ê°8¤Ã‚¨Á£¾ü"e9¥”ÓÐP!Zj îÑZ)%Ÿe³ÃÊ¡^’µ¨§R£v3:N[ÔÕ|LuM+Cé]MàD Ì!æßÄ a9PIÒcУd€/-x>ƒo£;wàê*”Ì!aVBÌÝð7õœ8\à ¦ä¤d endstream endobj 4547 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚ}Í=jÃ` `-¾A¬䳋M)˜òõPH§ !SÚ±CC ÉÑ|”Á£'ꫯ¡¸’oþ4J$ëüQ²LÞSþâ<ÜØh‡õ'+v É3v/ز«^e»ùþ`7žO$e7•e*ÉŠ«©¨*…ÚÝ#ÐÑ3‘Q€Æs;Ðþ*ÑØ— ø‰/‚Ô@iàh#2ê+1@îð„[|áiöÆ¡ÙyÚÖ(ÛÆsöÄç“G=‘Ö· ·G¨Ô#¸ô¡î–ʳŠßøà•pH endstream endobj 4548 0 obj << /Length 276 /Filter /FlateDecode >> stream xÚÐÍJÃ@ð 9æ’70û&‘ÒXµ‚9zò žl… …¬oè‹ì­×=¦3þwÛR<,û›Øù¸ÌÎg¹ÊÔN1S“‰ZæüÆÅqæB—xyåyÅé£*¦œÞâ•ÓêN}¼®8ß_«œÓ…zÂ7Ï\-”HŸˆèDìHC¥!Ú—%ZCÆ«%‚\Ä:Pm)î(0#µ”tB%ÔSØ@•=ER¥P¤GêéK(†b'$´GWP$d¥9óÒG…òmêæj9h m @¶Mi×^»£Hv:±vP{*ì½jÔÿ1ƒÄËuŒEü!7£è±blEèDna^ÔŸ(ôûö¯n ¾©ø™¶… endstream endobj 4549 0 obj << /Length 234 /Filter /FlateDecode >> stream xÚ}±NÃ0†ÿ(C¤[ú¾'¨”±4R[$2 ÁÄ€˜€‘¡lU›GKß$/à Çù¼0Õ²õéì»Oþ››euÅ%ÇÓ\s]ó[E;jj­ËXƇ×Zw䟸©Éßé-ùîž?÷_ïä×®Èoù¹âò…º-‹ü¢•p ÐÀiB1íŒE¸ mQ,GE!ýA‘Ë0)29÷Nò3Dœ¤hœIƒ¤AÒ iþ¡1µ„„Éæô7ºVÎpHšÉ4Y0Ml¾3ÃEˆg¡°²P1€jDßEæK ÛŽé(kЉ endstream endobj 4550 0 obj << /Length 267 /Filter /FlateDecode >> stream xÚ}ϽJÄ@àRn“7pî h~˜(Âb`]Á‚Vb¥–ŠB !y´ø&û)Sdw<óƒd„>¸ÃÌ™SŸ¥äRÊq™Ku&ZËsÁo\iLs9Õáèé•× g÷Riή1笹‘÷ÏÎÖ·—Rp¶‘‡BòGn6bŒ¡ØÌÿ™-Ñ‘eFGZ0ý‚Ucc^ÏpGí))€¡$ ·ô)ˆY†€È=ò ÜÆ¯ã—¥[Ç4Yêitìj·uGj†¿ wAlhA´_Bóí“gô6U¹ÊT÷¶2uƒ­Œ¶2H¾–òø’ƒo÷í^î_Ë„>áë>ƈ¯¾ã ø‹ endstream endobj 4551 0 obj << /Length 126 /Filter /FlateDecode >> stream xÚ35Ó30T0P°b 3S…C®B.c ßÄI$çr9yré‡+[pé{E¹ô=}JŠJS¹ôœ ¹ô]¢ÆÄryº(000````ò ¢H0ÿö@âÿ,Äáÿ0%#Œzÿÿl—«'W ØšŸ endstream endobj 4552 0 obj << /Length 266 /Filter /FlateDecode >> stream xÚmбNÃ0à‹Åöï³Ïãú¢|ïGý¿ýÓÀ/¼Òq¯CýyÜófâîίFî®0ËÝtíß^ߟ¹ÛÜlýÀÝÎߣÌO;O$™ˆ9Á 1!˜rðHõâ°Ðdš…Úˆõ4›f¢&˜ç‚p–B•l9{„ôŸÈÃÕ6©8ù,Ö´Â/õvîK¤qb´ûÒ·í¢+tÍÙŠ%+ ¿N»C7¶É"­EB´8Ñè¤V‹êP Í#R¨I*š‡h~ jÁ:¹Rᕤè[I®ÍÆlÍ`Φü˜þÊ—ßò'‰Ä& endstream endobj 4553 0 obj << /Length 258 /Filter /FlateDecode >> stream xÚ…±N…` …{Ã@Òåú $÷g%¹^Ltr0NzGÎðh< ÀÈ@¨=…ãâò íééicu]”RH”«Rb)U”·’?ø­XHU­×w>5œ?É1r~geΛ{ùúü¾p~z¸‘’ó³<›Ñ 7g!Ò‘ˆRUc¦ÚµŠ’R;Q2Q½P:X Ja2m0{´þ£ëûtÆ”yíl[ÀJ8ƒ XÏ í¥-ÖAvH¸xÎiO›zÚM¹Í÷YýSgâ¢ÄV6ë•Óo†¬GÐbìÔùÇÉÆï2ޏ´ÀºC’lÄLñUú‡[ÏŸù]~(ß6üÈ?údµ£ endstream endobj 4554 0 obj << /Length 216 /Filter /FlateDecode >> stream xڭбjÂPà„ ³ärž 7ÁDpI *˜¡ÐNJ'utPÚ-4Ù|-7_ÃÍÕ­…ôæÿmzàÞs/üœ{ÓñCk¤#»Ò‘ŽS]Ų•dbû¨k»‹åFŠRÌ‹&1 {*¦|Ô÷ÝÇZLñ4ÕXÌL_mÌ›”3ulåŽó‡š´Ø]â ðI@B’¨I Ü/àßsÁ„ÌÌÈ'©È¸à€ßsABN–‘jÀ¸à€AOB¾/#ù&-ª¹Çï¿ü'5£o#óRžåŒÔ‘ endstream endobj 4555 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚ¥Ð1NÅ0 `?uˆä¥Gx¾¤‘^:éñè€bF¬4G Ç GÈØ¡j°]&`£ª>EIcÿµï;Gy:räõžî>áÎófG}¿žÜ=â~@{M;öœ·Ñôòüú€vyJín¸Ð-2ЀÉL]_~ÔEÕI-jV£¸€8«Yåz&Á? …}—Bæ£Öæs훃$–SéÂhjääMM|wSSYNñ-ðµŸN¿m£²8±®NZôTÜÔ2fé5J÷ü’äD 2ЏMÐrà[μ©Ñ‚΂̿˜51ÿ=ž x…_‚²¶d endstream endobj 4556 0 obj << /Length 264 /Filter /FlateDecode >> stream xÚ}пJÄ@ð9®LsoàÎ è&p›6pž` A+ ±RK EëÝGÛGÉ#¤Œîs&åüƒ~Ålvfö õIYI)AŽ+ •ÔAî+~âuÐb)u½?¹{äMËþZÖý¹–Ù·òòüúÀ~sy*û­Üh£[n·B´@""‡^­H1Ñj$—¨éÉeŠÅLЯÓ; tËY½Ñ;su ÓVÈfLæ5*}:˜ñ›…ý;8ÝCD§á­×ëxÏ:H:n2Áæfìfu«Y›ÛÿrÐVÿµùißL=Ý’½züÊ! å´äŽmNû@¢½Hö´ h––ö”‡ø¬å+þy×- endstream endobj 4557 0 obj << /Length 214 /Filter /FlateDecode >> stream xÚ¥Ï= Â@à )Óäf. ›@LìÀ‚Vb¥–Š‚…hŽ–£ä)SuvVŒ°qŠv–÷–íF? Ÿ"jÔ )ŠiàØ—¼î™›õ ª…1ª ¯Q%S:N[TƒÙT#ZrÑ “µ@g¬ÄϽi¿¶K±s13Þ´é•»úpa¯bg¶ÔZ¢]ð œ 7S­—‚DA¢ Ñ·å±…ÖݼÖ3fRóáÍ(õZ«¡ý¾t~êþ¡s—Wê/â8Á9>?æŒ endstream endobj 4558 0 obj << /Length 290 /Filter /FlateDecode >> stream xÚU±NÄ0D7JÉ?!þH"]ÒZ:‰HPQ * ¤AíHüX>ÅmJ–—Ù=N:š'y¼ž™õ8]öƒëÝè.7nÝË`ÞÍn„Ø»i:Þ<¿™ýlº·MwÙtó­ûüøz5ÝþîÊ ¦;¸G=™ùàˆÂFD53h™W"Ï ),m¦*S]¨NT1Õ™š(WB¿X^lÁöÄxÆM™”E'YÞ¶HB’b3œ-—ªPÃü…?IJqD´¶bmN £¶MʬJÑÆ<K“e›àÑAñzó‘VDlaAD‰ƒ!I„W¶J{Ææ?1߈íx’^¶Ž~ÓM“ü•-ò{ ÊÝ(kÏM;¯Ú†$‚¹žÍ½ù«C¾ endstream endobj 4559 0 obj << /Length 265 /Filter /FlateDecode >> stream xÚ?JÅ@Æ'¤X˜foàÎ4 ¼Mx>Á‚Vb¥–ŠvBr´%GH¹Exã7I@E !ü 3Ë|b}VVRJ”ÓJb%u”ÇŠ_x1,¥®×ÍÃ3ï[.ne¹¸Ä˜‹öJÞ^ߟ¸Ø_ŸKÅÅAîpèžÛƒu9=‚AµÇ@u$Ò±™(ÓÞ'Ê•ÜLîhŸŸí7ÌXQcìWv @Ú8®Ô/Nÿ`ú“™¦î3¶1Ì&“šÜBX=Ñc¸¢Ë­fQò:¨Åƒ.rÿ$Âc³1ŒÞÞaÉØ˜VÿÖä@¿r&¸Âã0: ƒôS®ìYùZÛ™Z>´mJÎêç‹–oø3çÕã endstream endobj 4563 0 obj << /Length 204 /Filter /FlateDecode >> stream xڕб Â0à+ ‡Ø(z/ I• E¡*ØAÐÉAœÔÑAQp(â£õQ|„Ž^m‚E\$|Kîî¿¥Úý.Iòj’:Šzm}< ’Tœ00µÍãÅ’”D1åŠdF§ãy‡"žÈG1¦•Orɘ Æ<²ÀºØ€spùªÁ"–²G¥…9¦5¡4ÐÒʳò’ëQ3ÎܬŒxÇ:n¨™Ø«–~y~VýåòCTáé(Ô™£ÙüF++ÃI‚ |Û A¨ endstream endobj 4564 0 obj << /Length 194 /Filter /FlateDecode >> stream xڕн Â0ð+…Côï4_( Å¡V0ƒ “ƒ8©£ƒ¢àСÖGé#ttp0!‰Šƒ á·ärÿ$§T< N‚z’“’4”´xBÅÉ®‘ô¥ÝSlMŠ#››}dzA—óõ€,]NI Ëh#ˆoQgЀ–‰J£rÀª½Û—ÜHþÿððîNÔN#¨œ80om[…ÓµÀ™xáŠ"mTé#lûG[âX»)¼ŽúiuÞe0Û€3+|RA endstream endobj 4565 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚM‰»@@DûùŠù®e­h=[H¨¢B© ü½x7¦8“œc×zÔtTÌп/ä 0CG·~—ú ‰…4Ô¤ †Ø’벤J© [E¯ƒÍx>Û_?îÈ-j\•]** endstream endobj 4566 0 obj << /Length 136 /Filter /FlateDecode >> stream xÚ32Õ31S0P0SÐ54S02P°TH1ä*ä24 (™Be’s¹œ<¹ôà ¹ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ÌØ?ðÿ ÿ ?°o`0`(`H 0703°3ð1È0X…B \®ž\\Ë—!Ð endstream endobj 4567 0 obj << /Length 93 /Filter /FlateDecode >> stream xÚ32Õ31S0P°bCK •bÈUÈâÄ@tr.—“'—~¸‚%—¾ˆðôU()*MåÒw pV0äÒwQˆ6T0ˆåòtQàc°o¨oø u 6 \®ž\\TtÓ endstream endobj 4568 0 obj << /Length 117 /Filter /FlateDecode >> stream xÚ32Õ31S0P°b#3c3…C®B.C˜ˆ ’HÎåròäÒW04ãÒ÷Šré{ú*”•¦ré;8+ré»(D*Äryº(0Ø0Ô1üg„ÀŒ ˆ| ö õ ÿ!h€ —«'W %– â endstream endobj 4569 0 obj << /Length 111 /Filter /FlateDecode >> stream xÚ33Ö33S0P°T04T03U06TH1ä*ä25 (Ae’s¹œ<¹ôÃLM¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ìÿAà?˜úÇ@g¶õÿƒz0u€ËÕ“+ Áç+3 endstream endobj 4570 0 obj << /Length 288 /Filter /FlateDecode >> stream xÚÐÁJÃ@à„=æ²/ î¼@MbÛ”BI V0AOŠ'õèAQÈ!¤y´}”øñ¶B0Îl&‘.?|C›Ì¿ðÏV3ôqzŽÓ`‰á +| àÂ9=öqvïža“€w‡á¼+z^ro¯ïOàmn.0o‹»ý{H¶èÐiQ¢)eMJ]©S2vÒH’¹k²˜Ì„©÷d-Œ!]#¾~šœu?ÌÚá»Úëþ8é,yl-”šÇVÝW6|tOGœ¾qÁáµ8ãîmhm›q¿m¨›QÝNcG«PtV<Wcù_õý:RÓ‰…â-•Ô\GIñ¶‘Ò»>˜)Í¿iRéòçÒJNøÚ¸ o/‹¶¸Là~¥Ÿ§£ endstream endobj 4571 0 obj << /Length 281 /Filter /FlateDecode >> stream xÚuѽJÄ@à )Óì ;/pæ“Sç ¦ÎÊB¬ÔÒBQ¸BâÂv>‚Ïß$peŠ8;»çå¢n±»³ 3³Ù~vˆNœÄSLcLð.†GHºŽpšmb·0+ ¼Â4ðœøüôrálqŠ1„s¼Ž1ºbŽ‚VÞšÝë{MuPJ{µ oM”Â7´"Øâ5?ÐKŠûZØgcGý?ÒQýFö´vè¸>*jˆ¹Ìµh¹è]> stream xÚuÒÁJ„@ðo˜ƒ0_ væ6u©t!v`Û A:D§êTxX\¡ËG±70ºÌA´ofœ×mõç7Ÿ(g±Åt&¦Q,â¹8ž‹‡ˆ½°$z‹OÜÚý[¦,¸IÈ‚ \`Az)Þ^ßY°¼: Vâ6áKWpt²Ö ]EºV¢ü²ö*®%!ó ï•Åc3¬©Z€Ôj¨ÊA¶DQÕ8ÕN¤j`‚¢5^`÷XÄŠZyµkðª¡è®l+øU_ÆWîËcUàwvìðB·â‰£d¡OF¦Œs$9ÐÆÜ¤ãËMy«ÍáZSè•›£i fW­ Mï•I–¨d$вS•) í¹Ïx¿lÆ[áüri“ïÒåþó§Mј¸èþ‘ W>P¡qÀiÁrî—Ü,æÒ©]ðrauÊ˵՚—ÊHe>1ÿ2dµÿa&+Úî±­°ó”]³_82äî endstream endobj 4573 0 obj << /Length 219 /Filter /FlateDecode >> stream xÚUнŠÂ@à]¶X˜"yp7Oà&B¼tþ€)­,ÄJ-…xœ`—¼¯äÜ+ä ÎÒBX³3wf>f¦˜Q6øbйËG)î38Aîf©kÝbw„q fù̼›‚)øûs>€/'˜™â&Ãt åEòæªPš‰>{Zâ; f,óOÈž?B]}tì1LÂU|÷hµ‡¼ª§!´ð‰’€‚©­õ°L+ôƒ^¤Þ¨†Ð=‚ˆ™ˆI æÂTÌB?…KkÙÝ Y +xir§ endstream endobj 4574 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚUÐ;NÃ@à±RDšÆGðœ kK,¤‹”‡HPQ *BIAµs4ÅGp™"Êòÿ»Á6…õÍ®w»~¹¸óV¿ûÊüƒ*ýRÏuÉ%ƒ÷O]×ê^Ì{u{쪫íûøó¡ný´±JÝÖ^++ß´ÞšÌC‰„S¢É{)zÐÉü™\"i%»¬4á”6Íò‰Uj‰HSÑK&eo©ÂTF€çg³K´±³ðÿ5Ѥ²¨r#ïãŒØk¤ÁDV#¸ Ĉó7èÿ¯—'Šîïp*ÃSó¥±AÎ ×]­Ïú >à™ endstream endobj 4575 0 obj << /Length 275 /Filter /FlateDecode >> stream xÚ…ÐÍJÄ0ð顃}ƒí¼€öƒÍ² º‚=îɃxR‚ŠÂÄæÑú(y„{(3itáG&Édfôêd^QAeEÇ-–¤Wt_ªg¥5G Z”áèîQmj•_“Ö*¿à¸ÊëKz}y{PùæêŒx¿¥›’Š[Uo @<âˆ9ufÆ8g׋:&í°ç£ëh€¬FŽ÷ˆOÂ^|I‡ÌòÓNî{Œ§‘?,œ''Oìi%ÉÉõ‘”_ùàMÀü à–?ØK¯ÀÓ´ L Áz¢@;uÙúž3Áå2<ÛŒ+ãÙ¦Œ ÕJfWÄ-ƽ<Ï%5¾Þß’“É uöP›:¯ÕN}°m» endstream endobj 4576 0 obj << /Length 249 /Filter /FlateDecode >> stream xÚ]ѱNÃ0à‹Ù®ž¤f»–·Zªwn×BÆ{ÿG4êûèQ ù@ÅdNAÂÄBí¢Í^=•IÝ T‹d¬%sµ™÷˜Ú]KsýÄbr¦h6ó@Î^^43{2è±¹˜îƒzD!;‰(dý«­`ïÑ!´m¢X“Ú¯¡m㺠ZÆèB$B¤¹ŠÆRm7ó˜WúKPËÄ›–_ø †×Šæ endstream endobj 4577 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚeÐ1nÂ0à?Ê`é-¹¼Ô ÂС*R R3T¢CÅŒHµR¤äh…#ddˆ’úA vkÉþü{ño›áÀc6vŽ6c^'´##9–(›Õ–ÒŒô‚!ýjOIgoüµÿÞNçSNHÏø#áxIÙŒ¡;ê? *¡„Ðrú–§Ž£Ëħ¸óä>h Kur— FäP¡wåÙVÒ á¥¬Pu¨3ZB‰ŸŽÈç„Ïû®Òá(MnL| —Ü.G}Yƒk²ýzÉè~ƒm endstream endobj 4578 0 obj << /Length 270 /Filter /FlateDecode >> stream xÚmѽJÄ@ðÿ±ÅÂÞ˜yÍ— pppž` A+ ±RK EÁBÈ>Z:_#oà–)BÖ™½wáGf6󱩧ł2Ê :)¨:£òœžrójÊ’£UyL=¾˜umÒ;*K“^qܤõ5½¿}<›t}sAü¾¡ûœ²So€qĬ¼=f¼ï–›9fîðùÅ©Ëh€¤FŽ÷PC@s€>ítü©“óh¤G˜[†€ ´Rd‡ÔúÃJÉ " h"ö|š÷<zØŽÙtÄí! Í#ݲsi‘DÚ0$§'x,.$cq/õcÁ÷¢¿­,±Òág J z·ß\ÖæÖü­U endstream endobj 4579 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚÍб Â0à”…[úÞ˜V´…ZÁ ‚N⤎ŠÎí£ù(}„ŽJÏK‹ÑÀ@È—„ûá.‰Çé#œòfÌR<Åp…$å{d®æãxLÜa’‚\ñ+HµÆûíq™mƒÌqct•£ð‰tHTý€´#>EP3žßs‹Ò raJ !úÒ!L½Ñv(]p†gÑt.8÷Э xYÔ4}k]FhaZ7¥C|¦¢Ý©üÛxÞS)¨õºÞ‰ZX*ØÂ ¬Sšd endstream endobj 4580 0 obj << /Length 155 /Filter /FlateDecode >> stream xÚµÎ?AAð•Wl2#˜ØdKÉó$¶P)D…RA¨9š£8‚òbìóÆóË|3ÍüÐz´8*ãqqïà!ælK,Ýêf!‚™ç+˜´ÀËùzS/§èÀ4¸qh·TQûƒÒy”~1}áÉ „3îÌMP u|˜žðf*¡e´ðz”7"êÈ…`–`_ÂâSt endstream endobj 4581 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚMα Â0€á+…Cè ½'0©ØÚAª‚ÄI7ûh}”>BG‡bÌE1 䃻døÓA_æ$)å; tD‡/8ÌÌ,yä‡ý …bCà ÅÂlQ¨%Ý®÷#Šb5¥ÅŒ¶ ɪA¨u ÎD DµfcßÊ9ñ-O_pjÏ·3ðmß—3ômœÑß® ïýäð±5·áŸ~¶66¼fƒšÃ;_+­QÅáqÉšo&V—&9Ô ùx¾ç ×øûdœ endstream endobj 4582 0 obj << /Length 300 /Filter /FlateDecode >> stream xÚ]Ð?JÄ@ð¦˜"{¸3'0 ®› ë ¦ÖÊB¬ÔRˆ¢°U’›x ËÜÀ#˜8åÁøÞäŸIñ¿oŠóE«ÓÕZŠ&>Sç‘z Å‹ˆ( Ïb›ÿVEká_á«ð“kõöúþ$üíþB…Âß©»P÷"Ù)àÍ·é´$› £•NºšH’òA?%®“A^ à|‘6¤ï^ì£@Å(.§: \= )ʛɠâ¼Wš‘ªQY;àXývrÊšTfÀŠ©Š;£è¬ÈÀ‰£<Ö+fT ‡QR«‰÷ª8ä‚vÊ™– Y±eKÍa¦ hd'ÚÒþI~¶:t'mi «¹ ËÙª ñ#‰JkšRBÞÔVËAn+q™ˆñé¥™Ê endstream endobj 4583 0 obj << /Length 291 /Filter /FlateDecode >> stream xÚ]ÑÁJ„Pà#..œÅøÃÌ}‚Ô(u1 Lä"¨U‹hU-ƒ) \úhΛ½€ÐÆ…x;ç\G-PüëÿŸ(<‰Ou Ïè%œÇú)ÄWŒbZ¼äƒÇÜfèßé(FÿŠvÑÏ®õûÛÇ3úÛ› ¢¿Ó÷¡0ÛipM `L=GgŠ hTà6GÐ xŒŠa, B9Ǫ(A R}a9¡²Ø¬+ð,jX0ï?r¯•@5°dì'´ÛÂÆ¢ƒ„Qp,œÚé!@{F5Á(IÍ”’å€T@‘ÒÀõ£S’ _Ò =ß#¤ÂÏ% HÊŒVè–¿ HΈ^Z™ùƒGöÉ¿Ü (xš\Œ5™/3¼Å_Ë||Á endstream endobj 4584 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚeÎ;Â0 ÐT¼ôõ H«*0V* Ñ &ÄŒ ˜Û£õ(=BGÔ`‡O1$ÏN;f2Î2LÐК¤h¦xLá†ó„Sg(JÐ[4ô’NA—+¼]ï'ÐÅz†)è9îRLöPÎQ¬µå°j¥¢Nå-ÑrÄ„TÿžD#ɉ~ –T?Bª¬”„frOMPÕ¨sÐÈ`à;¤vôî)Gÿ/¤O7ºr$òi%±O#É}jIå£$Ö£w{ðÆÚç?°(a/5ÿsR endstream endobj 4585 0 obj << /Length 261 /Filter /FlateDecode >> stream xÚMÐAJÅ0Ð)]fa/ð¡sm+¶"ïìBЕ qõuéBQp×­Gɲü iœ™hMIyM:™ÌdhOúsj錎Oièˆ'Ͼa?ðbKýEú³ÅíˆÍõ67¼ŒÍxKïŸ/ØlﮨÃfGµO8îÊceID``g&@òY”â›ñ95³ü3çØ•’#­Ë™œœ¥ð “fW<@Ô ‚€E¿Çs>‰(Rµ §’:$ÓV.Á»¹bãAû*3ÂJêËü´€ î«Ê˜sìJ´¯Ú›?&¡JI_B”´›)J—rí&| eàýüD¯X‡×#ÞãdŒ? endstream endobj 4586 0 obj << /Length 255 /Filter /FlateDecode >> stream xÚeбJÄ@à?¤Lqy1óš;ÉåÄÀy‚)­,ÄJ--í‚É£í£äR®\g& wÚ|°ó'ìü[”‡å1Ϲäƒ#^¼<áǽP±’¡ŒSòðLëšò[.V”_ʘòúŠß^ߟ(__Ÿ³œ7|·àù=ÕP¹…aHÂ(fîãTÆÈ AêÄ#{Ľš8=N¦Ý¯™Ø#Ã_+ÑíÚAïžtjÖ›£4HÃ`~AWÓQ‚~,¨‚·@Ekÿ¥flF[bÛ³î[ªúÏ µ~”ö“-´½(½ÛN[¶N£ÏA/ñ£¼†V—í­‹³è¢¦ú?Fj¤ endstream endobj 4587 0 obj << /Length 214 /Filter /FlateDecode >> stream xÚUϱjÃ@ `ZîB­'¨ã«S0Òâ¡ÐNB§¤c )-t³ÍâGðè!øz²3HôñKh{~\.hN™ í)'—Ó)Ã+º,ä9Çqs<ã¦Äôƒ\†é>Œ1-_éçû÷ ÓÍÛ …é–áæË-ÏÕÞ±wzð´¶L“Ô 73ˆnb¤. fV÷ c†éF ÓI, —m%‰¦‘¬5µ¤Ò€Ä+I¤¹IbM/1šNb5Ó'ë1UÞó…Wà®Äwüݦpt endstream endobj 4588 0 obj << /Length 212 /Filter /FlateDecode >> stream xÚMÎ?ŠÂ@ðoH1ðš\@È»€Nbj£àº°)´²+µ´P´ $`‘No°g‰7ñ)S„dgFA›ï/ê÷¢ˆ}q7`Âo:PhŠ>‡Ãgg³§iLjÉaDêG—IÅ¿|:žw¤¦ó/HÍx°¿¦xÆ@@6/ïcGÇÄP‰Âà”¨!×Rˆ^!ª'“ÌâTH3=™â,ÑšÅæ×R˜;÷â…g¹X²Kž%Hs$h%Æ¢uõg·+> stream xÚMÏ¿ŠÂ@Çñ‘-¦Ù70óÞ&a…ÀÀ‚VWˆÕ¥…rWšGË£lgé–[„è¬QsŧùMó¾yK)¦!õêúJp©á1¦Á°¹|îpœ£þ Ô žóŒ:_Ð÷ág‹z¼œP‚zJë„â æS‚ º¶àÄŽÿÔ¬jußkÉÀzçäEª’¥òÌ «¬°Q)Ü]ÑÈx’îÄŽ/ÊÕ¬eQPú»¬xÏÑžc=þrÔ_ÇÁ»°0’%t£ÿÀà,ÇÞ!_‰ endstream endobj 4590 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚ]ο ‚PðOîœÅGð¼@]ÿ éb`955DS5¡öfö&>‚ã$»)5üÎð}œÃñü‘Ë6+X8!Cо¡ %j¡•P¦f•¢¶J`Rôò¢Ûþjµ×Ÿæ—­ùZzê FB”!Ì‚ž¥_©ºC4KhEoçM> endstream endobj 4591 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚUαN„@àÙPLÃ#0/  ¼æHÎ3‘ÂD+ c¥–íH ± Ó7ðY0¾ˆ@IAXÿÝcCl¾bvæß?;9Î2Id#G©d¹¬Oå!åg^å&²Þ^îŸxW²¾‘UÎúcÖ奼¾¼=²Þ]IÊz/·©$w\î…ˆÔÌGï ~=ÑBç‰Oá \N nk¢m`ˆª`Â\MèðÕd³G :5"ìÀ€šÕ»>ƒfÆâ®g¢ä|w3±ãÇòÞŒT8Ú¦¢º¥ŠLH[e"4ûü 8 ¿Ð6IõÔŸ—|ͬÁkÞ endstream endobj 4592 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚmÎ=‚@à!$¯á¼ èòS $Љ&ZY+µ´Ðh²…‘åfx“=%-l,¾f&™LCö9áQÀQÂÑ„)LLès›ý‰¦‰ ‡ ‰…‰IK¾^nGÓÕŒ9oöwTä ”€Ý×pŸ< ÑAZ-¤Ý@:ÒÔh½M¦,ÃÑ™òTYõ(ûÖPà zãõG÷ãߨ IaévíÁU.R8Uk®èÏÍ ZÓ¢ B endstream endobj 4593 0 obj << /Length 216 /Filter /FlateDecode >> stream xڕб Â@ Ð!‹? 4? ×Zµ¤­`A'qRGE¡C©~Z?ÅO¨[©&‡á\îA.ärI»ÛêôÐÄf›–ƒ¶ƒÝ>n,؃íÒµ‰N¯Ì­w0 A.ÐvAN(2œâñpÚ‚ÎFh pi¡¹‚0@!D-%ŒŒð\"ùƒ¸ŨÞr"Ë®R\uêŠTÇP\(z>Sa¼¡Ø§#|¡sf’ÌC§¢ÈuªŠLç¯1>|Sþ¶Á$^IÁk,b&â…rŸˆñÕs\ ãæð;ø]ª endstream endobj 4594 0 obj << /Length 236 /Filter /FlateDecode >> stream xÚEοJ1ðY¶L“2/ Ù¸{ºÀy‚[Z]!Vz¥…¢ ({ûh_$°¹"¬Î,»ÚüŠI曯^ŸSE º5Žê=:|ÆzÉÓŠÍôôð„›íŽê%Ú+ž£m¯éõåmvssAí–îU÷Øn @ð‰ÉëE2 ÊȨ èž1½JàAE8èƒA‡b„räÈßg|¯FÆí‰Ã„äÌ d¾]¥ 2÷ÑG€d˜÷Æ3úKê–‚ú'Îè‘'BÇ¥„žx`:!s\ÁIŸ²`~zNx /[¼Å_¨TdW endstream endobj 4595 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚUϱJÄ@Ð7¤^“ò~@gãfa„ÅuSne!Vj)¬¢`•̧åS"þ@Ê-ÂÆûFaæ0Üa.wª³Óª’™,䤜NžJ~å¹Cˆøü÷æñ…W5Û;™;¶×ˆÙÖ7òþöñÌvu{)%۵ܗ2{àz-” DfJ £HŸGº„"|„Z¥ÑÖ¦ÁçÑԠÛ)ä€ò`ötfTvhÌ"Ã?|@‘×QZ×計VШó@0ã1ØE–Îã×¶-eý¶ƒÒƒ¯nOæ;`ëDŽhI|Uó†´éd" endstream endobj 4596 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ…Í1 Â@ÐR,Lá^@ܹ€nŒ¦¢‚)­,ÄJ-m5âÅâMö)Sq79€3¯øÌ?ŠÃ<æ~ÈQÂq̇.ì6µŸý‰ÒŒô†£€ôžIgK¾]ïGÒéjÊ!éoCv”Í^a JH˸ìçø;%ü¢‡ŽB·‘Xœ[O”ë ÔŽgUð[¥kM•4FF~ŒúêÕxçÊÏ•€ÓìBTð hžÑš~; 9õ endstream endobj 4597 0 obj << /Length 248 /Filter /FlateDecode >> stream xÚUαJÄ@àY¶X˜âòr™ÐM.ÞA\8O0… •…X©¥ ¢íeå _ë|“XÙFlR,‰3…m¾â˜ÿ/ʽe4§Ýœög4/é6ÇG,r|ð{¹¹Çe…ö’ŠÚSŽÑVgôüôr‡vy~L9Ú]å”]cµ"Ð-€"ÀŒ4ÉÈ6"ñn"ja ‰g\ô ôê½… ßÃ}abZvL£ºRÈ´WÝ€î¸Wq‘þæÏz=Aè…æ³ã=AF­…Zp2Ǥ>}Ýþ±áÄm¼§ÿ1¾fxÔ‘0Sè!9„¦ƒTxRáþé^ñ endstream endobj 4598 0 obj << /Length 172 /Filter /FlateDecode >> stream xÚ}Ì1 Â@…á‹ÀæbæºÙ…è ‚#˜BÐÊB¬ÔRPQH!š£å(9‚eŠÝÙµ¾êð”(E!¨/I )ÒtxA©M )»eÂ8E±!©Q,LF‘.év½QÄ«I m%…;L¿ð>?9›:À^ÖÓj¬šµœŠµ7óœ’ùNÁ‚ÿ÷Ö=¨»Öj •‘Av†G ¹Êç)®ñ ®E‡ endstream endobj 4599 0 obj << /Length 266 /Filter /FlateDecode >> stream xÚUÏAJÄ0à?dQÈÂ^`0¹€v:B[¡LaÁ.]¹WêR¨¢ÐU'GËQ2x€‹É¢t|MUÆÕG^Âÿ¿dùéyªæ*W'©Êçê,WO©xÙ‚†t,¦›Ç±ªEr§²…H®h,’úZ½¿}<‹dus¡R‘¬Õ==ˆz­˜Å€È!ò|¯e£2ŽL»Äñ²ä[+1“-ÿ2R•c;“–íë¶2l ›IÓTšõAp©ÝfÒvàî@tc[¥§Ö èÙÿư`æ)ôÏaTzÄCY?›ô£´‰/C ÷EåîPÚÌ5¡„Û&„së~´¡„o eŸôs*ÁP%Äe-nÅ7ã7x` endstream endobj 4600 0 obj << /Length 225 /Filter /FlateDecode >> stream xÚUϱjÂPà?ÜáÂâ ˆ9/Pc0$Bj¡;u(ÚŽ…V2H¼à‹åQî#dtí¹É`]¾á¿çÿáÆÉ8ÉxÂ)?DÏxšògD¿GNxšõ/ß4/)|å8¢ðYb Ëo7»/ çëKºä7é¼S¹dÏâ蓺øù@7=æÊbTªEV´žÓŠUш?âI4›öà´õMÔÐâÚç;žØ@ê½A¯êmQSuj#Síêõ}7µ÷ÝÈ~Ô9ìÌÜ`^¹©ÀBË× è©¤ú’tUž endstream endobj 4601 0 obj << /Length 190 /Filter /FlateDecode >> stream xÚ=ο ‚PðO„³ÜGð¼@]ÿAµ(˜AAM ÑT Em¢B/foâ#ÜÑA´«BÃßóÀ›;¼â™ËÇþ‚¯.=È÷tè°¿œ6—;Å)É#ûÉ­ŽI¦;~=ß7’ñ~Í.É„O.;gJ Àì+ˆ¯‚92´È =™ ¡¥Y5"¡ÙÕ$*GE1À_ßkÐMŒAÛŽÌfb)­n!ê ¢Êa—!"„ºt¨5¾}€6)è•GÏ endstream endobj 4602 0 obj << /Length 238 /Filter /FlateDecode >> stream xÚ]Ï¿NÃ0ð/Êé!÷Òš?"R)èÄ€˜ZF¤‚@ê€j?šyó=D ç¤$¶ôî|§Ïjr¢ŸÊ=.ÏYMxzÁ«’ÞH•]õlºo-_iVSñȪ¤âNêTÔ÷üñþùBÅìᆥ:ç'z¦zÎÈLfÜU¸ò›/à2¸k`£­¸Ö&[ˆ~‡ÜÀõ6bòÓùÝ‘Tƒ~4óЃ{ÚÎh{“FRýD“öJÎÊÈ*+o£Ft:‡^˶ñCØÆf\8ØŒ&‡†Ñôи%F–Ó¶öŸt[Ó‚~JlÓ endstream endobj 4603 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚUÍ1 Â0à_:ÿ`/PìMC”v(j3:9ˆ“: U:ˆÍÑz”¡£ƒˆIÄ!Ë7¼ï‰é8âQL#NN"¦#Ç ¡ÃˆDòkgÌ%²- l©cdrE·ëý„,_ω#+h§‡ö( ò¯¿ ß0¬R‚GéC:k3•d¦V™ª4PÖ`  {@û1¼ÿ€¡gy9x–Ρoi|KãZ”Cf1.$nð ñÿ> stream xÚ=ͱjÂ`à2î’7hî èŸäÇ6]ˆ fìÔ¡tÒŽ…*:H|±é(V;Qû¬›X¶’¤\FjÓÛeý%E)æM“TÌ‚k1åRvûO1Åjª±˜™¾Ç}H9S Ü Á¹B†4øÅ7Z4^ë7^󝿬üð;r<×ÿŽÌȇ0È)¤ Êèz§»!ËB–e,; eá£__ß=Fʼ”W¹|/Hd endstream endobj 4605 0 obj << /Length 178 /Filter /FlateDecode >> stream xÚ]Ì1 Â@Ð )Óì„Ìt“MBÄ…Á-­,ÄJ-+³GËQr„”Bt ñóªÿá«|(¢œú1%Š2EûϨR.#Ê’ï²;baP®I¥(ç\£4 º^n”ÅrJ1Ê’61E[4%o!¨Aü™u4§x@ÕuŒ/øòØÓñYë¬qDówßûk;Ôp×pÒÐjh´WOü: ¬ðm 83¸Â7Ä¡B endstream endobj 4606 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚ5É1JÄ@†áo˜"ð;ÉMB¢™……uS,he!Vj)¬¢°•›x¥9ÊaÊ)Bp’ÍS¼oÓ\^]sÉ-_TÜ´\·üZÑÕëK®õù¼¼Ó¶£â‘ë5w1SÑíùëóûŠíý WTìø©âò™º##„M~!ÝJõ‰Ë&Ò ­zåt9FìaÆô¹õ¹u‘Þ"øYa€áÌ b&ÄõÏ9ã1¬ÄM¤‘J·°‘^-}´ð‰?Ÿ°9:o,”U ÛŽè;¢VF endstream endobj 4607 0 obj << /Length 205 /Filter /FlateDecode >> stream xÚUÍ1jÃ@Ð/¶L!]ÀXsxµ^ƒ¶¬"W.B*'¥Á v+éh:ÊaKÆxl%4þ†oÝlÎ9üdxaØüa苬•2gëÆËþ@ËšôŽ­%½‘štý§ïó'éåë3Ò+~3œ¿S½b$PTˆ§h»$&wÊ;.CÕ¹ Yw¬þÐ ¡A ß †¿ ¸HD†‘)Ô€ TøC‰8À!ö#Çÿø_¢^P=”W¼ÉDC)´ƒö­kÚÒ V²Aš endstream endobj 4608 0 obj << /Length 238 /Filter /FlateDecode >> stream xÚUϱJÄ@à?l±0Åí ·óš,GHŠ`à<Á‚Vb¥–Â) r—GÛGÙGØ2ENÜS8¦ø`vfv¦,Ï]ÅW|測y]ñ³£7* žc]§—§WÚt”ßsYP~-iÊ»þxÿ|¡|s{ÉŽò-?8.©Û2" 5Bõ¶×+hßú……–‰&Q[Xo}ÝÂöÆïfô?´BÜÏôAqaú#ÐGØÏ L0P3 ¨(E§È>QZ–ÐAj4‰ú„¯ÄNq1 ‚2!šQydqõ-«`l.ŒÜÝvL¿@WÝÑaÔ endstream endobj 4609 0 obj << /Length 216 /Filter /FlateDecode >> stream xÚEͱJÄ@…áR Ü"y¹/ Iv"f!XW0… Õb¥–B…KœG›G™G¸eŠŒ,Ææ+þSS_l8ç’Ï .K6—üRÐ;™ís6Õiy~£]KÙÍ–²Û%SÖÞñçÇ×+e»ûk.(ÛócÁùµ{†òÊAzD¬jÈUW>õsèô‚ÕnVÐnŠ¡í-t‹ ¬ß+Ãʼ2ýü3¢;Ž_| üJà%Ár,¡cQvŽ$FŸŒ)úêX£‘F \ì@7-=ÐsºJÅ endstream endobj 4610 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚUпJÄ@ð/l˜Â¼€¸óšÄäHŠƒƒóSge!Vj)DÑN.>Z:_ca;S„à·Q9m~ ³ó)³“âT3­ô8¯´,´¨ô>—')Œfº(¾îeÝHz­ÅBÒ Æ%m.õåùõAÒõöLsI7z“kv+ÍFá˜QÁ¸‹Ø–Ú"qõ Ißîé`{¿ƒ}w3ÁˆÕ ¢™á›fÀÆÿaBì™»=ÑÌð3ã ÓKˆ·žM;tŸÄ~®è±='sŸ.ìC˜Ë±ä |G ew´†UuÌ‚%s‘LáárÞÈ•|–ob3 endstream endobj 4614 0 obj << /Length 85 /Filter /FlateDecode >> stream xÚ32Ö30W0P°bC3s…C®B.ˆMÎåròäÒW0çÒ÷ž¾ %E¥©\úNÎ †\ú. ц ±\ž. ÿ €ËÕ“+ hz¯ endstream endobj 4615 0 obj << /Length 210 /Filter /FlateDecode >> stream xÚuν Â@ ð”B–>‚y¯¥VÝ ~€ÄIõÑú(}Ç¥ñ’£¶î¹»$ÿ$Å ijOQ2£s„7Ƕ¥”‡Óçš=c4k{‹&ÛÐãþ¼ ™o¡YÒ!¢ðˆÙ’˜ù `-ÕZµWb ¬–b *ѯEO'«¯?rûÓuùU;ÍMNu—ìm2Ôl ¿T~7U7O“á-¦yëÐYˆÁÝë0ï÷ê4E_çºëUižR-ú™ \e¸Ã/-©J endstream endobj 4616 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ31×3²P0P0bS …C®B.c3 ßÄI$çr9yré‡+›qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÁÜКì=,'Lp¹zrr˜‹r endstream endobj 4617 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚбnÂ0àC –ná¸(Nhš*€Ô •Ú©CÅŒ  vNÍÂ#xd@÷'@iÕ©Ë'û,ŸÏž'’H.cÉ™$²JyËYfEÛŽ»“å†ËŠý»dûg+³¯^äs÷µf_¾N%e?“T’W3!êkCD…LÕ ªœ¹§Akq"³Ž4 „#³¡^è©]yêÛ"wlEtF8Ü[„ßÖÍߢñ¿,4ÞkÝî%w¯ÿ^ÅäæºÎ#ÄO]į]D0@KÆ´”lÄb›^¼$i©ê-a¤ÍóŠßø ˜´ŒÉ endstream endobj 4618 0 obj << /Length 104 /Filter /FlateDecode >> stream xÚ3µÐ³0R0P°bSCS …C®B.˜ˆ ’HÎåròäÒW01âÒ÷Šré{ú*”•¦ré;8+ré»(D*Äryº(üg``°?0èHÀMN7c\®ž\\Dµ˜ endstream endobj 4619 0 obj << /Length 99 /Filter /FlateDecode >> stream xÚ31ѳ´P0P0b#S …C®B.c ßÄI$çr9yré‡+›pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ3ÁH'€àN‚ËÕ“+ •aý endstream endobj 4620 0 obj << /Length 231 /Filter /FlateDecode >> stream xÚm̱jƒPà#ÂY|ÏäjA›I!I¡…vêP:µ;4$!¨sËkøutÞþW¨÷’v8|üÿçöf‘eË—¥’.å=á/NM›h†·O^•¬ž%ÍXÝ£eU>Èn»ÿ`µz\KÂj#/‰Ä¯\nD·Dè+:Îô ÒãDýËŠz<€|檙\®)ˆ<ÁÒBЃ–K:ÐQhñA zŠ,hÀ@…… Õ†#U†ŠF‡Ü¬#žK„†“Kxê'ÎÁ¹û‹ÿݺè O7¤éÈÂw%?ñùˆ¶¬ endstream endobj 4621 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚMÉ1‚PPÉ6=ˆ$¿#AL¤0ÑÊÂX©¥…F[à&^…›È()Ȳš¿Å¼dfb½Ð¨§Ä!Æ/!ÜaI[@•Žó ÒÔ—¨Í´‚Ê·ø|¼® ÒÝ CPC Ng86–å×?[agza!,g¶"}¡W Òe[Òa;Òf{Òba)L*£_=¶!]¶%¶#m¶'-i!,göMúBïctG£#´ÿÂ:‡=|xb¬Â endstream endobj 4622 0 obj << /Length 281 /Filter /FlateDecode >> stream xÚ­‘1NÄ0E¥ˆ4¹$FÚPZZ‰HPQ *–’uÒq-߀+ä)SDþ؉¢"Vü,û{<ó§q§îŒkÞñ‰ÃÜpSóÑÑ íjÖq¾=>Ó¾¥êŽw5UWاª½æ·×÷'ªö7ì¨:ð½ãúÚSLF¿NzÌ™Èä"#`Ef œíø!£R,}0ÊÁäÙqƒFĕJÕ"-A#­è4ƒ®ÿš£ï%"ü+Öнþ3OP ”|Že `ÇlIÕ A÷1iÝÝgôÅ*V{qU‚iÕH?òm2,W"’Ú!©9±;ÅÔ…Ô¬?D”cBj¤M(æ„%"C—-ÝÒàçK endstream endobj 4623 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚeϱ Â@ à+B–>Bó^k­¸ª‚ÄIÛGë£ô:vž÷7HO„».!¹$‰'ó˜C^Ø›L9Yð%¢;Í ñDâ|£,'}àYLzc£¤ó-?¯+él·äˆôЇ'ÊWlŒ)•²¶½]¯ ÁJû¬aÐ@¿…£7ôÄ*Ñ8ºÙn¨•>ÒSúË_øWføÎÓ9sÖèä7p,"®Fâz"ª¾§K˜ŠýŽA=è7ƒcÙ×ÝÚ™üwߦÕ`PÓ:§=}Ù—š¦ endstream endobj 4624 0 obj << /Length 247 /Filter /FlateDecode >> stream xÚ}=JA…K&h¨dŽ0uíùc6lYWpA#YÔpƒ¡ûhs”9„,S¾qÃM>êïU½î¶»ª)¥•ËZÚZºRÞ*Þs³B±”®þë¼îxݳ’fÅþeöý½|~|½³_?ÜHÅ~#Ï•”[î7B™Q¡QÔ™.T5eÀà ùL:)ŒäRH”¥˜ˆR„ˆÌg¡§9“Q€0ŽËYä¹"Ä5ìVÍÁ:+²Ž ÑFhrÌ 7¶(?Áþ‘…›® /†ohǬq% 8 I™¦ˆçÃäf®–‚S|Ûó#ÿï·|ï endstream endobj 4625 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚuŒ± ÂP ES:²ÔÑAh~@_¯K§B­`A'qRGEçöÓü”úBcZÜD.gÉÍ=.¥“£©%—Kéhñ‚.¦>É·9œ1/ÑlÉÅh–zFS®èv½ŸÐäë9Y4í,Å{, ‚¨_B‘:yDÂvA;ÿ5R`Àãÿd¬V«‹£Îã¬ñ¸ªýé~ðY”ª¹j2ÎúͰ}s Oö:\”¸Á5y\, endstream endobj 4626 0 obj << /Length 180 /Filter /FlateDecode >> stream xÚ½Ž½ Â0€¯8·ô¼Ð4¦N…ZÁ ‚N⤎ŠÎí£õQú;”œJÝ\Ìð…ûÿÒùlI -hª)•?¡‹Æ;#I u_9ß0·¨d ª¤QÙ-=¯+ª|·"‰ :jJNh ò ïˆ:AÌ‚ŒkðÌ 0³vY \Õ¨iôah@ù‰¬ú_ xØùþZ·ŽÛàâ‚UüD²ä ü$ø‹àÚâßu} endstream endobj 4627 0 obj << /Length 179 /Filter /FlateDecode >> stream xÚ36Ó³4T0P0VÐ5T06U0¶TH1ä*ä2 (˜@e’s¹œ<¹ôÃŒ ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.Oæ òÿ0ÔÿÀðÿÿÆÿÿÿ0!û†þ ò8€˜Á¾‚븈ÿ‘õÀ̱?ÀÀ4— h‡û†:ö?Ìÿ˜ÿÿÿtà[>€ÝÄþ‡ËÕ“+ ßrDª endstream endobj 4628 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ½Ž1Â0 E]u¨ä¥GÀ€$1E*E"L ˆ @077£Gé; š4°ÀÆÂò$ûÿÑp0!IšúŠô˜2I{…'ÔÚ‹’2õÚ쎘[kÒÅÜË(ì‚.çëE¾œ’Ÿ Ú(’[´€qÿCZ{˜‡³qóÍÅÌì’6a—6»^ ”ÎTþ¢³»2>ÐþŒ¯á³GùJ ¹é=~w‰»jQW¸í\Mh€3‹+|'bo endstream endobj 4629 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚmŽ1‚@E?RL!G`. +¬šØH‚šHa¢•…±RK v8Gá”d×!R:Ékþäý=/BžpÄ£õŒõ‚¯!=HGNxÚo.wJRRGÖ©­Ä¤Ò¿žï©d¿âÔšORt¦tÍð 0@n ÇÚÒµ¶òZ¿ök·ñ+§ J´AO\ ‹e.d?:+°¦Ðaz²qw"–B…_c(/,]ã¹oÐé¹­¥¹„k@›”ô ÍUH endstream endobj 4630 0 obj << /Length 133 /Filter /FlateDecode >> stream xÚ32Õ36W0P0b# 3C…C®B.#3 ßÄI$çr9yré‡+™qé{E¹ô=}JŠJS¹ôœ€|…h ÊX.O†ÿ Ìÿ0ð±<Ûq}ㆠ Aø3“ÿÿÿƒ™É4‹Z˜ËÕ“+ Û[þ endstream endobj 4631 0 obj << /Length 234 /Filter /FlateDecode >> stream xÚ}±J1†ÿåŠÀ4y„Ì h6ç\·pžà‚Vr•ZZ(Úš> stream xÚ31Ò³T0P0bcs3…C®B.c4ƒH$çr9yré‡+pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ100Ð3þaøÇÿ¿áŸüÿÿêÿ?ø÷ÿÿ‡ÿ?äüÀþãÿæÿ˜ÿüo`üóŸÿÑs¹zrr¦…{ endstream endobj 4633 0 obj << /Length 95 /Filter /FlateDecode >> stream xÚ3´Ô³0Q0P0bCSs…C®B. ×ĉ'çr9yré‡+Xpé{¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þC¨'p¹zrr4ö+³ endstream endobj 4634 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚ½Î;‚@à%$Ópæ.bK‚˜¸…‰VÆJ--4Z³GÛx:)ã?ÁMöÛ×ìÌäÉ|Á ë̱$|NéFY†ótÔ‡Ó•JGvÏYFv[²nÃûóB¶Ü.9%[ñ!åäH®âÑ`ü›ÙÂD=ˆ;P´ n€x3‚8„„=ˆ:· h@í`'Òþ@ˆ|,oå…¿â‘EŒæ3µRxE ÅJ¤u#í TfÚP ­Ú¤™¨'<­íè 'µwÕ endstream endobj 4635 0 obj << /Length 89 /Filter /FlateDecode >> stream xÚ3´Ô³0Q0P0bC3…C®B.s ×ĉ'çr9yré‡+˜sé{¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þQ¸\=¹¹6VLÖ endstream endobj 4636 0 obj << /Length 165 /Filter /FlateDecode >> stream xÚÕL;‚@\BAòŽÀ; ! V$ˆ‰[˜hea¬ÐÒB£µ{´= GX;ÌŽ‹–žÀb2¿Ì”Åd>å”Ë)ç3>ft¡"÷þcÇ¢=S­Hî¸ÈI®|JR­ùv½ŸHÖ›g$ÞgœH5,‚—{ábèÂ%0´{ ŒžðªO[YtÑ`b BG:„ˆzè~¸rßï!Z*ÚÒK=Ù endstream endobj 4637 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ31Ò³T0P0bcsc …C®B.crAɹ\Nž\úá Æ\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.OÆ? ÿøÿ7ü“ÿà_ýÿÿþÿÿðÿ‡üÿØü?ÀüãóŸÿ Œþ3 ð?:`.WO®@.²dG endstream endobj 4638 0 obj << /Length 190 /Filter /FlateDecode >> stream xÚ1‚PDÇPlÃØ èç †X‘ &R˜hea¬ÔÒB£­p4ŽÂ()Œëw-hm^1“™Mìd6刧<¶œDÏùdéJqêÄ諨s¼P^’Ùqœ’Y9™L¹æûíq&“olɼ·¨,Þ@ 5I ˆô‰¼œî¿‡ èPÕA‹¬„MV#hü¶rèOÀë\š×ÿ‹áV1$kQè*-×:H§éHTÒ¡4ÐhYÒ–>Yñ]] endstream endobj 4639 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚ­Î;‚@à!$Óp纋‹D+ÄD ­,Œ•ZZh´†£qŽ@IAvœ5cibóóü£ÉxNšb…1EšÌŒN!^Ñ©jšF}ëxÁ4Gµ#cP­¤Ž*_Óýö8£J7 Qe´I0ϼÀ,$\e®™à&i«@(0<+À vJ!ù…âû¿/Ë×7.ý®OÐ$KU»|²àìÐû­ÛË·øfswo endstream endobj 4640 0 obj << /Length 133 /Filter /FlateDecode >> stream xÚ3²Ð36W0P0b#sc …C®B.#rAɹ\Nž\úá F\ú@Q.}O_…’¢ÒT.}§gC.}…hCƒX.O†Ø?üáÿðÇþßúþøûŸáï†ÿþ?`øŒþ3@Ñ?Š—«'W Ì“C¥ endstream endobj 4641 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚMÍ; Â@à ir„Ìt³‰­"1‚)­,DÔÒBQ°r÷h{”!¥…dc¾æŸW¢£„"Š©¯)‰(ÓAããTˆ†]g¼Dµ¦8E5—U¹ ëåvD•/§¤Q´Ñm±,L¿Àg¶³ Eö)ðmž}À?Óɬ¨[¹† ½Ñ@€ÛP&ØÉ„ª/ÿg"vâk tìŒeÙ3²¶wžòÈÎJ\ánONØ endstream endobj 4642 0 obj << /Length 133 /Filter /FlateDecode >> stream xÚ3²Ô³´T0P0TÐ5T0²P01WH1ä*ä22 (˜X@d’s¹œ<¹ôÌ̸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ŒˆÁÿÿÿÇÀÄê¥ÿch`üÇØÀðŸýÐR®ÿÏÀ`””ÀÀåêÉÈ|Q  endstream endobj 4643 0 obj << /Length 127 /Filter /FlateDecode >> stream xÚ31Ò³T0P0SÐ5T06¡C®B.c4¶€È$çr9yré‡+pé{…¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ10þ¡/f†bö?ÿäÿÔ7Ôÿ©ÿÿÿýÿŸ@üñÿÿƒ˜ÿ00p¹zrrÁja‚ endstream endobj 4644 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚMÌ; Â@à?¤X˜&GØ=k ¢VÁ-­,ÄJ--m“ÜÄ›hŽ’#¤L¢³ ÂÂÌóŒæ£ÉBUÈÍlœCºQ4åºïØÁéJ‰!½WÑ”ôš»¤ÍF=îÏ éd»T!éTxóH&U_ ¨r@–ˆ‹’‘%rô2K7 j¯uð¿qðZ¿fD ´¢º>D”@ÞÃoËâÏ‹‘¸oKLjօV†vôg9Hã endstream endobj 4645 0 obj << /Length 220 /Filter /FlateDecode >> stream xÚUÎ1jÃ@ÐoT¦Ñ4pVkYÄ®¢"W.B*'e »t’ä*{’ #¨T!”Ì®¬Ãò`g˜?“¯îkÎXó\ßsîß»¦#å…T3.–×Öá“6%©=ç©'©“*Ÿù|º|Ú¼<°&µåWÍÙ•[þ’¦Rë1õˆ©R‹ ž¤´BÜ¢f=¢n¤CÔGfWZ`ˆ= ðå‘iT‰L ý©Kñ·ãw"ê'dÏ ­kxš‰Øc]T •ìXù™!à2Kr×KÚÑ?§êVv endstream endobj 4646 0 obj << /Length 148 /Filter /FlateDecode >> stream xÚ36Ó3T0P0bccs…C®B.c˜ˆ ’HÎåròäÒW06äÒ÷Šré{ú*”•¦ré;8+E]¢Zb¹<]êÿÿÿƒ†00°``àbù@|€Á¾¡ˆÿ300üc``bæ?@ehJíQ•‚”1þASúMéÿÿÿþ£a.WO®@.—÷P endstream endobj 4647 0 obj << /Length 197 /Filter /FlateDecode >> stream xÚµÐ1‚@ÐO(L¦áÌtYqV$ˆ‰&ZY+µ´Ðh+£pJ ú,ÄÞæ³™ìü?“5å€CO9\²šóEÒBe†«E÷r¾Qœ’8p¨Hl̘Dºåçãu%ïV,I$|”œ(Mn À׆L€Ö%­+¸WcT»x•ÓÀ+ÑÀ/ÁÏ!2äf;Ï EÏð4†òü|Þ38²¥»¾Å†±±l@Õ†¶ñ»"l%m9´NiO_¼ìvü endstream endobj 4648 0 obj << /Length 219 /Filter /FlateDecode >> stream xÚu1nÂP †ÿ(C$/é âð’& &"•š¡R™:T€‘R‡Šäh9JŽ1µ#ÑU’Ÿ?ûÙY2>r̩؇#^%´¥4Ó<¶Ô Ë M roœfäžõ•\ñÂûÝaMnú:ã„ܜߎ?¨˜3Â@)€'RÃiˆ´E:DmtBTgäZÇÕ—öT' ¯:ç¢b¨ÿ`À5ò_T”=4p¾ÀÓ‘ðm£ U„ÍOÿ{¯õßôsÍ8ÌðÌðÍš¿Z)zð¿ §‚ô уe endstream endobj 4649 0 obj << /Length 241 /Filter /FlateDecode >> stream xÚ}±JÄ@†ÿá` ÷2/ ›\\Ñ*rž` á¬,DÔRPÑ:÷hy”}„+S„Œ3O¬,öc™ýçŸù÷¤:K.¹æ£%×çNù¹¢wªƒKgóËÓ+­Zòw\ò×Z&ßÞðçÇ× ùÕæ’+òk¾¯¸| vÍX QˆôÈD"r‘œÈ7ºEÌ'4}6¡&ªrÆÐißÈ/&=YÂ¨È i’Û™6…NSl&›o:\%þ#¹üØomÍ„~"þ ÕÅG¿s bKv}.h§±DÆ9oJžÙG ³ •ÓUK·ô =gf endstream endobj 4650 0 obj << /Length 248 /Filter /FlateDecode >> stream xÚuÏ1NÄ0ÐoE"Ò4>‚çàdCT‘–E"T[ *vK ´$7á*¾Wð H™"Ê0D@AóÆ[ãùÇåQ½â‚+>\quÆõ ïJz¤ªÖfÁõé×Íý­[ò[®jò—Ú&ß^ñóÓËžüúúœKò¾-¹¸£vÃÈ&N”N aDd"#ò)Ÿ`3ÁEÌp¯hzt‰F‹Ö×ÏJøƒý!þƒ‹Ýoš˜&'º¨¿)í)“ýˆ¹È{ÐÕÞ‚‘9=”´Ò. :í›yÁ¤¬Ùˆäš nÐåº+šÜ‰ôéä¢ÏŒ¦×A:—.Zº¡OÌæzc endstream endobj 4654 0 obj << /Length 163 /Filter /FlateDecode >> stream xÚ31Ô35R0P0U0V06W0¶TH1ä*ä26Š(›%’s¹œ<¹ôÃŒ ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h –X.Oæö8qsƒÍ憺Ì ÿê››ÿØnÿÁÿ¸ÿóïý ÿÿ10Øÿ``àÁ 6P $RR ÒÒ 2d>»@nárõä äøED‡ endstream endobj 4655 0 obj << /Length 149 /Filter /FlateDecode >> stream xÚ31Ô35R0P0Bc3cs…C®B.c46K$çr9yré‡+pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä00üÿÃÀøÿûÿÿ üÿÿÿÿÿýÿÿ@¸þÿÿ0üÿÿÿ?Ä`d=0s@f‚ÌÙ² d'Èn.WO®@.Æsud endstream endobj 4660 0 obj << /Length 223 /Filter /FlateDecode >> stream xÚUÍ»JÄPà_R˜æ´Vf^@O.fm„Àº‚)­,Äj×RPQØb1y´ó(±² ؤŽ?»²àÀsafÊâä¬ÒLK=ε̴:ÕU./RÌØdYí&Ë'™7î´˜I¸b[Bs­o¯ïæ7šKXè}®Ùƒ4 lè8 „ÜøH#PwÀÇ#õÄò_Xg_Ha8G5³5<žá0ì%\ߙȸÖòVˤ¶©ðƉñ·±éŒ_ZJ»#ÜVdoø3ÂuÓ–çÝ#|Ç >m@¬#䲑[ùŽqR endstream endobj 4661 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚ1 Â@E°L¡70sÝì ’@°ˆÜBÐÊB„€ZZ( 9ZŽ’#XZ:IV›t«þ 3ïOÌØÄrÄ#²‰xjø¨éBºN%7nt8SjImYǤ–’“²+¾]ï'RézΚTÆ;ÍážlÆ@TðJô ø@ ðhxÁ«jze/¨ š]aöåÙáýÝ;¿íÇÎAdDÉ/ak+ÚÎ?i¶¥”T“‚RSÊ"§…¥ }G«@ endstream endobj 4662 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚ1 Â@E¿¤L/ :ÐÍ®A"ˆEŒà‚Vb¥–‚Š‚…EŽ–£äÁÍ$±ÐNxÕÌgæý¡˜1‡qß„l">hº.§!Ǧ^íO”XRÖcR 7'e—|»Þ¤’ÕŒ5©”·šÃÙ”s Î@ t€h~//i¹ÝKxO`L®Ð“tIVãçßxÅ?üÞù¼¨>ö‡©(=C±uÚ•¿/ñ@ªÅRÓr•iniMoEËBs endstream endobj 4663 0 obj << /Length 161 /Filter /FlateDecode >> stream xÚ33Ñ3µP0P0WÐ5R²LLR ¹ ¹L @ÐÄ "“œËåäÉ¥®`jÀ¥ïæÒ÷ôU()*MåÒw pV0äÒwQˆ6T0ˆåòtQxÀJB±SŒ \Å¡˜!’ Ø%¡æý@5¯bÙ–A)~d%P PírÈFC-‚Z+‡ì$¨QL‚z…DK ¾árõä äµd*… endstream endobj 4664 0 obj << /Length 104 /Filter /FlateDecode >> stream xÚ32Ö30W0P0WÐ52T02R03RH1ä*ä24Š(XC¥’s¹œ<¹ôà M¸ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. ÿÿüÿó‡a0C ¹\=¹¹¶ h endstream endobj 4665 0 obj << /Length 102 /Filter /FlateDecode >> stream xÚÍŽ;@PÕggÜwAí“x…„J!*” Âî%>‰EÈt3ÍØ00 •¾UjÌØrR¬Ð豆iø¥qAæ 5‚T‡¸šûv̬ɩ‚½Ò p¯ó:½_ó¢thq_þh endstream endobj 4666 0 obj << /Length 103 /Filter /FlateDecode >> stream xÚ33Ñ3µP0P0WÐ5´T2u MR ¹ ¹L @Ð*•œËåäÉ¥®`jÀ¥ï¡`Â¥ïé«PRTšÊ¥ïà¬`È¥ï¢m¨`Ëåé¢PÿÀäÿP *ÈåêÉÈ- +´ endstream endobj 4667 0 obj << /Length 130 /Filter /FlateDecode >> stream xÚ-ɱ Â0…á gð 2œ'0¹-¥™k3:9ˆ TGAEçæÑòfÚ¢|Ûÿ—ÕÒ7ôlXUÔÀ:ð¢x@='eý;ý m„;P=ÜfÌpqË×ó}…kw+*\Ç£ÒŸ;Zä“Fy2d›åÏd“L*R!s™ÉB¬¹ËY°ŽØã ,P#Œ endstream endobj 4668 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ-É1 Â@EÑ?^á ¦xЙ‰‰mŒà‚V"ÑRPÑ:³´Ù™&Nwo¾\ø’ž%红V\ó¦xA=y1žö:À¨n×w¸°ççý½ÃÕ‡ ®áYé/ ­tò‹½4è’M22ÉD³˜ÉT&2+•<å*ØñBÛ#´ endstream endobj 4669 0 obj << /Length 94 /Filter /FlateDecode >> stream xÚ32Ö30W0PaCsK…C®B.K Ïȉ&çr9yré‡+Xré{€O_…’¢ÒT.}§gC.}…hCƒX.O†z†ÿ 0XÏ ÃÀåêÉÈ[\w endstream endobj 4670 0 obj << /Length 153 /Filter /FlateDecode >> stream xڅ̽AÅñ ɉ¨ŠóÌ—eëµSH¨"‘ ” ôÍ£xw³ÓN¦ø5çæþgvZ8œ8K¿àÜñbñ€·²–>žÎ7TzOo¡×²C‡ _Ï÷ºÚ.)k̓<j*¥zÑP ¢±‰R˜è.NÑO|[ƧÕmÈÜÏdSéL6•Îeé\6•NdV;üxÔ*Æ endstream endobj 4671 0 obj << /Length 101 /Filter /FlateDecode >> stream xÚ32Ö30W0PaCsc3…C®B.K ×ĉ'çr9yré‡+Xré{¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]dêþ7À`=ƒ 1S—«'W fp"¸ endstream endobj 4672 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ33Ñ3µP0P0U04T03P06TH1ä*ä25 (Ae’s¹œ<¹ôÃLM¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. õÿAà˜üÿ‡Îj-Ô\®ž\\~,Ü endstream endobj 4673 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ32Ö30W0P0S06V04W0µPH1ä*ä24PA#SˆLr.—“'—~¸‚¡—¾P˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓE±¹A†A‚Á‚Á€¡€!0€Âs ÿþÁz ´oàcàrõä ä-#ª endstream endobj 4674 0 obj << /Length 162 /Filter /FlateDecode >> stream xÚUÌA ‚@à7 ÿÂu ÁÿŽXÓJ0ƒfÔªEBµ ,jímŽâ¼AiÒ"ßæ=xj1›kŽû¤)«%gš/ ÝI¥ÊÆå|£Â<°Ò$7}MÒlùùx]I»'$K>&ŸÈ”ÂGƒÈ½mÞ~¹¼ûi\Ô…ÎáðG8Ô¢x­8ÂM lÏŸj„¨0­ íéb+12 endstream endobj 4675 0 obj << /Length 94 /Filter /FlateDecode >> stream xÚMÉ=@PEáþ®â®À¼™x¨ý$^!¡Rˆ ¥‚°{ äTß±4J2:*5¡Å4嬨`ö¢£ÿÆ´"žfšû¹@ò¶ BJJ7"”¼ï몀Ði ‹ endstream endobj 4676 0 obj << /Length 165 /Filter /FlateDecode >> stream xÚ32×3³P0PÐ5T06V0²P0µPH1ä*ä2‰(™B¥’s¹œ<¹ôÃj¸ô=€â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. Œ Ì Øð107È0°3H0°1X0ð10ð00È0$E@øPôPŸc0nøß`ÿàÿû0\@Œíø€Ìärõä ä;g0÷ endstream endobj 4677 0 obj << /Length 90 /Filter /FlateDecode >> stream xÚ31Ô35R0B#C##c…C®B.Cˆ D"9—ËÉ“K?\ÁÄKßCÁˆKßÓW¡¤¨4•Kß)ÀY(è¢ ÔËåé¢ð $—«'W Rˆ endstream endobj 4678 0 obj << /Length 119 /Filter /FlateDecode >> stream xÚ31Ô35R0P0´P01T06Q05QH1ä*ä24ŠÅ¡Rɹ\Nž\úá †¦\ú@q.}O_…’¢ÒT.}§gC.}…hCƒX.O ††Œÿ˜ÿ±ÿáÿ À¾¡ŽáÆ.WO®@.Ϭ{ endstream endobj 4679 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ31Ô35R0P°T0²T06V0µTH1ä*ä22 (Ce’s¹œ<¹ôÃŒŒ¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. 5 5ÿþýg„" Õ1ü*Êl*,,0‘ƒ—«'W /¨67 endstream endobj 4680 0 obj << /Length 172 /Filter /FlateDecode >> stream xÚ31Ó34V0P0bSK…C®B.# ßÄI$çr9yré‡+˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]ø0Aý? Áøƒ½ýãù† ö@CÿùA2þ€’@5@’±D‚!™dþÀðPI¸ùÌCdþÃÀþƒ¡þÿƒÿÿ “\®ž\\^åˆÓ endstream endobj 4681 0 obj << /Length 175 /Filter /FlateDecode >> stream xÚ3±Ð31Q0P0bScSK…C®B.SßÄ1’s¹œ<¹ôÃL ¹ô=€¢\úž¾ %E¥©\úNÎ @Q…h ÊX.Oþ êÿ³ÿg``üÁ~¿ùûÆÿüäØÿÉ?`°gàÿ¤êàÔ õN}`o`üÁÀþ¤›™ÚÔøFÑ¢¢˜ÿ0°ÿÿƒÿÿ? Q\®ž\\à  endstream endobj 4682 0 obj << /Length 154 /Filter /FlateDecode >> stream xÚ31Ó34V0P0bSK…C®B.# ßÄI$çr9yré‡+˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]øÿ0AýÿÆÌذIù~ iÏ"ëÈ?P¨†ñ3õÈÿ@€JR×|Z“ÌÀ0ù Çÿÿ@&¹\=¹¹)“ endstream endobj 4683 0 obj << /Length 208 /Filter /FlateDecode >> stream xÚåѱŠÂ@à?¤X˜f!ó·FHÄJð"˜BÐÊâ¸J--îÐÖ|1}_aaËÁu=ÎÒÎe¿Ùýg›Mû]îp,+íqÒçeL?”&Òwš¶¹X¬i˜“™sšË)™|›ßíŠÌpúÉ1™Œ¿$ùMyÆ€vˆ¤Š3|-{Pé½ÓeƒÓ!,¨„GpPghÁºFdPCWTíÓ-”k¦¡Cˆðj( ­g¸f"{¿!ªý—Â[ïÞ—ÿA£œftàùËC endstream endobj 4684 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚ3³Ô3R0P0b3sSK…C®B.3S ßÄI$çr9yré‡+˜™ré{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]ø0Èÿ`‚úÿ ÿÿ=```üÁÞüÈ`Àxþ?!ßÀþŸAȰgàÿfÔ1ðÿAeücu1þ``ÿ4Ä`¦ã?`cÐÓƒ–Áü‡;€‘ýàÿÿƒÿÿ7`2¸\=¹¹UEÖ¾ endstream endobj 4685 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚÌ1 Â@…á· LàœÀMŒÀBŒà‚Vb¥–‚Šv¢9ZŽ’#¤L!êÄ‚ºËWÌü0aÔíìs_„D¼hO¡Ïõ—±«-%–ôœCŸôX¶¤í„‡Ó†t2r@:å…œY’M¦€zÜáæ&óÐÎc¸¥§ÜÁ©ÎPÕêöøp±t¼¸e£] 0.â,$+IJ’“‹¬áâ­õ§_ÏFn_óoõ^:,Íè Àv;r endstream endobj 4686 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚmÐÁj1à é^=;OÐd-‘õ$¨…îAhO=”‚ÐöX¨ÒÞ„Í£í£ø{ô°˜N"¸Q6>fB&?™Nî'izàmf4Õô™ãáZûÒ||ã¢DõJÆ zâ.ªrM¿»¿/T‹ç%å¨Vô–“~ÇrEP@X×ìû8õ \²²IU{ó˜»ùÁ3ÌbÆYã¥1Ezôè$æ'i=SË©†LÂB„p6Pu Ž–8ç:R†£ ²Ž÷›[4ß9Þ²áéí…ÃŽ&ÎÈ&üZÚú'­ãXήÁÇ_ð%°m¼ endstream endobj 4687 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚ•±‚0†0Üâ#pO`Amd3ALd0ÑÉÁ8©£ƒFgúh< ÀÈ@¨…«Ú´_®íÝýýe4fÐÜ,¹ ¹¤kˆ”µÓ„íÅåŽqŠâH2@±5§(Ò½žïŠx¿¦EB§‚3¦ i3 €5C8ZA–›À/:LÊ^ÕÁ­ûpšôXpžÛôkÚF¶­±bIF°Ü2ÕéqžËUœNÐC¨™E>ª_…ñ÷c‹ð+v·d¯ó¯åínÔâ&Å~VŸP endstream endobj 4688 0 obj << /Length 260 /Filter /FlateDecode >> stream xڭѱJÄ@à? LaZ áæ4‰Üª[-œ'˜BÐÊB¬ÔRPÑÖÌ›ø*¾‰yË+Äuv²g!–Bà#“ÍÌî¿ÎïúnÙñÎ;ÇÎóMG4÷Zly¿›¾\ßÑ¢§æ‚çžš-SÓŸòÓãó-5‹³#Ö÷%_vÜ^Q¿d ˆRPDZT†¸R´öR ÊOÔµ þ@ù*˜(ÞAWEÁ],øR‚º˜IµRê5ú7P­Ñ&?”2oÆ(~#FLØàgÈü5=dF#ïzv¢L;mf–Ä&,—mXJ[°Ìa Þ#å }Rº:%e-vÁvS½•Ô=U:î霾šes– endstream endobj 4689 0 obj << /Length 194 /Filter /FlateDecode >> stream xÚ33Ö31V0PaS Ss…C®B.S ßÄI$çr9yré‡+˜špé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÁõBýc``üßD@.ƒý0ÅÿL1ÿSŒÀÃ?UBÙ7@¨`JJ=SüPêŠýê (<ö¡9ÅñP¯@=ómrüC%h˜ACž  !@ y`> stream xÚuб Â0Ð  ·ô¼/0­ µ‚Dª£ƒ¢³ý4?Å/iLsqˆð’»INÍÆª œ&vª)©9 ¼¢‹åý¶O4¬4Ê©åÊFQê5Ýo3Êj³ ­ioK¨k2ýè D˜ÒÀ€§dFLƤ1’(­C8^Qˆ€„ÉÆDð¹ïɰ|pÃ1ÆÛ½Ó.þ"bøÿyÒ€Œ)™gëºk¸×¿àRã?UŸ’~ endstream endobj 4691 0 obj << /Length 166 /Filter /FlateDecode >> stream xÚ35Ñ3R0P0bSCSs…C®B.s ßÄI$çr9yré‡+˜˜sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒÀd’ñƒü†ÿ Œ`’ᘬ“6`R‰äÁAòI68ÉØ€L2`%™‘Hv0)"ÿÿG'!âP5Ⱥ‰ A€J$ãÿ `G@%¹\=¹¹Mÿx× endstream endobj 4692 0 obj << /Length 254 /Filter /FlateDecode >> stream xڭѱJÄ@à?l˜&yM"&`µpž` A+ ±:--­7`ákMgé+ä ¼òŠãÖÙÍ& XšæKf’Íì¿]{Üt\ó)p×p{Æ =SŠu¨ÄÎæ‰V=U·ÜvT]j™ªþŠ__Þ©Z]Ÿ³>¯ù®áúžú5ð(ü6S¬ßü`À쑊-Ì— oÕ¶¸áÖë¥d‡ˆ¾¯ I¾Sòý03a‘™LlB".€¿Ñ!1ÍúOx½&ÂpcÄJÂ&ÆHù‹¸£…¸Û…˜„rI)¥ÌÜ” _ò,v0Ÿšõù{lØtéT–‰é¢§úî”Û endstream endobj 4693 0 obj << /Length 125 /Filter /FlateDecode >> stream xÚ33Ò3²P0P0bSKSs…C®B.SS ßÄI$çr9yré‡+˜šré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿÏøÿÿ?TŠñó bü78) À¤¯s‘)hèb y.WO®@.!»¥7 endstream endobj 4694 0 obj << /Length 106 /Filter /FlateDecode >> stream xÚ3²Ô³´T0P0aKSs…C®B.#3 ßÄI$çr9yré‡+™qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿ†€ˆ¡¾aècWüÅåêÉÈ3v\‚ endstream endobj 4695 0 obj << /Length 165 /Filter /FlateDecode >> stream xÚ31Ò33W0P0VÐ5R0¶T05WH1ä*ä26 (˜ZBd’s¹œ<¹ôÃŒM¹ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. öÿÿ?@"äÿ000°ÿâ„=ˆ¨oÿ`#ø?0üoõ ü ä0X0È`a°o`àŠ2°7Ãñÿ qõ \®ž\\ŸÎ`¬ endstream endobj 4696 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚ]ÑÍJÃ@ðYrÌ¡¾@ û&A[sjsìɃxj= QôjöÑò(y„=HÇíÌÿДeöDzÌÌ~,¯/•/üUŒeé7~_òG‹8"ÇÝ;¯Οãšó›GÿõùýÆùúéΗœoüKé‹Wn6^DÈÅ8×I êF"!¢:˜+2oa[8˜®7“`¦dÎ`+ØÂÁÔôhLM‹fp ˜&byiguf0«­~5Õ¿jŸþ©RrÀyd* îÕõSkÜ_ Ÿ¨ NÔÇ÷9LÕxoéá ÿádÔÿ™‹„sù¾á-ÿ5Š•P endstream endobj 4697 0 obj << /Length 140 /Filter /FlateDecode >> stream xÚ35Ô³T0P0bKSs…C®B.S ßÄI$çr9yré‡+˜˜ré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÿÿÿ€™dü€þ3 eR/i& 0È ò‚d“Ì`’LÊ?`üßÀðÿÁ@!¹\=¹¹Afl÷ endstream endobj 4698 0 obj << /Length 244 /Filter /FlateDecode >> stream xÚuÑ?kÂPð{<0p² Þ'ð%œÿ€ ur(Ávt°ÔÙ€«ê•]ÝÌGÈè|½¨X#yîøÝ=8. [~›< 8¢€:½û¸Ä°ËµW”ÅÇ|ýÕ”Â.ª1wQÅÏôõ¹ú@ÕjH¯>yoÉà瘣1 ýƒ¸ 8hFãx‡]Ê*ñ›1æ•øá8§¾yºØTBŸ¤,a P³ —À“M õ2Ü< œ fepÒˆ\$ÀIÂÖ5+zÛG4÷V¸Y5D NZ@fWðí¤'c´ÔÒÇýoÊÀQŒü¦Â! endstream endobj 4699 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚUпJÄ@ð/.0…ûfŸÀMNÖ?óSge!Vji¡hkRù\AKÁTÖ©$EØuwöŠM1üøf`Šï`¹·<’…Üw£¥>”w%=’Ö.>úÃí­jRWRkRçnKª¾ÏO/÷¤V›SY’ZËëR7T¯¥µ@fµm óÀ¦‡í¼ÅÏ0 à{d¾¦˜üۘÎ=õ4]LÕ3ùȦ€aÒ@b·´liº@ÏT|`Ä“MLjbËÀ¾Å4ŸLõ“ÿ1ÂÄdtFÀœW$®Gœ á*Ã.|ר™±ÕtIÿ6D†c endstream endobj 4700 0 obj << /Length 239 /Filter /FlateDecode >> stream xÚ­‘±‚0†Ï8˜ÜÂ#ô^@D'ÔDŒ“::htGáxWÚœmš~éÝßöú_LÂyÒxJsNgoô(ò»ÌéŠIŠîžÂÝ5‡ÑM7ô¸?/è&Ûñ~IŸ¼#¦K¶ Cµ¥ Ô¼*x1F%¨À)dBœÃè ñ‘Š…¬ªA«ÑŸ8çEÅjGîU…Ò(ßNk¼ûÈ4ª,— ~ÐjÔ…}Á<ÛC¿2[|Žþfa?­-ÈÖžÆ3ë ñ“­oŒ×œÈ¾}°]Ñ=ÂUŠ;ü”K‰É endstream endobj 4701 0 obj << /Length 167 /Filter /FlateDecode >> stream xÚ35Ó35T0P0bS#Ss…C®B.K ßÄI$çr9yré‡+˜Xré{E¹ô=}JŠJS¹ôœ ¹ô]¢ÆÄryº(ü‚ ê„úÏÀÀø¿,ÊÀ ÿLñSÌ? Ô0Åø™adªT Y;ªÑPû ¶CÝuP7ÈÙÿÀÔˆ ƒ™….ĵ˜—«'W ŽK€¿ endstream endobj 4702 0 obj << /Length 309 /Filter /FlateDecode >> stream xÚ­‘±JÄ@†ÿba æ3/ I ‰ Bà<ÁZYˆÕii¡(6‡Y±õ¡ò>D|I™"Ü:³$EÀÒò…Ù™Ù™ÿ/²Ãü˜Êé -¨àŸºKõ£Î3Ž&t”G›½¬t|My¦ã Žë¸ZÓóÓË½Ž——g”êxE7)%·ºZà[ÈÙV°óþz=ÞªEd€°‘¥ê€šKzNä¬.{7Aâ|®Œ$sQèЄÒ>j"‡vDÉmvsÔý#ƒL°ÿb~ÃüöùdóáGŒûñ¶[ÞVužeø½ÿajÖEyȳv¾Y©:À†%*?ñʵÑJî¤~D`q£ìû€@\qðíBìcáÌšpê`¶èŽÐþ ™j‚óÚ·²<§Øq}^é+ý 6²¥É endstream endobj 4703 0 obj << /Length 221 /Filter /FlateDecode >> stream xڕѽ Â0ð–‚ì#x/ i*Uœ ~€ÄIí£ù(}„ŽJãÙK Í"&…äHrÿt¢F*ÄÇ8 q¢0šâYÁ È€f4ãÊé óäžê ×´ 2Ùàãþ¼€œo¨@.ñ 08B²D­uåÐ uf,HW§‚ ô¥lüfëç¬(ºz¥eõ§Ö~ûüæÞ¦Øô§¹_Qš@™ñÍëõ6Ò+L®6ŸñeålóZ¹šÿ«›v,X¿ÕKéP~ï‡ÞEÔºe¯Ö©úN=â’¹«vð™<›Â endstream endobj 4704 0 obj << /Length 256 /Filter /FlateDecode >> stream xÚUϱNÄ0 à¿Ê)K¡~h{=îÄB¤ãè€Ó ˆ @°!ZÞ̉èF%Psw ²|Jì8¶ç‹Ãª¦’æt0£ùŒŽŽé®r®^j°¤EµËÜ>¸U㊠ÕKWœkØÍ=?½Ü»buyJz_ÓuEåkÖ?€ÆŒ!òÎf°l#>Ù3ZÎ;@Î'€ç7Àîx ïÉ&Œ&È–Nm9ƒR0—!¡G/aEïFD+E$½ÑŒµ²MX‰¿„^É>a‡-úÆü‘Mˆÿèû=¦×:upÇ´–¤-µiÞ}õèGŒˆA§Š^{s¦ywÖ¸+÷=Ÿ†# endstream endobj 4705 0 obj << /Length 150 /Filter /FlateDecode >> stream xÚ3µÔ³4W0P0bSsJ1ä*ä2ñÁ" Fr.—“'—~¸‚©1—¾P”KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEÁþ?<@£0ÿg`ÇÀøùA ˆbüP¢>€©T*L`¥€)‹`J+ŦF Åþ¿Hʃ‚ârõä äWÎr° endstream endobj 4706 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚåÐ= Â@àÑÖBÈ\@7‰¬ÆJðL!he!Vj)¨h«9šGÉ,SˆëlÅ3X,ßòf˜âu¢VsÀmnFlzlº¼ é@ÆH¸¤˜¬w4HH/ØÒ‰I'S>Ï[ÒƒÙCÒ#^†¬(±µÊ>ñl \3X~ZPCAù©J'BEH?4€þ—ºôuâ7{©-'¿ROrï%ËxºVÝ™‹Ã·¹CÙ ï qBszØxaº endstream endobj 4707 0 obj << /Length 240 /Filter /FlateDecode >> stream xÚmÐ1jÃ0Æñg1> stream xÚuÑ1KÄ0àW „ãºv8ÈûÚôÎb ç vtrá@ÿ…?'â)ΤC¹ø’£âMHøH^ÂK^Yì/Pá÷æX.°8ÄÛ\<ˆR¡ëÅÑvçæ^,k‘]b©DvJË"«ÏðéñùNdËócÌE¶Â«Õµ¨WhíÀ­í"kÿ·ä@öŒæ¤àmDâ$f~¤#; Hl ¿¥½8@£ÁŠwdFUšì¨%[pù¤^q(é`J7)¯Iˆ’›ÑMk¯T¢äRÙñRI JN%}¤½Ö<=“Dt2l¥IÜ©yÑÑ&ôFš:Uï; ôAš9ÉOŠ} ô5*¡¿­ºÿÄÿ‰°­ ÄœŒE'"'íEÑ<´¾¦®_g'µ¸ßÑÆ©Ñ endstream endobj 4709 0 obj << /Length 231 /Filter /FlateDecode >> stream xÚÍαJAàYÈÁL›"y÷.p1©b¯L•BAS¦P´Î=’p²2EÈ8»n@ô,†ofgÙ§“ËÉŒK®´¦×WüRÑ+ÕsË8ÆÅó– ¹5×sr·zJ®¹ã÷· ¹Åý5Wä–ü 7©Y²È ð~k%…öÒvìT²Z^{ÓcÝÙ³ ÷ÃâôU«o²CÕ0Ë–*¤ÅSTB¶‹ú`ζÑñÞ&‡í%‹ãE¶Ÿ´§QÒÈ0›b4è3¾Ýe}÷¿Íÿô"Ý_馡}Èl® endstream endobj 4710 0 obj << /Length 204 /Filter /FlateDecode >> stream xÚmÌ; Â@à . ´Vf. ›´1àL!he!Vji¡(X›£å({„”Á8ë£—åø‡ùÝéÅQ—Úš’˜º}Úi<"ÏÈŃ÷f{ÀQ†jÅ{T3ŽQes:Ÿ.{T£Å˜4ª ­5EÌ&¡€º6äü¥…°%/_x÷/PAP02gøýÁ0Ò¦–yp&îî¬dBw›:Œ+0ðÁüâ}¨AT¾yóMÞ6Ó¢5lö–¢.Ë5²Ài†K|¤øT£ endstream endobj 4711 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚ31Ó34V0P0RÐ5T01V0µPH1ä*ä21PASKˆLr.—“'—~¸‚‰—¾P˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEùÃT‚D0S$ê00|`ÇÀü¹A¾ù;ÿæ ì˜ÿå˜00þ* àÄ?8Q"êI&êPMÊøbÛ½`Ëßœq ä ã ò Ìê˜þÿ:]þ—«'W ÈckA endstream endobj 4712 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚÎA ‚`à'?( ‘œ ”ýüºÌ A­ZD«jXÔ.Ì£yàÒ…Tcu€ßæ 7f: 5ÙðP³™° ø éL¦ %¿—ý‰â”ü MþBbòÓ%_/·#ùñjÆ’&¼•ÎŽÒ„¡ZÀ{ÈUe5ÈTÆ©¬Ö-Õ‡W¨6êÀj@-ÐÉÅóOù¯Ó‰;*`{ú^‰ž[bàTd7“ý w§”§ÍSZÓ»= endstream endobj 4713 0 obj << /Length 198 /Filter /FlateDecode >> stream xÚ31Ó34V0P0VÐ5T01Q0µPH1ä*ä21PASKˆLr.—“'—~¸‚‰—¾P˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEÿó‚ÁþT‚zó !ÿHÔ±÷`øÁøþó†ú쀶¤ „|P±=˜i«‡u âÉDª)öph‘<„ÚkrF=ÈAï?0þ`<ÿŸ¡†½ÿ?ƒü?þÿ ì@‡s¹zrroXhI endstream endobj 4714 0 obj << /Length 189 /Filter /FlateDecode >> stream xÚ]Î1 Â@Ð\˜B/ 8ÐM²(ÚЦ´²+µT´“èÑr”!åbI qáÁ23ü;èö9änÀ¶ÏvÈû€ÎdC)úlGUgw¤IBfÍ6$3—2™dÁ×Ëí@f²œr@&æm)‰Ú¸·2Ï©\^¡sϵ2¸Î÷¯HÅøQ‰RñþQÖOþø—Ö5ÉQÑJrµìhè M£íÂá„TårL¼@³„Vô½£@ endstream endobj 4715 0 obj << /Length 141 /Filter /FlateDecode >> stream xÚ32Õ36W0P0bcSK…C®B.# ÌI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢*c¹<]ê˜ÿ70ð|À ßþ€ÁžÿCÿ`ÆÌ00ŠÿÿÿÇäè§3ÿa`¨ÿÿ޹\=¹¹¢&[ endstream endobj 4716 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚ¿J1Æ¿00…ñ v^@³9ïäŠÃ…ó·´²+µT´[¸}´> stream xÚ31Ó34V0P0bS …C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. Ì€à?É&™iN‚ìaþ`ÿD~°’È700nà?ÀÀüDþ“ØÀÈä‡$Ù€‚ëÿÿƒÿÿ7 “\®ž\\y endstream endobj 4718 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ32Ö30W0P0aCS3…C®B.C ßÄI$çr9yré‡+Zpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜ø0È@A@ 8~Àüá? ±q©ŽØ0üÿ‚¸\=¹¹(CE` endstream endobj 4719 0 obj << /Length 150 /Filter /FlateDecode >> stream xÚ32Õ36W0PÐ5QÐ54W0´P05SH1ä*ä22 (˜Ãä’s¹œ<¹ôÃŒ ¹ô=€\úž¾ %E¥©\úNÎ @Q…h ®X.OÆ ìø   P?`üÁð†Ø€¸ôE6Œ?êügüðŸ‚üc?PÃ~À†Ÿÿó.WO®@.ÿ§Wõ endstream endobj 4720 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚµÍ1 Â@Еir3'p.#˜BÐÊB¬ÔRPQ°ÍÑr±0EÈ:? êdÙ³3ó7èuÂ.{Œô¸òʧãH‰ÆrCqJzÆGz$¯¤Ó1öÇ5éx2`ŸtÂsŸ½¥ […RÊüâë?´LõºæÝ3Ø‚ærÁÊkm‚¨„;xÔÂ3êH†Kv¤Ø@%¯â.êýoÔ nn—**ŒÉù@Ô¦ôDr endstream endobj 4721 0 obj << /Length 108 /Filter /FlateDecode >> stream xÚ32Ö30W0P0aCS …C®B.C ßÄI$çr9yré‡+Zpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜?0ü‡!þ ̃±ÿ`øÿÿq¹zrrÆ‚Q. endstream endobj 4722 0 obj << /Length 177 /Filter /FlateDecode >> stream xÚ3³Ô3R0Pa3scs…C®B.3 ßÄI$çr9yré‡+˜™pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]˜?ð`Àðÿƒý†ú@úƒ=ãƒ:†ÿÈ77Ø3ðnà?Î ßÀüÿˆþÇÀDÿa`ÿÁÀNÿ``ÿ€þÀÀþ`Ð O€âÿÿƒÿÿ7ÿÿNs¹zrr#߈ endstream endobj 4723 0 obj << /Length 147 /Filter /FlateDecode >> stream xÚ31Ó34V0P0bcs…C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. Ìø?00üÿ`ÿD~°’È70ðnà?ÀÀüDþ“ØÀÈä‡$Ù0½ñÿÿÁÿÿI.WO®@.‡e% endstream endobj 4724 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚŽ1‚@E¿¡ ™†#0Ðeƒ6 &na¢•…±RK v9Gá”Tâd)H¬ÌN^fþîþù‘žÌ¦ð”Çš£€Ã9Ÿ5Ý(ŒE”qÑßœ®”R{cRk‘I™ ?îÏ ©l»dM*çƒæàH&g8^W‰S­œQƒdHàVðá•R¾ ò!J*¨- Ài~ nNû/†ooñkg»Íîõ$AéÖHåŠ> éáwlzZÚÑIKÚ endstream endobj 4725 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚα Â@ àH†B¡y½ž­uj;:9ˆ“::(ºÚ>Z¥p"ØŠç]qÐQ |CB’?Šû2ä€Ü“1G!‡#ÞI:R°«aøm”d$V$f¶O"›óùtÙ“H–$R^K6”¥ŒÊ¯À¨\ƒ¹UW0÷Â/¼º%>Á«°T¨5*è´4hy~“ÿÌ÷ö²¥ý¦Ýß> stream xÚ31Ö³0R0P0VÐ54S01Q06WH1ä*ä21PASc¨Tr.—“'—~¸‚‰—¾PœKßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEùÃùŒêØ0üa<|€ùÃãìÊð?`0?À€Áþ€> stream xÚ36Ò35R0PacCcs…C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ØÈ3üPàÿÃÇþ?nÿÀÿœýó3 ~Äo˜0ÿah`þÁÀ€‚?P³Íüÿÿs¹zrrjÙF„ endstream endobj 4728 0 obj << /Length 195 /Filter /FlateDecode >> stream xÚ=αJÄ@à¶X˜fßÀÌ x{›`TñSwÕ‡•Z * Wî£í£ÄÊ6`“"8Î%GŠ™ùÿfŠ|q~ÆK.ø4p¡ó‚½R^j¨çåÔ<> stream xÚ36Ò3²T0P0TÐ5T0²P05TH1ä*ä22 (˜Ad’s¹œ<¹ôÌ̸ô=€Â\úž¾ %E¥©\úNÎ †\ú. ц ±\ž.  Ø W á Œ@Ì Äì@,ÿÿ?Ã(f„ÊQ „þ0‚pC sC3ƒ=;ÿ?°f.WO®@.uH– endstream endobj 4730 0 obj << /Length 153 /Filter /FlateDecode >> stream xÚ31Ó34V0P0RÐ5T01Q06WH1ä*ä21 ([@d’s¹œ<¹ôÃL ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.Oæ ìþ`üJò`À‘p’ƒºBþ`°ÀÀðƒ¡üÆçÿì™Iùÿí@’ùÐ.WO®@.1c endstream endobj 4731 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚU̱ ‚PÆñ#‘k[çêªWJ'Á rjjˆ ¨Æ†¢¶ˆûh>Š`›Ph—º—jù ÿ¾@ BŸ\ò©ïQà“ÒÎÃ#ŠHE—Äè³l˜dÈ—$"äS•‘g3:Ÿ.{äÉ|Lò”V¹kÌRj×_œ œÒ.Á.X ,g0i)à <¡¥©¡pƒ¶&†®A†=éjœ|c(v‘kØ]þb=ÀÐ(Ô¿áúO¨ÁI† |F£?ê endstream endobj 4732 0 obj << /Length 233 /Filter /FlateDecode >> stream xÚUÎ=KÃPÅñs Xx³v(æùzËíËb ­`A' ÖQ|A7©‘|±€Ð~Lïx‡`¼7UÓN?8gù«áá°Ï!ñAÄjÀÝÏ"z$¥ìr·¿~nîh”¼d¥HžÚ™drÆÏO/·$GçcŽHNø*âðš’ WUPñ÷6¾Aß´4æðŠ5¹§q ‘þ" bxØ%âtÇq¿Á_ù®cùGˆÅ²h;²š÷L€ Ëtè5Â<þfúOk…2·|âµÁ+ñ–ZlECÝdÑ ±ï(°ç˜ÂÑIBô¥Y_™ endstream endobj 4733 0 obj << /Length 210 /Filter /FlateDecode >> stream xÚMν Â@ ð)(¡«ƒÐ> stream xÚUÎÁjÂ@àYi® Î èn²Zõ$¨sÚSE¨GÁ½‰æÑöQ|„x ‰³²Iéå;üÃüü=ÝF¤(¢N8 ^DúÖ!þ qª¨¯ÝiµÅIŒò‹ôåœs”ñ‚ö¿‡ ÊÉÇ”B”3úI-1žQY¦ãâàAægà//7ˆœŽ4gËZŽvª*Ì 0‰Ã¿˜Š+ã]S‡¸CEÉ@QsüϰFÕì,IqSn/¼'¶’gCþbŸ^m‘mjg`ç1øã'>ÚŸKø endstream endobj 4735 0 obj << /Length 183 /Filter /FlateDecode >> stream xÚ%Î1 Â@„á‘@„‡$|'0‰+AA¢‚)­,D¨¥ ¢æQ<‚eŠ`œÅ_ìì·°&î# µÇL_M¬‡H.bìÚ£½ØŸ$I%ب‰$Xp• ]êíz?J¬¦Êu¦[>ÙI:ÓIU•uO§Ã)Fh~ðß!;£ó:còÌÛዬQÖ‘‚ôŸÿ)HÿåpIëH]R·YÀ#õH[¤mé(œ²âl2Oe-?uàC endstream endobj 4736 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚµ1 Â@EH!L“#d. ›ÍºˆBŒ` A+ ±RK EÁBb޶GÉR¦R×l´6¯˜˜ÿþPtÌ+îǬƬ5$Ii;ŒXÜf¢$#±a¥I,ì˜D¶äëåv$‘¬f,I¤¼•í(K~ |[äj¿„W¢‚opGÏà ÀÄ!´—S‹¢E¦ /‹òèzù´ÌO¾6x+Ó¸YÛ~åÕÎÜuдñí…æ­éÂÕ`ú endstream endobj 4737 0 obj << /Length 121 /Filter /FlateDecode >> stream xÚ31Ô35R0P0bc3SS…C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]0001;Ëñÿ ÿaX*6T°ý†úÿÿ?À0—«'W ¾NÚ endstream endobj 4738 0 obj << /Length 228 /Filter /FlateDecode >> stream xÚmαJÄ@ÆñoÙ"0M^ป'p÷WóSZYˆ ¨¥ ¢`eòh>JáÊ+ŽŒóé5‚E~°;ÿY²¬šc­té_^iÓèC-/’³Ÿ+9¸’u'éZs–tî·’º }{}”´¾<ÕZÒFoj­n¥Û(Ê-€~‚Ù€8¶#J^ÎQì0CÜc…0áùîÈDÌ_úŸžÓÁïø:ßsöNüaçü™r$_΂[-> ³À,°ˆ, %‡s„'äƒlÏ"³ÈÌñ¥™aAZÒ›M°¿ÈY'Wò TŸc| endstream endobj 4739 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚuÐ1NÄ0ЉRXšß`3', ZiY$R AE¨€ ´ØGóQr„”[¬0¼„‰"OÊŒóÇ“ãîÈ/¥•^—ÒŸ‰÷òØñ+÷ÅVüɾóðÌëÝ­ôžÝ%Êì†+yûxb·¾>—ŽÝFî:iïyØ™-­2È9QµµÕ EëPõE6‚f¤LÍôV»&‘ÆàðÌÔb&e6‚€§Ñf“õÕŽó‘òY (yâ/ifU ý°Å_ cBüÔ¨M>Õ‹ý‚¸Ÿ™°y¥ÿ€‚޵¸2_ |ÃßÇ›jh endstream endobj 4740 0 obj << /Length 188 /Filter /FlateDecode >> stream xڕν Â@ ð+ At-(˜'ð®¶µkotr¡P?ÁQðÅ_ÄÇè èý‹­³ù‘äIàõÃ+FŠÃ!¯=Ú“™º,ñ‘o)Ñ$ìG$'¦KROùt8oH&³{$S^z¬V¤SBĢ⊠ØÀ©iƒèA«äf°1ë€h‚.p;»Áö`¯Z  \2ðoóŠß›ÿÂy™³54Ö4§òý`ö endstream endobj 4741 0 obj << /Length 226 /Filter /FlateDecode >> stream xÚ•Ï¿jAðïnaÜ ˆÎ ˜½s=b!j W¦J!‚`R ìnÍG¹G°´8ÜÌœEH:›_1;ödÏyŸSp¯ÏnÈyΟíÉ9)¦œ¿Ü_6[šd?Ø9²oR&[Ìùð}ü";YL9#;ãeÆéŠŠÇÀŒÇæÒºÂ„ÐpQ*Å+j .+xsº7á”xÄ•‘Íç–Üð‘\ƒ }µrÓþ† ”¿ø´•R þ/:tK­¬uéîNTc¨'Û¼‰Ä'ò¡jìiT”2ƒ®D¥×‚Þé+XÑ endstream endobj 4742 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚm½JÄ@…OØ"p›¼ÁÎ}d³ƒÚXW0… •… j)¨hëäÑò(ó)S„ÏD…m>†{çüÜuuìVZj­G+­ÏÔ9}ªäMjÇa©îägóø"›VìÖNìÇbÛkýxÿ|»¹¹ÐJìVï+-¤Ý*Ðô@ P„sŽºø‚&¾³¾[ D>#E@ƒ¢Ç†r˜Iõ~2û> stream xڕα Â@ àHÁB}Ѽ€Þ]õ¤“…ª`A'uª(¸ÙGóQî|ƒšTZèàà‘û†?$w#3°i²ÔhdÈŽéhð‚CË!Çá·s8cœ ÚÐТZpŒ*YÒíz?¡ŠWS2¨f´5¤w˜ÌHŸP˜Qžç®ÎëY’ 4aÐ:B@à ¸Ç8 ‚—1¾ìn -¡SQ¼üRá-8­ð d“_Ñ®Ó+ÈJ¢_<ÿ!’¯tùâ<Á5~lúQ- endstream endobj 4744 0 obj << /Length 265 /Filter /FlateDecode >> stream xÚMÁJÃ@Eo˜ÅÀ[8мÐ$A„ÒB­`B]¹WêÒ…¢ÐEÁù´ù” ;#Ç›*ÖÍyóî{wæÎquÔLµÔZ§ZŸjÓè}%OR7KmN~&w²l¥¸Öº‘₲í¥¾<¿>H±\Ÿi%ÅJo*-o¥])L OÄ[ À`;d1ëa¶°3X`LpÀM6{ä{xÖSÏœ˜°Hpžî|tO¥0£1l¹6Ì ùi4ÈþÓ,ìÀe3zŸÓáw™gRÒô¦SÅß@v伕+ùÿcå endstream endobj 4745 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚuÏ1NÄ0бRDšÆ@ò\œlÖBT––E"Tˆ ¶¤AKr®â›ì!eŠ3³ ˆšgiÿ_×'aE5t¼¢æŒB ÇŸ± 2¬(œÎ_žpÓ¢¿¥& ¿”1úöŠ^_Þvè7×çT£ßÒ]MÕ=¶[‚b—….'0SÉ2*(ÙŒ`&p ÞÁõBì!Ît ç¼àÒð_èÝ_èR¥c§Ø™%Éž 6{6Cñ!I¬cˆ“Ä)A×ô?€Ö«ÌÁ“ôXZ1IÁØËN+éOVë”ùÀäqY‰-Þàú m9 endstream endobj 4749 0 obj << /Length 102 /Filter /FlateDecode >> stream xÚ32Ó35V0P0b#CCc…C®B.C˜ˆ ’HÎåròäÒò¹ô=À¤§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹ƒýƒúõþÿ€AÏþ—«'W !‘$‡ endstream endobj 4750 0 obj << /Length 93 /Filter /FlateDecode >> stream xÚ31×37U0B#C #…C®B.s° 1D"9—ËÉ“K?\ÁÄœKßCÁ˜KßÓW¡¤¨4•Kß)ÀYÁKßE!ÚPÁ –ËÓEá?üC&¹\=¹¹J®# endstream endobj 4751 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚÕѱ‚@ à’.<‚}#èF‚˜xƒ‰NÆI4:ãñ(÷72(µeqbÑÉK._þÞµ7\šŽgÓDv6¥tN§¯˜%’czp¼`a0ÚQ–`´’*FfM÷ÛãŒQ±YTKÚKËMI>×A»Šk‰üb¶2p:È[àvä ²; ¯zªUë^_mT™ÐŒœè} ä2H«¾öÜ/;è¯óÿEægÎòMCâÒàßλáR endstream endobj 4752 0 obj << /Length 256 /Filter /FlateDecode >> stream xÚ}бNÃ0€á‹ó[ñòŽ«í#•Ú[wж¾£¯Ïï7´«ûkÊÑ®é)§ìë5€Ú‚,ÝÇH‡Y˜1Fu˜EÃ1˜Û$Ì`„Ú³$ª] ½ciÕÝiÇ’˜¶MÓ6Òj T§Ä%˜0Òú©`t‰è)ßšô »µýÚ£Éî§ûì0„R7¡ ŒÇ’A¢«Ó\—þt‚‡dèC@ëf;„wÛ€75>à/G°ž% endstream endobj 4753 0 obj << /Length 263 /Filter /FlateDecode >> stream xÚ½‘=NÄ@ …¥ÉÍ!¾L"±ËnC¤e‘H¢J ´$GóQr„-·­ñŒ7qF}#[ãŸ÷–«Óõ9Õ´ “†–g´XÑsƒo¨¬Sxm™§WÜtî5áZúúxÿ|Á°¹½¤Öª±Û´ (E¸TV";§‘èYäepšÒ{ðJý¥9†~P(eÔRÂé™XföìdH-Ø ÌXq*óKÏíÄ8§ãþ/÷ü§~ÖbyœoƃÑöq?´}Ý`ôƒéáÁô©ÀôºÓïëØ0fW Ø';´¬jœô÷#˜©†úcŠÍªþyÄ< ^ux‡ß³ = endstream endobj 4754 0 obj << /Length 196 /Filter /FlateDecode >> stream xÚ37Ö32V0Pa3 Ss…C®B.3 ßÄI$çr9yré‡+˜™pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒ@˜þ¥ÿÃè õ?ØÿÓp,ÿBóÿ‡ÐÌ@@4#P2Íðÿ„®ÿ€JÛÿ@£ÿ@hytúú?iBöÿAu?œ†ú«þª¿aá¥aá ?öÿ¨á[ÿþ°ø@‰Ÿ?P\®ž\\2oÉ™ endstream endobj 4755 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚ}б Â0à+Â-}½'0­Út µ‚ÄI‡‚¯ì˜¡Û¤…¦VÇÇår~>ÅS hR(Šéâ#^ô¦-Ç &ÙŽ"ŽlUÜ"“kºßgdÉfA!²”ö!”)isÞÀKT •¡oéY<py~# ³ˆ?@Iæz­S=©Z¿ˆ¿‹Ah1s–Ì!oâ9)ù–¹ÁÓʦ«:#Ç¥Ä-~·Ê endstream endobj 4756 0 obj << /Length 159 /Filter /FlateDecode >> stream xÚ33Ð3°T0P0bS3Ss…C®B.S# ßÄI$çr9yré‡+˜qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þƒÁ¬CýfÅPÿLÉC(~ÅŽB1£PŒX© ª‚Å€Dý@¦!;˜úÿ7UÓ€j š ø(ÚP °ÅEq¹zrrco©· endstream endobj 4757 0 obj << /Length 262 /Filter /FlateDecode >> stream xڽѱNÃ0à«2Dº%à{p<¸-“¥R$2 ÁÄ€˜€‘súh~”> stream xÚ36Ó32T0P0aSs…C®B.crAɹ\Nž\úá Æ\ú@Q.}O_…’¢ÒT.}§gC.}…h 1±\ž. ÿÿÿÿƒŒê0 uŒî'.WO®@.•õy9 endstream endobj 4759 0 obj << /Length 263 /Filter /FlateDecode >> stream xÚ}ѱNÃ0`W"Ý’GˆŸ'‚6Ý"•"‘ &ÄT¨`mòhåM"ñÙ"Ê‘³ÿƒ­ƒ¥Ï¶ìÿ|./ÎÖK—»óy”…[–î© WZ•ó<—©lì^hS“¿w«’üõ¼J¾¾qoû÷gò›ÛKWߺ‡ÂåTo3Æ2OÀ4ƒ1&ë Е&`1¶’H@ÕŒ@8-§iHd€D#` Ñ•t2*Æ= ð-¯ü|qÌâOŽéü¡h96Ž¥ŽbÔ£ˆR3· <9QXF7Ü+´chFm”vµb S„ŒÐ^¹:¿cÿÑ›ðƒ swtUÓýQ~Ö( endstream endobj 4760 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚ}Ò±jÃ0à·è ì{‚ʦIëBÀ¦P…vÊP:µ;´´ÒÁ~°~?‚Æ &×S !HÁßIËwWÅÙÅœ :—[U4¿¤—ß±šI_„6|<¿á²A·¦j†îV^Ñ5wôùñõŠnyM%º=–T> stream xÚµ’ÏJÃ@Æ'ô ì%/ î¼€¦©6éAX¨ÌAГñ¤=(z6>™ }‘‚/ðaé8³ÛÔéÑìæOæÛo·ÌË#âò‹ Ž'xŸ«'UŒ8:Äòx•º{TÓJe×XŒTvÎq•Uøòüú ²éå)æ*›áMŽÃ[UͨyR¢Zh‰FB ã™;$/€ör†«iÁeü.”˜ncŽkò“t{º^^8’ì¨#öa–3¾7³GÙØ ò/£xjÿ‹Ûævº¶é^ïoEÞ·v¼o¶Â6ÑjyÐ{óÆÉ„æn_Ì y²Ÿ`?ëôƒý5_ÜÃ^kéu⥠žòìà]<¯Ýp~-쉸oÉN©ö‘¿l7h×l6hD@Z„„+nL> stream xڥѽ Â0ð‡Â->Bï4bÛ­àØAÐÉAAëækù(>BG‡Ð3͇‚uP=¤òAYý‡Ú¯K]¹k̵ÚpÍ&ŽËœÛÈ…MšÊgd ŸÎoç°Úk|x–¯pÿ +‡Â@Zä/0ƒ´d73(Mº\5|¢³3¿WU =e0ƒ>¬ß endstream endobj 4763 0 obj << /Length 263 /Filter /FlateDecode >> stream xÚeϱNÃ@ à?êÉyƒÆ/iJ"•¥‘J‘È€D'ÄŒ X{÷hy”^åc¡¯êŠ™D5‡=îþÙü:þé§“ÎÇ|ñ_.þ(Ø_’ IŸ˜4B±±ÌCjÑz8½–nZ:Ð7¡6 endstream endobj 4764 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚuν Â0ð+„[ò¹'0­~€ÄIí›™Gé#tì =猪‹!ùAþ¹—úù€RÊÉG4Ó!Ã3vYªW}ØŸpR ßP>@¿}±¤ëåvD?YM)C?£mFé‹AhÀ0W–¹pµ•(Ô†Å&áRŽ_ïÕGW«¶RM©Êú1|šŠw5áFò—ú«ýö ]Ÿ÷æ·ñ¯¬5IW¦†º'C»§{p´Ü:ކ«ƒV†#Î \ã 8.y endstream endobj 4765 0 obj << /Length 191 /Filter /FlateDecode >> stream xڵϱ Â0ÐH†Â-ýï L«–ºj3:9ˆ“::(:·ŸÖOÉ'dìP{^ŠCEœÄ<¸Ü%¹$“Q”`„c^ Ïc¸À4å¸ }âp†Ì€Úâ4µä]Pf…·ëý*[Ï1•ã.Æh&GA‚}1è”t@%’c55lË)É1•’¬(*ÉÚúzí¼Ãºgã û¶?øqÛÛ[®ë„­Da_½=@ÖMÐ é4ÕBÚ3²ò'`a`Otí„€ endstream endobj 4766 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚ•Î; Â@à )ÓäBænbÄ*#¸… •…X©¥…¢­Ù£å(9BÊKÆY#X[Ìó‚?›M³ŒbJ]-(Ó9Á¦¹ô±kÝâtÅR£ÚSš£ZË•ÞÐãþ¼ *·KJPUtH(>¢®> stream xÚµ= Â@FR¦É2'p³$!vÁ-­,ÄJ--­o–£è ´‹dœ±ò¯æÁ·3ì<6{AŒ†\±Æ¸+ [ˆÎDi,7P3ŒP#¾eƸßÖ ²É5¨çƒ˜->E) ït´ÿD›ŽL®Ì”Z&U¼×!˧Òm,—J¯¿–yÿ"LŸXœÞI?ðåµ]ìÀ&^-Vìæ±gÇž·Zêø¿n$ù̴ɦ†¦p h¥Á endstream endobj 4768 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚ]ν Â0àS:wÉ#ä>m©Ð± ì èä Nêè (¸¥à‹õQò3ã­ þ\È'›3ʇEÁ)çrFçï2:RÞߥ}ì¶×”¬$S2{ZÏù|ºì)/&œQRñ:ãtCuňCèà:DávG|‡iÊFy”­öÐV;¡tPo¼0ðáƒÌ7ÀæÙ÷âª{äKxÕNÄ. P¡5­ô €’’ÒÒ‚¦5-éQle€ endstream endobj 4769 0 obj << /Length 155 /Filter /FlateDecode >> stream xÚ3²Ô3´P0P0a S …C®B.c ßÄI$çr9yré‡+›pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä?000þÿÃÀÀþÿ?÷£¾ÁþÁÿ†ÿÿŒÿ¡óFÁð¿FØ1 bˆÿ ÓÑbõÒøÿÿÁåêÉÈŽXo5 endstream endobj 4770 0 obj << /Length 264 /Filter /FlateDecode >> stream xÚ…½NÄ0 Ç]1Dòropõ @ZµU™ˆt`b81#æô x¥lŒ¼B$€Ž7œbì´Bb"Š~±ì¿?â¶?é;ª¨¡ãº§¶§æ”j|ƶoE]·„îŸp3 ½¥¶A{)~´Ã½¾¼=¢Ý\ŸSvK»šª;¶rJ“€xþâP0ów4Éð{\í .c9ØNø]ÿ”"ÿßY¹pÒ&Zm­¬m¥1¬˜÷BÏ`­XëX Ï2ÝÌ1Ï2s–Pª)£Ö—àH˜²r”Á€—L¥5ø1ýÒýáU¥—Wôš[$ÜtUòÝ’ŒáYņ'¼ðr˜Ô endstream endobj 4771 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ32Ó35V0Pa#SSK…C®B.#C ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ŒØÿ0ðÿ!ùÿ("”ªÁþ3Ô#!öÿ ÌÔFÿÿÿ€#.WO®@.Nq endstream endobj 4772 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ32Ó35V0Pa#3S …C®B.## ßÄI$çr9yré‡+qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ3üGBìÿ˜úÿÿq¹zrrÊWù endstream endobj 4773 0 obj << /Length 188 /Filter /FlateDecode >> stream xÚÝÍ= Â` àˆC!‹GhNà×"Ú ‚ ì èä Nêè (¸µÒÁkyo =Â7:”¾¦ÅÉÁ8„<ù! úín(žt4BMl}>pÐÓº.«ÁfÏ£˜ÍR‚›©vÙÄ39Ï;6£ùX|6‘¬|ñÖGB%%9µ "” 4Dªrr•{Ef‡V5 ÜR×’S^r_Ô,µÿ¬¥»IQiâNÉë[)%ö[ôyü/ Èû[<‰yÁo¨Rµ€ endstream endobj 4774 0 obj << /Length 151 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bS#cs…C®B. ßÄI$çr9yré‡+˜Xpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ1Ô`øÿùÿ Éÿÿ”gþ$mÿ7°ÿ«’Ìÿ>0Éÿþ`þ‰l@"üÿÿýÿÿ˜$—«'W Žá‰ endstream endobj 4775 0 obj << /Length 176 /Filter /FlateDecode >> stream xÚ31×37U0P0bScs…C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. Œÿ000ðÿÿ$ëÿÿ’ÿþ700ÿc°ÀÀþ‡Aþÿ2 \ i$Á €Êêäò?ˆl •Ä4b>Ä.dÛ!îp!îdræ~ùÿ€$Ø_\®ž\\-in« endstream endobj 4776 0 obj << /Length 193 /Filter /FlateDecode >> stream xڭп‚0ðš$·ðÞ h[I;˜èä`œÔÑA£3>Â#02Î+šhÔM‡þ†ûúçK£`¨#Ô8Âc¤1ˆqgàaÌSQðˆ¶H-¨†1¨ÏAÙ9žO—=¨t1A*õA½›¡ ]‘O›Pö±’JA…äy)Iˆ¼r&õÓ~ó®ßþàÇmý—·’ªkÂ]Ÿ{77”Ôx­Ü¿f}N$¹nýCâù&L-,á‹ endstream endobj 4777 0 obj << /Length 200 /Filter /FlateDecode >> stream xÚ­Î1 ÂP à‡B–¡¹€¾>ÚÚÍ‚V°ƒ “ƒ8©£ƒ¢›ðr4½I ›ƒ#Uuù†„?ùÓ¨•PD15m›RKqF ‹kL2F”ƯÕ|…ÝÍ„’ Í@çhÊ!m7»%šî¨GMASKÑ Ë‚Àð©†\.!ƒö97„;9ûwWð…ÃÚ è*¯=išÝ§ÕSùA÷uSyïÚA­û<»‰öÔÖìÉá& NÎj(GÕMÀ¿trÿû%Žñ¢‰› endstream endobj 4778 0 obj << /Length 144 /Filter /FlateDecode >> stream xÚ3¶Ô36V0P0bcsJ1ä*ä26òÁ" ‰ä\.'O.ýpc.} (—¾§¯BIQi*—¾S€³‚!—¾‹B´¡‚A,—§‹Ã?æ ÿÿñÿöÿDM}Ãÿ?þ`ÿ÷áÿæÿ@Ä8ÑPß$쀈` 4'þÿÿ‡Ap¹zrr8WÖ endstream endobj 4779 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚ%Œ= ÂP„7¤¶ñÙ˜„‡Æ.à˜BÐÊB¬ÔÒBQ°“£y”á•[„ŒûHñÁÎÌθb2+$˜Š+ä’ó]n: 2ç/*NârN7ærZmåùx]9]ì–bîJŽV9qµ*ý> stream xÚ36×34Q0P0bc#Sc…C®B.#K ßÄI$çr9yré‡+Yré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ø0°<¶‡âz þÁŒ@ÌÄòÿÿ?ø„™bTÂðÆÿ ÿ7~`øøƒýÿ@Ç400ÿcàrõä äÎpR endstream endobj 4781 0 obj << /Length 149 /Filter /FlateDecode >> stream xÚ35Ö30U0P0bS#cs…C®B. ßÄI$çr9yré‡+˜Xpé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ30ØøÿŸÁþ?’ý?ãÿÌ@5J2"‘Ì0’ñ?;ˆlàÿÿ¨Ìèâúÿ€¤üÿÿA*þÿçrõä äðŒ endstream endobj 4782 0 obj << /Length 199 /Filter /FlateDecode >> stream xÚe̱ŠÂ@Ð7¤¼&`Þ8Éš …(¨ ›BX+ ±RK EÁBÐɧ䦜"8ÞqaZÜ÷=¸yÒÎ$‘/$ëI§+ë”wœå良þ±Úò¨`=—,gýƒ+ëb*‡ýqÃzô;–”õD©$K.&âœQÎ~8¢˜¼-x¥)؇%‰à Vd‰.hUAëmPþ[‡0ªÃ+|D0|D] ×zy‡ÊÝ^Öœ}÷b‡Uc\6úù?ù»à?#Zh endstream endobj 4783 0 obj << /Length 236 /Filter /FlateDecode >> stream xÚuαJÄ@à9R,L³opÙ'p=…póSZYˆÕ¥…¢pE ûhû(û{]Ä#ãÌZ˜F˜ácfø«Ë³«Ú朻ªÍEmö%¾aµâ¹Q»WÜthMµB{Ë[´Ýùxÿ|A»¹¿6%Ú­y*MñŒÝÖ‰\Kÿ©&Ð#d!#P¬OIÇ*¿ —M «D // R2h‚``ÝRÌ“m\®ùÕ‹ãzð=@>6m8ˆ}F}:ä1Μ¢>²Šý ,EýÍfù¹œ‘]ˆîO Î sSq0€iî ›TxÓáþ¦‹j endstream endobj 4784 0 obj << /Length 214 /Filter /FlateDecode >> stream xÚeͱjÃ@ `-~„ÓôìÆ&lpˆ‡B2e™ÚŒZš-?šó&†¾ÀA–Œé– î㤻_*³—‚2z•S¼ÑbI_9þ`QJi©ŸßØthwT”h×ÒEÛ}Ðßï鈶ټS޶¥}NÙ»–˜a÷lÌ}ì!â!xHĢ µK{Ñ0S%¦ÓYLæIŒÙ±„4¬^½vA:ÓCžõÿ5ûÏ2?¹j,TÓkØ„pÂgÙ àe3D^63ÔìŸÅU‡[¼}l* endstream endobj 4785 0 obj << /Length 245 /Filter /FlateDecode >> stream xÚeϱJÄ@€áYR¦ÉÜÎ è&^¢‡óSZYˆ•ZZ( Wœ$/%ñEò[nnœYäÚ|Å,ü3[åû%åt@{Å!•Ç4?¢ûŸ°¬dšS5ÿ}º{ÄeƒîšÊ ݹÌÑ5ôòüú€nyyJºÝ”ßb³"fo8ü7a êLìàŒ¸{؈kq€ÐàEoÄÚ›A ª I¿sLÅlL;q›‰é6‘­˜ð,ú)þˆŽ"pøkë'ëaÒö“šß “6ª«jùTº…vûMtÕ%ü¥yþÖpû®É7«±šc%^–Æ ð¬Á+üš~oì endstream endobj 4786 0 obj << /Length 188 /Filter /FlateDecode >> stream xڵб Â0€á+Â-}„Þ hšP:j3:9ˆSutPt®à‹ù(}„ŽJc¼ quù†ËûO¥óTSLŠf’”"­è(ñ‚Iæ†1ií_ª3ÅŽ’ ÅÊQ˜5Ý®÷Šb³ ‰¢¤½¤ø€¦$,D¶¨m`ŸX˜ôP?¦䯰…¨a"GËä „ÝHíè¿°Žáüú’ñ[¹%=ãΡ‹i¸ˆÛ¸’{}9ßàs \Üâ#G— endstream endobj 4787 0 obj << /Length 122 /Filter /FlateDecode >> stream xÚ31×37U0P0bCS…C®B.cc ßÄI$çr9yré‡+sé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ä€ÀDübvQ$þÿG%úAüȨÿÿÿÁåêÉÈB•\ endstream endobj 4788 0 obj << /Length 231 /Filter /FlateDecode >> stream xÚmÏÏJÄ0ð¯,Ì%ÐZ%c‹ã7¢â!¿02I†ñ|ÜøÖÛz¿ü¾“éGÆ­…Vx|–í,ÍïGi®˜•f¾ö‡×ã“4Û› ßI³ó÷odÞy¸A# ÕŒJõ—&E½8]&”ÃRj ©Ð¤ šÙõKXÿ™"9ãØß°öC¯ú"‚ãƒùÊÞáN¤¶¶šàžç‚ +–o¨q‘Ô ™€ï@æF2ŠÌÏh.ÊpFmLF IÿA.g¹•OÕ¬—´ endstream endobj 4789 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚ}±JÄ@†ÿbaš> stream xڕϱ Â@ à– Yú6O`[¼Ò¥T¨¼AÐÉAœÔÑAQèP°ÖGé#tt«—ªtò $áB¢ÓyšpÄ :áDó%¦;騿‘¤Ò8ߨ0XÇnl•B³åçãu¥°Ø­ØVK>Ú/'2%;ŽãµÇÀ%|ÃAtG*èA0‡¬`/ºPu°½Fô19€9¬a{ÑíDíªb#úØj3XÃä5S¯øS… imhO_o`{ endstream endobj 4791 0 obj << /Length 229 /Filter /FlateDecode >> stream xڅϱNÃ@ `G"yh_éüp’([+•"5:T #Ö^í%pcó»He``ùÛ÷û\·wm# iä¶”º’¦–ç’߸jQD¹ùéœ^yݱßKղߢ̾{”÷Ïöë§{)ÙoäPÊâÈÝFnˆ(ºžŠèF Ñ©j…Àd|ÉŒL@Àä6ììmБÜT /åˆõ¤sg`À|¸®Œ¿8c†Â¨Ò’5 MñÃÙâ—”i\Qn+ ¥yrŠevœEs¬á‡Žwü Ô4„s endstream endobj 4792 0 obj << /Length 235 /Filter /FlateDecode >> stream xÚuÏ=NÄ0à¥Mã#x.N´ŽV[YZ‰HPQ * ¤Aíp³%G0¢ÀE”a²» ÍgûYš¿<]6\±ç“š½çÆóCMÏ´XiXqÓì~îŸhÝ’»áÅŠÜ…ÆäÚK~}y{$·¾:ãšÜ†ok®î¨Ý0`2™€R¤Ó—é†r@ìŠI…ÀærBÈG£b¶dÅþ2lRÌ“V;äxFïò!#äSòÕI§gìµk4I±Yòžñ€;ý!þGøaÜbóžÝ¸óài^aÐeb_È»î+:‚¶‡ÑÚ(4¢ó–®é–•™ endstream endobj 4793 0 obj << /Length 200 /Filter /FlateDecode >> stream xÚϱ ‚`ðáÁ{2As‰3È!¨©!šª±¡(hˆôÑzÁñĺïŒt©¡~Ãÿ8îÎûa@ ¨ç‘R0¤‡Gô=9›Îö€qŠîŠ|ÝÇè¦s:Ÿ.{tãÅ„8MhÍ3L®±â“+ÿ"dL-V¢K±x{°pprm î%@%*­!š¥ÞiÉfúÈ£ú1ƒÖºÕh¬´fG«£Ý¨ZŸFéȶ> stream xÚEÐ;N1 `G)Fr“#Œ/³£Ñj«HË"1Tˆ ()@PgŽ–£ä)S„{Aló)Çù“iw¹›iC]Œ4M4Oô2â;n÷²¸¡yþÝy~ÃÂÃm÷8ÜÈ2Ë-}~|½âp¸»¢‡#=Ž´yÂåH`xpœv ú$¸ä"¸,t¹?“”¬¥JIÏRÜsTR/´°vÌ „ –å6£#`f€ÀÁ3G&û-Û]\\ò\´Eõ«åV>R®ô­tŠUÌ?p¦²"ÅFÏ ¶ø¿Ìò¢!ÚS‚S¯`% ^/x?}Ï“… endstream endobj 4795 0 obj << /Length 237 /Filter /FlateDecode >> stream xÚmÐ1NÃ@Ðo¹°4°s°­ØŠR­‚„ $¨(U ¤A½¾ WñMØ#¸ÜšapJ‘æ³Úù·]_®;®¹å‹†Û–»–Ÿz£ÕƆ5wÝádÿJÛžª^m¨º±1Uý-¼¾Pµ½»â†ª?6\?Q¿cä Ài‚&dš r¢˜†2!Œ.ÁG?pS8’ôÈ|9‡]ó'ø?‚XP‹T)æL%—ü[2Õ/±jNl¥›þ§”>9Û’¼5þ‰FX ü”éà¢=Ø … Œ–W¨UÊUG@—˜ºîéž~Uí–Ž endstream endobj 4238 0 obj << /Type /ObjStm /N 100 /First 994 /Length 5582 /Filter /FlateDecode >> stream xÚå\[“7n~Ÿ_Ñë÷á È”k«b;Þ¸*»ë²·j7QéáxtlO"Í8sÙrþ}ðÝlræH::’'.©ûݼ€ | ÐC!Òä& ‘§èñ›¦dy™2òä¦è ÍiYM„‰}F"N‹&¼Ÿ$1aÊ.]PpyÊdµd*í±Ÿ¼Ë¨ÆaòÁ£8GM´À4ùPŽÊä™’ÖÒߌ&ØM>ë9i*±¶Ï2ùÌxÆZ® I§•õ‘Ò\´N“¦$áOmkªL:f4,ZŽˆŸ3ˆ“ ))ÚE’)dÇÚ0ddMe낦PŒ&Q¾9£SŠr0c\Yy•šòš*¨›ÃÉ[9™b¢¨]HÖT¶VhЬ®¶—úÐFc Ê6e¯¶aÍi±b Ëzs6Ú¢óâ Š¡z´bÙÆ©=m<&+¦DPB1­ÉÅP½N`Ñ )j6:e›ØB(J«(;ô™f3ÖØËÃŽsÏÚEt¤)匦xbòV#iJI ^_㑲“¨FÙä1¨S‘¸(ÙQ§BtF ̧œµ¯ R²§•tMé¢Ì1#•§uêÜë ÆÃN—‚K{]3ÞaFÙk4é3|Ö%âCB› žè äB“Z êÏäuÍxòº>•eúž"Ö°R­IÁX“×ÕÆØ;^ ö\À÷„5ž¼½Çé2ѤMYyêu”^¢è˜RíÄYQ…d%^“IA·X×R´€W¶øì0;‚ ±‚5‰P°ëDy¡lÀÒèzÇje_ð.Ä‹Ï>»Øýå¿~>L»úåþßÝïï»Ëýäfºøýï_ûÚãå³Ý×_|ñùþîðK«¨ øöy_ãúòæÅÕõ;”YsÓî¯W×ÿx}wµ½þòꇷ‡ëËÃÝôLy¾{uuýp7•´ûχ›ûÃËÃ÷ÊYÚ½¸¹y¸»»Úýx»ÿûa·¿|¸?ì.¯n/^ýðòðËîþêå‹ÃîÕþòöæz÷ýíAËh•ýååáú~÷âJ»¸»ºÛÍ×7÷/?ìnµïÝåáÅÕË—ûöð§‡ë÷·¯^îîw7?Þ\þC‡‹öî~Þ_ž¯<ùâö°¿¿º¹þR2ýîËÊKå'yOÇŸ\ìþxóâµïþr¥ã˜~÷íô‡ÛýÏ?]]ÞM~¸ÿùá^_}s{óâáòp‹·4ÇÙ²ôuƒGŸŒSòÕÍõýÅïï-‹‡þb÷§ý+¼ •í(3íþùðòï‡û«ËýE›•*¡uÊžÌ$Ñoi&¿œž©B²Å;íþö¯ÿ¦â "fκ[®^¾|CAšR”Ù«x Ë?ûLç€ÙdœÕø*Û¬ÈhÁÝßþüý¿.kÁ¯_©^U1]ß"+ÈRËfd¹e ²©5¥‹æò»Ã½r|÷Í—_éB8ür?=×Ê7ûuç~¡¤) ï0ËÙ&÷íáîæáfÔžýQy¹ÿüæ—é™ÓlRÂsíh¯s{MÞVÎÿ›ÍÀtt30ÿæ6ƒêŽÓ6ÃP&‰ùí…(‡Ù)(xÝŽ ¦ˆŸì}ãMï.gšuÉÐÔ6ÇWP§e-¦èsÉà¬Å¶ùt3’!M~¿ýÅGöŸ·¿Œ|ê¬ð)³ÒÒÌ쨦̳¨lyç©8€“?:è‹ýJ&`þ±É}Í|ž=)=ŠD^ÔÉDüŠD„£¢NâoNÔ%>qS _·©J!ÍN·üûí§7l]À0÷:‹-…÷ÛErdÉGØEù »(ÿŠvQ>¾‹òooÉ©»HÆ Â‰æ¬ ÷½Ñ3™Î‰ï·¾ó‘õé|…OåJ~‹lÙ8¢˜Ä7ÕÚíøÇPéèÌâŽp#ŸÈžrãT +—ÌuœÏ ~Êj­ÇÕ´{+7†‚§sã xÜGçq£ᆼ7ò۹щ…³†ó,Æ2Ç)—0—‰éŽéäÝì§Ì÷ç0e_fšJ$<‰y–IÍ<å\Ÿóœ&v uc˜ŠÖ,“ä¨å¼«E飜2^±‹¾ÎÉiUq^K¢PœµC¤ΓÉÚOZ- á5N Ç»÷m/?Tñè‚]Ьcâ‰ á Žåóí®4+Yy"%1<³NŒM'rªÓðÇýýí&xv>8,Pý·¥Ÿ×RŸÛ"˜MA¦¨tˆnÉ`.O×ׯt©}>=·¹üêêöîþ‹Ÿö·S,»Ùw™¿^½¸ÿ鮞3ÛªÛÔrt‹ÈFa´WžWUMqæ2Wσþe·¥­¿=]¢Ût>§în÷ÓùÈOù¨+©ñqI|ü4NŸzQL©“{6#ƒtŒô!tœLò„“)?åd¤•“~öp8ÌÏXwH®CXþ­OtE*ÇuP\în{ª³á—´ÓU2ÛZÙî®=ucÛºmÒš3œ.ºÿ¢òf.p8Ìp´È '…bp,ú9Æ¥d`ݺ½‚G3‚އ(õumºVÖÆ½"”eKãµ”ÝÝ‘ ùV#ú޳.tCóPfa„=_ÙRY·ÔëÛ“9T&CV†öo+•5½Ü­ç–|ÝÞ®<…²BÁ):]ü:.¿=Ñ2QiÊÛÛ,»=iY36Ú…«{»X/ðu{“õ .­Çàt{ÃQŸ`&Ú“äw{Unik7i{v%½”ž¤-%mI”ÑÒôÒvDûVØ)©Õ-m—Ö­‘Êúö6k=»´nÖºYûÐõ7º‹ÖµKë­ïÃÍãp‹¸nŒ›ÉôV[•Ú •=*{Tö¨ìQÙ£²GeŸpÜPãF@€!lâI×E¿@XÌ æЂÙÓœ¬9+IkÎÄÚ¢Ð÷8ù‚?wÉÁ§ëòšƒcÏ»5¿Ü‚zëÌÆz΃\®nÅ%g^½µ?Fi¥ŒÍÏ·R ‡£KÎzX{OÖÃJgÂÂJ‹¹ÃÚ;ü_1¬­ú +-‚ÂJ‹¹/ÃJ üj1¬´ÀñÃÊ -a¥E¬÷•Aïq¥EÐ{\iÉè=®´dôWZ ´b\iŸ7Æ•ˆ¯WZ àͬ9µWZŠõ¾Òço¤•wm$ß²æ£- r(¶,è!jYDܲ hõت¦HÒ² bõ(`e#»¥k\³Ü¨ò ƒUææF•ܨò ƒUðbGnTyÁ*8Ð#7ª†¹Q×väFU°•ب  *5ª‚y¥7u3@V½³òUD寊_ÜuN縤ñîÔ+tmÔ{m•$(”«÷úD”{â²ö"Áž*DUx˜$t‘BOÀ<”ÓAæy”¨µ“®ñâÓò~yfu—ÖUBGÒ.í£Ù]hÝ3à<šÞÚRÏ/ž=ÆÆ&pt ÈZÊ@µgm¿À¬vUlæu ÀÔJKg e³án~¯d1´î"ÚI~"6$¶rž3°tÊ(Á“TOr\Ù§oÓÔOo½ëæqõFÆ:Ö:ˆÔ(³I ´€¯)m”A)©d`Qh1éFÂ;åW-—T£Åg•É9´aÆc&E)ˆ;ðxnÈ|™D]¼”ÏXzfŽ4žŽ7ã¸ýS¯ÿ+¡l:¸Óëð&­¢dÛ´Š“oÒ"S6ä¾­š_Ÿö¹qwGŸ¹ØÚ‡hɽå÷×y?ÅSH¤º2òÝQ¸©øÉ®9õ’hê¥Ø‰À‡^Z޵k9ÖrºØyƒ¾IKÛø©*¾#üœdƒ°Â€z¥ÇðS/ÿ6Йµ´]e*nƒ¢Z¯ø©lã/ÚB˜Ûžh[…qˆ|6€ÅM> jEÄ`\^+ú”УOi(Ò¢¿JEó€E3÷X47, HC‡L©á* Sj¸ È”®bH冫£F WµRƒUpjSCUŠM4·RÍ«k˜J‘‰fö:ÉkÉdc§ ç–ƒÆîqq–çÜãâ\z\\\‹‹ïqq =..±ÇÅ…z\\¸GÂ¥¡dô^¤ÇÅ%÷¸¸”“s.&×P2xíz”L®GÉäz”L®GÉäz”LÍvA#5Û%[ï %ÛÊZë[Y ][¼aî°65›X›š•¬M>ôX›|ì±6yê±6yî±6ùÔcmòÒcmò¹ÇÚÔLœêrs=ô¦à{èM!ôЛBì¡7ê¡7î¡7…ÔCo ÒCo ¹‡ÞJ½)ºzSô=ô¦fô¦fô¦f ô¦Èý1ñ)(‡ÎA9ÁP‡ˆrü†rx]rÊáu5u(‡—5µ¡œÇ(À;Ü èà8zúxhæTüñ˜.÷ÞÈÅ}$v2VÑKu¡êš(oÃ,ç‘…à Çd¯¨µáwÆÁ™¾USâÂ&çîÎÕäÍ0~’­t+§ –¬P;?ˆ‡íø .ñó¡vþÙ¦vüAÖ wÐ…ÚfŸÚqÀ 7ÕG˜ÏXá¦úØâÛ¥ƒ'ÜT€µÓ‹“o'$Äý¥Ð j‡xÔñ,¨âXP;İ $° ”;`A©tÀ‚ÄuÀ‚ÄwÀ‚° ,¨A%ƒ xhªÝÀCSíšj7ðÐ¥‡(‹ñ%v€Ú”A‚/ 4xi Çd Aæä4@‚,$Èy€yÄeÄeÄeÄeÄeÄ…¥_Ò ô‹ J¿äAé—Ò+}v®Wúì|¯ôÙ…^鳋ïªåÃS-ï:-ïŽiy¯zž±çU¨}(ßY¯åW)ÐiùUôZ¾;ML —L s £N¤Á¡$3,_?ëL±y³Üòû®÷±ÝLUf7¸¾áöÕqªܬöL㉛ú/)~­§@QJÖ´F¢kfd L³ ¸Z” „ºÍQÓ™Ń3‹}¯1¹VИ܌0²z½ã‰›æ3ÙtÌ{nÞôg“ð¦?›††yÏM'üç¦?aÞsÓÞ0ï¹áƒdtJ§?ysfÙˆJ§?¹tПÜì9èOÞœYèosfY½^r³å²Õëõ 7K€qèM\nvô73úŒ7+úŒ7+úŒ7+Î>²Û¬8gŸr¯Ï8¦^ŸqüGÿÇÁÄ4ø˜ÿo^-(0Þ¼ZP`¼yµ ÀxójAñæÕ2¶yµLm^-S`›WËØëÞAù3ÍTí]§1… ÀÒz¦±)°´î©N¥-Èñ¢ ‡4§ô!ô4HŸ¹ÎŠ,êy„^¤î÷Ø¿í]ŠsZK%? Œô‰õ¤Þ¤j¸Ž îk¡fÖÈ]XRÕŽ½3ÍiK6¹™e@mð1+ f]C楲[—¯ôvO×Ô·~킪ÕBõnÑ"Î/ bf&AYeæÙ#Ìb†|rs|ÅU4ëFŽá$[z®=I­RÕaÏÉOϘÒVÞÛë-Ït®Õ©(æÿ¨mi¯ÙB¦ñš-„ï­y;‡Ú‚+ìeêlKn–˜éÆf‰Ù×ÎÍ«ß6ºªÙW°üx;Š6ʸ×\ÒÛz,½­ÇÒÛz,½­Ç;2=Öl(XwÜl(XwÜl(ÓjÍ„‚uÇÍ‚2­Ö (Xwœûc\nªé¸Ü‡LpîC&¸ !\† .CÈ—!d‚Ë2Áe™àÍ”‚ÍÆeTyeTyePyÉ */¹Aå%7¨¼ä•—Ü ò’T^rƒÊKnPyÉ */¹Aå%ÿÎ*Ï¡òà~V™¡øØŸ­ñ(½Îýœø©Æã#7âll"?[Éú»æÚñå£übù¨¹·j2’Y·w}¢ú,¯¥Uîëj…³=OÕìS5dÚÖÇ7ŠA&Ä4#xØ÷IÕIöI±‘ŒÇ¾Ì¶«¡ 5£6)ö ÞvU!gÔU ±“ÚÅÚ‡j¨zP[SCr‚~zªOê)',¨¦aÜjHá ³=•'&T2i•ä5šEíÙS´Šï=°½Áô+Ðø‹[Áê@}ìE;ÓfaGSïÕLÔ{5Sƒ°€ÚÁd²V¸í©™`b_:Ñžš1#V¯tÂö!†=±IY¦ª+^‹èt°ÝñGÁljú·u5½”·Îÿ'eP¥í2mÈÌ .üÕ©ö8E×BØÊmgzá“÷øTâiœß©Ÿ–¼WœŸ_}æzéþ¢3?3y—è¾ÇGñ¹œݧWú_ŽéSlÚ)$°@o›B†jGpÚ!‚á›vÜ`x¦)àX$µƒ‹¤vˆ`û§à—ÔŽ pd’Ú±÷©Eà‹—ÔŽEpœ’6Ç=ê5¸‰ÝvdÇC’>Ê0µ²1¸Ëe(C”¡ Q†2DÊe(C”¡ Q†2DÊe(C”a’ÞýŸÚQÜÿisñC½ä>Ê0µÃ³ rïÌH¹wf¤Ü;3Ré©ôÎŒ´Å¢÷-æ½o1‡àüs˜†˜Ã4Ħ!æ0 1‡2ÄÊs(CÌ¡ 1‡2ÄÊs(CÌ¡¸Þ±"CÌ¡ 1‡©ÔÙÙùv<…ñµc»b»#v– ˆ2D Ê(c¢Œˆ2F Ê(c¢Œˆ2F Ê(c¢Œˆ2F Ê(c¢Œˆ2F Ê(c¢Œˆ2F Ê(c¢Œˆ²™z¶ÆÒ»{Ñ9ŸK;ûÊ7C;ïèñ¯sôHyŠ`Ë[:+³ðx”%'a‰`vÞ%|æ}lѾ‡RÜ–”$"\@±ŠŠ¤ìħE³í½úi¯¹¤Lšá« µ)ñ3| ~Nv¨æøMY‚W¨–ªîš%g] Xm…U2×Á®))†Uky+SÓìfûd:Ú·¹*Gñ÷©YGgI»=¿øo¤ûÕ endstream endobj 4800 0 obj << /Length 223 /Filter /FlateDecode >> stream xÚíÓ±nÂ0`#†H·ärOP'€ [%R3T‚‰u‚ŽZµsx´ð&y„ŽTŠü÷¿ Á†XjÉÒw>ßÙ<?LFšê3k>Òm&ï’§Zbó&ÓRüJóø'®Š/ŸõóãëUüt1ÓL|¡ëLÓ) uUpµ)v ¾š -‘?@øË׌ö8õ€;n=pOkì£q11»EœcfØÕ˜À³1>†KZ³*t’¼³}–­w{¢»7¢á:Þïƒþy+Ø÷€}¬k(óR–ò éQtn endstream endobj 4801 0 obj << /Length 327 /Filter /FlateDecode >> stream xÚ•Ó¿j„0Àq%C ‹`ž *½B]®W¨C¡:”NmÇ-ív¨–GÉ#dt—&æ—?RiDø¨ ~ýi]_\V´¤;½×WôzGß*òIê’šMš ¯dß‘â‰Ö%)îôYRt÷ôûëçû‡Z‘â@Ÿõm^Hw ‰YmVìaܶb«Nß4RbÕXM›Î”\u®N›n•ònbÁý |ä± –mˆœbçÞ©¶‹LEæ´]$â±±7æ!3äi»ÈlŒzçÚ.2Ob'Þzº>¸Ñƒtî!ò¸´—Æ9™7Ê ×˜CîÒ.Ík&) 7L³Èʬ ¦k–üÓùì“ËõÁóÇ Á͹!¾·!×Kk¹KÛøÌ!×#°€Ü¥m<æá“ÆÌþçÎFkó(­°¿4J@?û¯ÉmGÉ/ðc ¥ endstream endobj 4802 0 obj << /Length 338 /Filter /FlateDecode >> stream xÚÍ“?N…@ÆgC±É6½€QãÚ¸Éó™Ha¢•…±RK vF8Þä%^€’‚0Îì ‘¼Z ø-;;3|óqvrX”ºÐ§ú ÔÆhs¤ŸJõªL¡ù6Ç~çñEm*•ßiS¨üŠ^«¼ºÖïoÏ*ßÜ\èRå[}O‰TµÕ@W‚€dªR‰ˆ;Ȉ,Q–ˆG¨9ÛCi ì7rXKËä0—Aà@$ˆs;’²º:ñ>GOÔ11PV¨GG’ª à{ ré(µëÜ‘  J}1*7S(»$;SheIÙLõ>âoúCø¨^¥f­i0Ó¤ÚÙIñ™Î§ÉÌô¬ð§ Cœ4ôqú¢ŽHºèG®¹‹nJÛè°¬‰®³œcÔC +{ç7ZÛÎÛ¶>»ƒ Úà¿¢‹*E!¼Õe¥nÕ/ÙÏíã endstream endobj 4803 0 obj << /Length 258 /Filter /FlateDecode >> stream xÚÕÓ1nƒ0`£ ‘ÞÂx'¨¡b€ ‰¦R"5S†ªSÛ±C¢d†£õ(9BF†ˆcWæGµR¦Z}lÀþ_ÇYÂ1§æÈSÎù#¡=e¹éÇ}·¿ñþEeEzÇYNzm®’®6|<œ>I—/Oœ^ñ«™æª‹kªo?nÁ‚>ƒíCK¹(Iç¸ÖªoïÐv^سs`'rVr\wƒ Iã‚—ý˼ÏÞ‹‘/ÞÁÈí¤íýênp=g¹ÇÍ?ôÿ;³†¸ÎØ—¹=Å  13èr…Ù‹ “E7™ÛòŒ™ÇZ€1µÓŒk kmªgjÖ.=W´¥€Ms³ endstream endobj 4804 0 obj << /Length 228 /Filter /FlateDecode >> stream xÚ•Ò= ð×t y G('«Æv3ñ#±ƒ‰NÆI4:—£õ(ÁÑIÓ¾ú¤H~…þi¿ÕE[ôLK;¶nc<`’˜ïgØìq˜¡\Š$A95½(³™8Ï;”ÃùHÄ(Çbe–Yc6º,wh*àúÀ´.9)"1RH HP+wh ¾yÅ›(¸/*±†øPè#qRDÒ¥LùSõÜ×õ¸c_ÿÿ½Ÿè擽®²éPèÒå[Ì+^« —& ÊIº ¬)J¢¢t*Jl)sŪJ¶SàN2\àîÀU\ endstream endobj 4805 0 obj << /Length 349 /Filter /FlateDecode >> stream xÚÕ“±NÄ0 †]u¨”¥P¿´U‘®"‡D$˜02€`ny³ãMNâ¸ñ†ªÆIÜ»´EÀJ÷“ã8vâ?ÏŠã¢Â x”cµÀ²Àû\=©Ò83,OÜÊÝ£ZÖ*½Æ²Ré9»UZ_àËóëƒJ——§˜«t…79f·ª^!ðÒ û5D±Åˆˆ6XÖÌ;Ж©‡Æí¤uH@†cýN.|ÍŽrá.m@µÎ³Û¯F|Ž=›Mb¶š Ö´`]ƒÃœb{)Ð$èÀU2¤ئç¿ô' ÄcW˜¾|–rƬÇ,eŽ9sóýÃôOx^cf¥u=þÌzÆ.‡–{6œü‡·›òðÖS–1´Œ¸;ôAýe&oVýögÛ›ù`¦_#œˆ7ÄŸ¢)ÒNG¼¼ èöÝYmv¢M£Ù­è×Üf !ˆ&\oê¬VWê ?¦! endstream endobj 4806 0 obj << /Length 105 /Filter /FlateDecode >> stream xÚ3±Ð31Q0P0bS #…C®B.C ßÄI$çr9yré‡+˜ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ÿA ÉÀþÿÃ(9THü±ÉåêÉÈ’:Õ° endstream endobj 4807 0 obj << /Length 344 /Filter /FlateDecode >> stream xÚ•Ó±N„@à%$ÛðìÜsT$ç™Ha¢•…±:--4Zãñ(<‰…„qÙøÙòH  ùwØòlwUܘÌ\Û³8˜ÃμåúS{{ŸÍ·óƒó‡>V:}6Å^§÷vT§Õƒùþúy×éññÖä:=™—Üd¯º:šF…öÚ]jQ¯ìÛÅÁ¨V‡÷pÒÁe × ž`)v‘⨇ãv‘âºI­æH6G²9’͑줅9’Í‘ÎÁK¤³D:K¤³D:—›ñ̈ÆÕ1aÞdã’P[=ï˜xªWÿŽ5-ßõ7”´|ï´¬µ1ÜÄ´¬©¥ˆÈN®­'ñ Ú¬¹Ákèû%Eðš{Æ^K¼_„Þ=£¤éÏ ú„Ї\;ñŒæ"¤=£ÿ¹éa7±ô¶oü;®ˆu¼Sò¯Í×áRë»J?é¤[¹ endstream endobj 4808 0 obj << /Length 311 /Filter /FlateDecode >> stream xÚÔ±N„0Àñ’oé#´O ”\<'HÎ3‘ÁD'㤎ÝHàÉ ÆÁÑGð‘áBýú•Iû%)ð+,ÿ¦`ÊÕÑz­ ½ÂaJ£OJ}oà Œ9Æ™ÂÙ=º{„MùµÆyÈÏqòæB¿<¿>@¾¹<Õò­¾1º¸…f«­µ£ #q·8&ÏtáÞ3ûŸxž=%Ýüæ·õT]ˆ_¶'V1ü´± òÃîˆSï>8ƒ|º‹bGýx ²¦~Ù‡©¨_‰(Jê¯fÔß2L©Šcâ–# ןî8º~w‰¢[ÙstýJptýU,Ýr´,]ÿÄû±ž#öc},»=Ö3Ö³Tëc)íÛfôÑrLi‡G’vKA;+DEï ñß1¥]þ*Y÷‡¨ÄB8kà ~oˆ§L endstream endobj 4809 0 obj << /Length 422 /Filter /FlateDecode >> stream xÚÍ”ÍJÄ0ÇSz(äRß ymë²n÷ba]Á=yOêу¢°±_¬Rß Þ"”ޓɇ]XéÕ¦¿mæ#“ù'Ëü`‘ËT.äþáL.g2ŸÉ»Œ?ò|Ž_S™¥Gvîö¯Jž\É|Γ3=Á“ò\>?½Üóduq"3ž¬åu&Ó^®%ÃG@ÍÌô h "AG ``Æ©Ar,=CÆ  ÈØŒú?Fmq¬zæÌ´‹ÉY€Ìš2fä`œÁb‡auDzvQˆ¡Ã~ŒåÅ@ƶˆ-pŒÂc=B[ žÄÊc»…fã¿[&ª$ø…häß:_gVÚ9] ÊWAîàú8©ßC†^{dA˜Çe‘QI#ÜX<¸0å° =v£;¿t–'±µXíÄÂß ÝÍ!¶ÐnÄà0ò7 6J9 |^ŒÖ0~ZòKþï‰õ endstream endobj 4810 0 obj << /Length 290 /Filter /FlateDecode >> stream xÚµÓ±NÄ `H‡&ÿÒGèÿJk×NMÎ3±ƒ‰NÆIMÔèÜ{4¥ÀØá"R ÜßÈ%)ù ~ø¡Ùœo®°ÀK<+±©±¾À×>¡©Lcuåz^ÞaÛxĦqkšAtwøýõób{%ˆ>•X> stream xÚ}ѱJÄ@à?¤l“v_@“pÞ] !pž` A+ ±RK E;!÷hñMÎ7H¹à’qfwO ¦ù`vv23»œ•µ)ÍÒVf±0õÌÜWêIÍ%Xšú8œÜ=ªU«Šk3¯UqÎaU´æåùõA«ËSS©bmn*SÞªvm€| 82"‡7@бï, }8$´þtHIR2>JØÜJ =°MT;4[6ÿ±ùR׳éÄÄ~“û íD©Ï}~k£.:Âíì£6ʃH«¬Ï±¥DÎJ†wðkñ©8ÊÌ1ÁÛ‡=Iszÿ‚‰6üÑWÎBðJIľ7ìl¢:šÇa²hJ½Ý7ùCÞ¦ûßÍ8‘ÂýðˆþÝÆðâÞ5,φýkV›Ôqœ<ò Òöè÷Ã/™„µXY×dã|…ËvRJµêJ}áI± endstream endobj 4812 0 obj << /Length 270 /Filter /FlateDecode >> stream xÚ•‘±JÄ@†'¤Ls°óšL® œ'˜BÐÊB¬> stream xÚÝ‘=NÃ@FÇJišÁsX[NŒ©"åGÂTPR€ ¶;®•ä 9BJGZí0;Þ J¨Øêifw<~ßEqžU”QAg9•—Tô˜ã –)fTûÎÃ3Îj4wTNÐ\IM}Mo¯ïOhf7sÊÑ,h•Svõ‚`Úæ_À ühv= ™{H™× ³ïñž¡±ÁBÊ [rë¡%k‰TïË3¶ü·š.‚ 0=€;  ý Ú¿€“ûv>ò;ö»ÕbC _Æ\”Éõ¶Aøf #àc§ƒ—è,'·4/+;h‚¼q1h¸¬ñ?7p% endstream endobj 4814 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚµ±NÃ0†/ê`é?BîÀ‰dSº`©‰ HeꀘhÇ XI-Â#dÌ`å¸s‚ºtÅËgý÷Û¿î·×~Iyºª)x ö5¾£_‰XQ¸™&oG\7èväWèEF×<ÑçÇ×Ýz{O5º ½ÔT½b³!€ÿ€œÈ£‚™Oª±ª–!2J`@;€÷PŽPÈ<²;…‘GgÈ3E9c̈¹*lÊ0´9Útüø / Îà Ýìi†Õnʲm'¾©¿;)¤ø–),åˆbÈߘ^‹ìJq™©Ý‚§®£zµlÑð¡ÁgüÍF‹¾ endstream endobj 4815 0 obj << /Length 253 /Filter /FlateDecode >> stream xÚÕÒ½NÃ0ðT"ÝâGȽu¢~n–ú!‘ &ÄŒ ˜Ý7è+õQúíØ!ÊŸ³¯ñ‚ŠÄ„ˆdå—‹³ÿÊl4¬æ\ñ˜¯jžU<ñsMo4HQÇúæé• Ù{žNÈ^K™lsÃïŸ/d·K®É®ø¡æê‘šgáʱ‰wƒ_ s=Ìÿ‡$ p8E €.¢° (±s‡×…¢ÀŸÂ4Ž2ì¥*ȱÓ| ]¹Ñ6&âÜ´LèÎpßàÚ‹À_à‡ýøËÇIHGN!ÄXÊ>±] ³7ž#†Ýfæýß".ŒÎF«?«Ç^Q 3Ò™Ö Ýщb= endstream endobj 4816 0 obj << /Length 244 /Filter /FlateDecode >> stream xÚ…¿J1‡gÙ"0M!óº·`D«Ày‚[ZYˆ•ZZ(Úºy´}”<•aÇ™¹ãôP1|ðå—?üâéáIO :¢ƒžâ1ÅH=>cT¹Pc;÷O¸°»¡Øcw!»á’^_Þ±[^‘ØÝÊ™;Và8ƒŒ‘?dm˜gPÇj·\R…q :“dÄ„*Á |…Vbn¶;ƒg³Eó çd˜ö1Öo( Ø÷aãhDBÿcü³!ýD[Áo˜¬1¿En¥ ¹±¦ä%iêÝînª6N:ó\ÒZÛ` æ]H›_ÙI<ð?yë­œ endstream endobj 4817 0 obj << /Length 175 /Filter /FlateDecode >> stream xÚÕн Â0àá–>Bï L*)¸j3:9ˆ“vtPtnÍGé#8fœ—:èÒM‡|ä~àŽ3z> stream xÚ¥‘?JÅ@Æ'¤XØ&GÈ\@“HòBª…çL!he!¯RK EëÍÑÖ›ä¦L2Î쮂°áÇîüû¾É®9o[,±Æ³‹w565>UúU7¿–Øv1ôø¢÷½.î±étqÍïºèoðýíãYûÛK¬tqÀ‡ Ë£î¯|¢QÑÑ’“CD–F°³"RcB|&;¦Jª ÀÌÆeÂ%w¹pU¾ëö3Bú?OûþÄÂ|€ G(ú‚^±'€f ‰]âTH¿Ø¯ð“|X9éʶÌÜ/O8E.‘> stream xÚ36Ó35Q0Pacc …C®B.# ßÄI$çr9yré‡+Ypé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ìþ``üÿ€ùÿ0fÿÿ+†ÉƒÔ‚ô€õ’ ä0üÿ‰˜aˆàÿÿÿ@Ç\®ž\\ÍÙ¥; endstream endobj 4820 0 obj << /Length 107 /Filter /FlateDecode >> stream xÚ36Ó35Q0Pac c…C®B.#K ßÄI$çr9yré‡+Yré{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]ì0üÿ‰™˜aãÄÿ„޹\=¹¹µ‰Ã endstream endobj 4821 0 obj << /Length 232 /Filter /FlateDecode >> stream xÚíÒ½jAð WÓÜ#Ü>·ÔŒ‚WZ¥©LÊ+³vrp!E¶›üçT°+‹ ó›Ý-ÆÙÇvïÞXÓÅqöÁt;æÍñ';ë±j-->x˜súŒÇéiNó©Y-×ïœgOÙ‘yÁÌ+ç#CYEI ºO$RáxŠ%4ˆDJʤnï«Ò 󢣨Ò×®U¶¤ Hª@Yûƒ$߸»Np·â§¤D@¥(€þ¿ØAx^ƒæ §¨å9ìÅE…ÿÇÍÛ„ÂÆip xœóœÿvÚiC endstream endobj 4822 0 obj << /Length 184 /Filter /FlateDecode >> stream xÚíѱ‚@ à& &]xúÞÜHLtr0Nêè ÑUy´{ጃ „zwÀ¡Í×6ÿÔd4”’™JBG´ñ„qlfiG{Ø1+P¬)ŽQÌÍE± Ëùz@‘-§¢Èi’Üb‘¤‚˜µ©ÒÁc®|æÚ!P÷Æái à±®!`{èø.ÿT¼ÊV6ß¡ýAÓõ_°yÍÀ4Õ8+p…o âøš endstream endobj 4823 0 obj << /Length 231 /Filter /FlateDecode >> stream xÚµ‘±‚0†kHná¼Ђ±0’ &2˜èä`œÔÑA£3<šÂ#02Î^KL%!_sý{½þ¬æI‚!.qa¼@¥ðÁCT±Ý9ß +@P% 7º ²Øâóñº‚Ìv+Œ@æxŒ0> stream xÚÍ’¿NÃ@ Æ]u¨ä…G¨_.!MB§H¥•š ¦02€èœ<’GÈx•ªÛ¹F:¡.§Ÿ¾óùÏçË“«è†"Jèò:¡lN錞c|Ã,5¢<WO¯¸(Ñm(KÑ­EGWÞÑÇûîÝâþ–btKÚÆ=b¹$(“#ýÑÃ!@5@÷Šøo˜J ÿ§4ö{®aäÁ³ÅŒòßëŽfJ®`o}4¼‘.lO­%Þw£‹m_…mt§¢e4](z†`_ëTÀU‰øµ`  endstream endobj 4825 0 obj << /Length 266 /Filter /FlateDecode >> stream xÚÍѽNÃ0ð‹2DºÅ{pBó¡N–J‘È€D§¨02€èœ¼¯”7àò-[+U9.¶«*SÕ%úéì;ÛÿãëlD etu3¢2¡<£—߱ȥšPYú¥ç7œT¨çTä¨ï¥Žºz Ïå+êÉã-¥¨§ô”R²ÀjJ!7 0¼†xóŒ bf Å­iêfتPï ì¤xÁ fØ BîdYqë  iˆå`ËæurÏóã?3ýŸïŠð!ØXÌ>1Ÿ¡ “}¼ûÀ£•íèA}ûõ»ÿÕÛa²sc!C:‡ˆÝ9àO¿D(f§SÀ» gø ‘dü endstream endobj 4826 0 obj << /Length 169 /Filter /FlateDecode >> stream xÚÕÏ;Â0 ÐtõÒ#Ô' ’VbªTŠD$˜02€`nÆQz„T d¨jœ20õXö“üYœé™žcŠš+ã4xRp“s?¶aq¼@iAîÐä W<i×x¿=Î ËÍÈ ÷ ÓØ Eá¢^¹˜6¡–­É±Câ‰:_øˆ:WóÑ«}ßÍO_ /h‰ Æmƒú ýIž™–¶ðj^¤ï endstream endobj 4827 0 obj << /Length 259 /Filter /FlateDecode >> stream xÚ]Ð1NÃ@Ð¥°4¾;ÛŠBƒ¥$\ ‘ŠQ%Ú¬æ£ì\¦°v˜Y)¢yÒî·çÝT—ëk.¹æ‹Šë57 ¿UôIõJ/Kn®æäõƒ6O\¯¨¸×k*ºþþúy§bóxË[~®¸|¡nËXÊp8™ÎÙë…HDÑFä#ò°Ô々Ú~Àþ¨¨7ö'ÉQÈ”´^;LKZ+45qj@.dêtÜÇv“ù!¤¸Ç"iíÐÄÌôehÖ”ôÁjÛ]ˆÿdVçµ³½ÍSuž‡è ±ýõ?h©›ÓêgåcfKxýºëhG¿Á•¡Z endstream endobj 4828 0 obj << /Length 186 /Filter /FlateDecode >> stream xÚ35Ô34S0P0RÐ5T01Q07SH1ä*ä21 (˜›Cd’s¹œ<¹ôÃL ¹ô=€Â\úž¾ %E¥©\úNÎ @Q…h žX.O†ÀOþÁN2bÌH$;É&åÁ¤=˜¬“ÿA$3˜äÿÿÿÿ?†ÿ8H¨úANò7PJÊÃç‚”ÿÇ`$ÿƒHþÿ ÀØ`ÿð(Èþßÿ ýß E` q¹zrr:é“p endstream endobj 4829 0 obj << /Length 187 /Filter /FlateDecode >> stream xÚíÑ1 Â@Ð  Óä™ èfÑlì1‚[ZYˆ•ZZ(ZÇÎkÙyÛt¦Ž»‰… а{üáÃÀ»°O!õ¨­(Võh¥p‹ZÛ0¤(j.Ë ¦匴F9²1J3¦ýî°F™N¤Pf4W.ÐdI àñ˜Kü#ZX€ƒøã+üÏÞ8ä¯È’ àö„wåÂ6î .n ŸÁÉÁNÃõ<sUÃv‹öÁ848Å”Ìðn endstream endobj 4830 0 obj << /Length 252 /Filter /FlateDecode >> stream xڅбJÄ@€áYR¦É#d^@7¹Ül œ'˜BÐÊB¬ÔòŠí°¸×ÊÜ+äR¦gvE8°X>˜YØŸÍ/Η%”ÑYJyN«Œ^RÜa¾aB«¥ß> stream xÚ•Ñ1j„@Æñ7XÓx牚à6l6‹@R¥XR%)S$$¸æfB.2©ÒNi!¾¼7ãÊ.V?ø¡ƒòÇu~žf*U+u–©õ…ÊWê9“o²(èfªòKÿäéUn*™<¨¢É Ý–Iu«>Þ?_d²¹»R™L¶jG/z”ÕV!â­ÿCì´؃@µp` 'h–Îì'–Ä‘vÄ ¡3k"úótÅ{O<¾8‚ FØ ¦evb8Ñ83Mð‹mH Є̎iÃoì˜Â“z˜ÑÌ>úBa"0‡Ži5s?hbé8–TÔ0µcíÙÌÄô00c*ÓCïÙ»1í‚Ö ¸ˆi<¸8Î^°óŽ‹˜­gëvJpÏi\DäXî‘ו¼—!‚ý) endstream endobj 4832 0 obj << /Length 270 /Filter /FlateDecode >> stream xÚ…±N…@E‡PLÃ'ì~ >ÄX‘<Ÿ‰&ZY+µ´Ðh+ü™| Ÿ€ÝK$\gfÑX)Éæ°{÷žúä ÚøÂʪýÑÆß—üÄu%ûB·úáî‘·-‡k_WÎeÊ¡½ð/ϯ¶—§¾ä°ó7¥/n¹ÝySÌÿ‘º…Èí‰壼£'7¬ìe†"Ê0Ò›0ÅDr„ì“92•ãD˜ÓIÙ-Ù¨l‘ÎèðÞ+s@!ËÊÙ˜Âb4ÐHëÜþfƒoöqŽ!þÿC»?ù„õI?b`6ÅÀ|ŒtC t} lL™D2r1uIU'‘TuIk*’ÖT%5P%5°­!Ä.ƒ>“ÏZ¾â/1¢¸¾ endstream endobj 4833 0 obj << /Length 310 /Filter /FlateDecode >> stream xÚ…Ð1NÃ@б\XÚÆGð\œ8ÁM,… á * D” è"ÖT¹–o+ølé"ò0³³DQXOš]yþþòôx:ÁNð¨˜bYâÉÆæÙ”OG8›…£û'³¨M~ƒeaò ž›¼¾Ä×—·G“/®Îplò%ÞŽqtgê%Qmÿ3¢ "Vì–åÏŠ<³Ÿ³•èXú1f3j îÔ„MÅVl!e±y‹ ºo+ =̃ï¬Zy·Çê½ÃÎÈ[‘ÄcoFG\{SZ·êƛЦQ?ƒä‰`߈†µ™=mÿ»•;4ëMÛ?l½þœ};Y«íTj¶Ä­õj´Ó©Ú õIP×Z§ël§klku釾2#}UJ.´Ò†RÌym®Íaɽï endstream endobj 4834 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚÍ’1 Â@EG,„i<‚sÝl±F«@T0… •…X©¥…¢ur4â,-‚ëw3)–.düfÉÿ3tƒ8–Hœô­ ­Ä#Ù[>±s#‰ÇUewä4c³çØÌ!³Ér9_lÒåD,›©l¬D[ΦBÔöá$þ‰»å½:À¨ë[þŽRI9Šùƒz%”î 7t„ø | t}º½€GIÀ³¦ã%EPþðú_üþ+µM_*|u°69X~o ©hFš˜æW§©ÙjÒš»nîDµ!<ËxÅo†s endstream endobj 4835 0 obj << /Length 137 /Filter /FlateDecode >> stream xÚ33Õ37W0P04¦æ æ )†\…\&f  ,“œËåäÉ¥®`bÆ¥ïæÒ÷ôU()*MåÒw pV0äÒwQˆ6T0ˆåòtQ```c;0ùD0ƒI~0Y"ÙÿIæÿ ò?&ù¤æDå(I²ôÿÿà"¹\=¹¹VI¢” endstream endobj 4836 0 obj << /Length 301 /Filter /FlateDecode >> stream xÚ}ÑMJÅ0à)Y²é’Ø–G_]x>Á.]¹WêÒ…¢ëôh=JŽe¥ãüˆ? Ú¯if¦“tߟ ChÞ¯6 §á±s/®ßÑ\¦¼ððì£knC¿sÍ%½uÍxÞ^ߟ\s¸>kŽá® í½Ào@£B,D¸'€DdZš"-š,-ÚB/6¨3"x‰š¢äç”™œ®—ÓÊ®k‰í ƒËpÞ7q|Ì$pãFúæš¿È »ùdíL™@ÚAvüZ´H¥ÙFÓ¬¦YM«5Þk|,ZdÖìI³eb4Ðj`Môä³g!@Tt¶«`[ÈBÍ».àA8ã²EþõËwÌ•b«ÔŠW¢’üÉü'îbt7î}tû” endstream endobj 4837 0 obj << /Length 305 /Filter /FlateDecode >> stream xÚ‘½N„@LJlA² À¼€ÅgErž‰&ZY+µ´ÐhÍ=Ú> @IA烋 á·ì|ýgf.ëK xQá®Âz¯•ÿð!ðe‰õ•Y^Þý¡õÅ#†à‹[¾öE{‡_Ÿßo¾8Ü_cå‹#>UX>ûöˆ)Eà§£‰¿ŽˆN£ÈGG#›"ˆqhfHøÔ8¾ÏéäfEÊAEIÅÈ=¿ÿ„Å-ˆÎ’%$©#쵂H\ÀÕWèfä¹  Íhg™…™cgݺi†¹8iZþG«`©s+´¤É,25×ô\iÜ`2[Ì[¸¨ÈE3)Dä/ˆþbZÁ1.8Gƒ ƒ•I¬³éUuužR¯áÍ:îXÔ&¼oÝ´í]Ö¯"MºÎÝß´þÁÿéýëo endstream endobj 4838 0 obj << /Length 225 /Filter /FlateDecode >> stream xڽнjÃ0ð ‚[ôº'ˆìPÛt±!têP2µ;´4›qüh~?‚G‚$ÎýÅC»õ@ú¡Bw—&ó,㈮+]pöÈo1}R2æ¢ñ8^¼~в$ÿÌIF~{Í’/wüýu|'¿Ü¯8&¿æ—˜£•kžnûLMÔÐ@;ÑÁž&žEõD-twñ>‡5 pU/jh:ØŠ¶,PW+D5À^Ôh ma#:ôYÀVpÔ=ìDÓŠºb~9¬a€g‰æ/ÌÿŸuøÿwiSÒ]]Óq endstream endobj 4839 0 obj << /Length 285 /Filter /FlateDecode >> stream xڭѽJÄ@ðY l“Gȼ€&áH¢ ç ¦´²+µ´P´N-²°`“b¹u>r‡"X?²ÙLæ¿Ó6']‡¶x\c[awŠOµ}µÍšéñLß<¾ØMoË;lÖ¶¼¢e[ö×øþöñlËÍÍÖ¶Üâ}Õƒí·hF8ˆs0;àÛ¤Ž¡+*³¯Lʨ€•Yñ ‘ iþŸŒk›àäï!%Nó¹4tíaà(.JÚ‚bÒî> stream xÚ’=NÄ0…'ÚÂ’›!sHRd ‘–E"Tˆ ()@ Qa-GÙ#¤Lyxcó´‘•Oòóx~ž×ÍaÛrÅ Ô¼®¹=âûÚ>Ù¦ÁfÅíqRîí¦·å57-ϱmËþ‚_ž_l¹¹<åÚ–[¾©¹ºµý–‰ÈÒOdÀ%2…È ¸9SQväTòÔy2ÙSÁ Tà» 2NXFvY òŒø_ȹèíC!š‹"Þˆº%R­î/ºQ‘‰(Œ¶"!×V$ÞMÀ x#$“0"»W ­ ÎˆPrÂ(¨ì$Ó7´Ày?â Âîßèö"^Ò\æ%òˆI‘Éd¾«^EÀ€AíÈRɯiP7ë@tÊê4F¦¾Ã}œÒ·  CÔGƒÉžõöÊ~†\ö endstream endobj 4841 0 obj << /Length 239 /Filter /FlateDecode >> stream xÚ­Ò±jÃ0`™[ü¾he…ÚÎTAš@=š)Cé”dÌÐnÁò£ùQü5˜8²þ@mp CoÐ'¸ÓJ“§,ã˜3~Tœ>óLñVÑ’Ô%cžMq³ÙÓ<'¹æ$%ùæÒ$ówþ>þìHÎ?^Y‘\ð§âø‹òGÂGT‚ ´%ð1Šîs °à< (G˜®Ï‹(ºnhÄÉõ<œA홀°OîÐÂS€ÆiüX+ÒÃé"¬]ö1¨Õö n\PrÀ䚇cDôÆÞ§ý+Á"ZlÎ`eºúý1´ÌiEWÂÁL endstream endobj 4842 0 obj << /Length 339 /Filter /FlateDecode >> stream xÚU‘1NÄ0E'JÉMŽ`_²)²ÊÒ²H¤@‚ŠQ-” ¨£…›øéHayøcARäIñÿù?ûî¼ïÍÎtæ¬5ûÖôæ¹UoªëðqgúË|rzU‡A5¦ëTsƒÏªnÍÇûç‹jwW¦UÍÑ<¶f÷¤†£!*y"<–Þ3Dà‰ê@¼àȓơ©ŠD,#DQÄc!C<– S 1¹©úŸ`}½EØ fðŠQæjÙÀM5ÏA°˜øcÁ²¦Ç.%ó‚Í€€ %‚Æ ç œ9æd’QÿÅœrè™’t‘pI#xÙï$u_"E`—-5KˆfXÊz‘ qv, /&Áy¹6:)z…‹©veÒuFµA¹EøÅ”àVxXVˆ;Õ³]äß‘^KFƒùa9 ÔjcªG²ëÜY•ëAEJ˜¨ëAÝ«D© endstream endobj 4843 0 obj << /Length 312 /Filter /FlateDecode >> stream xÚ’±JÄ@E_H10Íüy? ÙÙ(uSZY,Vji¡hý´|J>!eŠa®ïÍàÅsàN2sß½Y×'MÃ+®ù¸âuÅÍ)?VöÅÖµˆ+nÎÒÎóÝt¶¼ãº¶å•ȶì®ùíõýÉ–›› ®l¹å]Å«{Ûm™È`Oòô˜eÍ€@ªAÕ"dek¦v"ÂDÅLª8O92!~l@Ncï@ŠzÐÐ.1öaiÂŒßáÿðBÿÚ v?Qàƒàt>—p„ C 4‚s9¿ŸH]¶>Ÿ0BÁ/@ IL}~¦-&¾ÃÇ\²^+—™˜îèävq°€ÑÈpÚƒ Ä:ŠTNëµ&­ÐøXaž*ÌE——3ìµq}µˆNd”!ýÑ«ÌId/;{k?žnf endstream endobj 4847 0 obj << /Length 136 /Filter /FlateDecode >> stream xÚ32×3°P0P°PÐ5´T02P04PH1ä*ä24Š(YB¥’s¹œ<¹ôà ¹ô=€â\úž¾ %E¥©\úNÎ @Q…h ¦X.O9†ú†ÿ ÿᬠ—Àƒ€ ãÆæfv6> † $—«'W ÷ '® endstream endobj 4848 0 obj << /Length 95 /Filter /FlateDecode >> stream xÚ32×3°P0PaCKC…C®B. ‚†‰ä\.'O.ýp ŸKßLzú*”•¦ré;8+ré»(D*Äryº(È1Ô7Ô7ü? ¶—«'W Ë endstream endobj 4849 0 obj << /Length 193 /Filter /FlateDecode >> stream xÚÕѱ Â0à_:nÉ#xO`RÅêd@+ØAÐÉAœÔÑAÑÕöÑú(}„ŒŠñjÁ]ñÂñArán÷Æc6Ü—Œ<2|ˆèL±áæŒÚ‡ý‰¦)é džôBnI§K¾^nGÒÓÕŒ#Ò o#6;Jà‹N-(_)/Ú|bƒ¨ÞÃAU+‡ÐÁV]U"sb·hµ9²RÌð¦I+[9hJñmý+܇¿úÏ¿Øiö&cÊ|­¼/?¤yJkzo´º„ endstream endobj 4850 0 obj << /Length 257 /Filter /FlateDecode >> stream xÚuбjÃ0à‚Ž€Ödò=A-pèHR¨‡B;u(…@›1–²9æGñ#dô`ìžd •|' óŸ–‹;}Oš¼–üåô™ã÷¶5\—˜½RQ`öÈ»˜•Oôó}Úc¶~Þ÷[zËI¿c¹%àªa,ÑD!¯Q$mª‹bÞG¡‡Çá2bW…h*—¾^õjL/.i éÕA˜€j’S]3}`ðqdØô;€ÊÇç¸<ƒÆz¼ì<ÊÃÄ uH> stream xÚ½’¿JÄ@Æ¿%`` óÂÍ hþ`Œ×xpž` A«+á@--»|±t¾Æv¶)-­³»ÉWXZýÂd¾owç›*;9-8ã’ >+¹Êø1§*çR̸*üŸ‡gZÖ”®¹œSz-eJë~{}¢ty{É9¥+ÞäœÝS½bÉØ é È˜Þ2Ô „‹–FJŸÑ -_ñ ¾5’ÞJ5fÒ‚FÛvÑh4­PŠ"¡V»‘ƒe¬£‘ÖF T ³ûì·Íß„iÿ—Ó¹{ ÷šî=¾#0¼·÷ôs@7ÑÏIMlý£VMtsŽáç~ŸÃ!|.Gð9Ãçö—#äÛÙ˜­0¶Ì\f¼·Ý Œ{‚qo@W5ÝÑ/X¸’I endstream endobj 4852 0 obj << /Length 220 /Filter /FlateDecode >> stream xÚ½Ò=‚0à’$ßÂüN`!!U'ÄDŒ“::ht†£qŽÀÈ@Z©mIjüÙlBÚ-ïË$ÇCŒû‡ÏOñÁ¸š‡jª^gHs`[ä1°e¿ ,_áíz?K×sŒ€e¸‹0ÜCž¡ì‡ „(eml ñdE|µQ”ýb©M*mÐhýVK;-Fi,ŒI©U®Aml´¾µu¥Öø¡ü“ΧâûýéË÷Úl.CNµ›ŸÍÕZ¸=x¦Úº½%õÐë³gizïÜÿ@Õ‹6ð ·¯7 endstream endobj 4853 0 obj << /Length 296 /Filter /FlateDecode >> stream xÚÅ’±jÃ0†OxÜ¢Gн@k»g«!M¡ íÔ¡mÇ-íì@^Ì[^Ã[WŒÕÓI –õq’î¤ûÿUu¹¤‚–tqE+þ z+ñ«Šƒ…‹ÈÊë®ÌŸ¨ª0¿ã0æÍ=}ý¼c¾~¸¡ó =—T¼`³!ÐÀ–g°¶ƒžçÌÚA@jTê®,÷ ÙÈãÀ°8¨_=¸eãöµ½âC»¶®ŠîAMF‹^ò ¸|œ:I *©@=‡N` í¿À÷Ú ”åž»kÌÛ6„Öñ9&>0s‚!€žof ¾á&j‘‚—ɤ¤”bu”» g€ŒÏ«C0I¶µòF‚)ZëÍæ¥ûàmƒøê*­ü endstream endobj 4854 0 obj << /Length 295 /Filter /FlateDecode >> stream xÚeÒ±JÄ@à )¦ð^@Ì>ID“bà<Á‚Vb¥–BÅ29,ì|Ä2¾IÀHyE¸qwv¦0WløfÃîŸl~´_˜ÄÚ‘˜¬0÷)>a–Û:q¥{q÷ˆ‹ ãk“åŸÛYŒ« óòüú€ñâòÔ¤/ÍMj’[¬–†ˆ:ìcõÐŒvt¥­šÖ¡œ€àXQ(jE/:AØ f ØSŠZÑ xµ¯vàÕ;Š]E¡¨½ÀocêÌlÌÑZPŽ‚7ÅïÆcõCï+Áÿ°Oß+h¾ßÜ8‹"ΰó‚æk=Î8E¸Ñ³Ó>Ì¡é¦(µáœñƧà0þM4‡ytŠ^i¾$À×&"ê·g^á*þµÄ endstream endobj 4855 0 obj << /Length 152 /Filter /FlateDecode >> stream xÚ33г4R0P0bSs3 …C®B.S˜ˆ ’HÎåròäÒW05âÒ÷Šré{ú*”•¦ré;8+ré»(D*Äryº(üÿÿÿ*ÅøÿÔ€P £ˆ2ÀC@¨ÂÔ,ãdŠB±£PüÊBÕƒ)Æÿ€ˆAþÃ0@£¸\=¹¹õR€£ endstream endobj 4856 0 obj << /Length 258 /Filter /FlateDecode >> stream xÚ}ÒÁJ1à ] {-(tžÀdiµñb¡Vp‚ž<ˆPY¥§R=wÁ[ðEú{ÜÃÒ8Szh»M ß$‡dÈo¯/C2tÉÓéÊÒ{ŠŸ8²\)å _à$CýL#‹úžwQgôýõózòxK)ê)½¤d^1›’sðˆ]ã\)Jö¥vÚ,×¢³ú´æ•hp ¼å½5¢?f|#¨ßC­XQäÓ˜éxÕçFºGJøù=¯bnÄxujQüüÒ+Ø€*üZAÇ€úe7 dÝk)®L@Q= H5eKÀá ˆÿFTµ¥¸¸Ù*q[qœ«àœƒ(ùk ï2|Â]áÍã endstream endobj 4857 0 obj << /Length 160 /Filter /FlateDecode >> stream xÚ37Ð31R0P0b3s3 …C®B.3ßÄ1’s¹œ<¹ôÃÌŒ¹ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž. öÿÁàýAþÙ70ð``þaÇ¢~Ô@èš m£ ´ :¡yÑ 4!šB3ŒÒÓÀøƒú ’í 4—«'W +‚q endstream endobj 4858 0 obj << /Length 229 /Filter /FlateDecode >> stream xÚuϱJAà¹ba ï ¼yÝÙhº…Á+­RˆPK E;1 ¾Øt¾Æ½±»âp½‹ S|Å?;?¬ŸÏxžjösö3¾­éüTCÆÍÍ=-r+öSrg“kÎùéñùŽÜââ„krK¾ªyrMÍ’a{è„Õ®lBŠ-`a:`Ðu)xªu‹w­äG½W‹˜ÕùÇ2©&e˯œɦá¶ÏÚnh›‡Î ÙÍhüuð‡aǨ‡k}ÿ¡ Þ[ bÔªµoŸb»ý"E“z“†O¾€Nº¤oÉŒla endstream endobj 4859 0 obj << /Length 212 /Filter /FlateDecode >> stream xڽϱ‚0à’$7À ˜x/ ¥$N$ˆ‰ &:9'utÐèf,Æ£ðŒ F¼‚†ÆÕÄßp×öþ ü¡ ÑÃ$ÇÜK8¯‹†ïÎîq b~bNeé/çëD¼œ¢‘àF¢·…4AFGi¢ú[«‘µª?«2’×%éæ72byg6ù ã•Nh—:¡]hÝB¿íçQÖ©L›)õ϶ÿ˜?›Í$nþIØd¦ä¼Ô[Xm”ÑFŽÊiÇžzÒÕŠäuA63`– ^¶Ñj» endstream endobj 4860 0 obj << /Length 210 /Filter /FlateDecode >> stream xÚuÏ1jÃ0àg<þÅ7ˆÿ 4²‘ã1'…z(¤S‡$ MH×XGÓQ|„ŒJÝW\(TˆôúŸ 7uN3uúk‘i1Ó}.Gq%CËáf÷&u#öU])ö‰±ØæYϧƒØzµÐ\ìR×¹fi–Šè €éÆWà‚Op_ÝPIÓ!õ I@Ò*¤#f %×#ý¸~á,üK{ÇT#ç¼³¶,„ΰq`É(°nìYÜsLøâ¾Þ–ÇF^䃷V2 endstream endobj 4861 0 obj << /Length 125 /Filter /FlateDecode >> stream xÚ32×3°P0P0b#S3s…C®B.#C ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ŒØ€ÿ‚ˆ¥ˆŒþÃûæ? : æ ÿÿÿ€ .WO®@.»P endstream endobj 4862 0 obj << /Length 110 /Filter /FlateDecode >> stream xÚ32×3°P0P0b#S3K…C®B.#C ßÄI$çr9yré‡+ré{E¹ô=}JŠJS¹ôœ€¢. Ñ@-±\ž. ŒþÃûæ? ŒC 1ÿcøÿÿq¹zrrp^Ú endstream endobj 4863 0 obj << /Length 159 /Filter /FlateDecode >> stream xÚ35Ñ34W0P0bSC…C®B.˜ˆ ’HÎåròäÒW01çÒ÷Šré{ú*”•¦ré;8+ré»(D*Äryº(0þaüÇÀðÿûÿ@RŽý´`üÁÀþ§€ñóŸ ÿ`ø$@äÿ†z É€ ÿa/É òmÃÿÿ?ìÿÿC&¹\=¹¹?qjS endstream endobj 4864 0 obj << /Length 209 /Filter /FlateDecode >> stream xÚ= Â@…GR¦É2ÐMtý©bSZYˆ•ZZ(Ú‰ÉÑr2EH|›((vÂðí̛ݷ«Ga_<éIÛ=Ý—½Ï'Ö]ˆžQêÎîÈAÄj-ºËj™U´Ëùz`,§â³ eã‹·å(¢8!"«Ê@'-À1¹à4r²Sjed=L A Ñ‹]l»ÓŒßÄñ V0ùee˜þǯÛ̬äsnãÄ…«òíž ²Áœ¬Ì”/óÍKÝ´í*ëßàYÄ+~PûZ> endstream endobj 4865 0 obj << /Length 218 /Filter /FlateDecode >> stream xڭнŽÂ0 p[*yé#à€4"€øè€t7Ýpº ‘Á }4¥Ð±CHpH'n¼[~ƒ­8{`zzÄ9÷¹«Ç<Ðl o5É„jÎÃ~ÛÚìiVúb3"µ’:©bÍçÓeGjö1gMjÁßšó*Œ6±Þf¾'i%°ôQ|”p”Þ´Dй£+”7Y´¦Ñ&˜Dí»èþêï™ñÇÖºÍã^ÙÜ+­džF˰ÅU6ºƒ´uÒˆ“¬;Ò‰wþÛĽoÞ¤eAŸô$”Šš endstream endobj 4866 0 obj << /Length 144 /Filter /FlateDecode >> stream xÚ36׳4R0P0a3…C®B.c˜ˆ ’HÎåròäÒW06âÒ÷Šré{ú*”•¦ré;8+ré»(D*Äryº(0ÿ`þðÿ‡üŸÿ?lìþÿ(¨gÿñà?óÏÿ6ügü  u@lÃøŸñþC{Ì ´÷ÿÿpÌåêÉÈÈöPê endstream endobj 4867 0 obj << /Length 202 /Filter /FlateDecode >> stream xÚ]Í= Â@àYÑ6sݬ®+Á0… •…‚Z *Z»G²´ÌQr„”!ënÄ5Ø|Å›7¼¾èȈBêR[ìÑ^àË0$)?—ÝG1òÉùÌÄÈã9]/·òÑbLù„Ö‚Â ÆÒ:c:¯êk€{ê-Ŭ`m8ë¦8•u¨ t&p2 l©µ™Bâ̘ÑϘúê½> stream xÚeпJÄ@ðo \`^›B¼yÝÍ] ç ¦´²á@-íÄÛG²´Ì£äR^w¢ùÃÙüŠ™]¾™9ŽŽâ„ Oùpj8>åxƽPS5œÌþZ÷O´LIßpœ¾puÒé%¿½¾?’^^qDzÅ·›;JW\×…ªË¡~ lr¯&V‰÷g¸î¾{„'À´N2¬;säÀ8GÖêÊvn=§·õЪÊQoåb]pл ~‹‹¯^¶ã8ëõí®Ø:úg00ìœ7~Êžî¿®JT¥Ä٠Ͼüœ4s”M^!ÒyJ×ô[ÍX' endstream endobj 4869 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚ½½ ÂP F¿Ò¡¥Ð¼€ÞVn«“‚?`A'qRGE7Áúf}”>BÇÅšÞ‚Šè*3$|9º×î†ì³æV‡uÈQÄÛ€¤}®+ê5“Íž†1©%kŸÔTڤ⟎ç©á|Ä©1¯öר8Ux·èã”À*à%V7±38©“ÂÎ \Aî&°rOP ådeyÜ¿¡>Xý ?c\%éý#øë£æË'q¶(I£©fÔ‰µNšÄ´ ƒ…) endstream endobj 4870 0 obj << /Length 131 /Filter /FlateDecode >> stream xÚ3±Ð37U0P°bC33…C®B.c# ßÄI$çr9yré‡+qé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<] >00013Ëñÿ ÿAø9³ùà óÿúóCýÿÿÿa˜ËÕ“+ Ìt^@ endstream endobj 4871 0 obj << /Length 259 /Filter /FlateDecode >> stream xÚ]ÐÁJ…@ÆñOf!"·."ç åÚÍE0p»A.‚Zµˆ ¨vµ ôÑ|Á¥‹ËÎgH0?˜ñ?p´¬NÎNmn¹ÊÒ®×ö¹wYUºÏ¹å‹§7ÙÔâîìªw¥§âêkûùñõ"nssa q[{_ØüAê­…ÙÈB´aD4%;˜>Ú#îp¨§Ýà{%*eÌdl”鈧W”]èHÿ‹ùOË·ž¦…dfä 3Âױt¢KÒ‡óF¼oæû¼³MØfl=³oÂ,"†EÌ"pLΉ~WІh–Fš¥F³*Ö4×€& !Œ3ž´DWþËZnåÎvj endstream endobj 4872 0 obj << /Length 206 /Filter /FlateDecode >> stream xÚ¥ÐÍjÂ@Àñ„@CÐkBç º·‚Ð õäA ¶GAEÏæÍÌ£äMbö/hèµûƒÙf–Éf¯Ó±Zµ'›èdª?©$¶¹u©{øÞÉ<³Ñl(æ½½“èéxþ3ÿ\h*f©ÛTí—äKõ> stream xÚ¥ÏÍJÃ@ð Ci®Š°» ùX/b Í¡ §ŠPB,íM$–Gé#xôPÔÝ .ÔC¡3ð;ÌÌîÎ&z’§¬8åë˜ÍYÎϽQ›¢âì¦ë<½RQ’\q“\˜2ÉrÉÛÍî…dqÇɯ#VTÎx$ltŽøc¢uZGaýÚL„ÂùÚ¨EeT°†{Øšôk€ç.àÐYàjXà î-æ‚^› Çð Þ:~ÀwÇßޑþ×ÿ'žaðÙ”æ%=Ð//ó]ã endstream endobj 4877 0 obj << /Length 106 /Filter /FlateDecode >> stream xÚ36×31R0P0F¦ fF )†\…\`¾ˆ f%çr9yré‡y\ú@a.}O_…’¢ÒT.}§gC.}…hCƒX.O~ûõþ@Àúöø¨ pÙÁåêÉÈ1V2ê endstream endobj 4878 0 obj << /Length 97 /Filter /FlateDecode >> stream xÚ31ѳ4R0P0T02W0¶P06QH1ä*ä26 (˜C$’s¹œ<¹ôÌ͸ô=̹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þÁü—«'W ‘›44 endstream endobj 4879 0 obj << /Length 254 /Filter /FlateDecode >> stream xÚíÔ±NÃ0à³2Dº%+ö»:F*E"L ˆ‰22P• )}4%1C䟻8,bÉ’¿ËùlEÉ…°ºZmœwk™Áod·üÎÁkÈ]½¼ñ¶æòQk.o5Îe}率W.·÷×N¼sOÁùg®wŽdØÈ Õ%eÀ‰,âÅøÐ+š6ï3U}åŠL¶_V_T($HMsJiVjBRGH†Aœ ÃhÁ>ÁDE÷ Z:›o©‡æƒî›1•ÿ‹ñJÍŒ.¼ ?ãl,ïmÁ¿Gj*ò×Ò%ª¹mØH0ùŽ[ilñLðMÍü ?”5 endstream endobj 4880 0 obj << /Length 398 /Filter /FlateDecode >> stream xÚÕ”½NÃ0Ç/òÉyÔø  m¥ K¥Hd@*bFHÝ’Gó£ä2vˆjîü•Eb&Cô‹íÜÿö×ËË«¥ÈÅR\”b‹"ÏÅkÁ?øªÄQú.íÜË;ßV<{«’gw4γê^|}~¿ñl»¿Ïvâ©ù3¯vèѾQ¢5@d°ÖºµÈ´ÖG`ÊÌ·ìdQö¸bB\‰"dºÁW› Æ'œ‰º1é)àP’l$bÝ.µ¯DƦ9†hbY´±p‚ôÖ>bP:Ä`VE•S˜`ªœØåt¡³€ÖÆèÜL©t„Ç9”3)ï|Šõ bvóØÔÿ GÖÿNs@9ƒÑdSLç±8:›pÜ ¥1¸ eÃPQJn„gCÊ‹Áû9„RÞ@(ðƒo!ƒÞD¾E¢¼œiM«aZÓj$MØŸÔ|›h×f•‰ÖÛöj¨cÕ[ÔèÒæBíï’¥KÁï^~ïñiÂéûü¶âü+8éj endstream endobj 4881 0 obj << /Length 285 /Filter /FlateDecode >> stream xÚÕÔ±nƒ0`"¤[xî jÈÐ )M¥2Tj§ U¦´c‡FéLGá,\Û´ç“rJÒn±„õÙHðý.òùÍòs,íe±,ñµ€(vœ»¡»±{‡U jƒåÔƒU?âaÿùjõt‡¨5¾˜o¡^£ñ­l›h»ÀÁOkÛ5£cå&RóeûÌqfÚ_FMOôýÄTã‘83ÄÈ=í‡MK¬:bÖSƘhbÌ8ÝrÇt+ ´/!±#V2{‰ãpŽZbúŽ×Àÿ}ÿ;Ãå”·EÞB¶ÇlçM{º`äâbÕÇÊ“‘Õ/+pVö, ¦ Á¡´Ä!C‰–¢9ÅÔ‡7ñá ‘fA?Ž8üQ÷5<Ã7ã  endstream endobj 4882 0 obj << /Length 243 /Filter /FlateDecode >> stream xÚ¥Ó½jÃ0ð 7Ä/Pð=Aew± …@šB<š)CÈÔv,¤¥…nî£åQô;T+&ÿPŽB‚ßIè®.®ËÉ¥ò½’º’§‚_¹¬û8÷¡Ÿx|áYÃf-eÍfѲi–òþöñÌföp'›¹l É·ÜÌÅÛ׸Èý‘òš~÷¢Ìí);HCtR M¡ J¡$ ’=JEŠþ£Ý ]¼(F]œ¤¡J¡vOPŒN+þì’NSÝ¥w>ÿ“H]! —ëªFõ©nL* %¥øaÔB΢¢,ªÌ•§³¨Æý¸ø¾áÿÃ# endstream endobj 4883 0 obj << /Length 146 /Filter /FlateDecode >> stream xÚ340Ô30S0P°bKcK …C®B.  ßÄI$çr9yré‡+X˜pé{E¹ô=}JŠJS¹ôœ ¹ô]¢  b¹<]þ?ü@ÉbØìÿ€˜Ìÿ00Èÿ1ÿ7Œ2‡ó?Å ³áÉDʼˆ,MJIÀåêÉÈR… endstream endobj 4884 0 obj << /Length 313 /Filter /FlateDecode >> stream xÚÅÔ±NÃ0Ы×ÎÒ×@êÊÁ0·Ì=ÌãS,,D¿ uÇê‡Í+u|mÇêŠï‹ÛOö³ëîDîOæE;Y—ðЊÙDê3i S%wÎû3cH˜€ ;›<$érò”¯Ùét ?F7êðºÂ{ü‡ñ,\ endstream endobj 4885 0 obj << /Length 374 /Filter /FlateDecode >> stream xÚ…Ò;NÄ0à?JÉ`_’ ´@e‰‡ÄHPQ * ¤AKr´ÅGp™ÂÊ0ö˜ˆ] ¡-¾ÕÄžñØsr|xzf;{bŽìæÔö]gŸ{õ¦6M¿¾;’oO¯ê|«Ú{»éT{âªÝÞØ÷ÏÕžß^Ø^µ—ö¡·Ý£Ú^Z ! à( *¢˜lˆÐ4±ÎC #ê™]xKt¨"ûå8ÆšM`5ïôÈ©õ$šdÍŽH5à’`!Ùaõ+ëV—ÍêUúË\·Y¦==¤R(ÎÅ(š¥( ¸UÙÐP,RÎTå|²’J`(Ãúœ@>ðZÊÂuÁT2äŽ(üNÍ©YS9Ô°åpcY Vr6®±çÚõžÆËDýÍjøÇyW/jwÊ{NÒ‘ùq”ŽÜ(8È +Z°ä„KJT͈i°xHc@0§5sóL‡Š<'Bz ùtÿ!Yçg˜ÊÓ««­ºSßÔŽæ; endstream endobj 4886 0 obj << /Length 374 /Filter /FlateDecode >> stream xÚÓ1KÃ@Àñ 7´_ Øûš¤CI P¨Ì èÔAœÔQ¨¢s#~±lý·¹IÆ !ÏÜ»{w5‰Ö Ç—„ð?.qŸEs‰™8‰4i"bþÌS5ŒD™[÷O|•ñp#Ò9/Õœ‡Ù•x}y{äáêú\Ä<\‹ÛXDw<[ ¨™ºvÿ1ÈÑc(Ù²A2¿-õ#ÌkgSrí̪öC›wYÉX@–­ÁÙ7öŠ®skÏØÏ».БÕÒy§=ê¹DŸ¨e©=AW=/Ô2ÕNе³ ÞöÜPºÇ¯›ø{Ro0åR¼¶öó¾ J7ñÞ=Œ7ÆàÑ€KgŒŸW/´1>1®1x;à†ÒM¼4†Ÿö$.ÊÕñd¬s».(ãM.Æ[·Á£A—ÎmüdÐ¥c|b];·ÁÛA7”ŽñÒíYû@¹ÊïÖ|äÃÞ[3Ø3çOçÝ×/nœéþËæØ÷<.;Çí=ó‹ŒßðoZÎ) endstream endobj 4887 0 obj << /Length 287 /Filter /FlateDecode >> stream xڕѽNÃ0à‹> stream xÚåÓ»JÄ@à¶8MÞÀœÐÌÀÞ„°ë ¦´²­VK E[7e°°ô $2EÈ8gfö‚A´³0ðÍ%sù'™ ¦Ç$iH‡Š&’””t£ðÇ#[ËeåÛVw8Ï1½¢ñÓ3®Ç4?§Ç‡§[Lç'dË ºV$—˜/%¸K˜ó DÀºý¿ásÐ¥0­GbŒÇڷ鲸f¼V Æ[÷ÖïöÑ1>8Q†«.ìÝ„y4¿šT1£bÔ<¢[σ¶‡. êÃ| Ø¡ø ü¼Âº¯;í‡ Úý \tõ~˜Ûœ9ù„“ÙAƧÇrà×:ösÂLn˜ÙÿÊrÕnÈà™7ÃІûÂbÓ„/ǵàiŽ—ø »ÆËH endstream endobj 4889 0 obj << /Length 262 /Filter /FlateDecode >> stream xÚµ‘±JÄ@†ÿ%ÅÂ4yƒË¼€nnàà pž` A+ ¹J--îP¸B¸«Ø×\_ðSE;ò%ë_ûtòøBë–Ü=û’ܵl“koøuÿöLn}{ɹ ?T\n©Ý0`Bùòð¡h§"à(»Ù vì3…,r£Vˆç ½(R0§(™ºZ1̾‘?¡^3šAÑï RàWÄ^þS…ãML j×3ô)0}1Fè3‘õ¹fšÅš l—iX6e–§©î*y’›XˆÞ i}l±éæM‹ó£«–îè S-zY endstream endobj 4890 0 obj << /Length 290 /Filter /FlateDecode >> stream xÚåѽJÄ@ðYR¦É˜yM̲pž` A+ ±º³´P´”äÞ,÷&ñ ´ËAȸ³›„ÃÃΰ¿Ý%“ͦ‡GÇ”RFûš¦štšÒRãN2»šÚ¹ö{‹{œå˜\Ó$Ãä\Ö1É/èéñù“Ùå)Ùùœn4¥·˜Ï ܵç0Cþ v þ-¸ôˆ¸ñ0ÜypiV‚ …p-P¯‚¸ØLð"(J€Ëv×W—ÀU+ov®Œ‡-ã“ßúcDâõg˜Uâ7({ð_`üú7'4»¨¿ ÁlÃ…éâm¶sކH/@×b€±'Û¸^U Þ¶b°æÊUŒVlÿA1J·1×vÏÞ€g9^á[9×^ endstream endobj 4891 0 obj << /Length 267 /Filter /FlateDecode >> stream xÚ‘±J1†'lq0…ûÞ¼€f̰pžà‚Vb¥–Š‚]òhy”}„-¯86ÎL¢œ‡• Ù/Ìü;“üq«Ó5äè¤%×QwFO-¾¢kHfçræñ×Ú;r Ú+£®éýíãíúæ‚Z´ºo©yÀaCÕ 2–i¤´å¯™5º˜À€z„>‚¬%k<&rš¥,«¶`vŒìd+q3Ëß’1«^+ü ô\úoxE<@ØG*Ðqˆ ÷ù/|AüýoŒÙ¸=˜¨×,¨¢8U(`‡Ø´ fA-©‘pœûžçÚŸ¹Ú¤Pjí"ê{mœ¤ÔIš€‘ƒã倷øYRŽ endstream endobj 4892 0 obj << /Length 182 /Filter /FlateDecode >> stream xÚ31Ô34W0P0b3CC…C®B.# €˜’JÎåròäÒW01âÒ÷ sé{ú*”•¦ré;8+ù. ц ±\ž. ò€Ãÿ@‚ùÿ? ÉÿÁ$|@¾Á¾¡HÖ3ü?ÀÀðD2‚Iæ?`òˆdÿÁT!ù?0È ``€‘Óù`! ‡iŽßú? æPÂÁ$¹\=¹¹û™ endstream endobj 4893 0 obj << /Length 351 /Filter /FlateDecode >> stream xÚ­‘ÍJÄ0ǧäÈ¥¼€¶‹µ‹§Âº‚=zò ‚ =øu“mÁë£ärì!4ÎLRuD¶„™ÉÌüg¦^îW¦4•Ù;(M}hêÊÜ-Ô£ªKCÿQ•\·jÕªâÒÔ¥*NÑ®Šö̼<½Þ«bu~lªX›«…)¯U»6À_‡GzahBŸ ‚Õï„—ã›t ]æ2 º‡¦G6Da)…Æh˜rûÅÌcf÷EA¿1-Û?pλëÛÕ³«÷³î I}Òˆš6Ä¥£P€gOén Àâܘ’ÝÙ'û+ít‰c¢„036u! è’¡AÒMÄ"9Ñ%ûÈ} |H³=¤X9ÑZ±H v¹÷]Ͻãm³E=L‰QVþgÎq)Ïœ¯ïRþT7éØD]àãn²¤Çó cˆ»Æ’|´M É'bÛ<Î%øªNZu¡>ÚvÔ endstream endobj 4894 0 obj << /Length 219 /Filter /FlateDecode >> stream xÚ37ѳ°T0P0bsCC…C®B.33 €˜’JÎåròäÒW03ãÒ÷ sé{ú*”•¦ré;8+ré»(D*Äryº(00`öÿPÆ"Œ0C=Ã~d3ê@Ìÿÿ@üÿÿCö àP³?PÁ ÿÌøÀÀÿÄ8x€ýˆq¸¤Íþ83˜qÈøe0‚w`Œ0H+Èû¸p3Œ2¨ÆÅ>ãÿ òÌÀøþÿÿÿf qƒËÕ“+ ‡ÞP endstream endobj 4895 0 obj << /Length 142 /Filter /FlateDecode >> stream xÚ36×31R0P0bcCKS…C®B.#ßÄ1’s¹œ<¹ôÃŒL¹ô=€¢\úž¾ %E¥©\úNÎ †\ú. ц ±\ž.  Œÿ˜ÿ30°ÿoÀŠAr 5 µTì ü@;þ£af f€áú!Žÿ``üÿè¯ÿ ȘËÕ“+ > stream xÚåÑ=JÄ@ð )¯É2'p2°Dl ¬+˜BÐÊB¬\K E;qÒy­ˆ…å^aŽ2EÈ33ïŸÂEô„ßdȼ¯Ú»Ò¥Ou¤mYê­¥ªÂAßÃîöžÖ ™+]­Èœ…c2͹~z|¾#³¾8Ñ–ÌF_[]ÞP³ÑIÚ%ae,ò*˜¸=ëÿcÊ<üæ<¬6êF¹ç<ì â½Âö¢òÈÓ‰Y+æÈ _à ª^L½˜ubÞŠ¬qîð‹ï,÷?vïóMÜectJ§è¨ÄAq´O8Öç‡:ê®ÑG±ˆþò}-¢ÿ˜ ô¿È˜KHçÖ~Ÿc¹‹½DÇ='ùù0t[°gž7×ÒiC—ôÍâÞÏ endstream endobj 4897 0 obj << /Length 123 /Filter /FlateDecode >> stream xÚ36×31R0P0bc#C…C®B.#3 €˜’JÎåròäÒW02ãÒ÷ sé{ú*”•¦ré;8+ré»(D*Äryº(0°70ðÿo`ø†™˜†ëG1Õñÿ ŒÿÃúÿdÌåêÉȸ§‰ô endstream endobj 4898 0 obj << /Length 252 /Filter /FlateDecode >> stream xÚíÒ±J1Ð;¤¼ÂùÁ|IÜeÑj`]Á)­,APKAEÁnæÓ"vÖù„”[ û|Ï]°\k±äÜ„[Ý÷vGÜXN n2rבî)M‚Z/W·4mÉŸËŸ1ùc‰É·'îñáé†üôôÐEò37.\P;s0 ]*îËÉðÔ\æT3&‚œ0þÆ3vr•ÑõŠ‚ºHM“¤å%Á.,äè^{ØaK uÝ`†m)4ï‚å¾`±B¥°ŠOÅÝŠË5䀳¶Š"mDVô‘øÇ_ÅÏ—ÊBŒ.¤fY/ë©ó/AG-Ñ!A B endstream endobj 4899 0 obj << /Length 207 /Filter /FlateDecode >> stream xÚíÑ¡Â0à[*–œÙ#pO@·@ ¨%0&H@! $¸ñh%Ø#L"Çu€…D´ùþ¶—KzzµÙ¢ê²™Í"\¢1’CÝÅtíõˆŒAÝ“SÔiŸÖ«Íu{СuBãˆÂ ¦ ²åà³U|0Û€ù‰Ø–ØB%/Q@Px¼·à_åQvØïʲ#€rˆO‚û ^‰Ëç7\©ëŸ‘†ýãgpÓ÷x'A~^ɼ™¹P²Ù/ÀnŠC|U¸ý endstream endobj 4900 0 obj << /Length 249 /Filter /FlateDecode >> stream xÚ­‘±NÃ@ †}êÉK!~¸5Ç©©*ÁÔ1#æÜ£õQú3T9l× êÈÝIßɾü±‡Ûë5•TÓUEá†Âš^+üÀ:p°¤PŸ3/ï¸éÐï©è·Fßíèëóû ýæáŽ*ô-=UT>c×€Kxåiôi$Þ«Š@v”#W@Áø!ç'=rå4à8 E\)™æGCÎ †B1Š:‹6ŠÓ½bê¥:wZ¹KÿŠ??²"XÖi=Ì1w«½fùbpêYœ4?Í]óšeä[›ƒã©ÄßÙÄt~xßá#þ°´”ð endstream endobj 4901 0 obj << /Length 288 /Filter /FlateDecode >> stream xÚÕѱNÃ0Ы2Dº¥ŸûHmÚN–J‘È€SÄÔ22€`%ù4£Œýƒ*Ÿà1CÔÃg[!uBbˆòîbŸ»Éèt:£ŒFtr6¥IFÅ9­s|Âbl³ÍòðiõˆóÓ%cL¯lÓòš^ž_0ß\t—Svå‚ ÒPiˆYÇÜY0ë„Ù£Ö-$F°i nüQC$««­ö‚l±réÚ¢•ÈîWFÐ$\E‡aë×}!î~"Ú÷bÀÇ ö€?ÄqëÿÁ®·®Q®uæ{3}>t^ ãuCaÊΟ jëeG)…Am´«êÝø¢J¿IãŠe­Å[W.Üç¿¢jØ„7ý¼,ñ?n·Ùe endstream endobj 4902 0 obj << /Length 303 /Filter /FlateDecode >> stream xÚÕѱJÄ@Ð )S˜ÐËü€&{šœ‚ºpž` á¬,ÄJ--m.ñÏâŸÄ?ˆÝ!{3»Qä@Áf÷íf™™ÌŒÔ–Ú¡„RÚîÒHQ¶M× ï0Kù6¡=ÕººÅqŽñ9e)Æ'|q~J÷7§GÄç ](J.1Ÿ˜ÖxƒÐ4Ú´0˜J[ø¥ ˜ƒ_2¢¼Z k€FPTO3öžáú c :†³ð´«³ñÂp`÷ð œÁÆÐß 9 ©ëÏð›Âôê´Mð–»aå/wì³™~Û·×ö9êúÎoÈ"³8\â³@súwû°ïÍN¦àUÀÂgÊ™…™;D¦vàñ:ôþ[ø¦G`Ç'»qZ<Îñ –ÉÄ endstream endobj 4903 0 obj << /Length 185 /Filter /FlateDecode >> stream xÚÝÏ? ÂP ð¯,d°«ƒÐœÀ×ÚVt*øì èä ‚ Ž‚ŠÎ¯GëQzÇNÆ÷:ˆƒx‡üÈ—@ i¿—Drj*ñ æCDJb“Cíb¢qNjÍILjn¦¤òß®÷#©ñr©)oÌ™-åS†¯†/ž–ÂX¥ˆSeF·Ô•+^¡+ˆkÛª»d%ôA¢è3ðv×X}Xþ´øÅ~äÈö"õ7i–ÓŠ^¤Ds. endstream endobj 4904 0 obj << /Length 281 /Filter /FlateDecode >> stream xÚuÐ1NÄ0Ð¥ˆäÆGð\’o$"-‹D $¨(PR€ [mr®â›#¸Lv˜q v š'Ù3þ3Éêì´n¨"O'5ùsj<=׿Íx/—5«¥òôjÖ)ïÉ{S^˵)»úxÿ|1åúö’jSn衦êÑt8ä€å©zÞ[dŒö yDñbDΰƒtÁ‰=Z¨b‹è°M΢ýÇûyqPû¡©“Újë•e^Œ5X*³>ìYëŽYžÌ:#•õB´IjÆ!¥MlGÕ-ƨéÉâH]$?r>Pçäcš6òŸA§Ù ÓìÖ~¢þ¥I"v˜¶ÈfD7¸ˆ(Ÿ0æºl@/]æª3wæׄŒœ endstream endobj 4905 0 obj << /Length 191 /Filter /FlateDecode >> stream xÚ35Ò31T0P0RÐ5T01U°°PH1ä*ä21 (XXBd’s¹œ<¹ôÃLŒ¸ô=€Â\úž¾ %E¥©\úNÎ †\ú. Ñ@ƒb¹<] @€ò>’ƒdF"Ù‘H~$RLÚƒÉz0ùD2ƒIþÿ@ÀðƒD1aˆ’Œ¨L²ÿ``n@'Ù˜ÿ0°3€H~`¼ücà1ƒ(¸l@Aÿà(ÀáÍþÿ8¸\=¹¹~@‡Ø endstream endobj 4906 0 obj << /Length 203 /Filter /FlateDecode >> stream xÚíÒ¿Aðïr Éî$7/ÀÞÆeQIüI\!¡Rˆ ¥¡æÑîQ<‚ReÌž V÷Ûùv¶ù¶™Ö[mN8åšå¦e×॥-9§Ã„]úHkêfd¦ì™¡ŽÉd#Þï+2Ýq-™>Ï,'sÊúŒ0eQĈ"”ïüå²ÇÜŸÞÑñþñ3‚Ï?£(%V” œÊUè… Ð’“n(6áÁY4nú+|×<>èÈ­h‘\Ð ºEƒŒ&tj8­Ú endstream endobj 4907 0 obj << /Length 319 /Filter /FlateDecode >> stream xÚ}Ñ?NÃ0ð/ò`ÉCsƒÆ' Bm‡H‘J‘È€CÅŒH€@ê–l\+7à 9‚Ç UÏÏ6c#%ùÅÞg½lª‹êÊ®lÅ÷fe×—ö¥2f½åoùôÏofךòÑ®·¦¼åQS¶wöëóûÕ”»ûk[™ro¼òÉ´{Û Èùq 4M@s `d<ŠÜƒoh^53¼x@=tïÑqeÿF3`0b)(jA>á(ÐÞNp5g£ £P˜K«>â'¢û o4s„?uÀ‘'è4¥þ‘v)Jk(VλˆEÓ—M8ê"œÇ<Â¥Œ1fdc,­†,@÷YÈÐÒ"Ÿ -ò…ji_[i‘OHÇw¾ë’á».zŒ¿©HhœA~ ?4¹ðs‰xkAäÎÀÜ´æÁü“Xž¥ endstream endobj 4908 0 obj << /Length 257 /Filter /FlateDecode >> stream xÚ]ÑÏJÃ@Çñ = ÌeßÀ'pIÅ€¨ÌAГ‡âI{ìAÑsöÑ|”>‚ÇÊÆù»Ð|h¿|!Ëî¼ãš[ù-[¾¼à׆ިÕ{µþÕ/;Z ”ž¸í(ÝÉ]JÃ=¼n)­n¸¡´æMÃõ3 kŽ“ž| @5A<,„½P f<AÐçgÊ·ÑïáZg¾Œ)+Õ/W¶¥ #[ÆÁ-¥Ÿ‘7û–ži&ëU·ÀòŒbHžžàh¾çümýŸÌ°È–g€¢[Î ÍCŸDÏCŸDßBÏCÏ ž> stream xÚ·T›é.L±"EKi)(P<¸»»ShÑ‚Hpwwwww·âRœ"E‹-R¬@áÒ™93sÎÿ¯uïÊZÉ÷lßï~ö»¾PS¨¨3‰š@ÀRP8+3 @\QQ–•ÀÂÂÎ̆AM­[ÿ#Ç ~¶‡A 6|ÿ²·ƒà2 üÑPjs°°²X¹øX¹ùXXl,,¼ÿ1„Úó$@Ž€"3@j†aP‹Cm]ì!fæðÇ<ÿyÐÓXyy¹ÿpˆZƒí!Æ €"n¶~Ìh ²¨C!`¸Ë… 0‡Ãmù€@'''f5Œjo&DÇp‚ÀÍj`ØÞløÝ2@ d þ«5f j€†9ö§Bj wÙƒ+ˆ1Øöèâ`c¶úƒA+Ñ£Á¥ƒR¢ªÐc‡õ3¶‡ØÂaÌ0ˆÕï¿Ã<³¤‰8ÔÚl‡aü®Ob6~.ƒÍÿšjÿÜ]E° ÄÁúµ²pÐã:ˆÚ˜=Rš‰•ƒ™…ãO9&q›¨@àÆæÒæO¹æï…³‚Ø€U 0Èï+æÑ‹…åt[flùxÀ¹ù§ {\9øƒüÁKõßuHÚCM~o'dorÁxþ#⸱>®© Øùv€Ì6Pø£ à±g€)Ôã÷ ¹¸@ñߢ?Ï#½þFÜ, Ô?ˆ”ûq€òÿ Ç(Š#žG?•;¨þâßý8yÀÇ Äô·ä÷™Mþ½ÍþÓBþëµú>nú/ÈÚþ“ëÑÖö‘‡ÐE¼Øvÿ‚-Úÿ >z8þÙ+sþ|Læòü¯;ØÛ?NìMzœÖðw#ì 6ÆXü 5æ÷·¨õo¿®%vbÚ@9N¾ÖfcÏ×Gƒ÷KNlĪg¤/É—J-ö±Jé[t)‰Ù]g®ÎÿpÛª#¯wá¸d"—Ú5#7Šþüpùd6Î튄ò3N3BŽV¢_‘}?‚ in7º°‰Y¿:5ŽûÛÚÞ…8'‚b)n¹€v¥ÎîêâtBÞw‡_Õà-FCÛœç¯Þf}µŽòÛ × IRJ¥”èü‰ëT…»>82´Œ×GÚæ#çè»}BÇ“ä"‘àxZõn9û.«Èñ ßÍHú¹ÈIÙ]âu­Ò™ùÖÙm|7·¹a¼i8ë¡ëOR<Ûe±dûì¼P“/™AäHMƒBqW°w½)™«_I-å‚ä]–f{§Öïä“du&üicïË·=¨;"M[ßV'âmI2¦Óí{˜úåPYe,_ÒÌj±éð$›·k.óú·zkã±³c9B’+5± ߟ¼¿tså¸ÏýÑÙ)F³dWfîº^·ìžšŸssÌ ®7N© wu²Þ¸t¯rÞÐS´†xT¸¶[s­ÏãE†Cùä™%û]¡þ¯˜[C(+¾lö_•#F› +e—Ýœû~€¶#°c8û„߸þ:@L(aØÖ»¢”ª¼à7ÝeÆ5˜Û‰(´Èøp*Ôš¤ì-Ça-Ê2öK½ñs =Á['C.aë>/ÞFÄa{B1~KYÇ܃éùÚH,_Õ!¿½Ø¨ðvÑõó–¬0º™âÙ£gíÅ‚>h̼%ßÒÎÙ͈_ÿHÄ&×é4 0z€¼8#y—¿v3à;ú´ñL‹’üˆq«1#íã:èlúA ¦CçŸO}lÂvÖâ®ÔV1##t!áqq‚ö%#¦ÿ}vûQ} «Å‡J?³blÔ.V£Î–t¹R»a§yD‘‘]Ó{¿cc‹ø“Zmn—k3ŒçÉæDêM¹4(^ø¶÷LÓû¦Ÿõ ÛÏýÄV®ïö~ìÚ¨ýXï"5ˆ‹TÕÑ#ºº'Æ$hA˜›xÇè"SÒÄÕ#×`ìQQ–ÙŒúáF±©'®£-h ÌÑ1ÔÍýç(øË·ã7¬Ç SKx3OpµjÙFl¡é·ée!HÎB#¦ó2u7:äz’—=©jC¡ž@†[Ì­-Â}@j2îŠÏ–«ör¬míyVZ† Å»«e“FŠFo~ŽÜ<œEN>ÆÍG‚7ÆòQôËŸù\'^<Õ¯ÂwŲ¼ÌWYsêÙ qm³FÈÞ´ŒËãÒƒ'ç®bƒ÷M[N,äï"g¨,›­.W© έ©ôpSx7™úü²·_Z‚F½^/ÿLÖ˜Pau›ôyþšÀ&;$r.SjÉÍH£c¬Ý5ðëQv…[ˆÂôMpw7ƈvïæHáúÍÕ÷†5!aŸçK[õÙ CÐïjN©3|Adià–c àzHë.)IÏ+B—Û£flÿì øÎ’v®_+%·÷™ÜÝôÆ£g*ž®:Y]mF;Áå%¾@:¬žÍ"AY¿}ï—ºûY”fFkÀº›Ðl0»¼ªDܺ¶Í2N]î‘cûå¥É77sB¡PüЧúN…'"`Õsì>¤}Ääý”þºHWƒ0ší3;?I­X‹()øö–lðüâÒe…¼ñÞŽƹÐÝðtJ0ŸžäyóðèK¾÷âÛç¨T)šã$ BïZï NU¶ì|¯2šˆ‡ÞKO¹±^?¿“%ªFâ¢5°W¤¼˜x{û­”*²éC@—?I?Ù§´9º|©2×§ï‘‘_¬q×=_xâô¼áµâA;#}C_¨#§sioáËê,J.P{=6øý^ªG4W ›‡¼ËwƒwÕ„ãmáO¿Œ‹¸º=GCXÎ,Åbƒî­¾ 9Å®jï |•yQ=€ììˆßñÜÃ{KЉ*2͈€‚¶ÁÕRBUÍÎ_7ˆ½g‘ßÜ—a‰¹¥DtÉQ1ƒÊñ3å|­nùÁB”>ÍÐl:Hµ´¦¶ðÿ¨Oµ*–&¹¿¸­Ñî'þë^q^ð”mFî]ÀÏ蟅Âã¯"ìB’Û[ Î+žâM›*£i­N"ng;üdY¹Š‰°ÆVÒTq^<ž.þÙ0·€îSô¦ðþ݇R£CíL1‡1 B!ÉYËZïZ íþn…èÎÆëœÁͤêË´M€bÕ† ÉÍô½KZXs`àá мœ `'w×#Té¥lí»¶ø¬(UÒ$¼Ž—žÓdidò"òNÉ>ÙŸr§*ìôÖ\Ê#"YÍ›r9Û­g“¢»`Ô:yÔøÊÈëè©o¾%XÆUݽ¯q:O6ZT~OrΫUïHFÒui ³y)Üšùn×W®‘ˆì'*ù±%( [‡ÐuyÌ4¹Æ?iÞT–~EÇ”HQŸ}†Žºý´¤7ή´²Q™¥K—éE8Yæ\/† ‰½êet©*çež—Æ+# Ð8§%þá«+AU§\å{nBλà7Ä| 󌹚„ *Â1 ƒ#/•Ä+wÔ/ç ÇsXKB ØxWÁÛ϶OÙéç-ÞhõfHìóì†Q͸ŸeR4I…®Œ…6ß¿Þ[Rˆã7ðÂ0QM”“¥jlMì}?D»ðŠÐZÍn÷ùUžœÎ«XOÓϸH¼Œ‰e\u__°ÞäÍx:0ÛJHÔQ„Y£„ýÐ0|í_s±¢õÝTxÒ2oË&G:ÖŒÆÿ~¸‹ÞMTf-2MOx­AÀýE²±@KÙŒi)ñsO8NµÌžíÎ+l *%š®kþ¯¸Àé2I‹w(n¬!?XÇü4jÞ)üšætÑ’wwõžþ±™tâ¾Ôšo!f²ðN°Òu‘}©[㳜gûŽNmgÃý»á/Çì{[{?ÍgŠï´JÓ.™¿=ÏßMIÞ«®¨es͘;ñ/@ÂP炳6Xõ­¶¥î„"dµ"ÈN‘Ðe|Hù1kÆ•ÄV‡chs~ß ó…ösâ:+H|êMmôúÕ¯TH:©†P;J7pÞa“ Mô³É®]úœþ²Q:1UÃê]lðûzÃl¿ŠVDöCR§„ ©üWÓáö®_±kGâv”}% Îþú4UX)¦"04ú_³áàóê<·4qæô8«‹ÌÐ#ö<Á=µ5޶†#k­ˆvïD¬öže{[Kæ@¢eÁÆùm›ý2ó…}:˪´:ÑL̵Lÿåµ³ôsL ÎÁ+å«ÀÔaß-ª6¥4–Û'±©@Ç~¯Õ¾TßÀLãëóòt­½-Y¡5 ;^hAc;kÈÞ=’ûAFÇaŒâ•v?zii??ÍK˜MF¶ïÐýÒøÑwøáë­jè»ÑjoòÒVøpb¶²*ÝtN|üjMÉç-”KÛÀÙ–¨¹~ãC¢Ù临‹zŠ[Dóx8踗ËÑú>SsÊ 5V+“.‚$çÅú®œ’á>D®T÷¾£ÆG«,£–ê¡¶Q¢'ˆæEö0Ì€Ž`C¹Oq÷–aí-cÒ’æ³4»Â/üyÏ×+‰ 26ExÃ(’¡º" q $=58æ!ŽkWÕÛ×ô=WšüL’S¯·â mF_Wº8·ªšºî:Øâ;…ÊåíØ{ Ö‡ àE¤i{Ñ“îSZóÔÁ,yc‚;’1"U­ñÌÇlúëöu|Y´¤2BåàÝ%•±•ºYþª«…Áùk­ô=¦ÓÅ ÑqW˜!ÌÈ#:3|ñW/¬Y„À ÖDLÊÜ” îòÇQŽ•üX–dõ=lÕ\WÚÐèÉ%ˆŒ'?µ‰ŠvõlH_“ýy•]jýìÅñæqʲÇ®°æ ‹{<„á䬛åQQÒ™¦Næb_§Þ 1¿ [e@G­°UW}­1þÖ=‚JÁÕ9-ïË>œ5rø8c$˜·üËò¸í¶†º7MÏ~îõiió°€Gš/Äv¼}ø` Iñ”o&áÆæ×G*cuïbNŠÒØÌV–„ЯK"‰ž[è3oxøŸyåœÕ?ü€!“féïW š‰ŸäÆÔû¬ÿÜ=˜w}Êa ×nïùø'Y&®*¿Ãìý±Ë%^Â-mÙ’üs˜˜秘 /ÕÅÓÓÁƒWTiôM\17Cæö8~èäàrþÝQlïi­~æbÏ+é{Éäqt„üUÖ­Æ‚gHuè»R»g1cÍUeñ¸Ÿm¿™å+=qrÑ[û¬›¾ c³³þ~/œÉ¼P ßxsÉïvq¡ÑÂá‹Øõ1ªH)÷xwµÓò`½ÏdݹGÖ\RpЯ(¸@/VÏ ÛíÕú]Ö÷ö(m…¨ò VArÊý~¿zuÆ\¬±Ã/—M5Ëu¤èÇ7’†‘â²O>]þîíÚ*³Ùï:úi÷\W§ö­Ý;"{•àôYc§©Æ¸)5c¯c1 øá–³«Liû¤ÔEE(RÅ?Sˆž]¯Õ¾~‚$ªœE[6­¡¦]¾µ—ø"CÉFƒ’ÌdŠ)ìYb´yÎN!è ùCu/> ö@B€¿Î¢ºo¤éfmQvû'Œ€4·qíV´Þ,P:î“’ú`¨ñÛì]ë¼=>sàÊ&÷œx¤¾¸XöFØn5àŠ}ô”aâAº•]-›ÞJWŠ˜8C~7ž¥ŽôP¸hÚ–5ñêS?"ù ›àž¡Š§ú¹ üʃ°äÏyâ´4š:†!yöºTlèT:óá@ç϶ì_ßkæ”Ûù¡4Ð#fÛJ®D1+â4yû¡Ñô¶°g$?±$ .­,‹ŒDlT~Œñ«Å„ÛdƆ°¹LVú/6zµíÊï-È¿Óð{SÆóz#<3ÁV’¯Ói$#sŠPÒ3.«·¼WPöb/¤HnÐðd8^›NÍùx5v/©ÏsŠyɼø Z«„ Ñ~Ö"Ë¢qƒgO ¡\Á³ÍÀæcŸ>;dÂ!sù•ú{)~÷Y“wž½îgeMkè³xÏÏ5€ö]¿ É«ŽEûŒöÛóêo·¬Ê©­\ÏYRAž°oq*âJòº+g;Â’oNÕl¦¯(÷7,߬dÇŠ¨g߸ËaÒ=œËè"£x0ÆO;j KÐy&ëå§ýÊÿžÐv[þuuOzr¯'¡)UƒjWVñrÃ% !•‡¨Hê^ÝÔõ&KÐëõ "J ëù8å$wUÀègBzVˌͬWÁ dü‚XiÈÒ_¼¼\yp¹Õímik©B,/¶>‰l¢5&‡½ƒ?&¾$x3R v¿M>7ªúJ–‚ù ®Ä3UÃ’4ì>1³ß©LF·f7¹+•GOTÎBÌt®-híG [ÂZ(4Øé|ˆÃýÅT5­Ì»(ê1ö*GsÃE‡QÐÙ ¼§L¥-ª{-‡K-ÈBli“G8@ØÿÛ¶J[B ‰N之Düb×Sk­Bƒ7±Fa ‡Dw':Ÿ¡ç®…Z~'c£¾AT­v†3ä$ùºö®»ÏÈNßJ`vAåæ¾\öKûg q4|ZïCûÚSb›f¥ù &Bá!AˆòOÓ°DnÙçt¿«+ññää¾5CÞ+\CÓ^¥ÛšU3¢žº]‚†7y'ï …ramö zÒ%£+Çb”• j;q~RŽn¸[¦Ó‚‰¨€¯VåÊ:¥1›×ãÈ/z2IX/ oÌm§4ö¨ûζŸ0©eÓ Ðß O±q›·ï·ºË2s:ôªªä]}ö¥3<-IRUlÜ£½{zÅÇù*¡N¿ÈoÕß—@q­ LŠÆ)Mo(üIMJ±k½×û~nÌl3rß¶Ûti Ñé¡“s€Ǥ<¿%æH¾ï_GÃ¥Ù½^¬»‘ªWä-Qð×…ÖÁ:Æxô䋯Ù–c®kÆ[Yª ˆûq—´Å ïqOdm!-;ïŒÍ3õ^YÑ|YË‘ê]ákùˆ«œ¿Gõf(B‚¯! !€šñ)èÕfš¢sܯ¡AJ…¤a’&øô7|AŸYŽÙô¸i[9l1+UxÚéI˜‘9I3a£F‘uz ª,Çô×òG ó M"B`f¦%héLÔî½8Q%rb΀·ÕîñÀ”®'‘à *Ç^h¢DAÊ’YàÚ½‹ÏÏýì]Ðó/î6YqtB¬‰9Õd%yO ~º›;†IpÖR¾P¿y{¸ÝÙÂüD:Wò;šºÜ„ÖhÂXék%,Qä_§ì~~ݤ†5æSfùiÿ’šîeº>£ËF¦Ò½Q㉨• ˆ"s>â)›í·ñ¸Ò—³M€ï¹ò—ŸêÍú’¥Ûþ0~«®+ p¯eœŸ±›~a£€ŒåuVI-“£áÊCÌÚuôù¥–]Ã,)‰4‘y´gºûÂöÓKÌú6â®w—þºáЍñ"¾ äÌ´Ëz“çN~xŽþÃKÑ´Tæ .b_tób‹ß¦Üvþ¢Aøhé© àþ’çE]©F/×9˜yFœ×¾³*ÒňÔåF¿“2ï²ñ%.oq·7— z˳úÌ1ð "ldlN…kuzŒÛ q‚,DÅ";r­jwž Mv€œçUŞЭùwD§°ê‚Ó _®›ñÔX:€xºªæÙ­³)>’_?5=ªf¤ÿxP„cÕ—ÇÙÐQ—·–—Ñ òçóLy#œ¢Þ{ˆ½»2¬qdc—^•èWM>=|U¸Y’yÔƒ6Ëês‚u-Ý&’:³„Éä.¶§ ¾8åŸ|·ßf•bÛ•T*å0e:ÚµEÀFá¡Ã|‡mµ”Åq±Ÿü¦‚@І®Î9ªWÊÄcD5¡«Š04ašü˾%O¤«ŠXá–E„oÆK[."ÁyiKâpöÖË_hHÚŸ-7uužŠ[ãkQ†ÕaôÛÃÄ÷2¶z¸½B„‰˜’Ý™¸6ë^sÑhÑ>ߎaòrÛn£ Cñƒ±°t°Ž»©¿%§ÞdwËNp¬ñ9»$Žê—ó°N8ؤ ôÖÏÔ]Öbòqwùò2@ZŽ gpR«Æ½,ZBëÙršÇ+ö§Ùeƒá±áÀ¹¶-F6í·=.…ªÁ7ȃµPºTWîyâZ”ŽæÐYVgÄÓ`¸7Fí9+ª$˱i®K¼ 2©xH¸ÝF:ÓŠ­,8„Ø'ÛÁáªrÔ½Ü\WСz®å,³oë¹d§0ÅÈ*WJTÅD2Ó̉(z9†¨º¤Ñ·LÇ%ñŠ%ÉvŒLeÕ?w£–ÂûÌŶËòºm˜]ªë†¾óÊÐã¼ÐÁèþf˜¦-í5˳âõDTÞ:éan˜éíë«¥»0&§ò4h~ÚÓÄ–Ì-(^£Ä€Fߪ@üuÝνO®,I s¥ïp |› àc~Á‚kG. H⺅†k+çìñnËúüd³œ¦1€¯†!‚PŽ’6¾¸ëà ÚNsŸ/b|/)~ÕmÿW½\Œá[Œƒp‚xmTÚiS¨{õ¢¿€ç£¥Ô¯Ó$„dk\}çü°Ã"ÌgI|Š`¦Ë|u¯jo¨¾¼w}vA´ëmy™ ¥\#¨5ºšD±Ñ€,,Ù‚v¼ Žêz=òq“3ùÞ?Ì_ X0Ô}¥n9~T‹=¹Ý°Ždïží÷a’ÐÔò\0CUQp›nsàÂ(xöÓÍ'6‚ÖèTr*V-O˜‚+~L ²“Š‘À»’«8&1Öå¶Ùù^#Ok°*¹ù=hvo§7ˆDnúO¸§~ŸÚÒ¨²¼ŠÈ&Âe±\÷iúT!ñ}P´Ãv˜XL.$uÈv1àJWÜ¢)‘êá5{ë-»˜šÓ¬x¾‹;DK y‚6Ãïj-)‘™|¾È §˜>åG*,¥›‡»÷î‰ðÑ©üžÑšë˜`ËçYÓÄr­ Ñ|sø]Û¦F娔M? ˜Î[88΋R<á;°tþ©Ñ¯ paBË1fá¦ÓæMJæNtz:.s¾‚ªy†©Ë~õ”í¾×ƒ9f?ˆš­í¢Ì’mN&©=×R-~ gáæòÎÙ’ûœí(-m}-Ñ•r´cG= æŸE[t¤ %çû‰Za<æ÷%0ˆ’ñ5u‘¾P„ûŠæ,¹.ãæÐ%bŒÐ»õäØžxÅq($qAÅo‰_¦pà„šDÖŸg‚Óiîo«1ZÏ0´™Ðx®ê:¸ºíÒ-Ž»Ž|àZIˆ«Z’«r4ÆåfË,¼ØPq'|оÁ¶ËlªÞ{áçUlÉwÁ—~ù¹2û.¨²ÄøMô´N\ÌeVÖ ºXÛts'C3YÁȯrwVCÖ};´'9QrWqEVÀÌ‘RŽEX܇/E¯Dð®è][J[Ö45²ºr¤v¦qýû&hØ|µ˜ñ@‚ÉÈ|íT³¶‘ý•ä'r&{æ.ûÎâð(˽a3Z¹¶žvÀ¡ ËÜA­!)Ò>ÖWÒ\2ÛwÔŸn‚LÜçkHô^Ögî* ~(môß^dAØÑÜ{äZ¤ƒ{™ëAEEÖ/^“Ñýd´×M±Y²FºOÇœxr¨ÀŠ'YÙÆÅºvÈw Ÿ‹~\A@IÌÀÉ¢ 7…Jц:LñÈ•gØâµ=ì|µýôs^¢d؇E‘ Ä•£Èù'"5sç RÊ[‰&%ø:¼ OfЬefáøM ¦7¥ÅŠ=ãȼ©§ÜHZzmµgÏ%|aÍÚ»é“^.l!bƬ#Ýš®ü¡GÓ¤ør"+­/ §‰rª©DxH±)eë·¼uþ4GŠÊîÛ·‚Z'/ž½¡‹~•fhó"yò{§©µvZ½ÞÌRÍD+fMzETì/ž šì ‚“z¦ñôMÙË|Ãá€!É[7í.ÎOV|okæ1úTR,Ù¥8fÎÑ öéŸñF*n¸vƒ cERÖ»Þ{'Hô«5¸’8’p]=ì*§ ƇAܽiqÁ£óìV1Žœýû§ÇRvÆëòÑ~gª½ í/…޲`w<„ylJ_µç·÷oƒWúžl¼d\zUßPÙn1´äCœXôí[{ÕöM™%ï{½H‰fe¿l'“þ¦'µÏdB¶²?óU¯y™Ó˜kÔ>aœÔrû‰êÙrµ’dS©Eé`ãÝᤅ¦o•5·r‡žª÷©ãeK5P0²uS¢ŽäYàT@Yçùám`‚MØ}æŽ=l"C(™‰àX  èåù´‹ô|»Á™F2K™B|žÁyµáó¤uŒ(Of&¿ùKP Û©ÚfWP$]a÷ ÿê…‚æëõ~ý=DÂÈk½Åo©’Z‘_E(!–1f Æ„û7o-ŠÅÙd•¡(ë>ß8F‡åi©÷ÙÜC†-E_Þ:¯pPR~ìMêJËݯN{ÃPçáâSù~Dé‰49hüVaoµ,°éÔ inkÒ«(óÉwµSU¾Ð `¶¶¨ù¢ŽšÙ«ÑOê 2,E£„PJ ØòŒ% JÕXq¹ú-‰tìYNw #&ôDõi< ­0¥ðàÀõ‚ÖêÒ{B´Ürc^¬#±U¢ïÒOr‚Ä L¹>7W0ÛžÞžæu–ºß©_]ð¥b•ßlÔõ৘5ŸsŨi‚Nt9Á‹õu­uÈñ ‡dSz×g>E°‡¾‡dB=ogwJ?\“t\…,¼xœzÄ÷†™~ц&i’X ’9TOJTâçxü‚aTÏQQ8’â’Gí‰åP'oXÖáËÐÛ³ËOñškûSýq@îñ_‚N”ƒGùçÔ2±·vd Fù¦t·ZU^ËüÖv‘=d]Üß߸Dw¸ì‘“ss±½4üÖÖë‘ÐñŒ¯„¼kxŲp­_8ФïTEŒ!ˆƒÆ#DS·uAmÐÊ'T¹0»ý2°ù#'½r²²»Ú'ô–Îx5t²›|þI>¸²é­JkÐ[ŒüïDìVê•'䙇Zë˜GXvÇV)ql­s«K ýTÏttQ.z­P§d·s³V¬öc5íLFêõv–‚hΓÝÏ÷DÎV?)+å$ˆ¡úšë5k/£SíKc¿¥é+4W÷o”hP¶3¼næ¦ò#Sðr ùiÆŽtú)¤a)/[9žÚïšÎrfl(²–ØÀó/¾¿Oñw¸©É‹F [㺥!ôØ´ªTG¢-b«VÛáX¨ !Q+©pÝ¥4ŸnÞqûZZ£j2œ!U¬\²y¾„;l¬ˆup0Ýç¯{‡‰X—ˆÜ€ˆ‚Oߺ¡ÃL‡Ë‹âµÇ/8Φ2r숉â{ÜÙT3%(³éÉ|ö ?èÍ> !”¢<Ã{ ÷¢ùÞžøTN¿d²!/¼ÐW¾küq¨ëÆÿ[,Y_SâµTÚÅlýðLPIÉf4gK^ÌñŒàQ^ŠÎ䯽³¦f}ö¬†žT+3_èæèKw‘5~aw„Tí*æQ1Rª(‡È´¹+< »£$€Ï·ÎÊÚHÔ7«æ£…gŠà\êk˜,Â*7Î9o¢¤!ЬAÓÎÓÀ‘°£p—XXÀHg·w]„®Öx/4÷Æßørl{)ŠȆe½ ZžSÌlzÕîòšé@›³¥ô;o+)MÕ€^í{Œœz3É„{P¤±n2g÷D¿‡)Õåf~[×k M’,Käýqå×P‰°oS”\oP6L.È^ÞÉ ÏÆÓØ™ˆ|½y!µˆTƒ:ÆJfCöì£×¯¥ÛÅ3\ÕOži!ìt.äM±ä*P½;p™bú¡4YP§Ýõ vr‘ªRâE…³DÅÄÊÁE¬ž ðdôéBsê4¥.Ê-²wlùþ1@UŒCë=ñ\ÇpË[±R3¦½¢o"ž|•ðüÚ”·;¾5¬4%Î\¹ÿ?²6ZG endstream endobj 4914 0 obj << /Length1 1418 /Length2 6428 /Length3 0 /Length 7401 /Filter /FlateDecode >> stream xÚtT”íÖ6)ˆ„42ÄÐ1C—4HwJÃCÌC‹„4J‡ Ý]RÒ ˆ´R’"Í7ê{Î{Þóÿk}ßšµžyöµãÞûÞ×õ™tôyål‘60e$Å æI45UE $@ÀQΰ¿` ÌÝŽDHüG€‚; ‚BcŠ:N‰¨y:À‚°ˆXT€@âÿ DºK!^p[€&@ ‰€y®¾îp{ú˜½8 œ°¸¸(Ïït€œ Ì… š”Ì}"â ÐGBá0”ï?JpH9 P®üüÞÞÞ|>¤»½4'ÀŽrèÁ<`î^0[À¯ZØŸÉø€¸Ç\i‡ò†¸ÃhÀ…!<О[˜;}8@_U í Cü ÖøÀøën`>ð¿Ëý•ý«ñ;…"]\!_8Â`w†´•5øP>(aû+âìDçC¼ pgˆ :àw瀲œ.‚ð¯ñ< îpW”ŸÜù׈ü¿Ê oY a«€tq!P¿úS„»Ã èk÷åÿ³Y'Òáÿ—aGØÚýÂÖÓ•ßwó„©*þ‚†þÆìa(€0HLTPLsÀ| ü¿ÊøºÂ~;Á¿`ôþ®HW€zX܆þ#ð÷€xÁ(wOX€ÿ:þi€Á[8°ÙÃWGÃ0»?6zùîp€Í=0ôë÷ï7 4½l‘gß¿Ãï—_NÅÐ@[•ûÏÄÿöÉË#}þ¼`¯€0‹‚¢è—€VÑÀÿêôwª* ƒþt‹¾¦uìõ8þ'àŸÅ´hÖ“Ü$ ‚¢àÿ3Õ§üÿþ«ÊÿFòÿnHÙÓÙù·›ã·ÿÿqC\àξ Ië‰B @‰–â¿CaD« ³…{ºü·WA Aa&3/Xˆ$ô‡{(Ã}`¶:pÔáeþà†¿¤æ GÀtð_ßtô_>´¾ Nè—\´ØP¿×øË†¡åôÏ>”P¤í/Ý ‹ îî_ôêÑ–0ÀŒ¨-Ìç7³ü|$ @ϰCºüZ³°8€-^È/ø7 øíÿÃðÛÿ8êéîŽîì7_Ð]ýËþ­~Ì%˜BB%CkCÛN«åè¼yׯ¤p÷ROMxÇò-ñQ}JVˉúY™sê¥Ê³½`eKÇN-y·Óì/ÓGþ«uŒõ¾B'¼ŒÊßìm¦nN0'“üÒ3O‘4cä'Ëß—(rïÃÐaˆ¹ûö¶Œ­}Ÿ>ä1{mÏL’7E±²¨ZX›VÇÛêâL *zq£=T‹Í€Ášð1 {ΊKüÓ¯±æQ)ZéÌêRg‰ÞUw—ú‡H{ºb‚Õ¼BÖöYÃQ¤J’ôŠBxUF yÄ—9E^Ûédþ6ÉåU8Í&8“ŠÖ2úŒ·q#ª†\ÖŸ­{¾–ìrÜ.½Ì”ûZÏ Bâši­;òní{]ÍQð‚Ú1ãÍ vð­¶øJÁ}Ùìû;ù‡*m ú*çÞ2b€á ýýsXâ8ýö4£Ÿ¡@SùôPÁÚH C?fÁ©ÈÂÛ® “í ³Ò'1=öIŸ«'Î ¢Sì·]ØRËÔpÑDÉ_:},J}P††ðFÊåijδæ‹Ý²zFÑÂ/.®ƒ›¥×ÄxÇùÀîu ï±­Eñíò«Å %Ã>º«^«ÔOì>3fms;þ¤¨8{Nô*ê‰u+‡ÓsÙoøé ¦*ßJ";ü7K¤ßzLÎççˆ×}ù9ž¢ËþØo{g¼¤!н‚l Û-Û€òö¤ÆùçÀ°j¼Hø±3å^»$Ï»| ©^+Õä’èûUá£gÙ qxÄã¾’o]&¢Œ:zùì{Éw(¥»£$w+Û/— åàghõû«^`@FfTCßõÌ …¨Mc+Ub¸k(-8Àò1ºzlÈòæÐ@ÛòRó´§ ‹þŠÍ~Ì×yD_ y· hÙµkå¶q䇼Ç_Ǿä´1öcö¸|t$^5 šÀöS¯‘’– ëz}Ü‹þô’ß*IËÿ‚^p.¨dwøsST8){u"R,b”èénç9§ÔÁ2YôãRÁCE ¡£‹êoÖy·,hS÷æfVDQP©¸Ìž^ûñw?÷Ï ºS«å{ çö©²oîÉ~5'‹³·ÜŒÑ+ a<§YHŸÃ\d’û8wRSMÆ5Äôv æ6´ÖZ¤½(9Hºïæ?³úî,è°(.x—?9’žŒ'!”â¥úÅÕ¶X¯ïÐÖ óÜ;ÃÜëÛÜý/ç$*ÚCóÌ(d0.I3ºHJ-jòÏMÙCžïì!2 Ò$Œ½Fê˜oÊkI8Ss'tÛ6Ÿ]–Lz7¤ç2ÁZ¢b$ëðf”u(DTj5ñž¹<|dr#®ë…eëv½!ª`V"4™mlÁœg“ŽÎ„j]F«^ñy¿gÓ/b\H×µd° Ÿ4¶µfš&]`kbכ޾eê$Ñàë VZ†Yå)d¸CT™çX„]ÃY‰ÛV»"XŒ/{¨"¶¯Ž§û*óŒ¸Èi3-y©8X$œ]EjöØŽ³U{Û!Ÿ®6<ª³òIkÔÎkøxúi”´ „O‹ùYgSHõ‡·…“ë/Q÷ïûs8Žó©ë™Æþ輤dñ ÿþ²¥ûë‹Â„ÞØ§©‘½°FŸíÎO9×ø¡¹wéÚ´ºï,4»PÝüWžš ¸o¸*ë¿­²+"Äú™7ÉA\TU,l#&)ÐÀz@OMÓMJ€­@éFEiùÑã®Q½ïBÎbŠ«yß\Áͳ¸ó°÷ûv"ŸœšqH>*Õ<3^žÛÆ*jùì#ÎiØ&ý¯£Heª¡òóå˯R´îaÓì iyÇÑ´-‹¢„x}^h«?æ£íVSIަ‰ð9þ Sã”^íçJ;Ûg»žõ®.Ü‹ ›|.¬`LÇ™›R|~9:-’æpLQ($ )MŒÕW<1räVŸ±| ©f=¤å(µù°l›£ä™l5){ÚÕÕ§±s™êõ¦ÎÌóîòžˆoSeH2„•`öëx·„Dj«¤–í°'\P´<©Ó’ôûò!:† ŽL ɾF ª>J3$Çþt*³ópÁ–Ú {Žã-½Í¤{DPíy½å3òhñÓfXˆæg$ËõR|Y÷êäáw™‹ÇºDéz((Ýл½?Œž¯%1úñ¼œe+‚* SQ÷|¸×#T²hú.À´)…3®ž?Ö·Ã¦Ž ¶jºª.™‹[m£aènz°Ûë¨5«_'ÑlŒ+Õ3)M"‰Ú0ØåOHNî†Ï­e’ƒëžŠìUžŠèU”ÉÜùäåæy‡â±\Ót‹_k¿Öºb5…0%%EñÅɨjKÖÃWés°Aüžú¥§ÖÉUÓ©ã4Yïà7Ñ! Çíó~"ØÑÂ/ÖcKðGKß7Ia9åLë‘ ìKì¾IúQs|Ð6–5£@êòÎ6cDE²Ñú´Ðèç•î׃I8f)ܧ×ý.*³m~QÊ@Œss4¹ ³êÄCúÕXR×Iñ(}Ìê6èÑÎ Ë›´˜s×÷{ö‚¡Ž÷µRî³SHuJ&dÍ­ô&Ñ=Íæý`Rˆº œRfŠ ëÀ˜#¹=œg&Àø.€›WçãÅÍyqåõûï°WìŒ>ÇýÌïz7x(0 ìL¨æ¬{ÀgÏ‹3Ã#«k‘ü¾÷ì,ö ¶¤O1Ý,׬ƒÏk»1Hן°×e`[ ^ãtmNr¬¯‚˦æŸtoúMê9ÊyŸzVBÄXPZCÕn¹{¸ˆ‹BòYïb~yù”â¹¾væ{mʼ-Ùç1 oèV}IüÁ»Ê}e#xÉ=O9£-•ÕƒƒÔøNßË2 ù‘,Î;^|UdÅrºÇ Ú/¤ìÊhP…L‰áä–Ý‹>«¢§îªóY×½A¡^ž60ãdá&ÿ„‘­à)EdåUö ó&cóöVaâw[wýs 9~Yñ0©=Ž–Ï”oqé=œòò¿!ðêÅ™BOgd(|B?¤¬(5¼h¸[aÖ‰Ù³’˜}Ò¬&ͶÄ%rp›Fš>}|ïþP@ °bðš‹¢ar›Ãä¦z X“ÓéÝþ >§Î >—ß™ô1j·9õÚ~A˜´l@håðvÑ¡óà™ÓaJDgÛÂs†ÆˆA…†gÀñŽÃæÄjßKmHÙ!Œß«ö2D:‰³ ÍžÔQT ̘ô‹¹_ŽnZˆl€¹”¨±’±_G˜8…>Ÿï·½eÍëaüµþ¹õ&ŽùD û»ëÍáÝv¦åúOÒìjÄä›§ìfÃzŠ881êªÒ˜uŸ-m>ÈÒô¹q'Zê4‰È½_õd,í X ՑxȃëøtN…K-Âl­77i•Ó€"ìk}ˆqLŸYˆ¿í¯¹(ƨÈU«Çsº ä-»®$Õ›ú2h5ž§ã×§;â´¶ˆãvkR“Ó%è°Ü ÚúITkó «"%Êb±ºWJæ£õRÎHQÇ¡Û WOj0+6 ÙLÃ'*•§Qšj [³‚VâêÅÝÍðÒ"{ç¬ü%ѽyÕ÷ñúÆëòYAºK†Seä+ën W‚h¢¨—À¶ãÁ5¿yE¢̈ü僩;K/a½5÷¯mÝVäuÕ”ŠûÐö9 í½:ýÍ€.›!aþêÀÕ-~–O’¾ù/__õ~€Ñú)k¤ú_oÄjìÙWjÍe½) ¾@àÒPâ¶«Óœ°lu”OYuJG?´¬áÄ]Ñ'%hzÄRR/çÀY³%E[i>EsoÝü5[â\²¾WëÉ5N=Ew+z…°þ:°ïŠVHükû§g”*øŠƒ S_NŽ¡ É3ÉäâÔ–ê—“¤¾Aê«7­–3¤|ÛBïR[gÞ[¡à—øäCÔÊ-ÚèÉÓòyÁnlÖArÃÖ'ÅiðµO|B,£á{ýclh]nÔþœçÁÝØýð`´»¸,L!‹Ê2oÅ‘èb}Iyžö Ùßtè̹6åÅï½èÚîÿclÛzüMÀ›ŒT!ÁFå®ÚAŽIèQ*óX™LÎë}Ù…ðzÛwCJôÏt¢t¹ô¸X§'¡å—]s³D¤Ýª3„¼ ½A»G:F˜qQÌ]RÓ9/ÕZ|_n¼ã³ÔL%8³ž¯:ž”ÿ ·É¯£u{cçä‹Ò¨Ü±ñ0©!É…Yå«P pÇÝO !L+n"éRjÄ|y|~ßÍÙ» 'üF’êГ—8ú>—Ê™ŽYÉÌSò–©¼¼àûkŒÌùÛ¤„W*éqÃ-Gº¯³(¿¦¾7)~¯¬¨Kôáq?¸ä8ž‰Ü 5ùy—¨¬¾Fðë ¯9\˜Ù¹°º2] g÷ÓìÎÙÅ?sê3yh’=f@xÇÌO*ÉÈœ6ˆùÇgp}ë‰6!ªÍ*¤Hy±N áYTë>,‰Ô>׫/?zÖTÐV*$}/qHOLs(AÜñ `¿yËÓHðkn£©Ë‹'KK´†õB“6f‘\©ô1L‚€aTÎéFkHˆz·±Dk”jŸ¦Õ ªívË"FWÄÆ©:·•(›Xþ*¶€À…ãA±™[S Û£ûžCk +þç³EÛ2sÌžI-»aíù’²±õ€ª±O3ë9ÑÉQÌ6"Zq7¶FlðºeZ P¸Œâ5ßÚF`Lñ°Q"Òî$ Ê'™ßõþ{sôzÈL•+p`#йøÕÍüm.Of͇3‘TžÕËBº( ‘¾/ºÒŽvÇz¤E?h º¾klìöÍדOúã{3öa9Æcpt­—”%Q7 7÷@}!|÷ž[#ëüµBp8OîÁö=íÉ¿QÅ'ɳ¯PŸÛ0…rJ%‡F0Ép‰ÎógyRHx…Ï¥ðªüCýÜ߾ܰ¢ å`pÀ òãJ-ÛË-|ﯜ{ce$šTN5ãÚb9>ø©³ïZaë’dìs8\ßqM!¹ÏÃ’a~ø°rd,L±¶ð€…—x£2¤‡S`öa/îf3‘9¬øôõÏQ)«y?ÚHh“ÇJ|ÄËôkN欅5’’”k'äI¯KuBùƒêׂý¿_ªfHOâ\Yè“H ÒpymSdRK×ZXe~ù­ yŸ‰zY_¡1 .®6SÛ¥+Yi•Ac'¾+ö3Òeǧ¬§fÉd&IþŠàM後z¥× fØÿ:oºuÂñKfÚõ&eó Ð_aÛëȾ¯T‡¦>%If«Él%…ŧ¢e¨œ:“q0ÙÛùr¤•¦ÁÍïÜBöUwx§Â­Ã„bš v/ÃûøÃ¨¥ñ¶wïå~©®¢MFÏY±'/˜¯M\fQ w¥«3cN+\ÀSR=iݙ•y÷¥ªMhtí|¾¶½4‘¸s” üèôrðÛpóìõ‡DîÝ$º­ŽæNÈ¡”mg¯åøŽ+Þ=’Öf‡{f}q©©¢/ãŸcP5ÇMó¾Í-lûi_ö‘c†ØL”wg±-Ä^_DàÞ 8¡š,K0#¯x]Ð66tFx?á'£‘Œ§+Nøèiä[}ÍÍ•NÈ÷Ó3±>ú>f§4{Éx‚3ÌÅãI¯âï;S°dnåá‰S%Éi:¶›¿ Üœ¨˜«8ÙF(Ýk ´6Øö(6kh$ËyO_«Uµø)æ¸Â§øm˜Ì³ˆèŽ€¶nèä^α#T?Õ–¥¸þ if±Ëܵ¿ØÜóWb;lk—Š¢ÁD´Ýð=u{÷Öu‰¢:³íëRŠ¥’Ä®¦‹‰¾(}?†![%=ùZPQöŽHƒÃêi·ÝÓ„¨³vZY—¾:O˜Yuq8ϤÊ~-RvÿÕÆ·b']• -r£¶ÝóÎXˆÁæšfs…Z€+ƒk`ÿÝ7ÛÜÜôÔðMýÕN}ÇsYñ©4óÏöG¢ó)j‘ç{ÒSÔéÒtXáˆ.†!Š ©{35 “q²~38n“ïgÎjb“;'SÄý~:u Xóž 5ÆÐ +0}Þš^ .”£ôÖ»,»¦îb»¨â© ow˜¿É†h|W«IpÙ$2Nó)vÖÅ™QÅj(Cî·?í0mÒFäÿ±ã¹…ï®SKk– ivf¶þ÷ÝàqWæ °A•[xwôµˆZtu=sª¯"lîè¹ax<{ÏßÂ8Õ,aÁ¹›’0(}ÝäÏU[>:ºA¿1õ™œ~žOJ§Iê¬ÐY³º|ÏûjüÞææ¤®®q™Î£ÄõOl·ˆK½#N niÁUqë9 N‘OÞ&W–^YÝ­÷…XÞï°0ÅÀÙÏöZUF{ô#Å”`­¬gìJÒ$&è˜ÜóâV9Á$ü·ê+ý6¹¿†FHòÕœ4Òf{ÃLYñ}æ[ÈS¶¨í>ÕìM‹³¬,ük7ÈðýηK^Ï<ÚZ÷Qìh=¼û.cÊGõ½i-çDZr•¹JÑŽ€ÕjÊDyÁ7^¶mÍ¢†Io—ϳlgôï²Ò|ö°®›MÈÆWÈ'¿"•ø‚_(ÑDášùbH=$a<ÐÂHùu·‡äHõw¢l)ãž' 3ý¾Òâ1D" «UÿÕQÀñQU&ï‰;¼EÑÖ¦n­òKIg®lz›´ÚV9Ò’ ™pr7±Ý=ˆ CK ß(9 ô~rª6‡ ÀÄGÒÛÒ‹°÷àÓNôOH//ZÂ\ÃI1ýÁBè'»ò~e>¯²+5Y“=5”?­§ÌgÀ¬Y«•O«Áƒ|ÿŽ7Q†ô¢rHõpµõLß½HZçî»HÓøQ9esÇ%jQýVBkepù͹’§RÛ1±<”z_æaÅÜÇoåzU½a®^‹÷B8·'i~‰zW'q"4jž•µšf’-_õ¡ÀÐ5`ßÈm ÿ: ¯YXŸ×&]#ËBïÖY¢˜b×> Û· É[iî.þ¶ "Ñx}MÕ¥g[˜ôÚ{ÐéÕEKR+·i§tåÐd¹Ví¹‡?cíýs%húw¿‘ºfz?ï°- \(³ÑkÛ~.Q¼j!—÷No(ù±_óî-£ÌD«ÚªûÙC®.›æ$ã ^o¿+.WIVÆØèhˆ8.,’Äà±Õ™ 6Ýjôg4&wØ6ÞÔaƒ°Je[þáÎT endstream endobj 4916 0 obj << /Length1 1518 /Length2 7649 /Length3 0 /Length 8676 /Filter /FlateDecode >> stream xÚtTÔ[÷¶¤4Ò Cw ]Ò Ý%!0ÀƒÃPCƒtH¨„ ÝH#H—¤€‚t#€t×õÞ÷þïû}k}ßšµ~sö³Ÿ½ÏÙg?û0ÓkëqËÚ8YA@Np7‡O ¯¡ äðñ ððññc13ëC0È_0³!ÄÕ êÿ_yWq)€÷< '8@Õ €Ââ@q>>?ŸØßD'Wq€ØjÐà¨:Á!nXÌòNÎÞ®P;{Äý6/lÖì ˜˜×ïp€¬#Äj †4À{ˆãýŽÖ`@ÏÉ Axÿ+›¤=á,ÎËëééÉvtãqrµ“bçxBö]ˆÄÕbøU0@ìùS3@ßêö×s²Ex‚]!€{µ†ÀÝî#Üá6WÀýæ=u€–3þ‡¬þ‡Àøën@àÒýý+þ;lmíäè †{Cáv[( Щó ¼\0Üæ ssº{€¡0°Õ=á÷ÉÁ¬|_à_å¹Y»Bn¨+ÄúþÚ½yÿtöÜÉîû—a …ÛØþ*ÂÆÝ™×uq‡¨(üE¹‡°þÁì €Ÿˆ˜â€xYÛóþJ¯ïí ùíþ‚ï+ð÷uvrØÞñ‡ÚBîÿ°|ÝÀÂÕâïû¿ÿ¶°€@€ Ô°‚ØAáXÿd¿‡!¶ìûæ»B½¦|÷Úø~ýþ³zz//'8Ìûúïþò>Ñ54ÒQæüSñ|rrN^_nA>7¿øKd"÷ ÿ§ÑCÿ:ÆÿŠUÛ:Äþœöþšþ>±Ç_`ûk8ØÿÎ¥ét¯Z€í‘›ñ ñY߀ÿßRÿòSø¯,ÿ/‘ÿ÷@î0Øo7Ûoÿÿá;BaÞîE뎸 §û1€ÿ7Õògh5 6PwÇÿöª À÷ƒ ·ƒýç¡n ¨ÄFа¶ÿ£–?¸Á¯)ƒAám'7è¯gÀ}ßšÿòÝ–õ³û§Ãí^’¿]ûÉù÷–Špk'›_#Æ/$ »º‚½±î›|o |÷³hñú-b/Ü q¸/Ï`ëäŠõ«£b‚^k¨«µ»£-ìžyïû ¼÷ûvü xm¡÷òþðÞ?kÿØ|^çû·ƒØ"þA¡tðø>›3ÌÝíŸô÷ÑO§¢^ˆëà_[»»Þ§CüÖäýuümÿ~a /ˆ5Öô„“µD¨CuhËù{Y*OǣÌkFoÙ¹}§][Ý/ñ¾a¯L^t=•}ÓßùhnE‘íDf†îÆw»±æaDS‚Nó•ßµEœîÈZ3ÖÔ0駯ùÛ²zh0©¹õeÖýn\ü ƒž¡4"}TeÎvqÅÓÎ%:÷ìVòúÐS2;>±¦³^)¬†}]ò;Ö Æ,èÝsŽUÆ89:‚›ƒƒpß ìät”0ëëj'–ÿN¬@¯ÉÿË‹qŸù2}~·v & r”Â_¹Í$U²Iߢ‚¹OS^’tY¸\ÉsÜx6ùÓ*¡ºÑðú®*é6àjö@(+Õ'¢Õ„ªâzb W-’Êf‹h"D•À3Íf›­Ü|Ë©a‡­C2õŒØ·w€1\cûíÀ†ß«—ùþÏŸ¸Ï“›Îûë?¯tø½“¶ór(Ú›FÍÍŠ§Ñ$£• ‘Û *ĸf<Þˆ^£Ã$}ƒä.)Ëù||&¢h]HÔ?…²ý^ú—×îk¶-LÂ< Ÿ†Ü…kÞY}LÞßϧ°P´LgËISìx‘³ðŠUG¢R;R»¿TNÊ£PìM§¿,4uÐËT ¨¢Ôµ6YÑeìíp!–ÇóÓ°Ü ùµPžýêN4÷àfmPŸ\HX·Ø©Íæòii©œ9É–“áÅ~¹g¤\ÿËïú"¡9/Út³ÚÝ´R”d£‘ ÏVÆ»0­wõå<èë_áé?¾\l/¼öä*QQ`f-˜ÖèQÛ’Œð›~:¥PÐEñ>P†ôÅI} u«Ö9ÛœôGó/™Ó×gQ-Zûë n)å¨ôôÏs}–tM~\¡ÿ2²Âä +7{'ØÝŠIAűÐO®¦->f‹‰ºµjX0ð”­™¡®JûYÜé@•c|Ø*ÀG,5´£ È/fM_P/à$¾›HÈtXöɹ¤{Õð¸ÂͬzøD2¬ô±Y»1Ó¢‚t¤ÁÌáõká7Yß¼”rtཥT©Q«ÐJæ‰ÄLúÉ,uþdU¦™©Ç+ìô1¶aO‚1¬7 ¢1¬H޳÷U¿J:Ð%ÒPÌ¡å¯"`%Xº–ÅSůäA›î®–Wz Š(yÀÒå+‚þZ¸ ‹1Èp¸k¸}{|Byœ*á(š·ø3hÒΓ$”øÊó@/’ɯò.ÈIGrhc({Äòyd-¯Ø#åN²yËq¯¦þb*}¡ß~!;t±|+£¶öýû4é~ Ké#‘¤mRl‹l4Ó7mG¢^Ú’‚Àqš£Çˆ¯çÊfðq%„Sü]ÕÜ[W©òР©¤5ʈòê‘QÿSorÚ‰ÛçÖ´Ìf‹.{fMMë‚Z‚ô¦ig*M¹ï÷>T^“|Z·Ž¦ä[¤)=ÔP½ÐÈ2æ+xåá+¼Hž8avÞ@vÍréOe x|†’˜¡ÿÍXgNüG?{™Òg5_p¤¼‰œRf+-÷,^”kx¿ߨar…°Š6ìj벬;lÉ´|{ 2Ø}ÞK‰A¡60ÉÂÏl—hUéq¦:@‘Âåîô\£Œ¿›ÜgÁ=>%;bL˜#µ™£·§·täNìãPÑ¢twžZ"©5;ù—¯gßÍöí²å,ÒÅ+/¿v_ÁÑõ·=[Ö[˜²m4ÍäÒò‡f´N'¾Êñ{ÑmŠºÐ«Û|«X¡rÚ~¾ 4äé“{,Su|¹KÏßaœãäsÁ´{1|ÖÈÜ]þq¤ŸÄóûÂwþ§N%]‹€ ‹iû/øî›9rŽ?Aèdâµ@<Œ©$Œâ>oá³àö™ ·(”\.¤wèÉR̽=ú¾2SÉç¼Hìùã>ÖøU¶›•k{ÍËš ßU-BÞ[ Šº‡õ¸# ´¶°¥Acç‡c·L½Ñxx9y~¹ãœ3ßô[4ŽKËÔí‡Ý9 ‹ ¼¶']°VfmEþqZCYv=9uÞuÉÒŸBD%ò™²y‹g0‰ ß/íØlŒMSOÐà ôxŒèo„ŠúêN9Ått등­Zí#[ÉÞ¨ù9i`[MŒ&,ÞRǵâz¯jlÞ –fW™·ž™t2ZÀíÞŒ ºÄ:oZÆ”k| Éa¥“›ySDz»&Ÿ¯1 tLBXÉE)C§ªTuÊPî•‘µÿ†!ûkÔ9½¾Y(WÎ^л=]BÒÒ‚ÖfPl/JI«vÏf«:êH ×9j!¹…éÐÃH²Þ£cìJ\}í»ì ,Èg®xçÛÊ×û„ˆw҃ס1–œ0_JŒ3ˆÎÙÄk [2aJåEm°Çˆ…Á ‰Åû¬AâO&¥@ZŽ’ÕÞXÂÊWœ½VÎá¾ó%˜Aå:¤›††S9-ƒ‘£x¸„Z©!É`xÊèóœ<ù³ÇanMx\ÊéTO«œØ &xƒ±|¹<ð²Qb#ÃxV$ú`ø™fÄX´Ú{¤ìQ‰¼öc ° Ð%:öTŒæQT!’ÄÒ÷›Û²Î«]¤øòG׋-Q’Ÿ sÞ¬ô…• ¸µŠIÖ*½Â•W´ 3Üʵ_jíïf&ÑI8i·v/„0•¼neh9Ó›Û1‰u‹@bµ\)§ÅÝq1º×L,Øés=éM¬§“A· ÁI7§1šcáô$,†ù`¯3ñíU{·}ÚѳºË[cÐ*Ì"ú›2ŽÐ¾<Æ!(æîÝÆìª…´ã+ǰV×J!™èÈ á«L/!˜óVï’ÒÛM‹ØEºYÚ®³í‡à8U[Ƭc³àÎ:ý®Ö'®c‹)¼p øUõRl ¶$¬êì/éX嵚4¾j ÚÅÙ}ógiV ðÏIw-Õ+óžbÌ‚ó r{|¯# =–÷ÔçšÖsŽo™ˆ\eï~º½!îütt7YDáHi~\|öÙídß)ØJÆ7Î{ƒ^^ž.ڗ̃Ç(À¤ngv ޽dåfç¦ýÖ†‰{Äì´rh,E]Òù#*a>ŒǯñyZèæ%OwR§íP¯w‘GÝw‹j9ŸŠÏYáÇüÒc-èÈ?ŽZN&#ºž óèE)Æó±’f#Èí<§ébaœ‹¬0e¼õž>?ËBN)¿€9ÉMl•%`Ò%exÐó]lÖGƒqæ/+.‚M#ƒmϵ½•òIü~<4º®‘˜U¢ ~dLÄ w,4}t½~þ]ÙŒa´Ôý˜4”²k-¤y.Vâ,Å/¢Ú,wsTëÆ‹ò3ªÎŽí¸Ø‹D‡ !eZ±,:˜ äÖÓ$N§Ë$öT˜˜%òÒÑ»‚ZKåÑ¿åÐyjT­Þ­+gN£+†}Üöú`‘=iœ!^-¤ñ®uqýç,ñ^ÔC¢—ÍåøµTEW¼ùaK=Ó9ôþ –‰?·XŒ¨ûJV'tž42¡+/¾ÛÀ@¨ä—·`ôóLSÈLÁIJ]“YïÀç‚:1pÛ´®W²šhÜê¸ð¤èdi4‹Rs‹°Y;âøÚ癤Ÿ^IÄZÒ¾Þ-R“‹X؆t×uÌÑUÆ5`I%nÂ>ê8Ç…S–挲·‡×e\ÔòÆJ<Ô£`Å1o<_E ªV9Èü ö*ý¢ÈƧôYb¨‰dVÇùeqoâ3}ÖÆýÌG™’¯]¨àS«îA˜º<0áI7@h2Ë%n²Ûå[Aôjô°P^³:OØõœÒ¬Ç?ˆ-Pªš¤1ó9ô Œí`´– ƒ¶ Ò¯³Æëè¬)¤&‚dt‰òcïšZG)'•/™4ŽV ºÇøìéÞè:.B'6ŒÐI2~³óãÁý’ ƘñZÑh…ó¦ubeÃíUÚc¹é•§TzèÀ3ãÑh=Þ€©N¸º}‰1÷Zðs=×[o°@CÛX©x|X‚V 5–ú)jñ™ñÒè0¡ÀøùÅ6J¬óô8)쌮ú~e‡ˆÜG+n$®$Á^sIXë¨Ç8k99 7öu˜µðƒ!{ÐTX6±ªÀ²o–ªè×j®sNFµ;?ïø&æ¢+V¾Ý{<ä Þ4Çš²ßÖz†b™Qÿ3mÅùü§\ÔÝ{ŽÉõ0iþè;–­¿µK§P‡÷sú›ù§ã—Tçí;x\åHmˆlöu¨¸òav›VX÷,[…D+h‹dØvë2ŒN*Uæ¾¹ÔÍ­$ùý Û'$3,MÙÄŒù•Á®ÇTûZÜaŸsò¥/r±ÞÌšúË uÉ+žl/I·8«ÆŸ“r „žÑ@W&•eæ^Ù~ ¹y֠˳vrãÁØëÈCÈ:¨·Ò©Ð<0 ó¾¦#I ÍÅ1>™ÿPÞã¸Uk^W©ä.d¡”öð¼vXx…àþ]ŠXÞÇZ|Q,‡GZ\)Hù;£s®Û–؉Ù3Ñ\õ =•ÙÓ¸°œ2ÿÖ¨¤v*!TŠžïٻ݌ºªâê²'[$`+¼hLu/ ìœ_í:lÙÛùFhìúh‹FáäTüUìŒ íCÝ”y@‚,‚g›»ä51ûr¸$¿¿É~ù«˜éØ;÷; ½ r1µxŠP‚n}µbð¦UO»þ„:­Óed¯h*—Þ»Ó;Aé'üO;_ )§æ¦M¦šw »¨CœªÓßì=Ç9+ˆ‘Úaÿ””¢ ‰ÜTT.+°å«®+É˸Ñèé=¾p[+ ¼z&¦òä8Þ6¯8}eùîëÍ'ÑtáÅwIúx~|§oîbàPÕÁkŸ1¦­Ä ÞDÛs˜Å¥aù6-»©ŠÃYºù±±ƒp†ðñI’fΓ°Gµ¥¾1Á ÆYò õä;Á¡w?7¤Ó|e=Ý9뺑Ù*©Opqnº‘”)Ýæ/™ó6»Ôt¡öŸ"ÙÇôà—]\˜Ð–ù„*#dpÎ „©iY›S2Rì’Fö–«-‘Rw“¹ýwÏ¿C–v TÇý’›šžàû¼“wê#û¤ß'Û·‰mK~ƒü6/>QÛ_-Ša´Eít”q(N?»tvi¶Aysf>–€BC‰‚-‘‚Ùî÷C `ÖŒ«ì>&|§Ós3ü–5CG ÏJ‹±á%ÀÞ€x‰ƒÁî,sB5î!¯Ôç­»Ÿé4®† A^Oß7¢·H±/ïeuÔ> „e\ 9µ=2ÝÈI<âÒd)b%‚G™Uiêt¨* ÓµKë‹ïÊLöÈ64ï°ê=é˜ç«’,co¶_2š@j´m)ÔÛ¿šå™ú Ìn®‡6ÂM÷ô¿áÂŽ4ÑlP$–G:®<Ã6ÆŽÕEƒÔútŽî ´|3ê›BìÞÞ²|Ezn‘æÕ‚béÍú$¾¶7"TIß`â‘° ¶]JèÆÜ©Ôµx¿¡År¿Ôx¡‡ Ÿ?éh­ƒï Æž€ÁŒÏ§ƒ~÷UPº-ÊÀt~؉öbÑgvÅב¢øÁ×é—žìûvDQ_H\ÆÄ—l +çH"íºôb¤·¸9ár7ÊÄc©¡(‰¼Za(÷ÓŽ@^/¹\˜ú¸ù…ûçu«×èEˆÚ–Œ;¶¼ë”Ø{5±¯‡Íßý˜"nÂôƒMýTµjºÙÜRÚrêCRëòÀë |?ô/ˆ6àȧ4Ù ×Û(’Šö‘Š[ŠUN.5:?$ÌÚ°¯o ^¿NÇz{¦Zc:· iÐñDœ5xfVÚšó”y© sW³yNNOH,ü<¤ãRlI&C×Dwú»Mý­–ùUs«b£ ôY¶j&@Œ'zÙù&;ITLÂJ˜9±&½ky—±OdA8 ™k²„¬Š<•%od?·IØÇì ìà&*]M’c0H›brÞ¨@oM;z°B¶D‰5¤›´{î’ìÃð·Å=þ©aem‘²JÚ]ãU£~îjЗس»˜¬ÒD0ë³e7;…ó\àiS‡æ£»Rbú>Û?˜ç}’½¥žÏéèˆEê&–HÝ»Ø.Vw>©›Ð-m)´îæa׿©”uøš !!¢Ÿ—{@üé쎷SQë¶ŠÕ{½;}b·ïb‚$éûm-7±FÆÖ3g·ytÜs/ºdÌ:ÅŽ¼#ƒÄÄj²"øÇj«eOba“äóUv|ÜÑVQJânóä;|Ê•†™DU„¨¢EL¿FVk‹] 륊s˜vœ°‹ÇŸ¹^৘Ù<é»Ñ÷Ä㈠j‘O“æáõb¨1Å[x–“¾Qú¹¸W·/é¯:!\¤±_ý€8âëêê:fh¦¦ø©"}Òê²ûNÓ§)VêÊ·Pjœ—òæµI>É3éîì Æi*-Hš^fÆM寏d%(k§ã‘MðŸ‘FØ7ã@˜ÛÃçž_¥øX.Ž%„¾`\Ç÷³»t(BgN<`ÈÑ/ñC}kõøÚÕãó0¢Df0Hæ˜?9J™õlý4V<çuLqY߿ޫ!ó’΄Ù–ûìäó­!òSº¯¡]gŽ=D²´S]òºâò„ž~¾VêÕ‡\Ñú™×8‹ÁJ`›·²ž„á;%hé!ËYžµ’Ò¾6v`qï¸~ùâE ó1ámh ™^ꕦ9œàØÉ¼W·õSîvOðJ÷”I̛ǂ¨¦bÌ 1 ¹õ/ u?s*ËMÓl¦M¶“ï¶}D N„´wAè¶Øý ûLаeNígxe™ü¯Fïî˜ /·7ˆJÈ8÷œ%³pÍNôÙ’~øÄPª“cE@E¶¯%i¤¹˜Ìs—Í"Ú¹Ü.SÆ¢ÅäÄÕóKü`’ôm4¶FÉ+×|SSW*¤÷ËÞ44Ïʰ¶±Ìl¬™ÙTÍBGzê^ö!•ÎqЇ‚xxÆ•^¼© W+‘xãiûrt+þµá\†mf·ÝS©¥ÂÝàk¶?Û¤ÄWM•δµs<¼ø—¹U9¨O­9(+1–¯EBy VéŒLS®{ 1õªpbŽ€§Q ºû&vŒºØ{­žô±„+*æÅX)ˆNÁÒwÉÞg e3“'^°Uº¾¡ÎŸ;bkF5ÌÚ ¦¿ïiãä|O];sêB6‹ Tþ¾õˆ¬}1ç±2›WpO{ÜÙ¼¾"®©t'{ J*©þèÄl Â9Mçz€ÔOZ™§±Q© liY´!{0†KþJ“OôèòCb¾úÕìÃYj’*Ï*iBGŠs*ÑYÇw×ã¾ì Ρ*†Íu,<?3‹Š¡Zàç¼1sÐ^!1<ÆHÓ'ZŽxfS‘I×sS¦3»F>Bçß¶´oW˜Ìž¥Ûè&ZŸïyô —µ“0ï A®§óŜ觚xØZ‰vM:5©!¦™ eÛºM[ì™ÎYßÒ2ƒºhš;ÛMKp¹<õÓŽUá-Z.ýã|5î^møì]_>s|+O4ó…ûßDø%‡òå'¯(;½dë¦ts¥KU7oÓ!ëýíÀoÍwø %„üè]“¹x «ÆÃó¤õWoÝÍÙâÊ$åf–6möd%OŠzrCîž­{¬±ŠÐ ÌÊ$ãÈDd…ÇFº&»ÄvÇ>D?õG|ˆjDÚsB®‰°gg‰:æÅ(bÅr€oÉCÊâ×q[oê"gJ!^_…fÖß6¢„}}F­Ì²qÇß„þÃSPCºußH2N:±ùU;ò 3:Ó¡ª\Ê¢jò„4†› UTU–Ê”;¡öG]*æ6¹ˆpMUÕ÷ÛÒœ(dý7ª3u£T¦k² ¹MßKñF„‚Åez)༭ˆ¥eÞk†@/,3cZy(¿ ¦ôMç”]oáF9Ù¼:bTÍ—Ì|{å"ü^êÇ$ê#¾FZø~q„›ÊÖaK`Ér9 Óዊo&·IÇ"Ùuy”ý³qYÇX–ÕT®[DXÒ÷4ZNÑÇùr#±p†’Ñõ" üa?‹µëŒíÖ g‚—Õ߆®mIN°\«’šâÒ×3/?6P‰,ç/öN•*QE ÔjÂQ]zÔ0ÉSÆ-û«#±± -…Ý%ú í¬î¶HltUD=òf8“!Ñã¥É%¾ª‡¿ÆÎ¦¤ÃÞ±á¿(ê@RЀ¹{á±T°WOárƒõ?‰)â® endstream endobj 4918 0 obj << /Length1 1390 /Length2 6234 /Length3 0 /Length 7185 /Filter /FlateDecode >> stream xÚvTlû7£%•IH³¤»»¥ÆØ`À6#G J‰ R"HJ+"HÒL@¤$$””’TiþSŸ÷yþÏû}ç|ßÙ9Û}õuÝ×ïwŸñ_51SuŸÀµ0hœD,T74“‚Á’â`°€Ÿß‰ó‚ÿÑø­àX_$-ÿ¿ìêX8GÔi@qD7C ¨çç„H!2òYy0(Ëýǃ•j@ý‘®@Cq  ÷ð«c¼ƒ°H7w±ÊŽ@A˜"''+ú;¨Š‚c‘0(hŹÃQÄŠ0¨ÐCÂqAÿJ!¨àŽÃy˃@âP”¯8ë¦$$ @âÜfp_8Öî ü5.Њ‚ÿLÀ´pGúþQ›c¸($*¼08Ú—à‡v…cÄÚ@s] ±7ýÇÙàƒ(ð¯«BÄ!§û+úW"$úw0༡è $Ú ˆ@zÁÆZâ¸@œ(ŠvýåõòÅã¡þP¤Ô…èð»q(PKÕ%Î÷×t¾0,Òç+î‹ôú5!èWâ%k¢]Õ1(óüêO‰…È·ú½VO4&ÿsF Ñ®ˆ_#¸úyƒ,ÑH?¸®Æ_Dà”ƒÁ²r` Ü„¹ƒ~%·ò†ÿ6B~©‰ý‡â½1Þ@qx('þð¾P8‡õƒ‡âÿ·áߺ"a8  Ü ‰ü“¨†#þÈÄÍc‘À›`"ð @ð¯Ïß'"¶\1h¯ Ü/d§ilag-ò{à¿Mjj˜@ ^LB(&! B @Yâ!ôßYL È¿ºÿ«‹F`€rš%ÞÒöÿkû‚Cøï\F"bá@Án–È_ÿo˜ÿù¿¡ûW–ÿÀÿ»-?/¯ßVÁ_æÿà E!½‚þ²ñê‡#bßCdú¿]­áèjwEú¡þÛª‹ƒ9 Švóúû‘¾ZÈ@¸« sÿ•?zË_óB¢á&_ä¯(ƒÿËFdÌ“øhøñøÛ'’æß%5Ñ0Œë/vIHË¡X,4@\1Q’â!DºÂ#GcpÄ q¼P ƒüÚ§”D|–~)ËÄ: \æoYê: ÇþQü«2Ì‹%òî72ˆmýGþMr8<LŒa`7n{TÝ~³_©Ê ¶Ø¯8Ì¿hýHH ?mò;¤§Lz‘9ƒÝSMíigü´ )¸«2É}‚_{ýŠ2¦!Ù´ñ(äØ)Élh±0>xéíÀÓ5ÕjÂej.1 •¥Ÿ«[žd¯Ïµèñçúø]§7ÉgÞèÔ¬&”M½[4]z!£Os\öAìže‚ý­âþ<—'£l<8±ËT¶Fv÷†/ä œqë%‰B×ïIâíf%îŒ~f!áÛÊÎÇnÇv™l÷Âû¡kxµ•4=Öø’Âé‚{¿¢8ÉO­$ÚacóÔ² AȤë/•»É®.¹Íý\o¡©ïE‹jÇVL¦=]:-¯ð&•^Z>ïæt‡3nâÇ.—]¨­âi9~*«¾ÿ*ãâ¼L\„ïUEÅ]îmìÝIn¥Iníö´Š«Ñ :nS:-zÃWau…S8yW0›ç*²´- !ͬDK(8¦vMÕs,¯¹ÃÉN.º=àé˜^feåø ÌIý½F$ÖÓ½t˜ÔÃ8`¥é“Ï:)õ¶ç5Ñä%'刌÷§=±°+<Éhå½¢þQëØd¡ìä´Ñ»ÜÌ­ý—ÉŠ¨ïyv¤-ŧ:oܳ{^—ÒÚy`~Ž&M¸O9µ†"Bù%eÑšà†iNÚL:åxWQåÒ†¼î÷Ýo®4e@ÞîiÒÊK:`ö¯·÷8„Öjs±äÒxb«7Ò3©ÞÙcktû‹skfM›f¹¥†jókõ6‡šânÛTk}”IEÂ8ECѨßÖ*ãsº? W–èqÉû¦T{éjìvæˆ ?)Ú•ì’ÀöÙ¢†¹™!£…ÓœÈ8ç‡ù<›9ÏTYÖaÝÌ×JüœÇ+¡Ãá€q©E‹Œ3¡Ò°‹|ºüýg>³Mty«Å /$¬XzöÓ·ÖU¦ßŒLe1ÛÍèɸGl=ŸŸTtW¬œéO!ÏØÂ›ˆqóo˜fÛíO¸wò6εç.ƒ“{VÎïÂL^¨ã ùÅ™ýZWHü×ÏÚð­*®ýaA6ØæT c»ÄÍñÄOŠkÉ‚üŽ%M «ÖzV¡úfŽ'_?º¾Îlo ¶Ø ì”ç/p™Ý—³9OÇÕY v@çö¾˜2ß7xøŽ+’.XÜð2ê%w_áˬíãqjÇÕú1Õê7Œfï©v w™?×ú†Mn *iÏëW9O)»G•'ÕÛËZÖ¤‡È£Rv¶®ä ;®&Ó°ŒwŽû§’í I‰ŠDÂÛ¿½n, R™Å-¬§+ßרöû´¥µ3=¹WÎEU-–—[B¨¹± äÛýôèÞ¥Ä|aIÌ›¹ŠG‘¶#"`¼ˆ‘øáIMAi 6V@1÷V]—®ÞWáð>FÇ×Y™+ ¡ÆK*jOzT¬‘JíŽØ½“¼ØÕ¸Õ |znçÒÓ•MÞ´W¹Ñäre7v¯ÈUÏ =6 ¢§‘ ýäXƒòãÔÚÌï’8ŒÏKyV†’i§P°rÔ÷"ãî¶zô³â)fáumÆý¼%—κÎfµX&úå7ñæœí8Ή:dóA 6&ê)“Ú”ªp€œ-»ËQYíÇþÁÔG[ô 9׸t–Ü>"Ž:D˘‚¶Îná{ßg9$K®žÒdX†bŽòT¨ܤ×þìXÐ--Wõ¸6é] Ý¡<ÊÝãyלdv%P399dÁSñù©N±Sˆ~.§þí¤"™k­6b[Ø…¸—ý©ûJ_ʸ¥®Qi”±…ö!2™%ôÝBð€ö"¶¤OÔD°#j‰°å©ì\É;mþ€ÌôÙ«¯žÉƒñ~ì€+ùƒªW(§’ÖŽj$¥O> ž0³Ù’t»£ÁcÖf+Ìç”Iü.LvÒž®§Û¸+kSc “ЯFß)N4ÕOæv=ZKÆ×ø¾P\AÙGÞŠLmñcòrÔv7êæ§P9Z›äJOô¥ $o<”¹˜<Áõ’ÜåÐ0æ–Àá¯TµdeE™Eå/‹kèÕÜ×ø¬ìÊ nÑÆ H,>Ss/v]|Ì,e$ÅÞà9³$ÈBÀœùÚKlxÀXFÖ’3µ4g¯IÏ^œ­¾š¡ÊØõ>ÙèÃm}¦æ˜Ál0(Îá‹O¡Né/êÌ÷ZÛÊ752ÊÅÓ6qCºLØ4‡›6ÏõÒÄ9ܺ‡ .[}­M.Ÿöµ‚:A{Zìòˆáy7†7X—Š9Ån^ìÉ/s¹§OÝü&Ä´©óü 刪 餿ZcJçYñOK·ÏŸböŽjµò¥±wÂφ˜ÜéÇthùÎ7«LÊ£ÄÅ£A>éüeÞ^@µ'=buÑOv%½‰^?gqû±{Ê=ÿ@iŠ4íÆ²0vs?­®%á†ýõ-i¿°ÍÅ›òÜ"Úêò;UZ"k‰ôH2ÎIÿ"dfÃÀ{¹¾è _®Ð7Xê›MO¯ËF­aôœ„d΃J ómB®iüHîõ×çG‹ItئøFyðvK/gjH™á ó6ÛLbý©ç€às­3½p]8û˜Ë–Dò€GÜ$lUÒ\müÙÕ¾ôï}¾Ó×ßP‹ô/|ަKKE>ªŸXÕ}ÝsIã¸ñ âïâ‹Ý©VŒæ‘¡ xì]Š.{WÓþVçDÅ‘ÈøeÙ´wN4¦?©‚£Ì:ãèØµ‡YŠ!¹¹h>2 —‹V™ÍÖÜ;[5,fÛ~Û×_;¼’•à~Þ³ý (˲Xg®y©Qº² Õ8{|pËò¼2æ¹m5£µ=Ã黋ß¹s|âI‹XYMfHÞáv/ºŸ[¨iïê›3õ!{—AÓ…$’°Ô`'͢ȱ«Ô‘yN™±MËbÙ/à½Øèn~ÁLµz]I¢sš"ŠÊxTÙ‹ÇgZaHã«qtÌ®Ÿç.™”S(÷TW6o)-I¡³QKì!بœ2’±ÑI}ñÙ„šÂ¼b¹Ûš¾1=tmººq5f$YÐY¯÷ùGv9ñ˜.³‚Þ’ ¥eÑ7/tºAõOçCÄÁÀ¥ˆ²H¶çca}e~ñz/=4Ø rÛÝúŽÖ²gçk>´xê¬\ÇÂY×ÕA —º(œ¨î”¯-\e¦mº qëpsÖ}pùv¾Ö/ºöhÞÊcñÚ©\“/º88tÁÀN}í–ËWúYÆþ‰lBż~§ð‚•ϳ”+ ùŒ( B('Åٕи» áv¯ê ôÏvöSdkÓÐ+wNR—ZèeâöÖ`aWxŸ“c ëug¿<ÔVg‡fu "˜Î½¢…0(ϧ®*‰PÚêSrªÛ±Üá/Kñeòþ0ðs:p{ïLǘUÃì£ûmƒ#Ò¸„˜)¦ùÒRe€–è×=•©ºÄÇ]^bóüôÌ5Ö³~Ëo H[-ÒsÓbe¡¹}Ò€Å!öîÓ8ÅyÌþÐýKõ%°{YqÐSÀÖÄÖ§¶î2s;‚óbθ¤%¼(ÛTÆã!¥ãfÜÕº¤"\ø¢­(¯æ×Sÿ¨Þ±“úëÊ *ƒ «Lg(åÒ­ŽÛçÛëO†[l7ÓY[eG-Á1]ß ›'lD'zö0¤ÁE©i§Œ¢KN?QЫ›oç{»Œõ·tŸÙwàcl¢™‹kzf[ê~רO@÷x+áÍýÉ!½G¡WôŽn¯Î‹až°e÷ÛZ¤©;,!Gº@‡o¿õÙkŠbL) ÝêWyøŠçæž–^ ¼í\³q Rm­þ¹÷§gœ„­Î,cJ¢6ßšÞDçîHrºq’¾È-:.­©â4üúŸ6òÏ>ZO2ÐO®N[Û§Mõƒq™2æšÝg)J\¶x É®y ü¬´…]‰ÚËLÛˆO¸¡5xE{¬ø›ÀIóeù*BiëÅõK61èÝ7»}%> e6UÌqƒ/²ÈˆÏÅ;-âƒw‚¥Ë.˜·'©TGkmû Z ëÓ9[Ö/ºE‹{ó :/½‹l·(¸ÞØãúÔè›Z "¹%שH¡zB.G5"0¦îb¢”+:C_ãó$”C˜§}‡î-'GÏ _aòf©…Ž^µßhåto>÷z§/ÝËBöù"†ŽšÚÏnʰ™Ü_½Ê)ÿd¼$f-‰¿}–6WZ«Hh ØLð%´›Í‰¥]Ž ‚´VNF(ô Iù»–p'N·´iQ$L¤¯oßÜØnvžÌJŽú·î'܈§­s²…ñd¬!G~NÀ¦×úØt<Ýæ}›RõÎiÐa\ð$|×|…î¬TƒîºOÙ¾´ÅÇŠºfçnt‹òeu-ï+Um5åZnBèÂÜñ*˵"²ã‘8§Òõtú Õ¦sm:Em›á ߌZÕÎß#R+¼“ÞÌôWîÉÕáD¡¥°©â Êñ‡i£Ïò'=ÇWÄ™Ž&ú¤—hÞãæòQ}“ë^½Ë~–%0K|‡ˆÐ«&íKÃ%)šÖÿR6¾4‰yÓ»Ä}"­:DÂõ ˜M¤Rdªy‘¶;ÒM6»·¥¬®ºíRs‘:ÐF/3_1,gj°œwÞ j¢å¬qß!–24ûâ¼ÝϤ*¡g®{GÝŒ¡X­ï,çi¼y­Ü/_¾G˜ì ö±ß¦Xu¼â£’¬ºÚ×m”sïövVŸÛðþºª´L3xRÁ¥ª¿Jó#(x"fžSäBñ?ÎYðÀ“‘)–TrâÊf´âk™g˜—%ÏX¿<¥¯¸ŒésJN´]kÛè”òKUŠNéá6Ø€ƒ mwG©C¼"~tN¾†©œ8Â’$Ñx‘ü#—©àŽ’ÇÐèºÌ/E ö—/¹¿¦¶ò .Ô9×ÛYú E× Òtìø^ž»ÐJ¸QÉÔ¥…2}%p ®ÈiNØÙ¸˜J^ú Mœázöã…ФýE;£FË®Ÿ÷×®òÎЙ~hbP¯LËÖm¼[Âpþ¤†d“ÇÏóéC˜Ñ]!rY ±£rOç(¿ã¡&‰5.çYõYA&Ô›(øò1Bλu=QL&˜Ñ²¿›Íô+ã#ñem×üú»ÜªzËù¥¨¦ÃJ¼†Ç˜$z7R¬k<Ê] ;Z¸¿Ä/šO¡à¥œí<M34Šù¨serÉñ°ˆ—;1Ê3´‹©µÛ˦*­Q¤™»¯ØM$Ü A­×"…l¾ùOµ$ÛzŽÉ¾Oˆ´&ß@ëgÍÈÕÜjcN¨f)wn»¡yIÖö==s‹­Âƒ0ø~Jçûkœ}ÂÏÍ·ƒßµ[õ¢^ìë‹Íkªß;%¨´†:#_©Ìëy/·Äæ“ÔZa©-Pž0ó#®>ÃYÎò¢SÔ¼+eur ßp9|iÌK ýt\K'ȹ k¿šao“½ ÚÝ’.•éüÞáÅFZH²ôBÔ¤¤EèMöÉ×&rqY­Oõ%Ð, d\OÚ5s‰ ž¥Ýñ2î#Ê'²"íu÷‰¤çLëL¶Q×ÀJˆŠ}?Ù[Êh¸ºÓºR3ŸÍîu˜Ú÷zž¶0cz¥ÊÎè-–Ú¬ú:§(Ô¬)2M©L·´šÁê4˜•ðññrû²Ã0•fÁ®§ÇÒÀÚ'Ú“ç!çGéb=DBس—»v5+îÈýˆåmÓJCÙN•.‡…ix?O·à²±ãÿv4¨C c<&à<ʾKædMÚ_ §0VƒÀ \…rf—of¾Í—ìÍÂV¥&ÆÊ6’Hô§_8V‡ÓÌIºlñ«q¨ð•ºÖ®ó]\óM¾kòÎVd{¶-/‘:dtí»yß'©G»‰|y€+[ÿêö·:µ¯YÍ‘ìÚXåå¥2=_”æ}ñÛ×ê*JUèl‚™h¿Uñ~ ¼ £#¢ÁŸàofm|OÙŠJ’ IfD£ugøV–Üà9Ê\ÀMZžÆ,ê<+6}íQ/~|äTÒ€›CöÁ²[Ö“®êô7kfäΦú×_rÛïooN¦F À/ g×YòîÐE¿ÈÅöÚ¿1™9X׈~íø¼ b0 yÛþ c¥z³–ËÖ/CÓsÁ÷Ĺzçó¶u§^T^¯GøÓ–‹MôÏ’òOfßV³°zHΪS:eË*Òê­j˜é©By7ë±KF—ôØÞ9æûÒ~Îi'¯67µ5hP3qº©cM®v¡ÓÔ ±tÞnæ ãd*¹¿~3ðýÙ9i÷ É?IS¯”ÌøîÂx×¢ß`¯·cg³J¯_À ‚Ô‚ £èy”ph™÷óö;FIøFÄN®fD¬ Â(wÖ>Oü²³+¡&ê[É3,Íü"Ó8‡/¶AJš=Á\¬Ã’¥‡‘Õ)ð1éì™ó{-^ú™Å–D|?ÉËéËB_x¸0÷ æ¥~ÇÐT‘ §seÄáË:TY¥üþB˜pÞk?e®ORF,†Ù«|D™õÖöD”Ã=RÚÑs„W?®ÅÇB~¼îÓ77̰7N‚¿ÜbEÑ`Rª9¾l¬ð~ÿ0e–›~Xê-~ó˦åK^0^e­ <™ÃØèŒ4ßá§8ÞÞÍ6(ŸÌ>Œ­µÀWìÑÐú¡4ó@“ñÁ$ÅÄ+Ù!õ†’·Íz¾2Giª07siõmlÏüõU«ÊdµµÛ-¯"ž0>')…¸À%¯·¼±ZŽ8ùøE³]1Fbkv!—o ã‰Ÿn͇ì V[òŒ§£œÛ§®ŽUj¤É•(KZlÐì}ý[ˈåa§ÎÕ¶D«ÄzõǬ„í—\íáæƒïVª ƒÂqJ›±W–”_ÑqTãë"uýë˜nÜ’1,¤U¨6«îrþ9ŸJ ‘d–7:_ûÐ8­#Ä©ÝD\3óËWÍ-’AhÃV½œs¿·âÛÛûsye*%ýÛcŸÞ¢wÆüÅ{W¨‡ +ÞóeúÊ”ê·ÜV‹àKÑY¥H1b÷¸ªíIn“×lå_tm÷…Ÿ G¥…0¶¤‡sÝ{ÛyöÝL`ëüÓÕ°¾­Õzí(–M&y·ìU^îÄ„ îÁ m‰7äQåJöiN·yj|9}Vb,÷õnô}?×+ÑTÙ'Ð,KÉS<Ëzd©ö°#8y\˜ÑÏ,¸‹´–JÞzÓÜF uw©(´#bGŸ½hÑQõ¤ÏÐ ÈdÜ)ð»¿a[ýu3vŸanPq†L×ѤÍò½§Œ§ 8þvígñ©OxÐãÇdbCoªŒà±¯<*žÕū¾òsœŽçÖ{0ŠêFÉ; VC…øÈó¯J…›¨‰¹GhS«jîÛé³~¨mÕY“8ÎÀüyOÁ•Ož\âùÆHÓ; endstream endobj 4920 0 obj << /Length1 1404 /Length2 6198 /Length3 0 /Length 7161 /Filter /FlateDecode >> stream xÚxXÓmÛ>")¤s€€€tw—HncC6¤SºK¤C@º•”.é’’ð›>>ïû>ïÿßwì8¶ß}]çU÷}ž÷vŒ•IGŸWŒ°(!à(^> 8@^SßT…ø€@A|VV( ùÛŽÏjqABpñÿ@È»@¬Qh›‚5 ÔDÀj®0€€@@D\@Tb.âk7( ÉPCÀ!H|Vy„³§ ÔÎ…®ó÷#€Ä åùu‚¸@AÖp€¦5Êâ„®²†ô (åùíQ(gq~~www>k'$ÂÅNŠ“àEÙô Hˆ‹ ø52@ËÚ òg4>|V€=ù—Ca‹r·vÐ#Ñ!®p0Ä€®ÐWÕh;Cà5þðþl@€Oà_éþDÿJ…ÿ¶NÎÖpO(Ü` …AÚJ|(Àþ´†!èxk7k(ÌÚ øÝº5@IV`žðÏ|H Ô…äCBa¿fäÿ•½ÍŠp°<ÂÉ G!ñõ§u€ÐûîÉÿçpáw¸÷ß+[(lûk °«3¿!úÌ¢ªðƒ6áÿÛfA„b""ÂÈ3ÄdÏÿ«€§3ä·ó·=ƒ¯·3Â`‹â µ… ?ð½‘ÖnÊÅâëýŸŽ®ð`(°ØAáøÿÎŽ6ClÿZ£Ïßê0¢é'þzýëÉÍ00óü7ü÷ó+ªjª)qÿù_N99„À›WP À+&ˆDE…¾ÿÌ£c ýÓÇĪÂm±¿ÚEïÓß-»ýáÇpþ™K f.Àño¢? Aè7ÿ3݇üÿXþ+ËÿJôÿîHÉûíçø ðÿø­ 0Ï?4s]Qhh"ÐZ€ÿ7Ôò—t5!`¨«Ó{UQÖh5ÈÂíÐŒæxÈ|ø—ŠT‚z@À:PÈþ/Öüe7ü¥7ÑA ¡¿ntø_>´È@Žè[‰¦æo­¡ÖU„ƒà_bX»¸X{â£Ï½x  U †xü&3€ŸŽ@¡Cè}¶ü_+(à·ûuuA\ Ï\ѧ€öþvüNP¸+ò·á%A®..hýý溟¿×¿Åx@@øsÓD°ÃÛàÖË*Y:wÞÍaœ•Õöˆ8ÓžpaÛÌ+o{ Ü å‰grVà êÁTÙ’Ðñi:®Ã˧ﳖSTrPŠ=ërǼ¹ýßNßÛAÁZ»QÑÔˆuÒ£x]b+3l3öDãé«ÑN¡­7Ÿó¯Û‘[OÄöN€Âs¦:T´lvûæ S&–UÔ€éS’˜{.fi®ª†£×˜/ 1r­Q4ß<×ÍbÒ––>dõö¤ ä©wUŠT„’Ñ{©1e&ôÑPÄg©5 1Øä„ÏåK’ã˜i œBÙ–±¬D—Læõ¶Ä÷ ¹ÖÙiÉÜÕ~>TïZƒž–Ìî\>¡·ÜÈ4øÆOHݘaÏS•Ê"ÇZ Æ8H;ª‚åtaS2pjÚ~jN"ŠŠ/L50çë£pŸ Y|£¾´ŠÎˆ4O–„=êûôZNDÆèV¸Y~©—"ÂЬ×Z£õ¬Ï¥sȶþì€Ù…ÄÃg‹í:­#ç¥Ïä÷ˆÙgCÄ„Ö+4ýÙļ± Âü¿>ºGh=V(8 çð·­Ç߀I«ÏSæí™±¼hŒ$­ù®ì||ÞE¿DÖ\MϯÖçºÀ*TzôÃMGhñ¿‰¶ÈOYDGõáó½-sãgt šM8á¦WŠNCIóLc§†òLt5®×-›îV4• T’½ñ¨<&hÈûwÙ;Z]i|Z„—çßµî3èe(&¤7ÅNbžý`KZOƒÝWúIùÔOƒSÏ^à £R¶Í—ŠQ_î0¡ü¥9 °`¡“/˜ÞÍv Äm;J¥¹wp¿Æ÷&MâZg>¬°ðÓ+ÿl^êºAòZ¬^ªÝ?äz7êíäÛ[Ô_õHo,Q“ÆéC_Òú\e8”¢¸†ŠÈ&ï¾ÊòöYÿúU××ZhS©†•Ü~úÈ»œ7• b,[ÜY±&QÃ4o´ÊÁ,â6Ç{”Ñ6¶°-YÕK ÌÒšt÷¹ ²B°j¿Š—#èB(ÈãGcdÀ¾þ€¡Žj­·úHÉ0’6„àpØ´²5÷€ßí}ì¨YnÓYÆF Ví\™½t• ÐÄ{—uØcÔ^.ø¹ÅOñô²Ô2ÛiJŸÕìI¯&:sM‹ºÍPI.è }ו‰eòµ„-Ž…’# 6kÙ6‡h=u š´9ƒk Ë¢“Ÿ'X‰Bî+äOÐózMvzj»ã6fAª`¿xöx#Ï;=}M.ypwÚ÷û»Þ¹l¤ -»ü©çòZ•eß›É72æ ÆG‰ÕpZÑgìA4Ÿo©‡_=tÔ–¤:¸)“™6$/Âx–tŠ/–©>;b~Lç"Å{†e6Ï„³ñ½adv{ò)¢%Ðb†¥-jóôÄœô,9v£ÙÄüž?nmÍ‚3ƒÉ`³Ûßšðsµüpn¬f•2 MŸ9W"v;ùÊÕC?_Vø$]DN’t!Ï ¾n°ŽW‘[=ÚÊ2~QBfÎ3Ìëçë>ÞÛ/“3™Âý‚>Jtëºd=â ï_X¯ü4å]J¨UˆqdÏŠüVºsœ ÀhšYÕʧ ÜØ,7šßé ê°.É0?Û–žâ!À<8±AåÂÓìIDâj‡»uZáèí ÕˆÅé,°t˜t/î¼£»hr¹h}/QPó$e»£wÃm–QÌ‘À“4†²N%ÁÓY‚V¡fè@s 5&~¬l^¾”iã¥,/ÍÌèY*pgÚ®N‰,ÐÓÙfùÜÐ$þ³í#g[ŒâƒÙí0{y×foS=ÁA ~ºë—ß°¹º¨ÙE*§ÁÊ'W´ÝyDFßÍEƒOëFäs˜å‘™*›ÕÏNë³9Ó¾â>ËæžY™z&÷ ·ädÞÂ'³ÔŠº¶â•©ÁÞ3¹¦c?Ë­;/Aé÷烥—ªM(°É8‚LƒBº/µŒëLß(Í>Þ–ó­IÙq¬YèÂ]Ñ;à˜Ÿµœe%bÊ^]ï;·`DïÀ|œ‚“öKÒèn6STçz¾$óIŒw»ïˆûy\~cw’b(æãÛ9¬ÍÞ½þŠsÊ=ÔlÖ• $#tNG¾vÇMëp‹YYÄ— pŸð7'Û¼N W–*î]T·ÏVÇF“ÑÔ—•Håâr˜h º-1¹×²KŽåäefoöÒ‡ƒ¡&š€BŽê®äêÐ#/þÅšú9¯ ®'Á>M ·{ò[*8×GÒ>ÑÿÞx*Û·VŽ^óa•f¶Qv#©é} Ö^=¢rk†aàÑÌcщàª}”ÄÚ¶c¸;·Q3^ªpŠâÇB™£ÇºŽY€ ³7µe]FÒÐŽ{÷"¼N·õöøtH:xdDtÕ9õ}N]¥yV4d'?@4û®9ã–˜×í–Mƒpùe?þnÔóæøž´ÐÛE®ƒT±¨^—Ñ)Õ¹‡JÃõs2‡Üf¾;<8×Ü6UÓo¿t©fÂ4ŽtŸ` \ÔëðÂg­'mìÇLÛVp ¼ûü—DQ9¢Q\ŠÂRÁa_ò1)Þæò¥R,7XJw¼ì˜ÆÂ¹^#š1&o;D~äÕúp0\0\8yÛ£î®k·íœÅ%`AFÈ7þr¤s¯š@Ã(âùÙ‡ŸW—N„ä0ëBsVò}>æB«¸–Ë7º Pz?Ú çwç=1Œ¸¸ÈLaO>“ X,ú‰á7œ_>Óçä`žƒÔsòËʆ"–üÊòðèà@/ªRå7 «÷ŸE4ÄîY—ëî°zOR«½mš5ɧÍëB©z»Û_óaO>ˆè1K|Ϥð@ñc`‚³s¥WYñ×êå4·#íIð\~7ŸtËV,ˆ«’nßDükû–T_k†8×ð²ƒ-æp4E—X›u‚ƒ7ƒ7E 0ìçØ¼l‚]W•:×n€‰z'æ‚Q=»×Ü“Ó!Y†yÎ;ðÃóÑ»5S­I¤]éq #+Dj{G'; Ðâk³Âcqäã—‹‚L_È— þûdb¤<Àù&l¼g;n¹ûL'À÷âjÂGògTú÷L§°¶NÎ62CìKcŒïÆf">·³¬?OÏ{I‡2AaRùþ@Ñ̯S G)•u©³ô$~|;üJÅttýMƒÀ¼”^Öjs$&3½;„Àž–¦ƒHÇÿdcÚÉùäP- Q+SU½–ðÓòxWvÂO¨hM—b§CŽÑèì9˱˜b^3eœƒ$þ si@ÙöKo÷Û•–ÄÂBJ‡v“5_Ê¥oodîË—Ý[m{övôxøþÊ»åñ‡u¸‘Œaùqc‡otl©?Þ)?å™ÖïÉ9[o½MÿÊ%¿È,~é½›Õ'‚ÖºêÑTg~Ê,?sè‚ vGù|s›Fî%5S-޶+ §'ªª3â%©+ÞÛ2QݺÏ5ØVʇÿåŽÓ¡÷¨™CfnîE†!¨±M¦K‹MÕ)5{éµ” Ó§dÈ—™%‘ñOæ #y•íË—>:RMÅß~ìy™¥åJh„»[PÜÖÃWØ{„‰Òª-è‡ ¾%it”U5ã¤Ò¼$ö«×ÏûüÓ4e^Gƒ“;ÅVÌeÃÐÏ~’Á ^£¾bkè÷y¼2Ò“ŸzÑÎ8N{Puïçî\)wˆ¨Â¿þqîsOv§}äãtÃ1g&ËvÌ"ÝÖù¯ì…Z™ÊµG«·Ó¤ˆ0{Їß9˜×ÞƒŸ ™H©åzIÏ)øKj]†Üj³2D{?£²1åbž{ĵý¢½رØSè±y‰±ð?PYï$ŒUp_kº4Ï÷'h£‹£Ø¿òVL (èzá0G³šNÊÇBa´ºeO‹Ê:÷rdqtd1¸WI} ²mÌý^IÒ"mœ"s2xúCèåyªó}˜nå«DÝÏéØ6«ÅüΧ·êN_Ñ$>kW„my3%KšÐß#Óýˆû3ÏI=Æ›ÍKâñTG6N€ÓɺTth”²v/ëõv.Êëg&þ·à'¨ÇtSQŽ'üxÒ%‚N4œÙƒ£¶gM•É«ky—ž8Ö+­Xç½KéHŠ˜Zu³ølȦ3Û-¹2îò)—GŠ+Gf¨ñy;muúhÝ×,ßYÞJ’Ó~ œÉ’ÞË8IÌ…JiSˆv§è§0X¹4}Uè»hÓw ²%äÁ¯WÓn÷»8·ÑT ;\ç(‘Ò’t„ƒB ¨äeö‹5ù§)ÍΜØœç87Y–÷3Hó8«§8š¾gÔÝÕÔlƯ« &|ÖëÆV_9p!¿²)¤…Q¯ñYãn ãêO‰lm­ºÔÉ~ÁÍû²¢$×ðEjµÒWÃKæõ‘ÐPî²Ö Óvˆ(™4°Œ#ù ¦£ËШ•°sÄ{ÃT•7. fõæë¡„ÕÅÖgÙ1<ñÚ7¯VMUlëÖZTú¼݃úô,LÇ3hˆxð_±(LQQ˜;1¢•v>ÁõOm"×YfU’l ììë• Ã9Ÿ;ÏUVŸÕ±¯y®UkÖˆ­:`¹î/wl@鵕i‹J8w,È+iÃ4©dz{ÈPH™ELÑùذèíŒÖÂ# Øa9C$D&Eþ€ŽöKÊ8ŠÝ$L!Æ­(Z}¬µƒ—ŽzäÝc~åÔô’?Œænï’ì–™Š0­Í SÌPÓ”ó›ûîg²³t¦tÅn—¢JÒêÑnb±µ“ æÌ÷v‰r‘/£FzætcÎ$ä,tcµK…¾upÉݪ r…·`±4¬¨öíþÌ±ÔÆÜX}Ä¿ŸÆònÅ*ЗWŒB—¿»`S³âŸ-=û¾¯w¢ªî#ɾý–yd¡ÍqÇë–Ý2Ë]ÁÇã—Ã)½ÜØ$û(úÎÒ*³Ñ¬êpµÜ›m™|VÍxÕÀåBTaݬNPèÔSÚ&~›õñ®M#%Š ðÏnGÕMAc1)Ûß’ÉØewý™*¬¾ìgs®Ciha—sQíç³Ã¸iüœ¾~3ŠIHûÌÓ{5œ³aQGŠ•›Ä¬~¸* O1xÊ=F|ΕHƒ•ìÇJê¤ëa³·‡ì‹î6=£ÁpâY·×ç5~r/–kDš½¡êb@²xcÑ]kóe5¬T<‚åR[xEg#ؽËr,Bɤ¾,16Èl±9þÍîÙ°ÚV±—C™YòfÀ4×騌<˜’Ü X¼£ýíËžÕ½¼"ç„4ïÆ•bU*ùõky,~÷ª—Nä¸e‹úYÞèþ`—×8Ë;o¤ôHs¿ó©½!D©q9ó6ásæà ÅD©áPŸz +lâ·¬—÷ç+ Ì@Ó8æGÌHfåTCZ‡è•2œ`ÏÈc”›Ç”¸+X7žÒõ‰§%ù[0sbékî­÷Ú¡æ³°JOì"î'ë"&oåI:ÔµqiÞ‡ÙfrØÉ¸›Û¥všíú=ß‹Pú¶ÃhA,+äV~§oM;Óm¢’¾^ð–¾×÷MƒÆåïƒÀ¹%r›ç™·Ì2½÷ül2\ýŽ÷û/….‰>wÊñcO9Ñ›Glóñm™’°GÉx¼à\ì…6×ݧØŸ™Óü.Ø]|(˜¤„~k£©ºZ_[L½I¢æœJçõnÐŽmªÒžþ.H¢WÜYKìña{ï~¸nÞ™»œÝXüZëµþuKv&óL),ÓæøÜK¢©:MÕsê©âÌí÷ƒ»Î.ÅŽš 282¶w¯„’Ó`](ý‹Ïݬ œÛüÎz}—ËsïJ™©ë\ñÓ! —ÜÝsUÈ¢''ì´xäÕME_Ó>mÙ„ë¾¥=;®Ò‡ÝËqè9ÄÑÐzáºÑ`,û¯=gå#S÷zªEž¼uµ~A©¸‹Ë³1œ •Ô¤Bq’ó¨úŒ>å‹OÐÎ Ž7Jõ „Ï|Hd&îÐ5n~¤}ýu<þ!—¶×f>Pã©(©Ì”íjeqvv”,vWrOô^’)uzíùå‡ã]Yaø€êŠRd2–ôÕPdú*¡¹5’¯V‹ÿF~ª“Eµx­¢, ôð…0؈á¥êÓ°}Ë*ÇÛ nº´*S+bTñ¿p†©Uñ´CÚâ!ûaÖ¶MIËèýwìâêVîΠQ²”X¦ÅËŸç*itU—‘MÑK‘¡ñ§7 Þ)=”ó¾7*NOPˆ¤OqË»¢eí+ñ9ºÙ} ís6P©Å¬'ÚùEŒ¯‚#ÁÍ`¥©Ÿ…¹,í®Ï1™=£š®ž;íÓ—X5Ãä¬C"o…¶+Õ8qeí¨ÞrtžD”¾;,ºÄh ˆv¯¯kì'j§¿×ŠK’©SôÚRqa)sø4_¼¯ãÂñ _DA•Ú±p§Â3›ÙʦoÊ¢¼'…] ̪8ä/%Q¡óàÖ/Èjý±„6SklÊhœîøÔ©F±¿ÃÚ>"\*³d!&´å˜þ nøÐw‹.ÄELc‡f¦’%=fëùPm9Í¿€Àß1/.Ý(¼¬²«Õ¸x3Å×´v³;/ç´Ï^ÎŒÁ[$„sÖEoÕjìšò> stream xÚmTMoâ0½çWx•ÚÅ$ !Ù ‘8l[•jµWHL7IP‡þûõ¬V=Mžß̼ñ s÷ëu;ÑU··õÈÙ›=w—¾´“ì÷îÝÝå]yil;<[[Ùj<=?±×¾+·v`÷Ù&ß´õðàÈ›¶<^*;²~&ûQ·‚>ìþÝþ”MS >Ù_êãP·ò{=éÇsæ@öd”ôÇöçºkŸ˜xäœ;`ÝVY×`Œs4½JaÓQÜ¡n«þª‡í¡.’Uu9\ßèY6î>¼ý<¶Ù´‡.Z.ÙôÍž‡þ“4>DÓ—¾²}Ý~°û¯ÒÜÑör:-d0­V¬²WÑÍÿ¼k,›þ8ãóþy²LÒ»ðºÊ®²çÓ®´ý®ý°Ñ’ó[Å*²mõíLrŸ²?ŒÜÔqù¥ã• â5F8@ šˆ=@Šð)&°  È8Ô¹€ÂÅRx u€Dº\j2H—†ª¡ÐVÁ¹0CzL]ø Âb°ct‘I ©g$`htÑ‹0œÆ\F„áŒ0ä†sê‡á jd< —Iê6œ»õñzgóñºË»þê W ¤qÈ’£+—Ÿ#ö•ñÌÇkÄÞ .‰bªsré…¤šáæÄç†bïmŽXú¾„Kß7ǵHß7Géû„û¾nb§>&jÊØµäuœ¯¼ú•ñ1ÜV™÷•âÜãâµÇ‰Ou$ÕŸqWèS/%1{\øxB!€§ÔK(hH©—TЖ枃»J©Ïϯv×ÜëÁ=küÒ2ø¥UðKÏ‚_:~é$ø¥Óà—ÖÁ/¿Œ ~™Eð+7¿èË¢/ ÿlì¡ÛÒ(/}ïö -+ZXukoûìÔE?Z„ãæÅÛKýqíƒÄ endstream endobj 4923 0 obj << /Length 695 /Filter /FlateDecode >> stream xÚmTMoâ0½çWx•ÚÅ$ !Ù ‘8l[•jµWHL7IP‡þûõ¬V=Mžß̼ñ s÷ëu;ÑU··õÈÙ›=w—¾´“ì÷îÝÝå]yil;<[[Ùj<=?±×¾+·v`÷Ù&ß´õðàÈ›¶<^*;²~&ûQ·‚>ìþÝþ”MS§“ý¥>u;áà¾×ÃÑq~:fc_0F)l®»ö‰‰GιÖm•u f8GÓ«6•ê¶ê¯bØÒ"!YU—Ãõžeã.ÉÛÏó`›M{è¢å’MßÜáyè?IáC4}é+Û×í»ÿ¢Ìl/§ÓÑBãÑjÅ*{pÝìϻƲéOÞ(ïŸ'Ë$½ ¯ªì*{>íJÛïÚ-9_±eQ¬"ÛVßÎ$÷)ûÃÈM—ÏñP:^9À ^`„ª‰Ø ¤Ÿbr š€Œ@ ‘{@(\,…RH¤Ë¡&€ti  mœ+3¤ÇÔ…Ï ,;F™$Б€‘zF†F½ÃiÌeDÎ(ó0œAº1a8§ÎyΠFÆÃp™ nù[¯w6¯»ü·ë¯Îpµ@‡ )9ºréñ9b_iaÏ|¼Fì-ÐÐà’(¦:×ù(—nQHªY^`nA|n(öÞæˆ¥ïK¸ô}s\‹ô}sÔ‘¾oA¸ïë&vqêcâ ¦Œ YK^ÇøÊ›!¡_Ãm•y_)Î=^ ^{œøTGRý÷w…¾1õR³Ç…'ÄxJ½„‚†”zImiî9¸«”êðøüj'pͽܳÁ/-ƒ_Z¿ô,ø¥ãà—N‚_: ~iüÒyðËÈà—Y¿2qó‹¾,ú’ðÏÆºíŒòÒ÷nЪ¢5Q·ö¶ÍNÝ Yô£58.]¼½Ñ»á‚ò endstream endobj 4924 0 obj << /Length 739 /Filter /FlateDecode >> stream xÚmUMoâ0¼çWx•ÚÅvHU„dçCâ°mUªÕ^!1ÝH ý÷ëñ#xÙö?ŸgìÁÜýx]OTÝmÍ$|äìÍœºs_™Iöss îîò®:L;<S›zœ==±×¾«Öf`÷Ù*_µÍð`É«¶ÚŸk3²¾'ióÑ´ž‚}Øý»ù=©½à“í¹ÙM;áà¾7ÃÞr¾›f¶ÆnjÌ-ùeúSÓµOLg~¼À8÷ã ãâþÈ)okà çA„8 ö$`I\èÎ×3`çAfŽã<ÈZ]ƒÂ!‹„ê xNkÇyã¹ãÐð"œ7Á¿ _¥ã“§Ìq âH`òáö•‚nú¥¤kÌÂðRONH=CpB:# =Ñ%8“ˆ88QA~¡!*ÉzÆœøÐäT?!~Ž> étw©8éÄy*ás£¤Ï }nÔÌçFE>7*ö¹Q‰ÏR>7в¢ G]¼;~îó¤ŠÛ<©ò6OšßæI‹¯yÒòkžtèó¤g>O:òyұϓN|žôÜçI/|ž´òyÒÚçIg>O:÷yÒ…Ï“.}ž2îó” Ÿ§Lú> stream xÚmUMoâ0¼çWx•ÚÅvH U„dçCâ°ÛªT«½Bbº‘ ‰B8ô߯ß{ .Û@ãçñóŒ=˜»/Û™®Ú½…œ½Ús{éK;Kîºàî.kËËÉ6Ã/k+[M³ç'öÒ·åÖì>Ýd›¦yÓ”ÇKe'Ö÷$cßëÆS`vÿfÿÌÊS¯fûK}êfÆúVGGùf–¹û\b¸à·íÏuÛ<1ñÈ9w…¼©ÒöÎÁ|Á擬CÝTý¨„íAW $«êrGø]žÜIÀâíÇy°§Mshƒ$aóW7yúÔ÷ÌŸûÊöuóÎî? sÛK×-ˆ`ãθtJ!±'™ˆcøÀ8õãŒ3?NaœâOœâ¶<Dg!Àƒ;IXô ôÀÍ0z)rЃÌ@« kÐpÈBQ]^ÒZä 7ž!‡î /½‰ü òU Ÿ<¥Èɉ#“ÜW ºmÐ/%]cXß!õÔÀ ©gœÎÈ€žhŒœIDœ8QN~ACT/ès⃕QøŠøôQ¤ïRsÒ ç©…Ï–>7:ô¹Ñ ŸùÜèØçF+Ÿ­}n4eEƒ=zG~æó¤óÛ<éâ6O†ßæÉˆ¯y2òkžLèód>O&òy2±Ï“Q>OféódV>OFû<ãódRŸ'“ù<™ÜçÉ>O)÷yJ…ÏS*}žÒÅõÎð—¿tx›à½>zå¥ïÝ{ˆO->tðÄÕ½¾Æ]ÛÁ*üà3>ýcÀè¹þ¤C§~ endstream endobj 4926 0 obj << /Length 900 /Filter /FlateDecode >> stream xÚmUMoÛ:¼ëW°‡éÁ5?$R. ¤d9ôMðð®ŽÄä ˆeC¶ù÷³k›m‘CŒÕp¹;;†wŸ~>Î|¿Ž3óEŠ_ñ¸?O]œ5ß¶‡âî®Ýwç]Oßcìc]=~?§}÷Oâ¾yhÆáô9%?ŒÝ۹׬“B|Æœ‚>âþ)þ;ëvÇw%gÏçáí4Œ3‰ä§áô–’>\ ‚‚6ý§ã°¿ õEJ™€õØ7ûÆ8ó 1¿’{Æ~ºðÏ`W(-ú¡;]¾è·Û%=°ùñýxŠ»‡ñe_,—bþ+-OÓ;qü\ÌL}œ†ñUÜÿI--=ž‡·B«•èãKª˜æÿ¾ÝE1ÿpÆ[ÎÓû! Mߊyuû>Û.NÛñ5K)Wb¹Ù¬Š8ö­iÇ[ž_®¹uÊ•MúÑzQ­Š¥Ò)V†€Ú(TØ€àx¿àÞ¢ žjy‹°°!ÀÐÔ•µZÔÀ2àP="¦ZdÔ0\ÃG©R\¡·”).–2*ÎШa!„U¼Ä,†³ÔÛHð° `+jÐÃ.¸5Nα@èâ°èÐVK-àxŸ%ô˜Ü3š% A°YÓ€z¡ÎšÔ>kP#¬³¦õ™5m0W£oš¦Ã¾žj­®§Üý·.†ÐZ¡ŽT$X/©)n)æ#W—„o(æ“oÀRZÞ $K¢p4’ŽZ¶-bâ\­1¦Ü°Jä æP"Gñ‘XÔQ¬‚i/8ºkÉ^€ÂZqŒ:ZsŒ½š9”d š­Bù Ž)ßsLù-ï7½æx˜ÏJ›¡¾Ò`¯ažÉ½)f¥É$†µ’1™¸ dÑŠcªCZCù<£7Ã3JÊgózÌnøþHȰíáÌYÉšäTœ¯a…Šï¯Æ,_»œ-Ÿ—Oë87Ë}êÛKÔ´Ü—Ll¹oKñšò+Êg­JÌâ.¾GZyóº‹Vðc­48¸’ï¼äØWtù]Í:P~`áŒñ±–rZŽq.nÍ1]Ç ÇàSÿæ/©ßP•ýïuö¿7Ùÿ¾Ìþ÷Uö¿·ÙÿÞeÿû:û?Èìÿ ²ÿƒÎþ&û?”Ùÿ!dÿ‡&û¿1y–¦¼ÍH·œn5þ¹ã)º½ÝyšÒ“Bï½x#†1Þž´Ãþ€]ôGoáõñÅ×Mñ?®Xê endstream endobj 4957 0 obj << /Producer (pdfTeX-1.40.22) /Author()/Title()/Subject()/Creator(LaTeX with hyperref)/Keywords() /CreationDate (D:20231024165310-04'00') /ModDate (D:20231024165310-04'00') /Trapped /False /PTEX.Fullbanner (This is pdfTeX, Version 3.141592653-2.6-1.40.22 (TeX Live 2022/dev/Debian) kpathsea version 6.3.4/dev) >> endobj 4799 0 obj << /Type /ObjStm /N 92 /First 884 /Length 4190 /Filter /FlateDecode >> stream xÚå[Ûn7}Ÿ¯èGkîæEÀ`[1â$޽¾$Ù~˜ÈceY£ŒFYg¿~«ŠM6»‡Ý²œäi!L‹÷:U,ž*öHÆßˆÆø‘¡‘N6R Õ0¦‘Z*ÙFzÉm®QR`Õ†Fy¬ð¦Q¨ÓÛF+Trö¬¤ÅU-.¤5NÅ9+¨„ch*éÆ˽¶±^r›olP–J¡q<–”lœ¢‘ˆÚ9¥WF!`ç½B\XJ`Á6^8º„Æ+\K:Óxíh4ˆZ6Ú¨Æ[§ 8Ø9”'Œl¼Ç)FZ,¡¸8NöŒPÕ€„Zù¤ç4€V Rh@ªEŒPQÍ$¥kÀ*…\Âl8Ïy»’Â4€À°*p,€iHZ@ŒMÔ‰MMã ”FeT4ÚÒá8ì  Æ£mpœE‹¡IƒÓª±8ÎÚ$üM–Äq€648. .ƒ¤ Ä‚D«£nX½RèBYÜeTJhì’4X#TIƒ vÑXKFÄßNÓæiIE¶/™ »¤”†¶]ãX©A¬°hÉH’ö—pH  AãÊx1\_IÃ+ ù”ÔjÈÈÆ‘\Q¢#*¢4…ûHE”¦hC°H¾,‚AiäÌZy€þ+µa¼¥i§H0Ú±ã”f„"ÿE#K£,E÷FÇ"J3†ëÒXK ñ!Sè@Á¢4ãpT4jõàÁª{ýÇզ龼<Û½Û^ž¯ºÓíû÷›ýæòlsÝü¬d·FOWªk/w‡w›÷xÖ°Åã¦äãº5??´¶Ð'tk+ðƒ«X…ƒ‹œeÑ-†u¶:‹‡ihAYüÁµ®åq-4—Ðx\ÑãÉ0C ®âé$ -¸:¢$âábÂ#Ãì€cùƒJDW¤‡¤‡¢‡&?ËÃÑרђ‡@ü %$-!i IKHMCš,=<=h†¤Šf(ùvõżE´ÆãÞŠæåŠÍ5Ùרôè} =ăKµ@5ß×È9<žã¾FkBš‡îƒÌ›$Gù$'yä¾f©¦S¤“j„,ؾæh¤Mó£Nóá´iq·i1Rbª±îIOÈlÒÁ³„¤ƒ' .é@ôï]Ò‚w ñ¨w Kày Åï–@È\ÂBìˆUŸ«,r•…„\%)^ä*õ2WIŽW¹J‚|‚$)4yor•y›«$ÈgT’eT’öËgT’åfT’v 2*";•dÿɨ$;PF¥Øƒ2*vKˆ¨zWlòdwyXu¯n~9p•õªûnýúŒ]ñ€gëÃ~û±ùY´B€&eðg(¿£=Úá˜F5÷‰ïQ"ŠÇ®—›ëÝÍž8êÁƒ¦{±ß½Úp\÷âôIÓ=ý°>ßäu+àVäq”ÅUs9`#Z•aj×Úh’XB§nñÌÅñå:.´-cµ²~J7êúÅr|¾ý„xuþ–X„iÝ_äÿkTBê!ŠÈƒ™gy@Û"òÄc"h_DÐPDСˆ<˜Ã‘Œ,"ågC䣋ÈB‘„*"]D¦ˆ5 lk@¸"Ö€ðE¬E¬Áœ¼ˆ5 Ek(¡b HUĺˆ5 Mk@Ú2Ö€te¬Á俌5 ¡Œ5 Ck@‰2Ö€’e¬¥ÊXJ—±”)c ¥¤E¬åÊXƒ‘2Ö€‚2Ö€ e¬-ÊXZ–±´*c h}ÇX£åQ¬A»škRù8ÖðEÝáo5þ8ÔøJ¨ñC¨±®¸5Ä(‰<ýÆÀ>;ŸI‰Â &U“†q& )ìLúàKLжj•_ Qcz9þAò©æÑôŠ(fÚA¶>A¥[á*«`¯˜Zùö½0“oØÄ|;”E#‰‹ œÇÓ×H_Ì»â€blcU‹é¦á§cyGˆ(ëˆUãñÆà­’AF]Ó‹Èa0Á^[º9|JVÄêéî0PžªåÆ€Ô®‡l™¦F€”ðÆÇÝòd¦¼éDL_ˆò†Fš­Ô@š_OgRcªÊY0Ù|¡gªÊ7v¦ª|açü5ß×=1A¾®sšo뜇Bb Ëªò{"ÎJó{"ÎJ!Œh,ˆ9ÊJƒe¥ù]½dƪq^\܈ƒå¬FŒBɈAˆ’ƒe΄* 2]æ¬A˜2g –9kÈ—ÎJƒØ”Ͱééæúl¿½:ìö‘#—ž¾8ýúåë>~öì©$V½XŸ#I•Äy_óÛ"Œ|Þ­>¼>Û\0[À‘×W_m¶ç¿b¢I õÝ—Ôùô°¾Øž=¼<¿Ø` 6¼:l>|ÇiÕýØÏ2D©Dľ÷ºÇÝi÷¤ûºû¦{Ö½è^ußwg»ÖÝ»î¼ÛvÝ®»ê®6ûíî]÷[·ï~ï>vœD¼O¶( VÝÅ¿zóúùS6€¯ë/{õ%eC‰ú gÕÊ¢ªÌ]túñå÷?üë+ÔéåÜžâ-¶ßSôä?¡”H*¹0¯ÒvvóáýÅæc·ùíf}ѽßþ¾év—›îj|}±yˆ¥=Íî®.n®»ÃvÝ7ûÝÄ î.VøéËç¯ú¬0³±zû¥øÁÏÔQêNçõ˧߾ùú *õêßs{‹WÚû¾Ô#òðÞj¡ŽŸç°FÌ*v¾ß¬wyg?l/o®Çêõ÷üÛ’;\óÑúzC=Ǥ4²FüV”oHË,Ì]puÊÆ_ïÞ\n1Y`Pêî &Dq„Éa %&a L¢†IßÓä aòSL´‘mø`&Qdîi|ꎅ#DåΑFrDöGfŠ)½z0•F*}É¥ ÓR…”^àÝáOÉî†Èd…õ=1þŽœøfû³T÷¼‘ñ~ÔHß×c"ÖȘ.áo户Ÿ'$&@ЉA£T_—ÈFÅ| seõùBt|Úèxûlt¼-âï¾Ý û?!z¤!¾´¢ô… R==†ÌÏ“dD|=ŒË¸Tˆ)/¢L#eß%õŸPÊH“Ö‹w|,$™2Z ºÂÝ<F¢T¼¢6F™~aeSÁõvS>bv¾$J/ˆ‚$*fØT¸ºa#/výQýŽ›ÞÁ íw|ÿJå9aV ÿeK÷Öã@_öÓúMÍv˜L{~s¸Ø^ÒL&™¦Oï‰døbâK^Tª˜¼Æ-B+ÄŽ¬fË=²‹{dò™Å=ÒåUagóë±ùuÅü:›_/SzÉèfd~Sšß,š_góë±ùÓò,KU”Ry/”[˜Yî„®ð£ÊFVja™’xªh†@ óËÈr§T-ö ÕT—‰3kásˆž‹Á³<4zä™ ïš{¦•L‹§`ò+=#žY%’u9‘ÞS`JtïtwvÿÕa½?œ4²Ï2ïÑ[‚ÃvwÙ†VžPÒsê{ï·ç7ûM{¶¾â^)Nгgú$õÉzŸÃ¾þÎtÔçOèvÐggÝ·ÛÛÃfeÊÛ©VÓ!pBW _¸ªêRջ͋vrÜI†3ÆQŠ:c(*•¬ ®L½MY¥iõP·½2't%šm©SÍ€vÔ9§‘§N7³,Y_ÆÔgA]Â]™z«º´}JÔÕÅ%Uä¥ã.Ú¾¹½Õì÷¶®¬V|(ê£ÉúÊÃmʆ“ÚÔÛ”5¤« ƽK×Äi—£®:\Ü·tõ›vuÕm‡àµ²·¨hN*óŽ¼Â«±Œì_Iô ‚ Z$ÁÑe‹"¦lAÛët c ‚Ðöh3’ÐØÒ–bù8K;’¢™ÎFH˜8GÛª™.a4Ñ1‰*<=‡ÍÀóLJ²\’ ¥ÌH0Sž-›„ršazså^&µôjo Ο Ãêà óŒ–d¶ #Á†›J2d(-J£[Â[ŽAÃÉP·ÉMƒêÈ^Ö»óUü¤øî$}½Q¾`ßçÿóì_œožíÞmº7×›áÛçW›Ë‡Œƒþ$-Iü2EH endstream endobj 4958 0 obj << /Type /XRef /Index [0 4959] /Size 4959 /W [1 3 1] /Root 4956 0 R /Info 4957 0 R /ID [<8028C8B69ABFFEE885A5384F13C8F2F7> <8028C8B69ABFFEE885A5384F13C8F2F7>] /Length 13724 /Filter /FlateDecode >> stream xÚ%œuœU†÷V³É&™•¤îîîîî–Ôýp÷ÃÓ…âV(V¬,^¤¸»»MpýÞçäŸçwf’›™¹ÏyïL7ŠŠŠŠÿUT4ªp¾ß+¨66ª¨ÉO¢r ‘kľ‰l6MØ×Œ}Øl š±¯9ûƳÙøØçcß86+Ÿ}•ìËfT±ÏϾ1lAˆ}!öf3 <öÕ°o›Õ †}Qöd³Ô±¯=ûF°z‹Ü—}ÃÙlZ²oû†±Ù ´nTÎÙ7”Í6 -ûêØ7„Ív =û–²o0›@Gö-cß 6;Î*<¯+û²Ùteßpö `³èξìëÏfГ}£Ø×Í^ 7û¦²¯/›}@_öMcŸmÚ›û³oûz³iÒxõÕì³²“Ì>›¿žlÚe_öÙiØä gŸÍ_w6mbG²o ûìLÊhö e_W6M¨™¶°Þ°¦±n²6› ¦€©`˜f€™`˜ 怹`˜€…`X –€¥`XV€ˆƒ•`Xç**ÂÖü«ÁÎÞÚ‘¦n´–ª—µØfK^ØֻЦgÚØ ¼Ð‚·ÄÇÍ—œ²UýoÉ9^Xäš|q¯mÒü¹&®¢õjÛlÊ«\VŽnÏU¹ŠîgÛ "GgçÄçÆ»Fã;Û&m‘£-r´EŽîÌÑ9º3GwæèÎÝ™£;sÓ]£oØXZ4G‹æhÑ-š£Es´hÎ\ÎwVÿho¦OsôiŽ>Íѧ9ú4GŸæ¬_–»&”ß©pM›®¢‡ G]À =ØÖÄU®É±ÚfTkz7·¬ëÀz°l›x³u.ð¿:зŸÚf#Ð4MA3×äÏ—íÕæÀ*ß5­¬ÔY½\Wášçö±·´a×´¶|¦¶²¶¨5 Ö5=°ÒÞR"À–æ®éãßÚ ½@×ôÅcm³;èzÒzv ¶ h:€Ž®ùŽwlD'Ðt]A7×ü¯]öêÐÛùš´Í> èƒÎW5Í^†!ÎçÝbû†‚Ñ`¸óEºØ¾`$å|íëmßx0ÆùZŸm›c¹9ø©&8_»ílú€Ý ÛðÂD0 LSÀT0ÍUmUá*‡ †OF¬Fª7*G.Œ¾Rs‡0ö aÜ{ÂøŸ„‰Í„Ií„ÉC„)³…©Ê~å´c…éZ*g\#̼W˜õ‚0ûsaΡu'¡Íh¡íR¡nþögÔ\þŽ÷ ^:ïº*œþnZü݇ ==õ|àï•z«¹ü}îúªïýýÔŽ~ÖKÿÀ¶Â F ^( aÄPF »BΈÏ #µxøGý'ŒQ$ýcÕÀþqs…ñû N&^&LRû'?/LQ¶üÓbÿtµ¼ÆPaæ|aǘ­–÷Ïás9Æ<ÎjþÂBF,bÄbF,QHüK÷–imò/¿TX¡/Œ³ŠsV+9«ÕœÕšAÂZ5°Ø¿þ$aƒØ¿Q ìߤø÷Q¬üûþ#ì¯XùP¬ü*$þÿ)$þƒÔòþƒ+ÿ!Š•ÿPÑ#WHüG*$þ£ÿÑŒ8†Ç2â8Fψq¢V=ÿIZUü§´6sV§ÎûÉÍBŠëHs®ã4®ãtFœÉˆ³8«³µ¢ûÏá:²§[]½¢ë?÷IágĺÃú¿dÄWŒøš{‰î·D÷;F|ψñ£nþŸ®ŠŒ(1âgÝWý¿6~ë ü>JøCñþ? û_ºeùÿ¾Jøçá_ÝIüÿ)V µ| ‘Z>ÐXA 4QMÄ@31Ð\ÍðÝ)Tª~i ¤1ÔšõÂÓORÕšâ@¦8P{“P§)DÞ¢šâ@KMX •VÇ@k­\6Zmµ:Úi­ ´¿Aè µ.ÐQk] “Öº@­Ž®ZëÝ&ݵ:z0¢'#ziu ôæ}8F_ŽÑ?( Ðz¨õ40ˆc >BrŽ0”c ãÃ9ÆŽ1ŠcŒfÄFŒåã8ÆxFLÐ&j•L’øÀd‰Lå:¦qÓ¹Ž+„™c#fsŒ9c.g5³ZÀY-ä‹8ÆbÎj ÇXʈeŒX®ûB`gã¬VrV«±š+_Ã1ÖnˆÓÁ 0Óô D5 ÌsÀ\0Ì ÀB°,KÀR° ,+@ ÄÁJ° ¬kÀZ°¬ÀF 44ßRhƒ& )hš¨~U B

¾óñ™/sþ`ïãÏÛ¾<Îó8Ïã<ó<Îó8Ïã¾õñͨ¯L}|—êãKVß¾úøZÖÇ÷µ>¾Èõñ ¯¯~}|'ìãËbß"ûøzÙÇ÷Î>¾öñMµ¯°}|·íãKo߆ûò8Ïã<ó<Îó8Ïã<ó<Îó8Ïã<ó<Îó8Ïã<ó<Îó8Ïã<ó<Îó8Ïã<ó<Îó8Ïã<ó<Îó8Ïã<ó<Îó8Ï㼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/⼈ó"΋8/Êye· à@#Ð4MA3Ðø@%ðƒ¨AaàjPjAˆ€(hZ‚V 5hÚ‚v =è:‚N 3躂n ;èz‚^ 7èú‚~ ?‚A`0†‚a`8F‚Q`4Æ‚q`<˜&‚I`2˜¦‚i`:˜f‚Y`6˜æ‚y`>X‚E`1X–‚e`9Xb V‚U`5XÖ‚u`=Ø6œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç1œÇpÃy ç±U.pÞC.p>@¼àá"þøxñ£Â¥Ó…Ëv WD…m¯ Û/®["쨎˜/ÜxžpÓïÂ-ë…[?nãϽ»^î)äøKï]­…»¯øS{à>þæûÀ,áÁœ°›??œò_ ,½_xœ?ï¹Bx²ƒð:}¦‡ðì­ÂóµÂ {™Kx…?¿æ ¯s¦oü-¼•ÞþJxw¡ðÞ}Â…Ï>âo¯Ÿð§ÓOù›ïç=…/¸¢¯ß¼*|ËŸI¿ão¯?pÜŸ¾~毫G¿ üÚKøm«ð;òþsᯅFÿýZáª5MÚ MOš}'ø– •»…€ÞWUõ ê"„oªû5µ ‘MBËÎB«BÛ}…vÏ † · ]V ÝÛ=®zñQ}>úIJUÿ§„…A— C*„¡þF,FªªFk«Æh«Æi«Æk«&h«&i«&k«¦j«¦½¦k;~¥ªšºª™šºªÙS…y…ù 4uU‹& K9Ú2޶œ£Åå­j•¼U­¾DXË9¯K ' û:a¿…ý_%¤æª:„ë8TÍUuøFáˆg„£ÔUGß#;Z8îZá¿pâ‘ÂIÌý)k…ÍOIæ>ÅÜg˜ûÓ8¿3¤¶êÌw…³× ç<)l œû½°u¹pþÃÂ…Ý…‹ê…Kç —Ihà$I®º‚ó»Wq©Wß,\S-\{‚pÝ? êΪjꪛÐx³ú¾êÖUÂÎÇ„]˜¾Ów`úNÞr׳Bƒú¾êž{…ûÔ÷U÷«ï« +ð}TUþ$¡ ®«zŒ“ÜÃI>ÁI>¥pV=Ãü=Çù=ðb¥ðÒ«ôÁkôÁÍ„7ÞzCxGÙ¯z—û€ûsþXA¬úŒføüxá‹¢ð_ÈœªU j/ý÷ííÂ÷ý„.~䢋\t‰ø…øUI®ú}œðWôWôÏÂZ(‚tYÁÆG M¤"ØürÿÚ'è?]HE0(Á®2èé*ƒÕºÊ`­O¨Ë Q9¶|Zh=Hh«LÛ«1ƒÔ˜ÁNê`—?„n„îŸ ½®ú(ìÁ~_ öàà0DתS ŽP¬‚£š £Æhý ŽÓ%Ç?¢ËOíQ5QÙNR`ƒS¤18UƒÓ[3NfòÉs4ÁùšÎà6¸H\¬Ù.ÕZ\¦,W( Á˜&,¸’£­âh«9ÚZ޶N+MpÚ¨E&¸sµ¯Z ¸ŸZ x€Ú6x Ú6xÚ6x°ú/x¨ú/xo9œ·©. õ©pÌáØ»„ãºà Z(‚'+ÁS”à©ý…¤òL+ÁŒš:xºš:xz–üÏ–ß`–%÷ôÙª¶ðÉõ|òy|òV>ùÞw¡VôàÅLÉ%LÉå‹…+tw nS‡¯bJ¶÷®9_¸Nͼ^ͼá#áÆ™ÂMºoá-;ÕCÁÛµ"s}…;ïîn)4\)Ü«uÛcÕ&úæ&UA-桽·[å\èÛ­V5r¡ï޲ª± }¿Ìª&.ô뚺ЬjæB?M·ª¹ çYås¡RyD¥ ý¼Ú*¿ ý²Uúõ «ª\è·S­ ºÐï§[r¡?ê­ »ÐŸ‡[å¹Ð_Ç[UíB—GÔ¸Ð?åµ.ôï«ê\è¿ ­Š¸pÅVE]Ø]kU nt³U-]¸ñn«Z¹p“Ç­jíÂMŸ³ª 7{ͪ¶.Üü=«Ú¹°ï3«Ú»på^«:¸°¿hUG”Gtráªw­êìÂÁO¬êâ¡o¬êêÂ៬êæÂÞVuwáš «z¸pms«zºp]Ȫ^.‰XÕÛ…£m­êãÂ-ºXÕ×…[ö¶ªŸ ·dUn=Òª.ܦìh  ·ídÕ n×˪Á.ܾl…ô¾ÿ[«”ó^°J9ðu«”󇾶J9ßý“UÊùïZ¥œç¿´J9/ü`•rþȯV)çþc•rþxS«”ó=UV)çOÔZ¥œ?ÙÚ*åü©ÎV)çO·J9fœUÊù³¬RΟën•rþ¼Ï*åü…°UÊù‹Q«”ó·J9é?«”óWš[¥œ¿²J9-b•rþz[«”ó7ºX¥œ¿ÙÛ*åü­ñV)çoO·J9g¾UÊù»­RÎßa•rþ~+«”ó:Z¥œØÃ*åü£1V)ç·³J9ÿ¤«UÊù§}­RÎ?+Ÿ©rþyùÚ”óÏËצœQ¾6åüË­RοúÊ*åüë²åü›—­RÎ÷¾e•rþí‡V)çß}a•rþýwV)ç?üb•rþãßV)çÅ&V)祲Kåüç²Kåü—6V)ç¿–]*ç¿õ²J9ÿ=`•rþ{ùÊù?[¥œÿù—UÊùß­RÎÿñ[¥œÿ[c•rþ_yN§;¯¢<§3œçzZ5ÓyX5ËyË=4ÛyMÊ=4ÇyM§Z5×yÍæZ5ÏyÍ—X5ßy¾ý­Zà¼ÊìZè<ÿ±V-r^à«;¯*cÕçϱj©óBW[µÌyáV-wž·ËªΫn°*漚ÝVÅWû¸U+W÷¬U«œyŪÕ΋¾mÕçµ([]ë¼–YµÎy­ž±j½óZ—­np^›»¬Úè¼¶XµÉy›Qéß«^'ë¡ç¼ÎÖí œ×ź®¡±óºZ×54q^7뺆¦Îë>ĪfÎë1ÚªæÎë9É*ŸózÍ´ªÒy½W[åw^Ÿ}¬ 8¯ïñVU9¯ß©V׃U!ç 8Àª°ón•ç¼AÇYUí¼Áå5ÎrºUµÎZoUó†]dUÄyï´*ê¼×YÕÂy#ﵪ¥óF=lU+çÞnUkçIYÕÆyc϶ª­óÆoU;ç¿ÌªöΛpUœ7ñf«::o’™nèä¼Éå7åh«º8oêIVuuÞ´ò1º9ozùÝ7c«U=œ7³|ŒžÎ›UÑËy³Ë#z;oÎYVõqÞÜòˆ¾Î›WÑÏyóË×Ñßy Ê#8oayÄ@ç-*ä¼Å僷¤|Cœ·ô&«†:oÙV sÞòò\ wÞŠò\pž=¹…F:/þœU£œ·ÒÖû†ÑÎ[e]Ü0Æy«²j¬óÖXO6ŒsÞÚ¬ï¼u;­šà¼õw[5Ñy.¶j’ó6n³j²ó6]oÕçíS1ÕyûZ7LsÞ~ÖÅ ÊùþeÓÊù›­RÎ,÷†rþ¿-V)ç]h•r~ðV)燔{C9?ô«”óÃî´J9?¼øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâˆO >øâ“M">‰ø$ⓈO">‰ø¤nÛíì”D|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'ŸD|ñIÄ'oÏ*)ħŸB| ñ)ħŸ’øÓÛûŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħŸB| ñ)ħšF|ñiħŸF|ñi‰ÿ¶hïC|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸF|ñiħŸ±wA|ñÄgŸA|FÿLûÃ3²ÿ·§ÇÁgV¸êŠó„FÏW¸šÃíUœg®º©=£gh† â3aW°gÖŒçªÛå4lÌk²£„ÃÖ ÙÂöz!ßNx}_{3 ’©qÕµ£l³–Ÿsbî3ØÏD]u›×íÚ"c¿eF#eZºên)}J¯Ã„~«í-ôU¦µ«4Ë6i®L[W=m¬mÒa™ö®z–ý£!ƒýLgW½änÛ¤72ôF†ÞÈÐp.CÃeº»ê}ʧA×eèº ]—¡ë2t]†®ËÐuº.C×eºêSo¶a´@f˜«>{¨mÒ $3“ßÙ±Ÿr£ 34a†&ÌЄ›š0c?Ô3ÎU_l r†NÌLpÕ7=«ËßyŸp‡ý[2Ccf&¹ê»Ï·Mº33ÅUï±ëfhÑÌ4Wý´ýó5CÃef»êWÿµM:1C'fèÓ }š¡O3ó]õ[—é{W ÷T3ïzØ?#3tgf±«þ´«m.q5ã^Õ«óÆ k&‡óGTϳßZᪿÚj›M¿.æ5Íy•öÎÐÞÚ;³ÊUÿ´Í>”ÏÐãz<³ÎÕ4îk/Ðè=C£g6¹švGÚÇøi3¯‘«}°m6v5ƒŽµª¨t5cmF¿’æµ~U èj&ßiï 0ð@µ«Y|·½Pè]¯D\Í>cí…N µ«9ôIÛìøÉ2¯ h Úö®æ‚Nš«ÇØûºÎ®fÛNÛìB—Øû€î®æúåö‚ý ^`?Ë× Øñõö|ý\Í-ë“w_m#ø)`¿aÕžƒ%`)X–ƒ øyìê¼ãí-ôi}«kÓØ6íGöZp½Ú×KkvÝìaöýWßÊÕuúÅ6™zûɼր&¬§ ëÛ¹ºñ‡Ø[è¡úήnæï¶IsÕÓ\õ]¿YOwÖwwuËŸ°·ô½]݆E¶IëÕÓMõý]Ýþ—ؾœÍ_OÃÕvuEìÚ¬Þ~²q¸«;â0Û7ŒruǼi›cÀX@ÖwuÇn×òÃ5uÇg…V 'öºãÔtŽpòá”Âæ+…SÕfu‰‹„¤îLu©‡„ôwBæ{á´…Ó?Î ‚w„³.Î>T8g›}JØò³pnD8¯™°µµÀ _wAáBÝÕê.š+\¼@¸d…péBá2L_®è#\9UØÆénã¸Wi±¬»Z·Åºíášuµó…븬ë÷n*ì ÜJOÝMÊtÝÍ¿ ·6vvnë&ìâ¬vq1·ÿgó7¼úÉ€pÖOuu¹½åήÂ]ƒ„»{ íÁ'Â=7 ÷nîãLïo´è×=°Cxp“ð‡|è=a÷uÂ÷ ùÝBáká‘¢ðè›Âcÿ ì¹_xâ8áIFåÊ?-|¾TøâáË…¯Ž¾Þ |Û÷*Éuß‚ïø¨ïw ?Ü!ü¨•«î'Ú¬ÈDü¬ç¦º_8µ_G ¿$üŽÕ?n5¬‰õ,–õ3]ÝŸÌÐßý‡ëø—ëøor…‹T êΈSoD)4ÖµEšøÀ§‚i¾¯àÓüE*5¿¼EªšAµh$¤ÛI$¬;vÄSGªW 5jåHíùBÝBT3iÑJh©®‹ð¿DZ_!´Q>"mŸÚq´•BÇ:¡“º=ÒY­é²FèzÐí¡»žA"=ÔÏ‘žšˆH/ªÞêÎHßÐoºÐŽ0@z"! æì‡œ- ½[ö…0‚³Y-ŒÒhdôá6u³‹~ý\s­^ËŒã²ÆsŒ ºE&jÚ#“Ô‰‘)R™z€0Ÿ~–0³9Pâ#³× sd:2O-™°³Zt£°øa©"Y&)‘å¼o…²‰Iw$þ„°’iZVKrdÚ"²V+RdžÈ"ë6¨å#9Ú&.k_õFd¿c…ýï ƒ…ƒ´TE>W8Dùˆ†dþO†Èœø‘ÿÚås ¬_ºÈÑq½pŒr9Vk]ä8¤ß()‘´üGN\$œô˜pJa³"ID…$³–R˜"­u‘ÓôP9ýá ~&-pÃΙ$dñ»å-á\­>‘óÂV­ ‘ó_.øE¸È s—(‘KO.{P¸\í¹â?aÛ,á*å(r5}ºÖ»†)¹®»p=çw¦whíŒÜÈ Ý¤•:róëÂ-å5Œx=7ðú¥.²SÑìÜ+ìbwѧw`뎂;F¸S ÜE7ôî™-Ü«=rŸî‘ûiŸ0ý ]÷ГÂî«„‡µòGòZ¯"úô‘¤ðh_á±.à_a½öD; »Aä)‚øÔÛÂÓ·Ï öY-¾‘çèþ#òÈ‹~Á¾xðêyè¨ç¡£>æ"/3í¯dí…•€‡Žz:ê׸ȫDãµë…×ïÞxDx“Ó}‹8¿ÍÔ½Mû¼Ã«ï²F¼Gó¿Ï™¾Ïu|ÀÇx°ð‘þùù˜þû„|ˆOO>cÚ?'œ_ çË!ÂWË„¯÷¾¡©÷jq‹|û¢ð½î.‘F ?¢û'ŽVä¸%­¶‘Ÿk…_¸Ô_u÷‹üÖOøKøƒ•áÏ?„¿èˆ´ÆFþ¥‡þû³ÂE+´hE]Ih¬¨E›hî£MÙl® êë%T*ÉQ¿z(PÞ¢UêØhP] é. «1£ž–Ühu? ¶ˆÖ(tÑZ­Ñ:Ý%£‘ß„µà'¡U3 pF[kš¢m´ÂEÛiˆ¶×âí ‹Žv<^ètºÐY9ŠvÑí)Úõq¡Û+B> §V³h/Å4Ú{·äÁ°žÃú .Úço½ÐW¶¢ý8Éþ|èŒRL£ƒµÀG‡è¶ª‚è0Ýó¢ÃÙ¡ŽdJFkuŒŽÑÜGÇi‘ŽŽçü&p©% :IS,«Ñ)ó„©jåè4MvtºÂ1V˜)[ÑYjþèl>yŽîoѹÅyS„ùwž¢ ©øÕèb=#E—(ìÑ¥ gt™Z9ºœéŒéÑ —îèJ®cgµZí][gW¾‰‡» à\‹ÛuÛ‰ÃuË„¯å&z¢ÖˆèIê«èÉZ¯¢›9¡ÍZ<¢‰«…”î~ÑLGá´ …3Ô\Ñ3õ„=‹>8‡ãf°E‹o´^ Oô¤Õ6º›÷åµ*G LÉ#•@KxôQbð˜èöíÁ“Šnô)Úñé#…gØè³ZÍ¢Ï=dge?so¿k_é¢Ïk½¾pƒð"™yIy‹¾¢¬F_% ¯Ó o0ãoÞ*¼ÍY½«»Pô=Ô~ $ú¡îjÑÉ'Z•£ŸÒ>ŸÓ‰_ ¾¤s¾â-_k‰~ÃUîÕÓaô;-‡Ñïõðý¿?UE-¥Ñ’–›èÏz‹þÚÛN7ª@ÐE;Åö…\‹®OZv-&÷²Ês-ö9ݪj×"éYUãZlÓƒ\‹ízúoqî-vè¤Å-öjGÐ töoçÉ` °_©·_"Ÿfû#Ì,0ÌsÁ<0ØÖ/‹Àb°دíÛÏë/+@ ÄÁJ°Êµ¸M÷¼ù+þB®)b endstream endobj startxref 1556464 %%EOF cummeRbund/inst/extdata/0000755000175200017520000000000014516004263016305 5ustar00biocbuildbiocbuildcummeRbund/inst/extdata/cds.count_tracking0000644000175200017520000023326514516004263022025 0ustar00biocbuildbiocbuildtracking_id iPS_count iPS_count_variance iPS_count_uncertainty_var iPS_count_dispersion_var iPS_status hESC_count hESC_count_variance hESC_count_uncertainty_var hESC_count_dispersion_var hESC_status Fibroblasts_count Fibroblasts_count_variance Fibroblasts_count_uncertainty_var Fibroblasts_count_dispersion_var Fibroblasts_status P1 7.10922 943 4.9949 203.221 OK 0.494996 4 0 3.78504 OK 0 0 0 0 OK P10 13.9608 199 4.17386 142.435 OK 185.361 1532 42.9102 1470.79 OK 50.0667 3033 16.6365 1955.97 OK P100 0 0 0 0 OK 0 0 0 0 OK 36.3241 56399 66.8023 8238.88 OK P101 2.94871 12 3.5244 4.27577 OK 0 0 0 0 OK 0.655508 3 1.17964 2.19719 OK P102 0 0 0 0 OK 1.68685 111 2.42212 4.30432 OK 0.0197686 1 0.0392145 0.0662621 OK P103 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P104 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P105 0 0 0 0 OK 13.4507 65 21.3259 34.3219 OK 0 0 0 0 OK P106 1.39339 3 0.585492 2.02048 OK 0.566327 2 0.141665 1.44509 OK 0 0 0 0 OK P107 0 0 0 0 OK 0.0918113 1 0.181837 0.234273 OK 0 0 0 0 OK P108 5.84488 13 3.65959 8.47537 OK 180.111 497 32.2617 459.587 OK 9.08328 34 1.2145 30.4462 OK P109 0.892741 2 0.649688 1.29452 OK 7.9709 43 10.1435 20.3392 OK 0 0 0 0 OK P11 0 0 0 0 OK 0 0 0 0 OK 55.5304 1107 50.4381 818.716 OK P110 0.481711 0.481711 0 0.481711 OK 6.44423 6.44423 0 6.44423 OK 0.594944 0.594944 0 0.594944 OK P111 4.45592 4.45592 0 4.45592 OK 29.9302 29.9302 0 29.9302 OK 17.9248 64.5406 0 64.5406 OK P112 0 0 0 0 OK 3.9569 51.3563 5.67976 14.7279 OK 0 0 0 0 OK P113 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P114 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P115 74.0036 653 19.3561 597.784 OK 262.881 1113 127.476 978.465 OK 249.588 7770.21 62.2085 6721 OK P116 7.85321 188 13.3432 63.4364 OK 0 0 0 0 OK 0 0 0 0 OK P117 0 0 0 0 OK 46.4256 271 73.0468 172.8 OK 12.9678 889 23.0082 349.201 OK P118 0.00771084 1 0.0152962 0.0622864 OK 26.9136 157 46.6069 100.175 OK 10.8656 942 20.4768 292.592 OK P119 109.591 1416.74 0 1168.4 OK 193.908 444.954 -7.10543e-15 477.122 OK 2.37978 4.33669 0 3.35053 OK P12 0.000105872 1 0.000197978 0.000127692 OK 23.8138 49 24.9548 24.5787 OK 46.8338 895 48.6881 690.497 OK P120 68.8854 578.354 0 578.354 OK 86.3464 120.977 0 120.977 OK 0.594944 0.594944 0 0.594944 OK P121 1.30489 11 2.5276 10.8226 OK 0 0 0 0 OK 0 0 0 0 OK P122 59.4407 592 34.5805 492.994 OK 299.305 1334 121.805 1200.96 OK 83.101 4337.38 107.161 2118.13 OK P123 4.30283 75 2.3124 35.6871 OK 35.1537 175 25.714 141.054 OK 3.63919 933 3.16868 92.7577 OK P124 20.5966 597.483 28.9137 170.826 OK 66.7156 411.617 103.101 267.696 OK 173.571 7376.75 108.342 4424.07 OK P125 5.24019 286.719 8.36309 43.4615 OK 2.44878 38 3.88294 9.82571 OK 0 0 0 0 OK P126 7.81288 3207 1.21321 437.935 OK 22.275 1045 8.0543 508.849 OK 10.6386 282551 3.79686 5479.79 OK P127 59.2928 6194 4.17201 3323.54 OK 114.048 3027 20.8058 2605.31 OK 113.965 265590 19.5069 58701.7 OK P128 5.21177 293 0.858405 292.135 OK 15.3704 507 1.94317 351.121 OK 4.39406 2264 0.50157 2263.31 OK P129 92.1693 801.958 0 801.958 OK 762.203 4511.79 0 4511.79 OK 0 0 0 0 OK P13 5.66027 7 0.000197978 6.82685 OK 31.6534 58 24.9548 32.6701 OK 11.2897 1128.64 19.3725 166.45 OK P130 7.96795 31 6.05186 18.3179 OK 285.988 1412.33 62.7498 1073.42 OK 0 0 0 0 OK P131 10.6588 36 6.05186 24.504 OK 72.8803 582.005 62.7498 273.548 OK 0.594944 1 0 0.594944 OK P132 1.45799 3 1.26121 1.45799 OK 0.207346 1 0.367865 0.207346 OK 0.000120751 1 0.00022661 0.000228083 OK P133 0.00397896 1 0.00785548 0.00397896 OK 0 0 0 0 OK 2.41731 10 1.8737 4.56598 OK P134 1.58899 3 1.26328 1.58899 OK 1.63712 3 0.874879 1.63712 OK 0 0 0 0 OK P135 0 0 0 0 OK 0.640365 2 0.732123 0.640365 OK 3.9566 12 1.87371 7.4735 OK P136 22.4395 449 13.0602 273.584 OK 208.975 1379 149.742 1224.83 OK 75.5738 4023 60.7863 2749.66 OK P137 137.533 1730.1 13.0602 1676.81 OK 541.901 2703.27 149.742 3176.16 OK 387.213 20307.3 60.7863 14088.3 OK P138 400.713 8852.95 0 8852.95 OK 2457.98 30132.5 0 30132.5 OK 2311.86 242240 0 242240 OK P139 12.4772 1397 16.5241 430.066 OK 101.157 2097 116.787 1874.45 OK 120.844 54221 181.578 27857.4 OK P14 109.513 1080.67 0 1080.67 OK 502.184 2296.71 0 2296.71 OK 1367.24 95380.1 0 95380.1 OK P140 34.1028 2411 17.8221 1175.46 OK 159.672 3411 122.441 2958.72 OK 407.454 106189 193.543 93927.3 OK P141 5.72045 1758 8.23824 197.174 OK 39.859 1106 55.7757 738.588 OK 43.4458 56440 63.127 10015.2 OK P142 2.76816 952 4.86346 53.7389 OK 0 0 0 0 OK 0 0 0 0 OK P143 0 0 0 0 OK 0 0 0 0 OK 8.45779 6993 10.5158 625.273 OK P144 19.2286 796 14.526 373.289 OK 146.203 1135 67.73 1048.48 OK 0 0 0 0 OK P145 16.2161 393 13.3375 314.806 OK 73.113 614 73.8457 524.321 OK 26.5411 5577 12.2455 1962.15 OK P146 1254.27 50600.6 0 50600.6 OK 1083.92 8011.86 0 8011.86 OK 12340.2 7.84133e+06 0 7.84133e+06 OK P147 35.7911 4151.04 62.6464 984.19 OK 163.486 1047 178.557 853.86 OK 0 0 0 0 OK P148 18.1116 1426.03 33.1775 498.036 OK 0 0 0 0 OK 50.0687 8865 92.6658 4575.3 OK P149 107.357 3953 168.785 2952.13 OK 45.8788 338 82.9615 239.617 OK 432.46 42116 626.037 39518.4 OK P15 480.802 11598.9 0 11598.9 OK 14167.9 517645 0 517645 OK 15728.2 1.48338e+07 0 1.48338e+07 OK P150 30.3477 1638 39.1988 834.505 OK 10.534 95 13.3683 55.017 OK 33.8075 9020 53.0004 3089.35 OK P151 36.4692 2107.58 65.0075 1002.84 OK 16.5878 222.579 31.1267 86.6349 OK 38.8344 9067 74.1969 3548.71 OK P152 352.206 13486.5 247.764 9685.03 OK 350.355 2063 228.293 1829.84 OK 1165.2 122098 713.607 106476 OK P153 31.0014 1687 18.5577 1265.29 OK 37.4466 1012 22.6854 842.061 OK 19.0294 546160 11.3737 13650.9 OK P154 9.57616 2052 12.0404 390.842 OK 25.1584 1149 41.0688 565.736 OK 169.518 524757 304.278 121606 OK P155 1384.23 70106 33.1763 56495.9 OK 6530.11 161365 69.2425 146842 OK 13506.1 1.28894e+07 318.12 9.68874e+06 OK P156 1.65948 4 1.98312 1.93428 OK 70.3232 123 24.968 97.2746 OK 272.319 8914 126.154 8637.4 OK P157 6.28893 10 1.98312 7.33035 OK 16.6609 52 24.968 23.0463 OK 93.694 4923.17 126.154 2971.78 OK P158 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P159 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P16 0 0 0 0 OK 2.50523 2.50523 0 2.50523 OK 0 0 0 0 OK P160 507.14 12966.8 0 12966.8 OK 888.348 5831.28 0 5831.28 OK 8578.29 3.46542e+06 0 3.46542e+06 OK P161 105.498 1257.91 1.77636e-14 969.604 OK 258.748 1095.19 -1.42109e-14 781.37 OK 2126.92 264023 3.41061e-13 207334 OK P162 0 0 0 0 OK 31.1712 2272.9 52.8314 107.465 OK 9.61652 1116 17.4809 277.905 OK P163 115.011 1135 0 1134.55 OK 283.437 2289.63 52.8314 977.175 OK 284.224 8891 17.4809 8213.71 OK P164 103.497 1529 19.4864 1390.51 OK 671.349 6470 228.994 6199.55 OK 814.662 52465 100.913 50224 OK P165 80.2409 1196 19.4864 1078.06 OK 876.094 8371 228.994 8090.26 OK 225.318 15103 100.913 13890.9 OK P166 37.4295 1714 62.5846 1504.41 OK 144.637 5231 244.298 4599.67 OK 97.1528 1.47975e+06 155.961 116325 OK P167 91.98 5760.75 140.728 3696.97 OK 1453.16 48246 1161.98 46212.3 OK 204.207 1.45298e+06 299.227 244506 OK P168 283.269 12841 172.96 11385.5 OK 858.756 28576 1099.32 27309.6 OK 486.395 1.43681e+06 361.554 582383 OK P169 91.6094 881.483 0 881.483 OK 151.513 311.808 0 311.808 OK 990.476 56044 0 56044 OK P17 0 0 0 0 OK 14.3381 26 9.72406 15.4876 OK 0 0 0 0 OK P170 22.8015 67 0 66.2587 OK 114.914 195 0 194.183 OK 7.9194 16 0 15.5536 OK P171 0 0 0 0 OK 25.1035 1144 48.0149 555.576 OK 0 0 0 0 OK P172 6.03788 2179 9.84271 228.291 OK 20.412 1040.13 36.449 451.748 OK 320.653 130443 543.063 81411.6 OK P173 1138.12 43310 158.716 43032.2 OK 6278.01 139687 317.852 138942 OK 5168 1.34947e+06 999.497 1.31212e+06 OK P174 60.8936 2985 91.2784 2302.38 OK 9.13019 651 16.0953 202.064 OK 50.9937 68955 96.3179 12947 OK P175 36.6705 1521 63.4934 1386.5 OK 124.195 3076 221.29 2748.62 OK 199.139 65355 355.524 50560 OK P176 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P177 0 0 0 0 OK 28.9381 1073 54.9178 628.851 OK 0 0 0 0 OK P178 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P179 271.164 36861.2 428.001 16136.6 OK 797.356 18864 1226.74 17327.3 OK 214.961 172245 357.269 71370.6 OK P18 0 0 0 0 OK 21.6026 35 9.72406 23.3346 OK 0 0 0 0 OK P180 0 0 0 0 OK 12.2833 1965 24.4294 266.927 OK 50.5024 118324 97.8315 16767.6 OK P181 1297.7 80550 418.159 77224.3 OK 1570.15 34786 536.658 34120.8 OK 5580.58 1.86887e+06 487.406 1.85284e+06 OK P182 1767.23 108738 738.274 105165 OK 3855.27 85422 1618.7 83778.4 OK 1290.54 440586 740.175 428480 OK P183 971.972 34032 97.1401 33736.1 OK 12666.7 448726 1338.06 446239 OK 20382.6 3.11771e+07 1331.56 2.93949e+07 OK P184 4.32495 2240 7.65597 150.114 OK 4.42418 2283 7.85602 155.86 OK 7.88488 3.02991e+06 13.7406 11371.2 OK P185 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P186 51.8246 2571 90.1963 1798.78 OK 723.532 28037 1331.03 25489.5 OK 702.71 2.08946e+06 1318.71 1.01342e+06 OK P187 14.0019 240 4.6135 155.56 OK 29.1796 111 7.84449 100.944 OK 10.384 2438 9.66669 477.586 OK P188 89.0398 1045 28.9547 989.224 OK 183.153 694 54.0553 633.599 OK 562.635 27018 99.694 25876.9 OK P189 2.64713 268 3.83877 29.4093 OK 12.3578 81 16.0961 42.7507 OK 3.89813 3919 6.11275 179.284 OK P19 241.224 3870.14 0 3870.14 OK 768.285 4571.9 0 4571.9 OK 2400.81 257045 0 257045 OK P190 29.2916 382 31.0605 325.426 OK 94.8318 397 61.0887 328.062 OK 90.0913 6537 109.539 4143.52 OK P191 3.35527 232 5.11904 37.2767 OK 0 0 0 0 OK 24.199 2258 27.1288 1112.97 OK P192 125.113 1470 4.61609 1446.15 OK 1111.15 8472 5.03005 8439.75 OK 1561.78 132939 130.512 128043 OK P193 0 0 0 0 OK 0 0 0 0 OK 61.6863 7011 107.396 5057.35 OK P194 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P195 7.04028 144 4.61609 81.3771 OK 7.47845 115 2.89896 56.8026 OK 2.97005 10031 2.16463 243.5 OK P196 3153.6 184178 87.5904 184031 OK 10176.3 309773 284.279 309042 OK 9554.82 4.42784e+06 0 4.42784e+06 OK P197 48.1068 3598 87.5904 2807.32 OK 147.255 5828 284.279 4471.94 OK 0 0 0 0 OK P198 21.5572 1054 0 1053.69 OK 2.0001 54 0 53.428 OK 18.6975 4303 0 4302.79 OK P199 514.64 12989.4 0 12989.4 OK 1138.82 8677.44 0 8677.44 OK 995.51 57405.1 0 57405.1 OK P2 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P20 0 0 0 0 OK 76.369 285 85.0738 192.158 OK 24.6868 1281.87 38.8305 414.114 OK P200 30.5679 193 14.755 168.557 OK 331.732 1194 0.27148 1193.27 OK 2.3796 4 0.000329766 3.35028 OK P201 13.5498 135 14.755 74.7159 OK 0 0 0 0 OK 0.000173876 1 0.000329766 0.000244803 OK P202 0 0 0 0 OK 17.3072 2390.12 33.511 264.922 OK 19.0307 3563 34.837 1050.11 OK P203 60.274 1601 55.9462 1194.14 OK 424.758 10401.5 511.242 6501.76 OK 440.647 29689.5 377.989 24314.7 OK P204 0.00734912 1 0.0145769 0.1456 OK 112.347 5984.08 197.789 1719.69 OK 0 0 0 0 OK P205 10.3073 431 8.4434 204.207 OK 91.2082 1626 67.2716 1396.12 OK 33.7865 3235 47.458 1864.33 OK P206 96.6105 2327 56.5386 1914.03 OK 705.643 14017.5 540.7 10801.3 OK 382.062 24628.3 377.671 21082 OK P207 43.9978 219.285 0 219.285 OK 37.0478 37.0478 0 37.0478 OK 425.483 14738.3 0 14738.3 OK P208 132.594 1435.67 0 1435.67 OK 577.571 2882.6 0 2882.6 OK 15.9475 75.9065 0 75.9065 OK P209 33.8297 2692.01 56.0472 639.993 OK 55.035 771 101.279 545.972 OK 29.3503 6860 55.2575 2304 OK P21 0 0 0 0 OK 7.89904 53 14.6552 19.8754 OK 23.7582 632 37.9232 398.537 OK P210 0 0 0 0 OK 9.31425 276 16.4138 92.4015 OK 33.2104 6750 60.7753 2607.02 OK P211 135.448 4803.92 139.82 2562.41 OK 1148.33 12084 660.052 11392 OK 1138.89 103711 634.102 89402.6 OK P212 48.9319 2777.05 74.7002 925.696 OK 248.707 2839 344.892 2467.29 OK 110.369 24925.1 175.401 8663.95 OK P213 96.7385 2212 122.683 1830.11 OK 273.064 3188 419.003 2708.92 OK 325.942 31259 495.044 25586.5 OK P214 1.13454 24 0.25802 23.0051 OK 3.60808 87 3.4876 28.8248 OK 11.9147 24191 4.80797 1799.61 OK P215 0 0 0 0 OK 5.79833 68 3.82547 46.3227 OK 0 0 0 0 OK P216 0 0 0 0 OK 7.56596 134 8.95267 80.5405 OK 8.62721 16465 11.0807 974.596 OK P217 1.74123 980 2.42446 30.2423 OK 4.39423 165 5.57055 46.777 OK 1.79282 37870 2.38484 202.531 OK P218 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P219 9.4189 291 1.00115 163.591 OK 1.09751 12 0.194374 11.6831 OK 0 0 0 0 OK P22 10.0761 15.6915 3.44993e-16 13.5364 OK 100.737 407.234 92.1856 253.473 OK 78.6175 1534.57 67.4414 1318.79 OK P220 244.292 4276 10.1808 4242.96 OK 1899.76 20266 38.5463 20223.1 OK 2426.25 278333 56.3722 274088 OK P221 0.0953662 2 0.190224 1.65635 OK 0.555983 6 1.11044 5.9185 OK 0 0 0 0 OK P222 6.06649 398 7.27972 105.365 OK 19.7722 380 24.3793 210.477 OK 35.1308 13540 43.7192 3968.64 OK P223 19.5999 11991.7 35.4751 707.798 OK 5.64687 285 10.2612 76.2586 OK 296.724 4.79477e+06 542.878 645916 OK P224 990.869 46380.5 35.4751 35782.5 OK 2876.1 39020 10.2612 38840.5 OK 25050.4 5.68373e+07 542.878 5.45304e+07 OK P225 1199.02 45097.9 -1.13687e-13 44749.2 OK 4499.8 76568.1 -2.27374e-13 79630.6 OK 11118.5 6.58273e+06 -1.13687e-12 6.1286e+06 OK P226 293.932 5326 0 5326 OK 1830.86 18761.3 0 18761.3 OK 695.807 32506.4 0 32506.4 OK P227 5.25454 531 9.24541 94.9558 OK 0 0 0 0 OK 6.83016 101 7.23359 44.1056 OK P228 258.886 5002 54.9873 4678.37 OK 1547.14 14997 156.504 14803.1 OK 13.636 120 7.23482 88.0541 OK P229 27.3029 1407.12 47.5483 493.396 OK 67.1251 797 118.738 642.251 OK 0.00140322 1 0.00275525 0.00906126 OK P23 0 0 0 0 OK 11.6787 61 21.175 29.3856 OK 14.5512 357.532 25.3537 244.092 OK P230 0 0 0 0 OK 21.005 332 41.1473 200.975 OK 0 0 0 0 OK P231 0.000607993 1 0.00118416 0.00158231 OK 20.6415 80 33.5198 37.5994 OK 322.743 77630 578.07 63226.4 OK P232 0 0 0 0 OK 105.171 228 33.5198 191.574 OK 3865.56 772846 578.07 757275 OK P233 64.2149 5276 51.4446 3271.38 OK 0 0 0 0 OK 0 0 0 0 OK P234 85.7274 7561.2 164.556 4367.32 OK 0 0 0 0 OK 0 0 0 0 OK P235 0 0 0 0 OK 19.7384 335 37.3804 236.387 OK 8.29527 50282 15.2946 1543.57 OK P236 2094.51 107830 388.062 106703 OK 1235.57 16665.7 1069.07 14797.2 OK 2662.85 1.18793e+06 1729.11 495496 OK P237 110.874 8118 198.738 5648.4 OK 973.86 12777 1059.28 11662.9 OK 1127.01 894896 1554.59 209712 OK P238 0.521883 0.521883 0 0.521883 OK 2.0001 2.0001 0 2.0001 OK 0 0 0 0 OK P239 13.3225 182 21.5926 116.472 OK 7.513 19 11.324 7.513 OK 0 0 0 0 OK P24 111.178 5234 49.9088 4038.52 OK 750.069 19485 201.28 18783.1 OK 630.511 382451 237.786 275787 OK P240 76.1187 702 21.5926 665.466 OK 33.5299 45 11.324 33.5299 OK 0 0 0 0 OK P241 1.85458e-05 1 3.16041e-05 1.85458e-05 OK 0.505127 1 0 0.505127 OK 0 0 0 0 OK P242 0.521865 1 3.16041e-05 0.521865 OK 0.505127 1 0 0.505127 OK 0 0 0 0 OK P243 2.40856 2.40856 0 2.40856 OK 1.48478 1.48478 0 1.48478 OK 0 0 0 0 OK P244 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK P245 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P246 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P247 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P248 0.21677 0.21677 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK P249 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK P25 15.3384 1388 9.82185 557.164 OK 27.4502 1295 19.5185 687.404 OK 23.8915 204343 20.14 10450.2 OK P250 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P251 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P252 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK P253 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK P254 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P255 756.357 32624 638.781 31385.4 OK 2284.69 50144.6 2137.73 41886.6 OK 91.2116 4045.31 105.122 2403.94 OK P256 655.968 29312 638.781 27219.7 OK 2467 56999.2 2142.76 45229.1 OK 160.474 4825 105.122 4229.4 OK P257 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P258 0 0 0 0 OK 18.5703 813 33.0112 340.461 OK 0 0 0 0 OK P259 47.5611 1633 68.5816 1326.49 OK 171.146 1510 241.991 1209.64 OK 99.6707 10414 167.559 10055.1 OK P26 33.8293 1382 44.7964 1228.84 OK 115.248 3255 186.654 2886.02 OK 138.005 195270 219.287 60363.6 OK P260 142.355 4801 200.238 3970.31 OK 71.6232 662 129.844 506.224 OK 0 0 0 0 OK P261 0 0 0 0 OK 34.4579 316 44.1913 243.544 OK 60.418 10434 65.2295 6095.19 OK P262 3.04983 1991 5.95064 85.0606 OK 0 0 0 0 OK 69.2059 10545 112.029 6981.74 OK P263 437.986 13008 223.151 12215.5 OK 723.799 5429 276.18 5115.72 OK 1886.33 191677 207.596 190300 OK P264 13.8206 230 11.5951 144.17 OK 24.1109 203 33.9388 133.255 OK 37.5263 5915 31.4784 2842.98 OK P265 3.02588 228 4.83958 31.5645 OK 76.4782 614.55 121.106 422.677 OK 92.6279 11940 156.346 7017.46 OK P266 0 0 0 0 OK 61.447 441 78.6194 339.603 OK 33.7577 6082 42.4432 2557.47 OK P267 79.5916 1000 16.7965 830.263 OK 179.22 1238 225.28 990.51 OK 10.2586 7824 19.6415 777.184 OK P268 0 0 0 0 OK 273.142 1784 247.318 1509.59 OK 576.499 140567 629.137 43675.4 OK P269 8.18816 189.013 12.9179 85.4151 OK 0 0 0 0 OK 655.072 143844 639.913 49628 OK P27 116.779 1180.53 0 1180.53 OK 400.73 1597.85 0 1597.85 OK 1352.09 93029.7 0 93029.7 OK P270 0 0 0 0 OK 31.2718 202 55.629 131.435 OK 95.7449 7607 168.517 5798.47 OK P271 106.179 1861.85 2.13163e-14 1049.77 OK 407.103 2729.8 55.629 1711.04 OK 978.679 83852.7 168.517 59270.5 OK P272 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P273 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P274 3.05482 5 0.700594 4.72165 OK 6.37886 8 1.38817 6.43189 OK 2.46991 19 1.77188 9.79143 OK P275 7.30215 12 0.700594 11.2865 OK 32.4763 35 2.12092 32.7463 OK 9.71379 52 2.57172 38.5082 OK P276 0 0 0 0 OK 0.53115 1 0.0493654 0.535565 OK 0.594944 3 0 2.35852 OK P277 306.218 5761.87 0 5761.87 OK 1118.9 8437.14 0 8437.14 OK 4236.07 795691 0 795691 OK P278 9.89142e-06 1 1.59161e-05 9.89142e-06 OK 0 0 0 0 OK 0 0 0 0 OK P279 0.521874 1 1.59161e-05 0.521874 OK 0 0 0 0 OK 2.68094 4 0 3.30449 OK P28 6.14209 7.30868 0 7.30868 OK 6.51564 6.51564 0 6.51564 OK 8.81552 19.8959 0 19.8959 OK P280 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P281 0 0 0 0 OK 1.00006 7 0 6.30426 OK 0 0 0 0 OK P282 95.8687 3814 126.908 3378.02 OK 51.2132 482 75.4581 385.134 OK 33.6018 8706 53.2527 3014.74 OK P283 639.043 23350 393.075 22517.3 OK 662.899 5300 293.2 4985.15 OK 1407.62 131779 628.988 126291 OK P284 215.348 8897 319.476 7587.98 OK 147.689 1717.29 240.079 1110.65 OK 384.658 40748 593.884 34511.3 OK P285 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P286 24.2865 864 20.7964 702.504 OK 2.62711 64 2.22785 17.4637 OK 1.00984 58 0.827306 57.6263 OK P287 370.698 11346 31.1146 10722.7 OK 460.458 3119 38.8947 3060.9 OK 538.827 32040 38.7227 30748.2 OK P288 287.095 8951 51.9109 8304.44 OK 451.441 3046 41.1225 3000.95 OK 419.443 25646 39.5501 23935.5 OK P2881 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK P2882 301.08 13338.4 197.428 7624 OK 1389.14 18553.2 944.442 17710.2 OK 147.349 5044 98.574 3796.51 OK P2883 13.6891 25.3656 0 25.3656 OK 23.5573 23.5573 0 23.5573 OK 38.77 258.572 0 258.572 OK P2884 13.0069 1043 8.11551 408.162 OK 74.0776 1807 35.1224 1420.47 OK 44.5354 64021 38.4814 11079 OK P2885 355.958 11817 331.237 11170.1 OK 1526.78 31758 2058.37 29276.7 OK 1460.3 372265 2021.92 363275 OK P2886 279.201 9954 322.689 8761.44 OK 3059.77 61165 2233.39 58672.4 OK 3283.7 1.26637e+06 2129.72 816879 OK P2887 61.1304 3045 62.0216 1918.3 OK 439.671 9237 471.445 8430.88 OK 197.537 598911 213.801 49140.9 OK P2888 0 0 0 0 OK 1.58548 8.38045 1.11094 1.58548 OK 5.26949 52.3509 3.64119 33.917 OK P2889 17.4227 48 0 47.7638 OK 21.0963 33 11.8526 21.0963 OK 19.3507 143 4.51561 110.47 OK P289 591.643 16261 0 16261 OK 3276.8 47768.8 0 47768.8 OK 7970.37 2.91049e+06 0 2.91049e+06 OK P2890 0 0 0 0 OK 11.2982 24 11.8526 11.2982 OK 2.99294 61 4.51561 17.0862 OK P2891 19.6515 189 25.8348 149.975 OK 18.2807 117 30.2768 69.3512 OK 42.9597 2035 51.8773 1338.89 OK P2892 37.5935 346 31.9692 286.904 OK 174.888 831 157.228 663.471 OK 126.314 10436.4 151.194 3936.74 OK P2893 17.1649 228.091 22.9721 130.998 OK 40.1381 223 53.4299 152.271 OK 0 0 0 0 OK P2894 0.00128044 1 0.00251115 0.00977196 OK 19.6848 143 36.6188 74.6781 OK 71.113 7401.9 106.564 2216.33 OK P2895 6.47819 147.234 11.5789 49.4399 OK 35.902 210 63.0145 136.201 OK 30.6583 4510.59 54.8463 955.503 OK P2896 0.481711 1 0 0.481711 OK 21.4756 24 0 23.1974 OK 0 0 0 0 OK P2897 0.717547 1 0.260061 0.717547 OK 0 0 0 0 OK 12.2606 38 0.00224839 37.7104 OK P2898 0.00106706 1 0.00208632 0.00106706 OK 26.7954 37 10.1912 26.7954 OK 0.00114782 1 0.00224839 0.00353038 OK P2899 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P29 34.5492 2322 49.0295 1129.55 OK 254.478 4453 345.546 3844.23 OK 428.8 135914 332.795 91157 OK P290 7.65209 12 2.02641 9.29398 OK 26.5667 27 0.00185466 26.5667 OK 23.2402 151 8.32475 123.616 OK P2900 0.766692 2 0.258727 0.766692 OK 9.70144 20 10.1912 9.70144 OK 0 0 0 0 OK P2901 0 0 0 0 OK 1.9899 2 0 1.9899 OK 0 0 0 0 OK P2902 0.481711 1 0 0.481711 OK 0 0 0 0 OK 4.46577 7 0 6.06008 OK P2903 32.0919 2074 53.589 978.784 OK 37.31 746 64.7122 561.212 OK 907.941 1.25171e+06 1486.83 716801 OK P2904 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2905 7.91371 970 2.49209 241.364 OK 132.463 2164 41.7812 1992.5 OK 56.8912 636081 35.37 44914.5 OK P2906 631.105 19896 92.4222 19248.3 OK 2887.83 43798 284.584 43438.5 OK 13253.9 1.05842e+07 1706.16 1.04637e+07 OK P2907 6.06174 6.24262 0 6.24262 OK 38.3949 38.3949 0 38.3949 OK 55.9469 575.399 0 575.399 OK P2908 9.20877 699 14.0293 215.603 OK 49.8971 640 83.6395 493.024 OK 180.927 57194 303.064 30272.4 OK P2909 23.2303 1594.4 33.7941 543.886 OK 126.25 6169.14 199.096 1247.45 OK 286.874 64856 465.78 47999.2 OK P291 6.42293 7.18464 0 7.18464 OK 44.9207 44.9207 0 44.9207 OK 0 0 0 0 OK P2910 379.502 10159.7 70.8136 8885.2 OK 1378.48 17815.5 311.542 13620.5 OK 3056.42 531541 788.682 511395 OK P2911 14.6397 629 21.6114 342.756 OK 34.5496 423 52.9287 341.378 OK 50.0534 29623 81.1062 8374.85 OK P2912 4.76405 899 7.51825 111.54 OK 0 0 0 0 OK 4.92422 50376 8.99885 823.913 OK P2913 23.8452 559 0 558.284 OK 131.895 1304 0 1303.23 OK 58.6426 9812 0 9811.98 OK P2914 137.959 5235 77.4115 5011.34 OK 692.77 18254 757.473 17348.2 OK 2501.42 1.14647e+06 917.832 1.09413e+06 OK P2915 11.7405 1652 19.7426 426.472 OK 451.343 12037 554.072 11302.4 OK 264.838 193219 429.901 115841 OK P2916 19.0877 1378 13.6472 693.358 OK 220.966 6180 121.707 5533.39 OK 199.748 192319 150.343 87370.2 OK P2917 54.9376 2713 58.686 1995.6 OK 623.646 16250 571.23 15617.2 OK 385.917 192054 457.546 168801 OK P2918 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2919 71.3193 3938 29.8919 2590.66 OK 323.569 8659 197.812 8102.76 OK 28.5587 201984 23.7434 12491.6 OK P292 276.553 10364 382.928 9881.71 OK 238.017 3850 428.177 3390.22 OK 747.571 349323 1279.22 254314 OK P2920 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2921 0 0 0 0 OK 37.4683 1423.04 66.2173 938.275 OK 5.1596 331911 9.11692 2256.82 OK P2922 42.0408 2801 55.1669 1527.12 OK 421.163 11320 433.263 10546.7 OK 321.699 192073 323.218 140712 OK P2923 16.4885 1472 20.2827 598.943 OK 184.781 5135 260.357 4627.25 OK 111.151 195831 160.418 48617.9 OK P2924 11.28 1645 17.9167 409.742 OK 93.6246 2619 158.688 2344.53 OK 46.4599 203616 72.0591 20321.7 OK P2925 0 0 0 0 OK 99.8923 3323 178.912 2501.48 OK 146.822 195352 252.824 64220.1 OK P2926 477.703 18179 186.544 17352.4 OK 3328.87 84906 1202.82 83360.9 OK 3961.88 1.9102e+06 1022.6 1.73294e+06 OK P2927 15.6588 1520 22.8703 568.801 OK 107.71 3257 164.271 2697.26 OK 34.1722 208195 52.9503 14947 OK P2928 22.0194 1498 40.9888 799.851 OK 8.57915 876 16.3113 214.838 OK 5.95113 320984 11.2891 2603.04 OK P2929 2.35724 3407 3.57754 85.6261 OK 61.8339 1980 95.2758 1548.43 OK 9.07257 259791 14.5225 3968.36 OK P293 30.7946 2721.11 31.577 1100.35 OK 33.7213 649 44.3182 480.312 OK 13.2662 138973 17.8651 4513.01 OK P2930 52.8372 1084 48.5841 999.405 OK 874.448 13948 705.844 13218.1 OK 86.4379 28419 89.9626 14443.3 OK P2931 196.855 4142.49 98.0686 3723.47 OK 1973.02 30972 1087.45 29824 OK 2996.98 528250 799.358 500778 OK P2932 52.7503 2009.01 73.1943 997.763 OK 561.145 29351 726.415 8482.22 OK 435.528 213798 650.74 72774.4 OK P2933 6.74646 496 10.2855 127.608 OK 67.7048 27771.2 97.611 1023.42 OK 86.1044 169795 140.971 14387.6 OK P2934 75.2445 3580 127.136 3121.1 OK 0.00605773 1 0.0120056 0.0215686 OK 4557.93 8.03793e+06 7012.61 7.45795e+06 OK P2935 2.34525 4559 3.63881 97.2799 OK 50.394 261 70.7722 179.428 OK 40.9182 2.87926e+06 63.6372 66952.7 OK P2936 629.734 59535.7 362.322 26121.1 OK 152.486 709 155.659 542.928 OK 15331.4 2.6771e+07 11171.5 2.50861e+07 OK P2937 4.61502 3087 8.11581 191.429 OK 23.0822 147 38.5466 82.1844 OK 149.926 2.74172e+06 277.405 245317 OK P2938 185.939 37802.6 283.978 7712.64 OK 107.319 523 134.198 382.111 OK 4471.31 8.03836e+06 7016.93 7.31622e+06 OK P2939 715.564 21339.2 -2.84217e-13 21180.9 OK 2619.7 48142.8 3.41061e-12 33400.3 OK 4130.34 1.17439e+06 4.54747e-13 788532 OK P294 765.981 31069.4 407.549 27369.9 OK 2880.35 40065.1 469.137 41026.6 OK 5728.66 2.06175e+06 1294.94 1.94882e+06 OK P2940 127.88 6246 220.008 4959.36 OK 440.178 9010 763.305 8201.4 OK 307.79 145088 555.297 65025.5 OK P2941 20.8576 1704 35.7634 808.887 OK 304.952 6528 536.102 5681.88 OK 46.141 48085 87.9795 9748.03 OK P2942 205.489 11378 323.502 7969.13 OK 799.891 71129.7 1244.45 14903.6 OK 530.487 192308 903.181 112074 OK P2943 734.121 29916 549.825 28470.2 OK 1914.14 37692 1850.16 35664.2 OK 2957.75 668601 1871.23 624873 OK P2944 209.436 9160 269.253 8122.22 OK 1389.34 62775.7 1601.96 25886.2 OK 814.254 376310 1122.01 172024 OK P2945 43.2947 2152 24.6 1415.47 OK 90.9606 1554 46.0648 1374.08 OK 31.3488 46456 16.1767 6664.32 OK P2946 691.291 22825 26.7139 22601 OK 2474.84 37561 55.3715 37385.8 OK 4081.08 899642 30.6485 867581 OK P2947 5.02912 48.2776 6.16366 18.0351 OK 13.3978 42 16.1276 21.1026 OK 24.7841 669 29.1132 437.889 OK P2948 0.00230519 1 0.00454289 0.00826672 OK 67.4544 151 41.9114 106.246 OK 0.00228718 1 0.00450719 0.0404103 OK P2949 12.3243 26.2426 0 26.2426 OK 83.2646 117.1 0 117.1 OK 186.689 3807.84 0 3807.84 OK P295 725.589 25339 292.217 24839 OK 3106.71 132571 2203.67 58803.4 OK 3057.18 809868 2140.79 697239 OK P2950 9.28183 1843 8.45647 369.169 OK 16.0034 325 13.8944 282.706 OK 4.67455 132470 3.62831 1472.78 OK P2951 470.353 20127 63.514 18707.5 OK 702.183 12797 128.867 12404.3 OK 1034.55 396113 169.078 325949 OK P2952 907.773 37090 70.8698 36105.2 OK 3771.33 66973 141.832 66621.9 OK 5985.31 1.9792e+06 172.482 1.88576e+06 OK P2953 12.9154 1619 19.843 473.665 OK 214.293 7243 361.48 6345.53 OK 99.4505 474399 185.804 67297.5 OK P2954 7.83894 1714 9.47521 287.489 OK 308.229 9812 432.67 9127.12 OK 173.868 465972 289.13 117655 OK P2955 45.0955 2801 48.7085 1653.85 OK 1609.9 49798 1441.6 47671.5 OK 2196.51 1.83206e+06 1645.65 1.48636e+06 OK P2956 9.9968 1781 17.7966 366.627 OK 527.427 17056 856.656 15617.9 OK 609.74 459693 999.927 412607 OK P2957 0 0 0 0 OK 0 0 0 0 OK 125.666 469225 207.271 85037.3 OK P2958 3.25714 2763 5.08592 119.454 OK 25.5145 936 34.6496 755.522 OK 94.7563 471632 141.497 64120.9 OK P2959 0.0501395 2 0.099851 1.83884 OK 1.11595 85279 2.19879 33.045 OK 2.96069 1.23468e+06 5.87145 2003.48 OK P296 194.986 7262.63 292.217 6674.92 OK 1758.36 132209 2203.67 33282.1 OK 1701.49 417033 2140.79 388052 OK P2960 0 0 0 0 OK 21.3517 953 28.8826 632.255 OK 6.08731 706236 9.62959 4119.24 OK P2961 0.837518 31 1.59594 30.7155 OK 13.1002 1046 20.2729 387.918 OK 55.1503 484694 91.364 37319.8 OK P2962 7.18757 7629 8.82441 263.6 OK 7.04693 1086 7.00118 208.67 OK 9.51839 580066 12.0077 6441.03 OK P2963 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2964 0 0 0 0 OK 53.1275 1865 97.005 1573.18 OK 12.7617 596435 24.3745 8635.77 OK P2965 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2966 0 0 0 0 OK 247.046 8091 385.184 7315.41 OK 301.494 461855 459.684 204019 OK P2967 6.55916 1977 10.589 240.554 OK 304.139 9843.41 426.596 9006.01 OK 263.123 462533 401.491 178053 OK P2968 20.2909 1446 21.9975 744.157 OK 317.277 12789.2 426.539 9395.05 OK 357.455 460600 470.435 241887 OK P2969 3.10043 2913 4.97466 113.706 OK 187.651 6241 237.981 5556.62 OK 27.188 517069 48.2347 18397.9 OK P297 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2970 9.78627 1773 16.7838 358.906 OK 0 0 0 0 OK 0 0 0 0 OK P2971 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2972 22.7995 1440 26.6602 836.159 OK 271.704 8975 411.197 8045.57 OK 363.85 460930 535.391 246215 OK P2973 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P2974 49.6904 2738 38.8805 1822.37 OK 363.563 11280 235.792 10765.6 OK 461.525 458705 342.301 312311 OK P2975 75.9165 4028 38.5349 2784.2 OK 267.187 8707 185.284 7911.82 OK 191.036 461642 176.024 129273 OK P2976 118.874 5505 150.445 4359.64 OK 1177.49 37111 1431.5 34867.2 OK 1185.88 917421 1512.47 802478 OK P2977 18.3622 1387 10.3138 673.423 OK 83.6889 2614 51.138 2478.15 OK 45.8808 469528 28.3265 31047.2 OK P2978 21.0024 1453 24.8328 770.252 OK 136.028 4441 153.586 4027.99 OK 325.103 460013 321.259 219995 OK P2979 253.324 9216.83 173.99 9290.53 OK 2233.64 56336.1 1521.44 66141.5 OK 2511.62 1.97645e+06 1617.26 1.69959e+06 OK P298 0 0 0 0 OK 2.85685 33 3.61188 8.81909 OK 0 0 0 0 OK P2980 17.0067 1437 14.4523 623.711 OK 33.4626 1835 31.724 990.878 OK 14.2321 511775 12.0555 9630.78 OK P2981 29.7458 1476 28.5239 787.679 OK 279.266 4663 295.189 4150.23 OK 46.9284 20550 69.6007 6548.82 OK P2982 67.1219 2187 93.7061 1777.41 OK 337.684 12804.2 485.18 5018.39 OK 8.33846 26989 13.4197 1163.63 OK P2983 11.9599 867 20.3772 316.702 OK 40.2219 723 72.4004 597.746 OK 4.5397 36407 8.23207 633.513 OK P2984 464.766 12373.5 131.937 12307.2 OK 2712.28 43865.3 781.141 40307.7 OK 3144.25 424579 90.4185 438778 OK P2985 5209.13 383659 28.6925 382851 OK 15148.7 586836 24.0322 579554 OK 42373.8 1.70165e+08 47.6072 1.59588e+08 OK P2986 15.397 6624 28.6925 1131.62 OK 13.5838 1797 24.0322 519.687 OK 26.1358 1.61651e+07 47.6072 98432.2 OK P2987 7.56834 72 10.8489 32.5932 OK 65.6798 307 89.6659 206.88 OK 15.4833 50 0 49.766 OK P2988 30.5683 157 10.8489 131.643 OK 211.212 763 89.6659 665.284 OK 0 0 0 0 OK P2989 0 0 0 0 OK 7.00036 15.4118 8.88178e-16 7.00036 OK 0 0 0 0 OK P299 0 0 0 0 OK 22.7434 103 27.0151 70.2088 OK 0 0 0 0 OK P2990 0.521883 1 0 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK P2991 0.43318 1 0.492327 0.43318 OK 0 0 0 0 OK 0 0 0 0 OK P2992 1.0923 2 0.492327 1.0923 OK 4.50533 5 0 4.50533 OK 0 0 0 0 OK P2993 5.87104 655 4.41275 137.103 OK 38.4374 743 29.1573 602.843 OK 24.8876 8539 10.5313 2274.36 OK P2994 6.02928 678 5.44401 140.799 OK 57.3085 1011 67.6298 898.812 OK 141.074 16873 143.152 12892.1 OK P2995 85.2588 2106 12.9511 1991.01 OK 1027.8 16173 51.3213 16119.8 OK 1206.74 115777 116.603 110279 OK P2996 4.22342 50 1.19132 30.308 OK 9.73597 134 6.36221 111.093 OK 22.0155 1291 11.3343 784.376 OK P2997 19.5172 189 5.73978 140.059 OK 42.1662 689 50.9807 481.141 OK 64.0052 2530 35.536 2280.4 OK P2998 0.888912 7 0.714721 6.37899 OK 3.60629 220 4.97669 41.1497 OK 0 0 0 0 OK P2999 3.43098 81 4.35339 24.6213 OK 103.977 1249 54.5936 1186.44 OK 24.256 1355 29.4562 864.199 OK P3 334.249 19494.6 189.715 8144.19 OK 2495.5 30227.2 0.111192 30870.4 OK 82.985 1677.66 50.3921 1363.51 OK P30 67.0352 3264 57.5628 2191.64 OK 511.443 8283 372.05 7726.04 OK 248.121 91319 311.139 52747.1 OK P300 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3000 0 0 0 0 OK 19.0416 525 33.4392 283.815 OK 38.697 342548 68.2042 21701.3 OK P3001 219.978 8486 53.0116 8352.6 OK 882.719 13536 262.918 13156.9 OK 1407.26 942589 407.728 789195 OK P3002 177.998 2342 0 2341.89 OK 948.601 6446 0 6445.66 OK 1062.64 63378 0 63377.8 OK P3003 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3004 2.97061 2.97061 0 2.97061 OK 3.50528 3.50528 0 3.50528 OK 0 0 0 0 OK P3005 1.04769 25 0.087877 24.5211 OK 37.0717 532 8.09863 440.517 OK 7.93134 15880 1.43979 981.461 OK P3006 0 0 0 0 OK 0 0 0 0 OK 3.51534 5.28145 0 5.28145 OK P3007 181.51 4964 123.339 4279.95 OK 281.228 3209 427.023 2713.72 OK 503.729 29221 387.873 28742.4 OK P3008 131.016 3349 123.339 3089.32 OK 1377.62 13788 427.023 13293.3 OK 403.94 31856.7 387.873 23048.5 OK P3009 112.714 1933 59.1645 1674.25 OK 515.034 4813 375.516 4390.19 OK 524.703 26413 199.523 25866.2 OK P301 2.65242 573 1.83447 52.4783 OK 24.2746 112 28.7596 74.9355 OK 0.594944 48 0 47.249 OK P3010 47.8546 1062.22 54.0048 710.83 OK 403.103 3836 358.896 3436.09 OK 159.317 16599.8 187.664 7853.81 OK P3011 52.7556 838 10.6376 783.63 OK 442.191 3861 75.0196 3769.27 OK 89.3345 4797 19.6573 4403.91 OK P3012 514.963 12901 0 12900.1 OK 2785 37200 56.6726 37122.7 OK 1213.21 83504 135.806 80964.7 OK P3013 886.334 28798.7 0 28798.7 OK 3538.15 54073.2 0 54073.2 OK 2996.18 391842 0 391842 OK P3014 93.6102 2937 107.559 2239.75 OK 112.907 1237.06 160.212 754.316 OK 309.534 55605 424.342 31604.5 OK P3015 39.2472 1233 65.4649 939.041 OK 198.729 1626 287.4 1327.69 OK 461.546 52589 676.3 47125.4 OK P3016 289.968 5551 17.1466 5377.5 OK 848.199 5531 32.2972 5493.48 OK 1494.12 114059 9.83336 110858 OK P3017 21.4962 284 7.11415 214.521 OK 146.3 1044 54.791 976.717 OK 31.6717 1319 17.9299 1146.38 OK P3018 75.9013 838 24.6824 757.455 OK 723.948 4967 114.019 4833.17 OK 411.052 15330 36.7019 14878.3 OK P3019 26.967 173 17.7061 129.735 OK 140.322 424 68.3923 352.81 OK 5.0034 62 6.39921 23.7203 OK P302 0.472119 10 0.679166 9.34089 OK 3.99187 24 4.66265 12.3229 OK 0 0 0 0 OK P3020 0 0 0 0 OK 21.3875 102 34.008 53.7744 OK 13.7639 87 10.0446 65.2525 OK P3021 1751.14 81414 284.449 80744.4 OK 8717.87 253909 262.782 235584 OK 12276 1.14287e+07 5777.57 1.10945e+07 OK P3022 163.554 12719.8 284.449 7541.39 OK 146.651 17966.3 262.782 3962.97 OK 3832.24 4.08896e+06 5777.57 3.4634e+06 OK P3023 2368.56 136588 756.148 132765 OK 5918.29 136405 1170.52 135197 OK 9269.09 5.03345e+06 1991.39 4.77436e+06 OK P3024 477.595 28678 756.148 26770.6 OK 695.051 17190 1170.52 15877.7 OK 1178.57 798935 1991.06 607062 OK P3025 38.3444 489 6.87781 393.777 OK 254.26 1532 37.9765 1469.52 OK 567.742 54120 88.3439 50151.1 OK P3026 83.653 962 6.87781 859.072 OK 472.416 2774 37.9765 2730.38 OK 1088.36 100394 88.3439 96139.7 OK P3027 90.7557 2557.34 117.69 2243.14 OK 1263.22 25725 1712.87 23850.6 FAIL 98.9358 89948 191.952 29157.9 FAIL P3028 0 0 0 0 OK 0 0 0 0 FAIL 42.0223 94296 78.9541 12384.6 FAIL P3029 213.669 6162 221.2 5281.1 OK 1238.18 25425 1728.77 23377.9 FAIL 703.138 601575 1176.53 207225 FAIL P303 5.84526 501 5.92521 115.649 OK 10.9416 63 13.786 33.7768 OK 0 0 0 0 OK P3030 75.8548 2563 110.94 1874.85 OK 143.701 3372 238.468 2713.19 FAIL 137.715 88566 220.161 40586.6 FAIL P3031 122.501 3799 178.211 3027.76 OK 1775.09 35935 2121.13 33515.2 FAIL 2848.54 868233 2232.54 839507 FAIL P3032 9.99577 14.1364 0 13.1442 OK 28.0321 29 0 28.0321 OK 4.99901 9 0 8.96205 OK P3033 0 0 0 0 OK 2.47463 3 0 2.47463 OK 0.4172 1 0 0.747942 OK P3034 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3035 0.0103079 1 0.0204769 0.147549 OK 254.545 3647.25 413.636 2846.28 OK 72.3805 2327 100.272 1981.38 OK P3036 0 0 0 0 OK 47.7861 2150.06 91.2102 534.336 OK 0 0 0 0 OK P3037 0 0 0 0 OK 31.5888 572 54.5716 353.221 OK 14.838 879 24.2073 406.183 OK P3038 30.1906 678 44.4761 432.152 OK 0 0 0 0 OK 0 0 0 0 OK P3039 17.2687 445 17.3417 247.186 OK 113.729 1518 120.516 1271.7 OK 14.7919 842 18.5048 404.921 OK P304 10.2113 413 5.92521 202.032 OK 108.494 350 13.786 334.921 OK 3.03643 242 0 241.146 OK P3040 6.67825 219 3.46529 95.5933 OK 85.2155 1092 52.0275 952.864 OK 7.01167 819 3.35391 191.941 OK P3041 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3042 0 0 0 0 OK 0.667478 8 1.32954 7.46362 OK 5.22064 1000 5.17856 142.912 OK P3043 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3044 0 0 0 0 OK 16.7348 357.091 29.0468 187.125 OK 0 0 0 0 OK P3045 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3046 13.7474 416 6.09458 196.783 OK 253.899 2989 135.663 2839.05 OK 7.19458 935 7.63046 196.948 OK P3047 26.8022 798.366 43.9187 383.65 OK 301.698 3916 471.372 3373.53 OK 0 0 0 0 OK P3048 4.14314 371 7.1487 59.3054 OK 202.253 2602 304.541 2261.56 OK 10.8193 940 17.6709 296.172 OK P3049 18.5213 728.776 25.8876 265.116 OK 134.736 1829 194.986 1506.6 OK 5.27916 1157 7.95901 144.514 OK P305 573.342 27463.3 718.467 25185.2 OK 1933.31 38714 2217.62 36338.9 OK 5448.72 6.55079e+06 6542.85 4.59591e+06 OK P3050 80.5398 1680.31 79.4226 1152.86 OK 588.757 6406.16 710.969 6583.37 OK 136.751 4521 118.592 3743.48 OK P3051 553.019 14392 0 14391.8 OK 535.65 2587.66 0 2564.78 OK 825.178 43037 10.2185 41927.8 OK P3052 0 0 0 0 OK 710.515 7619 722.054 6832.92 OK 1403.73 839472 1490.17 213510 OK P3053 277.99 10499.7 155.917 6591.53 OK 407.023 4444 441.759 3914.28 OK 409.48 69778 507.483 62282.4 OK P3054 183.059 9597.53 155.917 4340.6 OK 532.232 5776 622.867 5118.4 OK 1707.87 746455 1468.49 259769 OK P3055 936.611 32346 43.5977 32283.3 OK 4420.63 82462 276.528 81914.3 OK 4489.5 1.05855e+06 318.536 1.03493e+06 OK P3056 14.5196 1444 26.6021 500.465 OK 90.2966 2212 165.273 1673.2 OK 75.8599 55500 141.285 17487.4 OK P3057 6.18289 1878 11.3271 213.113 OK 39.0147 1152 72.3326 722.944 OK 74.9524 55557 140.982 17278.2 OK P3058 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3059 0.00794891 1 0.0155155 0.21858 OK 0 0 0 0 OK 0 0 0 0 OK P306 594.196 43052.6 735.996 26101.2 OK 2082.16 65319.8 2270.95 39136.7 OK 5322.26 7.82623e+06 6524.21 4.48924e+06 OK P3060 0.473762 14 0.0155155 13.0276 OK 0.495301 3 0 2.58687 OK 0 0 0 0 OK P3061 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3062 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 2.02429 2.02429 0 2.02429 OK P3063 112.488 4538 137.209 3749.34 OK 44.8931 491.57 48.3751 397.569 OK 120.499 71051 101.978 31957.2 OK P3064 782.952 27093 137.209 26096.7 OK 1388.68 12363 48.3751 12298 OK 5682.94 1.54164e+06 101.978 1.50715e+06 OK P3065 3.56552 1741 6.04179 104.39 OK 2098.11 54999 2820.95 51830.3 OK 8941.35 5.28271e+06 2614.9 5.14078e+06 OK P3066 0 0 0 0 OK 0 0 0 0 OK 98.6868 341626 171.982 56739.4 OK P3067 89.9347 3510 100.145 2633.07 OK 10.3127 711 11.5072 254.758 OK 13.3577 386938 15.3184 7679.96 OK P3068 606.526 18524.7 106.186 17757.6 OK 5545.24 146548 2832.46 136986 OK 1883.11 5.47392e+06 2586.61 1.08268e+06 OK P3069 3.4925 103 0 102.252 OK 0 0 0 0 OK 0 0 0 0 OK P307 502.377 45955.7 664.163 22067.9 OK 944.839 57768.8 1422.63 17759.4 OK 4478.43 4.27242e+06 5848.06 3.77748e+06 OK P3070 5.29683 22115 8.66264 614.444 OK 11.4897 20708 19.9859 1451.91 OK 0 0 0 0 OK P3071 13130.4 1.53755e+06 2564.15 1.52316e+06 OK 51684.2 1.00465e+07 40244.5 6.53114e+06 OK 47140 1.89738e+08 44747.9 1.8009e+08 OK P3072 0 0 0 0 OK 15340.5 5.37901e+06 25101.4 1.93852e+06 OK 18009.1 7.29945e+07 28781.2 6.88009e+07 OK P3073 0 0 0 0 OK 90.5971 70784.3 169.89 11448.4 OK 0 0 0 0 OK P3074 5.87927 22149 10.7094 682.009 OK 5.99165 26128 10.9558 757.143 OK 0 0 0 0 OK P3075 1152.37 155989 2076.64 133677 OK 16983.3 4.96764e+06 25822 2.14611e+06 OK 26392.2 1.02179e+08 34969.7 1.00827e+08 OK P3076 0 0 0 0 OK 1460.5 2.26845e+06 2867.47 184558 OK 878.669 1.46569e+07 1739.27 3.35681e+06 OK P3077 383.82 54349 549.072 44524 OK 469.299 64337 678.332 59303.5 OK 325.524 1.47206e+07 470.43 1.24361e+06 OK P3078 0 0 0 0 OK 0.505127 0.505127 0 0.505127 OK 0.8344 0.8344 0 0.8344 OK P3079 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P308 22.3971 2205 42.8368 983.836 OK 0 0 0 0 OK 150.583 728851 291.116 127014 OK P3080 0 0 0 0 OK 5.48466 6 0.000632743 5.48466 OK 0 0 0 0 OK P3081 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3082 0.71795 1 0.232527 0.71795 OK 0 0 0 0 OK 2.57164 2339 3.3547 85.2022 OK P3083 0 0 0 0 OK 0.000328935 1 0.000632743 0.000328935 OK 11.1897 1398 19.4752 370.732 OK P3084 3.29643 5 0.232527 3.29643 OK 0 0 0 0 OK 216.032 13021.9 22.7849 7157.45 OK P3085 8.8589 28 1.99213 21.6821 OK 12.0115 16 1.72442 13.5866 OK 2.41781 27 0.304223 26.2707 OK P3086 1.8064 5 0.535822 4.42115 OK 4.57288 6 1.11527 5.17253 OK 3.34738 37 0.963326 36.3709 OK P3087 3.62848 17 2.33579 8.88066 OK 5.91706 11 4.3798 6.69297 OK 20.3272 372 17.2375 220.865 OK P3088 5.37675 20 3.01834 13.1595 OK 41.9764 55 6.56798 47.4808 OK 48.389 559 17.8643 525.77 OK P3089 148.894 1762.49 0 1762.49 OK 851.217 5456.86 0 5456.86 OK 224.353 5239.76 0 5239.76 OK P309 213.793 5806 215.562 5135.77 OK 1049.83 7819 57.7335 7743.73 OK 5562.06 1.51114e+06 680.356 1.46014e+06 OK P3090 0 0 0 0 OK 1.01031 33 0 32.1292 OK 0 0 0 0 OK P3091 700.623 28755 373.127 28160.3 OK 5654.61 184036 3765.21 179824 OK 6901.99 8.60558e+06 8681.01 8.26406e+06 OK P3092 3.2571 3476 5.4269 130.914 OK 318.968 11487 577.788 10143.6 OK 1228.48 4.83701e+06 2091.13 1.47092e+06 OK P3093 275.665 13143 370.777 11079.9 OK 2759.25 91799 3567.76 87747.9 OK 112.446 1.48218e+06 219.656 134637 OK P3094 0 0 0 0 OK 0 0 0 0 OK 10874.2 1.43366e+07 9187.99 1.30202e+07 OK P3095 552.878 20004 2.84217e-14 14418.4 OK 1949.6 19306.5 1.13687e-13 20761.6 OK 1223.31 96823.6 1.13687e-13 78394.8 OK P3096 0 0 0 0 OK 0 0 0 0 OK 5.27717 6230 8.83853 324.149 OK P3097 165.652 2576.17 5.49225 2133.38 OK 270.246 1059.64 2.66159 846.412 OK 1123.47 68433.7 15.5171 69009.2 OK P3098 6.80602 188 5.49225 87.6525 OK 4.3242 29 2.66159 13.5434 OK 7.02481 4732 6.741 431.498 OK P3099 396.323 12912 250.455 12098.8 OK 921.111 23755.1 745.531 11737.2 OK 876.103 248532 690.12 87988.3 OK P31 0.963422 0.963422 0 0.963422 OK 19.4653 19.4653 0 19.4653 OK 0 0 0 0 OK P310 227.271 5774 215.562 5459.53 OK 0 0 0 0 OK 0 0 0 0 OK P3100 372.752 12005 250.455 11379.2 OK 1696.69 31937.2 745.531 21619.9 OK 1352.77 287042 690.12 135860 OK P3101 1.79371 44 1.42394 9.18105 OK 3.11032 25 2.21196 14.4069 OK 0 0 0 0 OK P3102 11.3528 80 9.57204 58.1088 OK 161.328 907 142.276 747.263 OK 16.0564 93 6.74953 73.7233 OK P3103 2.12215 106 3.86815 10.8621 OK 170.115 964 167.049 787.963 OK 5.99978 58.8864 6.40174 27.5481 OK P3104 27.9265 162 11.1584 142.94 OK 174.963 959 126.866 810.422 OK 2.35865 30 2.03346 10.8298 OK P3105 1.44439 2 0.00144115 1.44439 OK 0 0 0 0 OK 0.00370839 1 0.00728655 0.00370839 OK P3106 0 0 0 0 OK 0.00213681 1 0.00420887 0.00213681 OK 0.591235 1 0.00728655 0.591235 OK P3107 0.000739743 1 0.00144115 0.000739743 OK 9.93718 10.2157 0.00420887 9.93718 OK 0 0 0 0 OK P3108 64.0257 445 0.0787621 444.993 OK 109.557 210 1.32763 206.34 OK 29.2361 155 0 154.83 OK P3109 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P311 0 0 0 0 OK 32.2826 380 57.7335 238.121 OK 157.433 70264 291.611 41329 OK P3110 0 0 0 0 OK 0.574893 2 0.137086 1.08275 OK 0 0 0 0 OK P3111 5.6233 40 0.0787621 39.0832 OK 23.8338 47 1.2445 44.8884 OK 0 0 0 0 OK P3112 454.286 19685.3 292.992 13867.7 OK 5187.24 104723 537.386 103959 OK 7339.82 3.38122e+06 2407.94 3.37652e+06 OK P3113 314.827 10255 292.992 9610.53 OK 295.597 6714 537.386 5924.17 OK 1660.33 848345 2407.94 763799 OK P3114 0 0 0 0 OK 12.2018 310 23.3093 193.957 OK 17.1112 31672 32.869 2758.77 OK P3115 94.2818 5385 107.337 3950.82 OK 179.726 3329 199.842 2856.88 OK 71.7589 26618 78.6489 11569.4 OK P3116 1454.13 61820 107.337 60934.3 OK 3570.32 57051 221.75 56752.8 OK 3619.72 594265 110.756 583591 OK P3117 2045.4 100768 132.071 99976.3 OK 8147.42 218665 929.174 217639 OK 4699.1 1.10827e+06 886.862 1.08139e+06 OK P3118 93.8168 4888 132.071 4585.64 OK 553.953 16125 929.174 14797.5 OK 566.052 159929 886.862 130264 OK P3119 169.704 3730 1.93775 3362.14 OK 2150.54 33092 22.5988 32918.3 OK 84.3335 4654 0.228805 4653.49 OK P312 14.7839 425 16.8329 291.595 OK 149.569 2871 204.325 2497.84 OK 95.9739 5196 119.715 4848.8 OK P3120 0 0 0 0 OK 10.2158 781.084 17.3596 156.373 OK 0 0 0 0 OK P3121 1836.93 95192.3 -4.26326e-14 83365.3 OK 7192.85 176466 -2.27374e-13 170626 OK 2148.03 210899 0 215444 OK P3122 35.5968 893 62.4951 721.798 OK 482.051 4421 558.965 3851.09 OK 1595.64 312406 1617.62 241006 OK P3123 283.187 5936 64.5155 5742.2 OK 689.493 6245.71 560.335 5508.34 OK 1661.08 274007 1618.22 250891 OK P3124 0.963422 17 0 16.7331 OK 7.46469 80 0 79.4624 OK 10.246 1158 0 1157.46 OK P3125 167.837 2748.29 0 2748.29 OK 3.99001 3.99001 0 3.99001 OK 0 0 0 0 OK P3126 132.734 4996.21 166.902 3655.1 OK 243.475 2899 345.801 2432.53 OK 229.581 128055 324.303 31882.9 OK P3127 480.022 14079 166.902 13218.3 OK 1513.33 15532 345.801 15119.4 OK 2478.89 344992 324.303 344253 OK P3128 424.422 14095 331.516 13042.4 OK 522.728 4104 427.009 3645.43 OK 640.135 37450 355.388 35885.8 OK P3129 12.6539 1036 10.9509 388.853 OK 31.0617 290 24.9496 216.62 OK 1.1983 10681 1.20332 67.1766 OK P313 1.42205 1490 1.82542 28.0482 OK 7.79711 334 8.47253 130.214 OK 0 0 0 0 OK P3130 326.702 10388 309.42 10039.5 OK 421.253 3365 395.279 2937.76 OK 298.47 19026 353.381 16732.2 OK P3131 15.5768 1036 16.4899 478.672 OK 12.4683 164 13.4904 86.9525 OK 0 0 0 0 OK P3132 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3133 55.5587 324 0 323.913 OK 1891.46 19933 0 19932.8 OK 1375.98 102607 0 102606 OK P3134 0.120428 0.120428 0 0.120428 OK 0 0 0 0 OK 0 0 0 0 OK P3135 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3136 8.58428e-05 1 0.000159401 8.58428e-05 OK 0 0 0 0 OK 0 0 0 0 OK P3137 0.21677 1 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK P3138 0.216684 1 0.000159401 0.216684 OK 0 0 0 0 OK 0 0 0 0 OK P3139 7.66739 9.29871 0 9.29871 OK 240.308 693.118 0 693.118 OK 146.188 2496.11 0 2496.11 OK P314 47.9224 1188 43.5204 945.211 OK 79.2235 3561.68 130.3 1323.05 OK 7.99399 3517 12.673 403.873 OK P3140 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3141 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3142 0.160097 1 0.000913431 0.160097 OK 0 0 0 0 OK 0 0 0 0 OK P3143 0.000472956 1 0.000913431 0.000472956 OK 0 0 0 0 OK 0 0 0 0 OK P3144 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3145 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK P3146 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK P3147 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3148 4.9778 4.9778 0 4.9778 OK 15.0008 15.0008 0 15.0008 OK 0 0 0 0 OK P3149 0 0 0 0 OK 379.38 2771 353.205 2391.58 OK 183.922 8159 197.39 6743.88 OK P315 73.3883 1598 92.2149 1447.49 OK 2962.13 65723.8 1088.33 49468.3 OK 551.431 34898.4 231.975 27859.4 OK P3150 81.7187 1938 82.392 1596.2 OK 191.546 1493 235.634 1207.49 OK 64.4708 2792 95.6831 2363.96 OK P3151 129.156 2613 68.3266 2522.8 OK 145.121 1052 106.018 914.831 OK 91.86 4049 69.0064 3368.24 OK P3152 116.255 2684 105.043 2270.79 OK 89.2316 735 152.452 562.508 OK 114.766 5036.62 151.697 4208.13 OK P3153 0 0 0 0 OK 35.3163 567.257 60.3932 222.631 OK 13.1771 1650 22.7484 483.165 OK P3154 101.965 3593 0 3592.82 OK 248.768 1871 0.0151021 1870.79 OK 74.9987 6729 0.148077 6728.85 OK P3155 1176.82 43435.6 0 43435.6 OK 6129.63 133968 0 133968 OK 6380.34 1.97115e+06 0 1.97115e+06 OK P3156 4.68216 63 0.412613 62.1379 OK 15.6116 105 1.20089 99.4901 OK 1.3543 97 0.327498 96.0937 OK P3157 112.709 1709 61.616 1495.78 OK 710.165 4752 193.629 4525.78 OK 1239.81 89629 260.037 87970 OK P3158 0 0 0 0 OK 16.3402 207 30.0428 104.134 OK 10.729 6728 20.0984 761.273 OK P3159 37.9101 769 55.4393 503.113 OK 68.7895 580 119.648 438.385 OK 108.297 10410 192.421 7684.19 OK P316 161.762 3417 76.8116 3190.56 OK 637.685 22418.4 835.27 10649.5 OK 88.2041 11982.3 135.617 4456.25 OK P3160 0 0 0 0 OK 19.1115 198 36.3382 121.795 OK 0 0 0 0 OK P3161 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3162 7.2975 206 7.16494 96.8466 OK 13.1977 132 13.9239 84.1071 OK 14.4551 5865 19.0195 1025.66 OK P3163 0.029182 1 0.0580152 0.38728 OK 5.05473 63.964 7.25388 32.213 OK 20.0031 5605 26.0352 1419.31 OK P3164 4.85364 236 5.19391 64.4137 OK 8.73586 89 8.23026 55.6723 OK 22.4748 5450 24.9583 1594.69 OK P3165 13.9552 465 24.8655 276.104 OK 0 0 0 0 OK 39.0293 6827 73.8845 3099.61 OK P3166 9.03838 512 15.2604 178.825 OK 0 0 0 0 OK 62.6462 11295.4 115.911 4975.21 OK P3167 112.297 2338 91.3533 2221.81 OK 10.5517 47 4.4677 32.5732 OK 549.747 50802 668.61 43659.6 OK P3168 66.1961 1663.05 79.1616 1309.69 OK 8.34645 32 4.4677 25.7655 OK 765.483 108233 700.066 60792.8 OK P3169 0 0 0 0 OK 0 0 0 0 OK 141.803 45064.9 245.445 11261.7 OK P317 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3170 3.83413 447 1.52071 75.8586 OK 34.9605 114 3.20024 107.923 OK 50.7667 6251 4.78419 4031.77 OK P3171 2.20768 619 1.52071 43.6792 OK 3.42954 23 3.20024 10.587 OK 4.5953 9146 4.78419 364.948 OK P3172 13.3855 2053.66 23.5007 283.461 OK 3.32921 289 5.6248 39.5281 OK 0 0 0 0 OK P3173 366.052 8146 23.5007 7751.79 OK 2302.63 27375 5.6248 27339.4 OK 3001.55 447835 0 447834 OK P3174 12.8817 233 23.2341 180.792 OK 631.131 9088 854.031 8177.03 OK 208.069 6417 94.1801 5603.28 OK P3175 0 0 0 0 OK 0 0 0 0 OK 59.3672 5412.26 82.1696 1598.76 OK P3176 184.224 2773 23.2341 2585.54 OK 2062.08 27664 854.031 26716.7 OK 19.887 794 27.5182 535.555 OK P3177 16.0977 32.2129 0 32.2129 OK 78.8205 104.945 0 104.945 OK 215.616 4838.83 0 4838.83 OK P3178 21.1607 1102 29.0307 466.224 OK 5.48041 104 6.90222 33.4002 OK 30.7307 5257 40.3374 2154.86 OK P3179 338.451 7951 61.8464 7456.93 OK 764.698 4738 48.7684 4660.44 OK 1282.23 92267 161.192 89910.5 OK P318 6.99478 37 6.73337 20.8776 OK 0.000155301 1 0.000295258 0.000155301 OK 1.17908e-05 1 1.97244e-05 1.17908e-05 OK P3180 13.2914 765.527 21.8627 292.844 OK 25.9048 257 41.4174 157.876 OK 76.4537 24687.5 125.275 5360.98 OK P3181 31.1584 965 13.7187 686.499 OK 2.96814 19 0.922302 18.0893 OK 0 0 0 0 OK P3182 0.957894 43 0 42.0774 OK 0 0 0 0 OK 0 0 0 0 OK P3183 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3184 0 0 0 0 OK 31.0402 144 23.5483 113.38 OK 11.0828 197 7.44316 152.981 OK P3185 0 0 0 0 OK 170.517 2696.62 178.432 1198.36 OK 628.525 106395 741.206 102347 OK P3186 36.0288 1627.21 50.5291 942.842 OK 39.4934 387 67.8122 277.553 OK 264.366 53657 422.941 43048.4 OK P3187 2.25002 2244 4.09386 58.8812 OK 4.60949 81 8.44737 32.3946 OK 4.1616 51354 7.35208 677.66 OK P3188 258.816 7336 72.677 6772.98 OK 476.395 3634 235.985 3348.02 OK 2088.22 343584 911.859 340038 OK P3189 0 0 0 0 OK 3.71652 5 0.366626 3.71652 OK 0 0 0 0 OK P319 4.23664 33 4.45887 12.6453 OK 5.91357 11 4.17494 5.91357 OK 0 0 0 0 OK P3190 1.56565 2 0 1.56565 OK 21.7389 23 0.366626 21.7389 OK 0 0 0 0 OK P3191 3.3144 757 4.99532 65.3725 OK 14.6653 311 20.552 244.914 OK 5.81345 3111 4.10921 293.707 OK P3192 23.4616 758 4.99532 462.752 OK 162.545 2910 20.552 2714.55 OK 5.35099 3225 4.10921 270.343 OK P3193 621.551 19525.4 193.455 18664.3 OK 3946.93 118390 1214 72262.7 OK 1579.71 199480 500.27 176185 OK P3194 120.026 4699 193.455 3604.21 OK 803.693 59566.7 1214 14714.5 OK 326.594 54928 500.27 36425.1 OK P3195 15.7486 583 15.0355 367.364 OK 28.6217 688 37.1587 513.898 OK 0 0 0 0 OK P3196 6.40198 832 11.6441 149.338 OK 46.3295 20886.1 84.8832 831.839 OK 73.7189 5999 134.78 5611.57 OK P3197 0 0 0 0 OK 21.7148 704 25.4767 389.886 OK 35.7681 5920 22.7894 2722.71 OK P3198 197.255 6846.72 209.672 4601.33 OK 2190.51 61540.5 2148.49 39330.3 OK 582.691 46561 679.855 44355.2 OK P3199 198.057 4929 210.277 4620.03 OK 1917.4 36866 2108.15 34426.6 OK 674.606 64714 713.911 51351.9 OK P32 4.77123 410 8.27839 74.5033 OK 123.152 7347.16 201.052 1020.07 OK 50.2538 3403 90.8214 2858.04 OK P320 5.26799 32 6.5225 15.7236 OK 0.745322 3 1.35831 0.745322 OK 0 0 0 0 OK P3200 28.854 2000.8 45.1316 673.072 OK 406.175 7920 586.656 7292.8 OK 206.565 17567 259.451 15724 OK P3201 622.652 17272.2 0 17272.2 OK 1579.1 14771.3 0 14771.3 OK 4419.26 843537 0 843537 OK P3202 3.63178 33 3.33234 18.9702 OK 5.36867 48 9.23112 17.2341 OK 0 0 0 0 OK P3203 43.8184 247 3.33234 228.88 OK 279.554 911 9.23112 897.406 OK 6.34268e-05 1 0.000116247 0.000101784 OK P3204 0 0 0 0 OK 0 0 0 0 OK 2.92034 5 0.000116247 4.6864 OK P3205 5270.78 462599 -4.54747e-13 398570 OK 22169.8 1.21597e+06 9.09495e-13 1.09832e+06 OK 3430.99 540643 2.27374e-13 534066 OK P3206 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK P3207 229.768 5265.44 144.323 4552.54 OK 1467.45 18461.8 943.822 16736.4 OK 1120.35 82963 521.12 80956.7 OK P3208 108.685 2419 144.323 2153.44 OK 712.623 9161 943.822 8127.52 OK 344.324 26417 521.12 24881 OK P3209 238.616 3881.51 0 3881.51 OK 540.696 2585.27 0 2585.27 OK 1481.34 112518 0 112518 OK P321 0 0 0 0 OK 4.78545 9 4.14697 4.78545 OK 0.834388 1 1.97244e-05 0.834388 OK P3210 6.7 6448 9.23039 454.495 OK 1499 95947.3 2317.83 64410.2 OK 691.965 967722 1167.81 444735 OK P3211 38.5603 4842 51.0804 2615.75 OK 1962.5 134043 2735.12 84326.1 OK 1339.59 1.24242e+06 1853.21 860974 OK P3212 259.091 33730.2 415.914 17575.4 OK 28.0066 1979 38.7843 1203.41 OK 33.8979 449202 51.1857 21786.6 OK P3213 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3214 0 0 0 0 OK 483.67 43857.4 887.524 20782.7 OK 0 0 0 0 OK P3215 47.3242 4845 77.7555 3210.24 OK 604.06 28119 922.113 25955.7 OK 434.84 415301 657.371 279477 OK P3216 0 0 0 0 OK 66.8244 4975.69 128.14 2871.37 OK 52.132 443062 100.905 33505.9 OK P3217 1.63902 15436 2.22861 111.183 OK 232.877 14180.9 442.688 10006.4 OK 597.004 557377 989.844 383702 OK P3218 4.61433 7289 6.12483 313.014 OK 40.113 1974 77.3318 1723.61 OK 148.362 421908 253.044 95354.1 OK P3219 4046.88 278853 584.9 274520 OK 12850.8 557979 4314.03 552185 OK 9036.84 6.19015e+06 2968.96 5.8081e+06 OK P322 10.7182 21.9841 0 21.9841 OK 40.8185 42.6001 0 42.6001 OK 0.8344 0.8344 0 0.8344 OK P3220 48.5237 4621 22.869 3291.61 OK 16.9441 2010 16.6999 728.069 OK 14.4389 471244 14.8141 9280.09 OK P3221 69.9383 3375.46 118.272 1837.19 OK 486.461 8242.05 773.646 6192.76 OK 864.324 972511 1522.7 329517 OK P3222 429.656 12150 169.996 11286.5 OK 1958.85 25883 938.443 24936.7 OK 7145.22 3.37173e+06 1910.99 2.72406e+06 OK P3223 0 0 0 0 OK 118.092 6046.67 218.693 1503.34 OK 200.919 147719 384.478 76598.7 OK P3224 19.3685 3196.78 36.2796 508.788 OK 16.7341 396 31.6265 213.029 OK 52.54 155533 100.731 20030.5 OK P3225 7.4865 9 0.000545388 8.03299 OK 26.5422 27 0 26.5422 OK 19.2924 75.9899 0 73.4272 OK P3226 0.000284146 1 0.000545388 0.000304888 OK 0 0 0 0 OK 0 0 0 0 OK P3227 7.08542 7.95273 0 7.95273 OK 19.4755 19.4755 0 19.4755 OK 13.8725 41.5589 0 41.5589 OK P3228 7.74884 195 5.961 102.902 OK 2.07709 79 2.14692 13.3889 OK 2.41262 38757 2.44291 342.554 OK P3229 166.677 2290 5.961 2213.4 OK 870.749 5619 2.14692 5612.84 OK 3075.69 684723 311.788 436701 OK P323 3.53267 4 0 3.53267 OK 6.94576 10 2.12664 6.94576 OK 0 0 0 0 OK P3230 0 0 0 0 OK 0 0 0 0 OK 165.711 379190 309.551 23528.3 OK P3231 1416.11 87859.1 996.706 70336.2 OK 7971.07 205134 223.221 204794 OK 23967 4.0244e+07 355.785 3.80224e+07 OK P3232 13.5297 2845 16.2951 672 OK 16.4525 730 20.7183 422.699 OK 138.501 2.56384e+06 185.477 219725 OK P3233 33.9246 4178.25 49.2081 1684.99 OK 141.005 4069 203.471 3622.72 OK 115.713 2.57991e+06 172.241 183572 OK P3234 752.195 39791 977.815 37360.6 OK 0 0 0 0 OK 0 0 0 0 OK P3235 5.26007 100 9.45756 42.5737 OK 0 0 0 0 OK 65.2273 26257.9 121.909 4509.66 OK P3236 10.2576 145 9.79543 83.0228 OK 15.066 56 14.803 36.2983 OK 42.497 4923 41.104 2938.14 OK P3237 2.1686 242 4.00141 17.5521 OK 0 0 0 0 OK 15.4135 5678 24.382 1065.65 OK P3238 0 0 0 0 OK 3.07268 54 6.01281 7.40294 OK 0 0 0 0 OK P3239 2.36709 160 3.53301 19.1586 OK 0 0 0 0 OK 132.704 9761 214.103 9174.81 OK P324 0 0 0 0 OK 2.03431 5 2.12664 2.03431 OK 0 0 0 0 OK P3240 55.9397 485 21.6649 452.762 OK 168.647 428 20.1406 406.317 OK 1117.17 85822 354.778 77238.7 OK P3241 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK P3242 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3243 41.1079 371.868 0 236.164 OK 29.4556 31 -3.4792e-16 29.4556 OK 8.80812 25.4984 2.16515e-16 23.3156 OK P3244 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3245 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3246 153.58 3741 95.2454 3342.21 OK 287.8 972 10.2311 954.864 OK 14595.1 1.66668e+07 4774.3 1.65305e+07 OK P3247 369.343 7702.97 0 7702.97 OK 853.157 5421.54 0 5421.54 OK 2956.3 383602 0 383602 OK P3248 3559.76 220318 54.1613 219290 OK 10304.7 307378 67.4736 307110 OK 21243.7 2.8887e+07 38.4886 2.77027e+07 OK P3249 4.72795 6842 8.47871 291.253 OK 0 0 0 0 OK 0 0 0 0 OK P325 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK P3250 23.0767 4273 38.7195 1421.58 OK 37.8616 2429.18 67.4736 1128.38 OK 20.7151 2.006e+06 38.4886 27013.4 OK P3251 4.06116 7378 7.14975 250.177 OK 0 0 0 0 OK 0 0 0 0 OK P3252 7.6785 241.725 13.8206 65.6095 OK 188.434 1283 255.988 1003.7 OK 0 0 0 0 OK P3253 80.0772 732 19.3872 684.226 OK 393.106 2375 273.478 2093.9 OK 92.4814 3762.53 61.5126 2286.27 OK P3254 0 0 0 0 OK 11.3606 108 19.9478 60.5129 OK 18.1121 696 31.0094 447.756 OK P3255 0 0 0 0 OK 6.20228 360.164 11.1477 33.0368 OK 6.95064 902 12.4706 171.83 OK P3256 4.69485 114 7.77231 40.1155 OK 17.9255 318.857 33.2355 95.4813 OK 105.122 3045 73.2759 2598.78 OK P3257 0 0 0 0 OK 62.0102 600 115.981 454.645 OK 271.796 31577.3 364.027 15247.5 OK P3258 26.2233 303 31.6345 221.271 OK 505.302 6639.83 478.703 3704.76 OK 272.461 27152.9 357.748 15284.7 OK P3259 703.646 39080.9 821.532 35977.7 OK 987.233 15821.9 842.913 13381.7 OK 4934.75 4.98716e+06 4970.36 2.79394e+06 OK P326 0 0 0 0 OK 18.5316 425 33.8043 247.975 OK 0 0 0 0 OK P3260 748.145 47790.6 855.063 38253 OK 1031.4 14353.5 993.07 13980.4 OK 4790.96 3.50168e+06 4865.77 2.71253e+06 OK P3261 574.7 31475 602.878 29384.7 OK 526.714 7707 544.622 7139.49 OK 583.66 658783 775.847 330454 OK P3262 53.8813 5626 95.7464 2754.98 OK 177.068 2868 260.565 2400.12 OK 227.367 325004 405.684 128730 OK P3263 62.2053 5309 46.6881 3180.59 OK 85.3648 1288 78.9434 1157.1 OK 181.369 324002 206.586 102687 OK P3264 65.9842 5443 91.0878 3373.8 OK 48.0513 759 56.9279 651.325 OK 475.629 321162 415.175 269290 OK P3265 78.2751 4778 115.654 3763.01 OK 79.3135 1538 125.083 1358.5 OK 81.5019 251823 128.853 40170.1 OK P3266 223.19 11715 298.836 10729.7 OK 0 0 0 0 OK 0 0 0 0 OK P3267 391.238 21112 571.1 18808.5 OK 973.909 18332 1426.72 16681.3 OK 1635.53 974403 2585.38 806109 OK P3268 209.587 14599.7 371.876 10075.7 OK 1697.13 33041.7 1963.76 29068.8 OK 2941.84 2.34913e+06 4058.76 1.44996e+06 OK P3269 9.65493 3163 18.1487 464.153 OK 0 0 0 0 OK 201.061 247097 389.686 99097.8 OK P327 267.146 6620 190.95 6307.61 OK 2079.15 28762 922.097 27821.5 OK 123.746 20881 231.089 12431.8 OK P3270 1146.44 57557 894.414 55114 OK 1479.8 27291 1845.3 25346.3 OK 3095.34 4.13764e+06 4186.74 1.52561e+06 OK P3271 33.5527 11521.7 64.705 1613.02 OK 33.8932 1009 65.136 580.529 OK 2095.47 2.37239e+06 3199.15 1.0328e+06 OK P3272 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3273 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3274 184.007 6295.73 203.857 4228.61 OK 146.827 2424 271.355 2018.76 OK 4175.3 1.35706e+07 6917.7 7.90349e+06 OK P3275 0 0 0 0 OK 32.3255 638 59.0002 444.452 OK 557.862 3.6046e+06 1015.43 1.05599e+06 OK P3276 25.629 1182 38.4015 588.971 OK 30.977 634 52.091 425.911 OK 151.231 3.6661e+06 271.063 286267 OK P3277 139.022 3792 182.287 3194.82 OK 2218.96 59174.8 1058.48 30509 OK 16550.5 5.49355e+07 12746.3 3.13287e+07 OK P3278 80.0172 3840.66 128.6 1838.85 OK 499.572 34890.1 809.703 6868.75 OK 5917.94 5.43899e+07 9069.44 1.12022e+07 OK P3279 0 0 0 0 OK 22.3933 436 42.413 307.892 OK 66.0677 3.79092e+06 127.741 125061 OK P328 51.1217 1793 80.8034 1207.04 OK 295.164 4528.01 482.282 3949.64 OK 70.4127 10510 129.527 7073.81 OK P3280 35.4863 305 35.1739 252.241 OK 226.332 2076.43 277.154 1159.71 OK 5.71289 10 0.00886678 9.18201 OK P3281 19.4145 231 27.673 138.001 OK 215.665 1406 271.627 1105.05 OK 0.0044839 1 0.00886678 0.00720673 OK P3282 14.5265 307.731 21.0644 103.256 OK 82.0085 645.704 129.069 420.206 OK 0 0 0 0 OK P3283 4.11591 83 6.78307 29.2564 OK 79.1442 1950.11 128.242 405.529 OK 0 0 0 0 OK P3284 173.717 8464 253.476 7064.97 OK 364.398 13929.3 526.861 5169.24 OK 325.486 245250 514.342 69135.7 OK P3285 17.3908 1956 32.2585 707.274 OK 7.4531 1092.47 13.8594 105.727 OK 0 0 0 0 OK P3286 32.1819 1646 10.5259 1308.82 OK 9.1006 205 4.16628 129.098 OK 2.52668 64627 1.35831 536.687 OK P3287 170.517 8293 139.161 6934.85 OK 183.055 2830 192.902 2596.77 OK 146.024 45703 190.277 31016.6 OK P3288 305.231 13238 272.111 12413.6 OK 106.293 1878 139.363 1507.85 OK 349.393 274664 390.432 74213.8 OK P3289 703.559 29616 529.417 28613.4 OK 2342.33 36425.8 933.889 33227.6 OK 3882.98 854520 1182.22 824775 OK P329 83.5249 2311 119.125 1972.11 OK 208.227 3162 318.464 2786.33 OK 29.9464 11157 52.4852 3008.48 OK P3290 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3291 52.3747 3549 93.0669 2130.05 OK 114.213 1935 208.479 1620.19 OK 155.788 45974 290.225 33090.6 OK P3292 592.801 18448 187.407 17769.9 OK 11184.9 406702 3952.4 402425 OK 45345.6 5.4146e+08 16504.9 4.48338e+08 OK P3293 92.4774 3784 157.2 2772.12 OK 1875.43 71272 3203.99 67476.9 OK 9394.88 9.77802e+07 15502.2 9.28886e+07 OK P3294 12.4948 1043 15.8386 374.545 OK 672.68 26311 1003.49 24202.6 OK 767.614 9.82001e+07 1369.32 7.58952e+06 OK P3295 9.06478 1174 14.2878 271.727 OK 0 0 0 0 OK 0 0 0 0 OK P3296 24.5676 73 0.000655155 72.1102 OK 293.072 989.27 0 966.596 OK 0.0171637 1 0.0339104 0.0249525 OK P3297 0.000340285 1 0.000655155 0.000998795 OK 0 0 0 0 OK 2.48604 4 0.0339104 3.61419 OK P3298 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK P3299 86.9303 8237.62 155.15 4851.55 OK 13.1371 307 21.1436 213.433 OK 0 0 0 0 OK P33 217.503 3433 8.27839 3396.33 OK 1178.59 10629.2 201.052 9762.29 OK 898.494 54127 90.8214 51099.3 OK P330 0 0 0 0 OK 0 0 0 0 OK 1153.45 120984 928.304 115878 OK P3300 2806.22 176326 155.15 156614 OK 3894.73 78915.2 21.1436 63276 OK 6450.78 2.26973e+06 0 1.93158e+06 OK P3301 246.079 4099.51 0 4099.51 OK 392.791 1565.31 0 1565.31 OK 0 0 0 0 OK P3302 163.525 10325 292.561 9475.18 OK 6.4308 1003 12.5095 162.152 OK 0 0 0 0 OK P3303 133.313 10440 247.079 7724.59 OK 541.49 15143 995.635 13653.6 OK 744.687 582849 1363.91 400910 OK P3304 42.1031 3580 76.14 2439.58 OK 213.456 5929 373.516 5382.29 OK 181.811 295199 337.913 97879.7 OK P3305 0.233016 14 0.465302 13.5017 OK 9.61431 860 18.5441 242.425 OK 0 0 0 0 OK P3306 919.695 57534 1230.06 53290 OK 3201.44 84883 3604.99 80724.2 OK 2962.91 4.34781e+06 4069.2 1.59512e+06 OK P3307 1650.37 97228 1490.22 95627.4 OK 3418.42 162552 3685.71 86195.3 OK 5552.67 3.18855e+06 5111.21 2.98934e+06 OK P3308 231.484 17232 404.039 13412.9 OK 511.89 61457.3 945.612 12907.3 OK 1276.26 2.28028e+06 2207.98 687089 OK P3309 11.3478 4263 18.6492 657.529 OK 5.07327 1082 9.12638 127.922 OK 0 0 0 0 OK P331 0 0 0 0 OK 0 0 0 0 OK 731.713 81110 881.197 73509.5 OK P3310 106.217 2147.31 2.85244 1417.1 OK 81.3763 123 0 122.182 OK 1396.85 131933 12.7885 103399 OK P3311 0 0 0 0 OK 0 0 0 0 OK 4.8928 3378 5.63193 235.636 OK P3312 14.053 181 14.012 129.265 OK 0 0 0 0 OK 69.0962 4783 85.5715 3327.66 OK P3313 0 0 0 0 OK 1.94462 3 0.845403 1.94462 OK 22.1901 2611 37.1586 1068.67 OK P3314 42.1899 475 14.012 388.077 OK 2.04538 3 0.845403 2.04538 OK 648.668 31938 126.421 31239.7 OK P3315 0 0 0 0 OK 3.23573 394 5.40835 44.3996 OK 0 0 0 0 OK P3316 0 0 0 0 OK 40.9593 854 79.1193 562.029 OK 0 0 0 0 OK P3317 297.243 7501 175.431 6934.39 OK 2350.93 37045.5 890.249 32258.6 OK 2015.31 247669 754.532 227197 OK P3318 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3319 53.8583 2093.55 88.7185 1256.46 OK 250.317 8627.08 437.353 3434.76 OK 208.887 25827 369.036 23549 OK P332 0 0 0 0 OK 5.43689 270 8.83299 72.7521 OK 8.33178 14131 13.995 837.028 OK P3320 56.2661 1736 91.0179 1312.63 OK 57.687 1038 111.781 791.561 OK 199.517 25852 349.682 22492.6 OK P3321 36.0089 171 0 170.375 OK 511.032 2376.24 0 2372.72 OK 255.821 7221 0 7220.07 OK P3322 164.097 8622.18 167.319 6162.85 OK 189.698 3377.88 189.661 3046.28 OK 381.827 33729 369.363 28572.3 OK P3323 1022.18 38616 167.319 38389 OK 3571.31 58226.3 189.661 57350.1 OK 1118.32 88834 369.363 83683.8 OK P3324 1.40441 654 1.7005 18.8268 OK 4.33971 63 7.20042 27.5993 OK 0 0 0 0 OK P3325 2.88735 229 1.57808 38.7062 OK 11.2106 125 7.82228 71.2965 OK 4.21282 4347 3.14322 240.27 OK P3326 38.0154 906.009 51.7169 509.614 OK 69.7933 748.396 111.304 443.866 OK 200.587 26948.1 275.144 11440.1 OK P3327 23.7278 538.928 29.4163 318.082 OK 90.0242 705 114.331 572.529 OK 91.1876 16629.9 117.638 5200.7 OK P3328 9.93607 345.764 15.8915 133.198 OK 25.3977 633.393 41.9927 161.522 OK 46.7033 3428 80.0447 2663.63 OK P3329 106.242 1739.86 73.3028 1424.23 OK 652.274 5171.76 236.455 4148.28 OK 601.608 47640.2 379.584 34311.5 OK P333 10.9447 590 6.49151 258.416 OK 98.9274 1423 86.3128 1323.77 OK 26.1736 10787 27.4182 2629.45 OK P3330 13.394 283 6.98116 158.092 OK 14.5462 81 4.93967 70.2026 OK 64.2936 9656 31.2638 6302.94 OK P3331 3.58129 166 1.95731 42.2706 OK 12.7962 84 5.47665 61.7566 OK 6.14363 11626 4.17611 602.283 OK P3332 6.28075 181.523 8.21784 74.1328 OK 26.5895 171 34.669 128.325 OK 0 0 0 0 OK P3333 108.778 1424 16.2714 1283.93 OK 436.126 2230 122.951 2104.81 OK 1955.42 200048 248.476 191697 OK P3334 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3335 0 0 0 0 OK 55.3895 380 87.3973 267.319 OK 119.005 19890 216.549 11666.6 OK P3336 162.703 2007 0 2006.23 OK 247.108 749 8.36998 737.231 OK 229.13 5826 1.61297 5388.04 OK P3337 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK P3338 122.396 7134 205.774 5875.4 OK 942.879 16151 941.222 15117.6 OK 1851.09 380563 880.444 361532 OK P3339 1198.5 58762 90.1333 57531.8 OK 2242.79 36845 677.165 35959.8 OK 2388.4 494076 607.218 466472 OK P334 45.361 1776 58.1454 1071.02 OK 120.908 1871 184.862 1617.89 OK 0 0 0 0 OK P3340 2.33812 8 2.1315 3.45718 OK 0 0 0 0 OK 0 0 0 0 OK P3341 1.85847 5 2.21318 2.74796 OK 2.18671 6 3.62681 2.18671 OK 0 0 0 0 OK P3342 0.876918 3 1.33493 1.29662 OK 8.87328 16 6.49258 8.87328 OK 0 0 0 0 OK P3343 0 0 0 0 OK 3.21741 8 4.12139 3.21741 OK 0 0 0 0 OK P3344 0.70703 2 0.397675 1.04542 OK 3.17762 5 1.342 3.17762 OK 0 0 0 0 OK P3345 0 0 0 0 OK 15.545 21 5.41364 15.545 OK 0.000618572 1 0.00120265 0.00130652 OK P3346 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P3347 0 0 0 0 OK 0 0 0 0 OK 7.85707 18.2218 0.00120265 16.5954 OK P3348 6.94482 8 0 7.70653 OK 3.92034 10 5.41364 3.92034 OK 0 0 0 0 OK P3349 147.542 1922 16.4363 1795.05 OK 205.432 1070 193.813 867.4 OK 0 0 0 0 OK P335 6.66397 8.52878 0 8.52878 OK 30.5271 30.5271 0 30.5271 OK 10.0054 23.5232 0 23.5232 OK P3350 0 0 0 0 OK 0 0 0 0 OK 0.00258505 1 0.00508834 0.00258505 OK P3351 2.88485 299 4.14256 35.0983 OK 66.6291 328 38.5506 281.33 OK 0 0 0 0 OK P3352 0 0 0 0 OK 58.7983 372 97.1202 248.266 OK 0.133063 1 0.181144 0.133063 OK P3353 7.13682 299.537 12.6873 86.8293 OK 110.74 641 152.251 467.582 OK 0.281552 1 0.18297 0.281552 OK P3354 5.45122 214 3.70378 74.256 OK 3.66226 30 1.22778 14.6888 OK 19.8535 1872 7.60156 853.097 OK P3355 3.12933 397 5.19856 42.6275 OK 28.7603 181 47.0892 115.354 OK 29.8119 2004 50.1883 1281 OK P3356 146.408 2093 25.3554 1994.36 OK 353.497 1502 75.3482 1417.83 OK 451.293 22675 197.161 19391.9 OK P3357 11.048 224.22 17.7267 150.495 OK 17.7244 115 31.8512 71.0903 OK 115.577 6035.44 161.771 4966.29 OK P3358 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P336 42.5442 215 2.69788 208.919 OK 748.514 6166.83 6.72838 4465.76 OK 0 0 0 0 OK P337 1.93503 69 2.69788 9.50224 OK 5.88741 2801 6.72838 35.1253 OK 0 0 0 0 OK P338 211.555 3434 0 3433.85 OK 1087.97 8475.12 66.977 8281.11 OK 0 0 0 0 OK P339 0 0 0 0 OK 34.9264 986.769 66.977 265.842 OK 2.5032 4 0 3.63915 OK P34 18.9347 54.4857 0 54.4857 OK 271.704 849.392 0 849.392 OK 49.2598 398.908 0 398.908 OK P340 1.44503 2 0.000187273 1.44503 OK 6.05116 7 0.000298989 6.05116 OK 0 0 0 0 OK P341 5.6546e-05 1 0.000105546 5.6546e-05 OK 0 0 0 0 OK 0 0 0 0 OK P342 4.39184e-05 1 8.17452e-05 4.39184e-05 OK 0.000157973 1 0.000298989 0.000157973 OK 0 0 0 0 OK P343 669.417 19138.8 0 19138.8 OK 2143.61 24185.8 0 24185.8 OK 2976.89 411506 0 411506 OK P344 74.0837 1135.42 55.444 791.902 OK 458.122 2887.02 172.084 2302.6 OK 617.615 37145.6 313.372 32093.2 OK P345 4.13961 199 6.93376 44.2495 OK 0.0483646 1 0.0963799 0.243089 OK 31.5149 2955 58.0915 1637.61 OK P346 51.7224 702 53.7021 552.876 OK 128.09 898.351 172.053 643.802 OK 207.188 15407.8 283.8 10766.1 OK P347 245.478 7674 4.6397 6921.11 OK 1586.74 17250 119.774 17078.5 OK 3513.78 6.75658e+06 503.659 5.27456e+06 OK P348 0 0 0 0 OK 3.27781 238 5.51527 35.2799 OK 5.7005 3.82011e+06 10.5607 8557.06 OK P349 0 0 0 0 OK 319.339 3601 126.483 3437.12 OK 14242.8 2.49387e+07 4944.76 2.13799e+07 OK P35 14.6749 546.077 18.2542 323.527 OK 338.226 10162.9 392.665 3539.8 OK 273.779 20216 300.766 19410.7 OK P350 352.266 9932 0 9931.95 OK 33.1976 512 52.0189 357.313 OK 2989.71 4.51069e+06 4659.94 4.48788e+06 OK P351 2.52907 2.52907 0 2.52907 OK 42.941 42.941 0 42.941 OK 0 0 0 0 OK P352 387.508 8290.68 0 8290.68 OK 1065.12 7793.15 0 7793.15 OK 477.077 17737.6 0 17737.6 OK P353 0 0 0 0 OK 1.51538 2 0 1.51538 OK 218.008 6388 4.76989 6267.29 OK P354 0.481641 1 0.000128528 0.481641 OK 0 0 0 0 OK 0 0 0 0 OK P355 0 0 0 0 OK 0.989851 0.989851 0 0.989851 OK 0 0 0 0 OK P356 14.2508 30.939 0 30.939 OK 53.4059 56.7037 0 56.7037 OK 1.18989 1.18989 0 1.18989 OK P357 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P358 2.32172 4 0.975847 2.32172 OK 28.7743 64 25.8475 36.5777 OK 0.00285822 1 0.00563405 0.0037126 OK P359 6.57819e-05 1 0.000120836 6.57819e-05 OK 0 0 0 0 OK 2.08314 3 0.00563405 2.70584 OK P36 56.1249 1496 60.9868 1237.35 OK 208.055 2298 112.535 2177.46 OK 65.7395 5061 46.1319 4660.87 OK P360 2.69618 4 0.975768 2.69618 OK 45.0559 83 23.9368 57.2746 OK 0 0 0 0 OK P361 1.96702 1.96702 0 1.96702 OK 103.623 163.729 0 163.729 OK 3.21417 4.18493 0 4.18493 OK P362 71.9411 561 5.35869 525.99 OK 110.565 203 7.901 194.041 OK 152.599 2838 0 2837.72 OK P363 0 0 0 0 OK 180.989 1648 267.022 1308.91 OK 1052.67 345126 1530.6 275956 OK P364 655.455 19724.7 0 19642.6 OK 864.816 6535 267.022 6254.33 OK 4717.66 1.30252e+06 1530.6 1.23673e+06 OK P365 6.8086 179 11.9297 77.0612 OK 61.5295 274 85.2242 178.148 OK 99.7204 18722 184.22 9442.92 OK P366 0 0 0 0 OK 6.88497 42 10.2783 19.9342 OK 48.7025 9502 84.7565 4611.83 OK P367 16.8687 300 28.3012 190.924 OK 11.9448 75 22.2295 34.584 OK 154.535 18362 279.531 14633.5 OK P368 117.298 1446 36.8519 1327.6 OK 164.072 578 97.8942 475.041 OK 1517.1 166503 483.911 143660 OK P369 877.454 29525 121.164 29396.1 OK 12239.9 439270 1229.61 421422 OK 133.003 3941.37 8.63072 3041.77 OK P37 109.341 2941 100.681 2410.56 OK 982.411 11011 697.399 10281.7 OK 535.021 40248 488.747 37932.5 OK P370 13.895 1375 25.3858 465.504 OK 101.623 7743.86 191.734 3498.92 OK 0 0 0 0 OK P371 43.7493 4440.36 79.8431 1465.67 OK 313.921 12259 599.249 10808.4 OK 4.4726 990 8.63072 102.288 OK P372 12.4734 1416 23.2484 417.879 OK 274.274 11036 505.768 9443.32 OK 0 0 0 0 OK P373 17.1811 936 11.663 515.022 OK 90.1891 3897 66.8818 3244.94 OK 53.6278 1.00873e+08 46.0022 530227 OK P374 0.481711 1 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK P375 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P376 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P377 35.249 3477 62.5055 1999.91 OK 20.2053 508 36.2289 297.508 OK 102.405 867901 180.986 93849.3 OK P378 7.19384 3462 2.48174 408.154 OK 13.5789 223 9.69836 199.939 OK 80.1788 850762 45.2467 73479.8 OK P379 496.768 101950 773.678 28184.9 OK 186.115 3182.37 316.709 2740.39 OK 1214.75 1.68483e+06 2025.99 1.11325e+06 OK P38 208.461 4812 153.277 4595.78 OK 367.111 8578.98 536.656 3842.11 OK 331.254 31408.7 421.139 23485.6 OK P380 2371.9 206370 827.201 134573 OK 3098.24 46042 369.478 45619.2 OK 14975.7 1.42649e+07 2216.05 1.37244e+07 OK P381 9.92793 4378 18.5638 563.277 OK 8.93801 287 16.6275 131.605 OK 0 0 0 0 OK P382 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P383 19.6237 1361.39 35.7949 395.33 OK 668.267 8251 825.759 7310.08 OK 50.576 6533 96.6913 3968.29 OK P384 34.4161 816 23.6678 693.331 OK 49.6281 593 40.7835 542.875 OK 21.0118 6709 23.0907 1648.63 OK P385 293.205 6678.5 56.7297 5906.76 OK 1108.59 13304 838.856 12126.7 OK 1553.53 128155 118.496 121893 OK P386 5.40797 26 2.63334 17.0181 OK 87.2892 282 36.1644 239.176 OK 0 0 0 0 OK P387 21.127 71 2.63334 66.4835 OK 123.554 382 36.1644 338.542 OK 0 0 0 0 OK P388 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P389 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P39 89.441 3001 144.119 2394.65 OK 1241.17 20035 1514.97 18422.1 OK 2223.83 447776 1841.34 412772 OK P390 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P391 0 0 0 0 OK 186.847 2003 315.662 1653.46 OK 320.731 115533 573.988 76612.1 OK P392 0.0224444 1 0.044667 0.215563 OK 331.171 3503 484.135 2930.62 OK 245.167 116186 451.082 58562.4 OK P393 112.782 1084 0.044667 1083.19 OK 920.401 10206.5 641.459 8144.88 OK 3217.28 848092 945.47 768504 OK P394 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P395 2439.11 142011 933.705 140923 OK 9510.49 323123 3830.95 318730 OK 4313.73 1.11029e+06 2031.9 1.1035e+06 OK P396 674.388 53419.6 933.705 38963.5 OK 2844.89 109776 3830.95 95342.2 OK 1505.56 393547 2031.9 385139 OK P397 1.99401 263 1.13364 26.603 OK 1.94154 4 1.84071 2.91511 OK 43.4993 5525 21.1656 3219.96 OK P398 9.69364 178 3.78359 129.328 OK 12.5341 21 1.84071 18.8192 OK 62.0897 5496 32.4515 4596.08 OK P399 6390.33 560661 2190.21 558336 OK 28920.8 1.89206e+06 6461.1 1.87488e+06 OK 19695.1 7.77334e+07 21184.4 7.76534e+07 OK P4 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK P40 444.847 14211.4 179.498 11910.1 OK 1925.75 30370 1573.8 28582.9 OK 1616.51 310537 1820.56 300046 OK P400 1217 115613 1997.96 106332 OK 2977.04 199934 5259.31 192996 OK 20415.5 1.28013e+08 21205.9 8.04939e+07 OK P401 128.01 15766 245.854 11184.5 OK 706.47 51374 1350.02 45799.1 OK 3128.36 2.38954e+07 5681.58 1.23345e+07 OK P402 168.642 15148 34.587 14734.6 OK 366.651 24985 123.51 23769.3 OK 132.842 1.5607e+07 37.1591 523766 OK P403 1488.11 63123.9 8.82559 61311.6 OK 2660.48 35024 69.0652 34815.6 OK 5063.6 1.15113e+06 95.2926 1.1353e+06 OK P404 24.6487 860 43.4786 689.376 OK 85.5536 1164 153.91 882.624 OK 165.613 19095 288.35 16018.3 OK P405 614.881 17689.5 43.4786 17197 OK 1758.73 18322 153.91 18144.1 OK 1951.16 194744 288.35 188718 OK P406 434.856 13038.4 251.316 12067.4 OK 1131.7 20676 1610.91 18973.8 OK 305.452 25622 476.198 24297.2 OK P407 37.8324 1694 69.1408 1049.86 OK 0 0 0 0 OK 0 0 0 0 OK P408 88.2262 3243 148.028 2448.31 OK 2384.1 42107 1896.75 39971.3 OK 973.222 83324.7 617.413 77414.8 OK P409 68.7804 2422 106.931 1908.68 OK 603.177 11210 845.042 10112.7 OK 185.236 19355 283.071 14734.6 OK P41 31.6321 1573 47.9681 846.902 OK 141.199 2571 243.681 2095.75 OK 82.0674 35735 144.914 15232.8 OK P410 1876.88 85755.8 0 85755.8 OK 2408.87 29578 0 29578 OK 3447.05 514118 0 514118 OK P411 0.00170504 1 0.00335251 0.00469359 OK 0 0 0 0 OK 1.42926 2 0.00014651 1.42926 OK P412 12.6475 55 10.8264 34.8156 OK 68.5467 81.0564 0.00553655 80.9083 OK 0 0 0 0 OK P413 9.75094 46 10.826 26.8421 OK 0.00280556 1 0.00553655 0.00331151 OK 7.91867e-05 1 0.00014651 7.91867e-05 OK P414 0 0 0 0 OK 22.9224 196.384 41.9406 115.219 OK 277.032 595521 516.645 93858.7 OK P415 65.4005 2637 79.8249 2345.37 OK 91.0684 564 89.8921 457.752 OK 241.408 115676 313.582 81789.1 OK P416 3.88714 1858 3.55284 139.399 OK 0.987408 5 0.960639 4.96317 OK 3.17857 186949 3.01535 1076.9 OK P417 736.76 27595 80.0852 26421.4 OK 451.667 2413 122.51 2270.29 OK 6277.36 2.67154e+06 805.337 2.12678e+06 OK P418 23.3778 1269 4.13499 838.364 OK 15.3595 86 3.3618 77.2042 OK 16.8108 119205 5.88657 5695.52 OK P419 7.09152 336 12.5807 109.133 OK 13.6769 64 21.2344 35 OK 48.0574 15174.9 77.8781 1799.82 OK P42 3.3817 100 4.47215 26.4334 OK 92.4544 1918.81 100.519 707.446 OK 0 0 0 0 OK P420 0 0 0 0 OK 4.91514 43 8.54669 12.5781 OK 43.0306 6884.41 75.8642 1611.56 OK P421 4.03785 432 6.83119 62.1393 OK 2.57014 32 4.06706 6.57711 OK 6.95862 2120 12.7958 260.61 OK P422 204.779 3365 36.6038 3151.38 OK 182.052 499 31.6392 465.881 OK 284.362 11158 199.193 10649.8 OK P423 10.5827 300 19.9646 162.859 OK 0 0 0 0 OK 81.2758 13702.6 129.314 3043.9 OK P424 2.04736 2.04736 0 2.04736 OK 9.49539 9.49539 0 9.49539 OK 0.4172 0.4172 0 0.4172 OK P425 0.0310473 2 0.0618451 1.35436 OK 0 0 0 0 OK 1875.65 411086 2227.62 400547 OK P426 38.2085 2029 67.5398 1666.75 OK 111.353 12443.1 205.555 2257.49 OK 54.2757 48279 94.0161 11590.6 OK P427 1268.69 56803.8 468.959 55343.4 OK 3227.94 67640 1971.74 65441.1 OK 2554.33 592924 2263.07 545478 OK P428 335.29 15382 435.389 14626.2 OK 2179.26 54832.9 2007.46 44181 OK 330.48 242908 578.079 70574 OK P43 0.0404941 1 0.0805351 0.316526 OK 75.721 766 127.487 579.405 OK 39.5417 5895 72.0029 2925.89 OK P44 0 0 0 0 OK 12.9787 144 24.6344 99.311 OK 151.119 18194.7 256.419 11182 OK P45 5.24282 85 7.74146 40.981 OK 110.295 2292.28 176.393 843.964 OK 104.314 11325 177.591 7718.7 OK P46 16.5057 214 25.1035 129.019 OK 0.011528 1 0.0229048 0.0882106 OK 45.0556 6288.23 87.1401 3333.89 OK P47 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P48 0 0 0 0 OK 14.5745 429.741 27.7203 111.522 OK 0 0 0 0 OK P49 10.6255 152 16.7051 83.0551 OK 0 0 0 0 OK 55.4155 54098.8 101.643 4100.47 OK P5 51.9052 2019 54.2737 1628.81 OK 4.42255 546 5.30023 84.8043 OK 7.81277 86041 11.7699 1943.57 OK P50 0 0 0 0 OK 257.642 2374 372.798 1971.43 OK 93.9564 55252.7 170.146 6952.3 OK P51 34.0707 311 35.9187 266.317 OK 304.436 3106.54 412.411 2329.5 OK 162.457 16878 277.706 12021 OK P52 11.4648 150 18.8312 89.6157 OK 277.365 4018.78 394.732 2122.35 OK 823.51 65662 690.366 60935.6 OK P53 1.37738 4 2.09719 1.37738 OK 38.1758 80 31.1656 47.3626 OK 5.58246 36 5.78888 22.1967 OK P54 0.202063 1 0.382732 0.202063 OK 6.88776 35.3414 8.80003 8.54526 OK 3.59862 55 5.16655 14.3086 OK P55 0 0 0 0 OK 0 0 0 0 OK 8.63718 48 7.78236 34.3427 OK P56 4.46221 7 2.29102 4.46221 OK 28.3586 66 29.6037 35.183 OK 0 0 0 0 OK P57 5.35927 197 0 196.548 OK 12.9405 1003 15.5853 383.188 OK 1.56786 2.16556e+06 2.63772 1060.96 OK P58 0 0 0 0 OK 57.5863 2588 15.5853 1705.22 OK 55.7194 458013 2.63772 37704.9 OK P59 1.52548 1.52548 0 1.52548 OK 2.49503 2.49503 0 2.49503 OK 7.20104 16.8246 0 16.8246 OK P6 38.5161 2074 44.5253 1208.65 OK 9.31442 405 7.24329 178.608 OK 58.3927 62838 33.3498 14526.2 OK P60 2.04736 2.04736 0 2.04736 OK 26.4657 26.4657 0 26.4657 OK 0.8344 0.8344 0 0.8344 OK P61 8.67116 12.3414 0 12.3414 OK 77.4887 98.9312 0 98.9312 OK 0.594944 0.594944 0 0.594944 OK P62 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P63 4.99777 770 5.76468 116.71 OK 31.1416 790 36.5946 488.417 OK 0 0 0 0 OK P64 2.22725 846 1.45778 52.0118 OK 3.39035 338 2.63341 53.1733 OK 0 0 0 0 OK P65 0 0 0 0 OK 0 0 0 0 OK 45.8921 8749 62.8905 4193.87 OK P66 71.6222 2280 98.1028 1672.56 OK 117.97 4488.22 220.649 1850.21 OK 75.1929 8466 70.9148 6871.54 OK P67 177.355 4295 103.393 4141.68 OK 1904.57 30294 351.049 29870.8 OK 0 0 0 0 OK P68 48.2932 1128 0 1127.77 OK 205.951 3231 0 3230.08 OK 151.982 13889 0 13889 OK P69 562.295 14778.4 0 14778.4 OK 4366.32 75900.2 0 75900.2 OK 7849.78 2.82964e+06 0 2.82964e+06 OK P7 11.9119 1068 8.69793 373.8 OK 0 0 0 0 OK 0 0 0 0 OK P70 41.8689 3124 67.2053 1589.77 OK 97.1207 1641 164.205 1447.59 OK 372.87 316861 648.315 209106 OK P71 963.648 38031 115.956 36589.9 OK 2400.16 36245 385.516 35774.5 OK 9526.5 5.65204e+06 980.382 5.34248e+06 OK P72 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P73 0 0 0 0 OK 0.000256118 1 0.000493478 0.000256118 OK 1.92845 51 2.989 7.17441 OK P74 0 0 0 0 OK 5.55836 11 4.73147 5.55836 OK 3.09879 44 3.54435 11.5284 OK P75 1.03732 3 0.98055 1.03732 OK 0 0 0 0 OK 0 0 0 0 OK P76 2.41496 4 0.980589 2.41496 OK 6.90633 12 4.73149 6.90633 OK 5.9212 43 4.27922 22.0286 OK P77 4.43026e-05 1 7.99437e-05 4.43026e-05 OK 0 0 0 0 OK 0 0 0 0 OK P78 3.57746 27 1.80702 18.5026 OK 2.24864 4 1.19073 2.24864 OK 169.783 12565 79.7957 11013.5 OK P79 2.76045 34 2.14055 14.277 OK 4.94483 10.5073 1.53813 4.94483 OK 89.4382 8427.65 103.523 5801.7 OK P8 62.5442 696 31.5484 638.109 OK 458.862 4084 380.975 3640.93 OK 282.997 12143 188.133 11055.9 OK P80 12.7745 101 6.48593 66.0696 OK 0 0 0 0 OK 848.815 58271 225.611 55061.1 OK P81 4.71461 74 5.35657 24.3839 OK 0.0625481 1 0.121776 0.0625481 OK 53.8467 4355 75.1567 3492.94 OK P82 232.891 9485.75 215.062 5450.8 OK 1164.84 15926.5 1090.71 13841.6 OK 1343.5 175085 1335.03 166251 OK P83 47.5642 1800 84.3848 1113.24 OK 117.53 1664 212.234 1396.58 OK 172.684 31328 313.178 21368.7 OK P84 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P85 20.6618 617 38.3836 483.589 OK 40.1378 630 74.9869 476.951 OK 44.6564 16488 85.6683 5525.98 OK P86 152.263 6013.24 194.072 3563.73 OK 871.534 11542 1029.96 10356.3 OK 1207.29 153392 1320.97 149396 OK P87 0 0 0 0 OK 101.888 1522 181.304 1210.72 OK 11.7033 20178 22.1215 1448.22 OK P88 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P89 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK P9 17.8183 202 8.31842 181.791 OK 124.584 1064 68.559 988.537 OK 32.1599 1563 26.9402 1256.4 OK P90 0.00257746 1 0.00511581 0.00257746 OK 0 0 0 0 OK 8.90761 523.574 15.194 83.0447 OK P91 0.0035957 1 0.00713731 0.0035957 OK 0 0 0 0 OK 51.7198 566 15.194 482.178 OK P92 2.05466 4 1.71916 2.05466 OK 40.9974 78.4168 11.9329 40.9974 OK 0 0 0 0 OK P93 0.00230678 1 0.00457836 0.00230678 OK 0 0 0 0 OK 0 0 0 0 OK P94 1.46952 4 1.71636 1.46952 OK 6.98469 46.8987 11.9329 6.98469 OK 0 0 0 0 OK P95 152.408 2099 31.5328 1997.17 OK 665.608 5015.23 344.755 4529.15 OK 5.60754 30 4.19539 15.676 OK P96 0 0 0 0 OK 10.2111 122 19.6593 69.4818 OK 0 0 0 0 OK P97 4.10372 178 1.08715 53.7754 OK 15.1737 127 4.39457 103.25 OK 0 0 0 0 OK P98 19.4773 595.934 30.7617 255.232 OK 261.258 2151.03 337.868 1777.74 OK 4.21273 29 4.19539 11.7768 OK P99 507.179 12810 0 12809.8 OK 1193.68 9366 0 9365.61 OK 5169.1 1.1781e+06 66.8023 1.17243e+06 OK cummeRbund/inst/extdata/cds.diff0000644000175200017520000027006314516004263017720 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 sqrt(JS) test_stat p_value q_value significant XLOC_000001 XLOC_000001 - chr1:11873-29961 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000002 XLOC_000002 OR4F5 chr1:69090-70008 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000005 XLOC_000005 - chr1:322036-328580 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000006 XLOC_000006 OR4F16 chr1:367658-368595 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC NOTEST 0 0 0.479212 0 0.517875 1 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC NOTEST 0 0 0.0977461 0 0.56036 1 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC NOTEST 0 0 0.412453 0 1e-05 1 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000026 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 0 0.434416 0 4e-05 1 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.119239 0 0.652225 1 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 iPS hESC NOTEST 0 0 0.00591279 0 0.941245 1 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC NOTEST 0 0 0.124414 0 0.380655 1 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC NOTEST 0 0 0.311178 0 0.129975 1 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 0 0 0.178384 0 0.207455 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0.447823 0 0.057975 1 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC NOTEST 0 0 0.258845 0 0.06322 1 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.652612 0 0.04586 1 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0.232113 0 1e-05 1 no XLOC_000046 XLOC_000046 - chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC NOTEST 0 0 0.00487698 0 0.91369 1 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 0 0 0.664284 0 0.06783 1 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0.154468 0 0.0069 1 no XLOC_000052 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 0 0.164572 0 0.375045 1 no XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0.228604 0 0.002495 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000064 XLOC_000064 - chr1:4847557-4852182 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 0 0 0.0803005 0 0.6716 1 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC NOTEST 0 0 0.072065 0 0.95548 1 no XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC NOTEST 0 0 0.239448 0 0.182465 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC NOTEST 0 0 0.117739 0 0.241955 1 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0.0904953 0 0.88702 1 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0.311847 0 0.28082 1 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC NOTEST 0 0 0.0408911 0 0.643935 1 no XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC NOTEST 0 0 0.435222 0 0.042365 1 no XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC NOTEST 0 0 0.183718 0 0.18844 1 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC NOTEST 0 0 0.0915306 0 0.224695 1 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC NOTEST 0 0 0.269748 0 0.194165 1 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC NOTEST 0 0 0.27615 0 0.14106 1 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0.114261 0 0.193795 1 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 0 0 0.00553365 0 0.89069 1 no XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 iPS hESC NOTEST 0 0 0.119644 0 0.47825 1 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC NOTEST 0 0 0.0022836 0 0.937575 1 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0.167188 0 0.581665 1 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC NOTEST 0 0 0.194019 0 0.00043 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 0 0.0819049 0 0.59011 1 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC NOTEST 0 0 0.0630176 0 0.34135 1 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 0 0 0.0771635 0 0.393765 1 no XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC NOTEST 0 0 0.672685 0 1e-05 1 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC NOTEST 0 0 0.393761 0 0.00036 1 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0.0387091 0 0.45367 1 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0 0.246838 0 0.00073 1 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0.569267 0 1e-05 1 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC NOTEST 0 0 0.162779 0 0.011655 1 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC NOTEST 0 0 0.0951446 0 0.57789 1 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 iPS hESC NOTEST 0 0 0.110553 0 0.284905 1 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC NOTEST 0 0 0.200804 0 0.15 1 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC NOTEST 0 0 0.118196 0 0.196985 1 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 0 0 0.0204716 0 0.82591 1 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC NOTEST 0 0 0.141045 0 0.35279 1 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC NOTEST 0 0 0.486038 0 1e-05 1 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC NOTEST 0 0 0.403237 0 0.070845 1 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0.154476 0 1e-05 1 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC NOTEST 0 0 0.189525 0 0.293145 1 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0.546855 0 1e-05 1 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000170 XLOC_000170 FAM43B chr1:20878931-20881512 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC NOTEST 0 0 0.316089 0 3e-05 1 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 0 0 0.25968 0 0.00276 1 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC NOTEST 0 0 0.0544696 0 0.70103 1 no XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 0 0 0.131047 0 0.292525 1 no XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 0 0 0.309036 0 0.12592 1 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC NOTEST 0 0 0.119115 0 0.203365 1 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 0 0.397897 0 1e-05 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 iPS hESC NOTEST 0 0 0.0114635 0 0.75691 1 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0.0526173 0 0.82666 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC NOTEST 0 0 0.0722914 0 0.26861 1 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC NOTEST 0 0 0.0139767 0 0.81161 1 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC NOTEST 0 0 0.375834 0 0.01035 1 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 0 0 0.166145 0 0.01559 1 no XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC NOTEST 0 0 0.18904 0 1e-05 1 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0 0 0.159061 0 0.12287 1 no XLOC_001221 XLOC_001221 OR4F16 chr1:621097-622034 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001228 XLOC_001228 - chr1:761586-762902 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC NOTEST 0 0 0.154292 0 0.375915 1 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 iPS hESC NOTEST 0 0 0.359776 0 0.00944 1 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 0 0 0.247895 0 0.370885 1 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 0 0 0.64674 0 0.09798 1 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0.136728 0 0.35727 1 no XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC NOTEST 0 0 0.0509468 0 0.91437 1 no XLOC_001241 XLOC_001241 - chr1:1189293-1209234 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.23339 0 0.41193 1 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.157049 0 0.059335 1 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS hESC NOTEST 0 0 0.059236 0 0.86745 1 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 0 0 0.327596 0 0.17454 1 no XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC NOTEST 0 0 0.164665 0 0.39832 1 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC NOTEST 0 0 0.0308089 0 0.5316 1 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 iPS hESC NOTEST 0 0 0.70497 0 0.06623 1 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC NOTEST 0 0 0.114708 0 0.14322 1 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.327242 0 0.3826 1 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.13901 0 0.749535 1 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0.0684931 0 0.73687 1 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC NOTEST 0 0 0.0349735 0 0.721685 1 no XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC NOTEST 0 0 0.0107538 0 0.78643 1 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 0 0 0.393115 0 0.224195 1 no XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC NOTEST 0 0 0.0845185 0 0.144455 1 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 0 0 0.312076 0 0.03664 1 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC NOTEST 0 0 0.104323 0 0.371165 1 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC NOTEST 0 0 0.204148 0 0.18832 1 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC NOTEST 0 0 0.0489825 0 0.506555 1 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC NOTEST 0 0 0.116079 0 0.14422 1 no XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC NOTEST 0 0 0.0643001 0 0.197475 1 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC NOTEST 0 0 0.0268548 0 0.63608 1 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 0 0 0 0 0 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0.252987 0 0.080995 1 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC NOTEST 0 0 0.428544 0 0.000885 1 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0.0157199 0 0.937335 1 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC NOTEST 0 0 0.150881 0 0.113605 1 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0.447859 0 1e-05 1 no XLOC_001295 XLOC_001295 - chr1:8412465-8877699 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 0 0 0.316557 0 1e-05 1 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 0 0 0.216256 0 0.31636 1 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC NOTEST 0 0 0.142416 0 0.0029 1 no XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC NOTEST 0 0 0.109049 0 0.14633 1 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC NOTEST 0 0 0.285794 0 0.2586 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 0 0.109305 0 0.27554 1 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 0 0 0.35725 0 0.004465 1 no XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC NOTEST 0 0 0.0206372 0 0.69018 1 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC NOTEST 0 0 0.0437797 0 0.488725 1 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 0 0 0.24624 0 0.042775 1 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC NOTEST 0 0 0.0703995 0 0.285055 1 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 0 0 0.0473072 0 0.90735 1 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001325 XLOC_001325 - chr1:13182960-13183967 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0.484999 0 1e-05 1 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001338 XLOC_001338 - chr1:16133656-16134194 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 0 0.175716 0 0.51362 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 0 0 0.202379 0 0.0111 1 no XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC NOTEST 0 0 0.199294 0 1e-05 1 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 0 0 0.185656 0 0.31417 1 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 0 0 0.450424 0 0.000885 1 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0.00707395 0 0.93333 1 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC NOTEST 0 0 0.143494 0 0.230925 1 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC NOTEST 0 0 0.00714474 0 0.903335 1 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0.480676 0 1e-05 1 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC NOTEST 0 0 0.157958 0 0.11819 1 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 0 0 0.375302 0 0.000265 1 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 0 0.28118 0 0.391835 1 no XLOC_001374 XLOC_001374 RNF186 chr1:20140522-20141771 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC NOTEST 0 0 0.0143634 0 0.730015 1 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 0 0.235355 0 0.051915 1 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 0 0 0.202001 0 0.01605 1 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0.109461 0 0.60521 1 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0.396639 0 0.01337 1 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 0 0.390463 0 2e-05 1 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 0 0 0.132176 0 0.66018 1 no XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0.272482 0 0.102935 1 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0.298815 0 0.277915 1 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC NOTEST 0 0 0.116337 0 0.18745 1 no XLOC_001396 XLOC_001396 HTR1D chr1:23518388-23521222 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 0 0 0.164491 0 0.251275 1 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 0 0.682589 0 0.012515 1 no XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0.232161 0 0.00132 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC NOTEST 0 0 0.0992068 0 0.13985 1 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0.150601 0 0.587525 1 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 0 0 0.226563 0 0.002755 1 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC NOTEST 0 0 0.213398 0 0.06579 1 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC NOTEST 0 0 0.454255 0 0.073705 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0.121078 0 0.644625 1 no XLOC_000001 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000002 XLOC_000002 OR4F5 chr1:69090-70008 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000005 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000006 XLOC_000006 OR4F16 chr1:367658-368595 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0.537612 0 0.490145 1 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts NOTEST 0 0 0.1338 0 0.827365 1 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts NOTEST 0 0 0.725236 0 0.007115 1 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000026 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 0 0.31557 0 0.17441 1 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.0902701 0 0.929985 1 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts NOTEST 0 0 0.209022 0 0.65846 1 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts NOTEST 0 0 0.0651591 0 0.64526 1 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts NOTEST 0 0 0.326515 0 0.195275 1 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts NOTEST 0 0 0.310961 0 0.04085 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0.536577 0 0.005655 1 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts NOTEST 0 0 0.67898 0 0.000165 1 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.790979 0 0.06578 1 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0.637059 0 0.05242 1 no XLOC_000046 XLOC_000046 - chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts NOTEST 0 0 0.00708065 0 0.9054 1 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts NOTEST 0 0 0.255494 0 0.56203 1 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0.107245 0 0.456665 1 no XLOC_000052 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0.300868 0 0.3088 1 no XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts NOTEST 0 0 0.0513101 0 0.303625 1 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0.128371 0 0.23564 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000064 XLOC_000064 - chr1:4847557-4852182 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 0 0 0.312903 0 0.38441 1 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0.098507 0 0.93082 1 no XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 0 0 0.520825 0 0.28235 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts NOTEST 0 0 0.0214464 0 0.887365 1 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0.0456135 0 0.96419 1 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0.230262 0 0.407725 1 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts NOTEST 0 0 0.0596562 0 0.775225 1 no XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts NOTEST 0 0 0.380461 0 0.10852 1 no XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts NOTEST 0 0 0.104138 0 0.268225 1 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts NOTEST 0 0 0.16801 0 0.192375 1 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0.0530971 0 0.955555 1 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0.261132 0 0.405995 1 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0.279929 0 0.020595 1 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 0 0 0.0311199 0 0.7749 1 no XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 iPS Fibroblasts NOTEST 0 0 0.183855 0 0.810275 1 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0.120012 0 0.16851 1 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts NOTEST 0 0 0.07386 0 0.155265 1 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0.107868 0 0.55679 1 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts NOTEST 0 0 0.232859 0 0.231025 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0.0537242 0 0.75532 1 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts NOTEST 0 0 0.0215808 0 0.756455 1 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 0 0 0.18637 0 0.327115 1 no XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts NOTEST 0 0 0.742733 0 1e-05 1 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 0 0.313867 0 0.07598 1 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0.123411 0 0.35962 1 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0.33067 0 1e-05 1 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0.71635 0 0.00624 1 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts NOTEST 0 0 0.181764 0 0.1148 1 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts NOTEST 0 0 0.196719 0 0.39904 1 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 iPS Fibroblasts NOTEST 0 0 0.114968 0 0.422455 1 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts NOTEST 0 0 0.187583 0 0.42042 1 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts NOTEST 0 0 0.115363 0 0.31603 1 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0.0379957 0 0.832965 1 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts NOTEST 0 0 0.0205459 0 0.997415 1 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts NOTEST 0 0 0.485548 0 1e-05 1 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0.454351 0 0.085255 1 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0.721558 0 1e-05 1 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts NOTEST 0 0 0.12362 0 0.74415 1 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 0 0.597138 0 0.000915 1 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000170 XLOC_000170 FAM43B chr1:20878931-20881512 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts NOTEST 0 0 0.324848 0 0.025445 1 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts NOTEST 0 0 0.11061 0 0.44223 1 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 0 0 0.105656 0 0.622895 1 no XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 0 0 0.108486 0 0.781575 1 no XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts NOTEST 0 0 0.257169 0 0.31808 1 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 0 0 0.242277 0 0.14798 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts NOTEST 0 0 0.0347587 0 0.6618 1 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0.210969 0 0.69227 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts NOTEST 0 0 0.278757 0 0.170205 1 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts NOTEST 0 0 0.0613136 0 0.610055 1 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts NOTEST 0 0 0.428229 0 0.00241 1 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 0 0 0.156533 0 0.344565 1 no XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts NOTEST 0 0 0.3049 0 0.32331 1 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts NOTEST 0 0 0.396291 0 0.022355 1 no XLOC_001221 XLOC_001221 OR4F16 chr1:621097-622034 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001228 XLOC_001228 - chr1:761586-762902 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0.189786 0 0.62726 1 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts NOTEST 0 0 0.211385 0 0.26558 1 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 0 0.413753 0 0.154475 1 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0 0 0.492494 0 0.243305 1 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0.0594194 0 0.897545 1 no XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts NOTEST 0 0 0.0828993 0 0.930385 1 no XLOC_001241 XLOC_001241 - chr1:1189293-1209234 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.12187 0 0.94744 1 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.213948 0 0.488095 1 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS Fibroblasts NOTEST 0 0 0.169291 0 0.72339 1 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 0 0 0.111885 0 0.947465 1 no XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts NOTEST 0 0 0.070765 0 0.98291 1 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts NOTEST 0 0 0.0824077 0 0.362555 1 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts NOTEST 0 0 0.0096909 0 0.81436 1 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts NOTEST 0 0 0.126255 0 0.291715 1 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.347435 0 0.861195 1 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.213358 0 0.96076 1 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0.227552 0 0.34713 1 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts NOTEST 0 0 0.629985 0 0.00494 1 no XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0.0263487 0 0.75958 1 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts NOTEST 0 0 0.10219 0 0.93096 1 no XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts NOTEST 0 0 0.0952529 0 0.352785 1 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 0 0 0.0181577 0 0.890195 1 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts NOTEST 0 0 0.0901444 0 0.764615 1 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts NOTEST 0 0 0.176934 0 0.437695 1 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 0 0 0.160029 0 0.363055 1 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts NOTEST 0 0 0.149426 0 0.21832 1 no XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0.0556887 0 0.550075 1 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts NOTEST 0 0 0.0215189 0 0.8509 1 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 0 0 0 0 0 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0.367101 0 0.095825 1 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts NOTEST 0 0 0.446419 0 0.061515 1 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0.0335524 0 0.921025 1 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts NOTEST 0 0 0.17676 0 0.15491 1 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts NOTEST 0 0 0.695378 0 5e-05 1 no XLOC_001295 XLOC_001295 - chr1:8412465-8877699 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 0 0 0.368818 0 1e-05 1 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts NOTEST 0 0 0.077175 0 0.78084 1 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0.581398 0 0.00314 1 no XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts NOTEST 0 0 0.0822105 0 0.544345 1 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 0 0 0.368514 0 0.3192 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0.179742 0 0.13161 1 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts NOTEST 0 0 0.189176 0 0.145055 1 no XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts NOTEST 0 0 0.0779966 0 0.46512 1 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0.11856 0 0.3919 1 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0.299354 0 0.024385 1 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts NOTEST 0 0 0.128194 0 0.371025 1 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts NOTEST 0 0 0.146708 0 0.297195 1 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001325 XLOC_001325 - chr1:13182960-13183967 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0.429918 0 0.07535 1 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001338 XLOC_001338 - chr1:16133656-16134194 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0.245289 0 0.5482 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0.23167 0 0.291415 1 no XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts NOTEST 0 0 0.671402 0 0.003855 1 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts NOTEST 0 0 0.18136 0 0.32348 1 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 0 0 0.405493 0 0.03898 1 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts NOTEST 0 0 0.00905658 0 0.94011 1 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts NOTEST 0 0 0.260945 0 0.0158 1 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts NOTEST 0 0 0.0642148 0 0.588745 1 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0.479597 0 0.00078 1 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts NOTEST 0 0 0.125519 0 0.53941 1 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts NOTEST 0 0 0.140626 0 0.277495 1 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts NOTEST 0 0 0.377054 0 0.00025 1 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0.210592 0 0.84576 1 no XLOC_001374 XLOC_001374 RNF186 chr1:20140522-20141771 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts NOTEST 0 0 0.0346222 0 0.64207 1 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 0 0.498542 0 1e-05 1 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts NOTEST 0 0 0.469461 0 0.082955 1 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0.181208 0 0.77323 1 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0.446396 0 0.0039 1 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts NOTEST 0 0 0.302522 0 0.334115 1 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 0 0 0.467773 0 0.07912 1 no XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0.265751 0 0.411365 1 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0.281235 0 0.47991 1 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts NOTEST 0 0 0.152202 0 0.120885 1 no XLOC_001396 XLOC_001396 HTR1D chr1:23518388-23521222 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 0 0 0.154605 0 0.26487 1 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts NOTEST 0 0 0.269442 0 0.335325 1 no XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0.0958992 0 0.00437 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts NOTEST 0 0 0.0968845 0 0.330865 1 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0.0630614 0 0.99509 1 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 0 0 0.225082 0 1e-05 1 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts NOTEST 0 0 0.316862 0 0.011485 1 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0 0.783948 0 0.06304 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0.149 0 0.82089 1 no XLOC_000001 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000002 XLOC_000002 OR4F5 chr1:69090-70008 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000005 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000006 XLOC_000006 OR4F16 chr1:367658-368595 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0.166195 0 0.780305 1 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts NOTEST 0 0 0.146699 0 0.43843 1 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts NOTEST 0 0 0.523776 0 0.061745 1 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000026 XLOC_000026 B3GALT6 chr1:1167628-1170418 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 0 0 0.141028 0 0.34529 1 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.0457139 0 0.917635 1 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts NOTEST 0 0 0.214797 0 0.336125 1 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts NOTEST 0 0 0.0611071 0 0.629615 1 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts NOTEST 0 0 0.104963 0 0.59599 1 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 0 0 0.137813 0 0.223575 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0.503631 0 1e-05 1 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts NOTEST 0 0 0.579816 0 0.001405 1 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.19565 0 0.71286 1 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0.765951 0 0.025575 1 no XLOC_000046 XLOC_000046 - chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts NOTEST 0 0 0.00220415 0 0.94103 1 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts NOTEST 0 0 0.681335 0 0.002205 1 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0.103688 0 0.5583 1 no XLOC_000052 XLOC_000052 ACTRT2 chr1:2938045-2939465 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 0 0 0.154076 0 0.296035 1 no XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts NOTEST 0 0 0.0513101 0 0.303625 1 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0.118496 0 0.298305 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000064 XLOC_000064 - chr1:4847557-4852182 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0.377151 0 0.1267 1 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0.166065 0 0.86275 1 no XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts NOTEST 0 0 0.713138 0 1e-05 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts NOTEST 0 0 0.0965877 0 0.29868 1 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0.131023 0 0.7904 1 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0.439729 0 1e-05 1 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts NOTEST 0 0 0.0418983 0 0.645405 1 no XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts NOTEST 0 0 0.0597637 0 0.62458 1 no XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts NOTEST 0 0 0.0942014 0 0.608715 1 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts NOTEST 0 0 0.257423 0 0.03628 1 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0.240439 0 0.43691 1 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts NOTEST 0 0 0.218148 0 0.315845 1 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0.384044 0 0.00071 1 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 0 0 0.0366217 0 0.474145 1 no XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 hESC Fibroblasts NOTEST 0 0 0.253678 0 0.239415 1 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0.120012 0 0.16851 1 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts NOTEST 0 0 0.0719575 0 0.02387 1 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0.212451 0 0.10794 1 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts NOTEST 0 0 0.106112 0 0.57251 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0.0285456 0 0.7923 1 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts NOTEST 0 0 0.0429804 0 0.46025 1 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 0 0 0.121149 0 0.24614 1 no XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts NOTEST 0 0 0.0964964 0 0.37265 1 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0.107197 0 0.272395 1 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0.0849071 0 0.373645 1 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 0 0 0.270138 0 1e-05 1 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0.515079 0 0.052835 1 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts NOTEST 0 0 0.02272 0 0.793975 1 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts NOTEST 0 0 0.122642 0 0.479875 1 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 hESC Fibroblasts NOTEST 0 0 0.0435608 0 0.69709 1 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts NOTEST 0 0 0.0793301 0 0.57673 1 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts NOTEST 0 0 0.00285963 0 0.974165 1 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0.0175421 0 0.83238 1 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0.127109 0 0.440345 1 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts NOTEST 0 0 0.00496914 0 0.228045 1 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0.181363 0 0.43634 1 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0.719631 0 1e-05 1 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts NOTEST 0 0 0.124649 0 0.36244 1 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 0 0 0.476656 0 0.004045 1 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000170 XLOC_000170 FAM43B chr1:20878931-20881512 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts NOTEST 0 0 0.0104363 0 0.888875 1 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts NOTEST 0 0 0.216288 0 0.24891 1 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts NOTEST 0 0 0.106933 0 0.213125 1 no XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 0 0 0.0250081 0 0.9595 1 no XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 0 0 0.323049 0 0.053805 1 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 0 0 0.196149 0 0.23906 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts NOTEST 0 0 0.0233037 0 0.586485 1 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0.262128 0 0.496425 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts NOTEST 0 0 0.334102 0 0.11184 1 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts NOTEST 0 0 0.0475124 0 0.49407 1 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts NOTEST 0 0 0.0640525 0 7.5e-05 1 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts NOTEST 0 0 0.235704 0 0.20753 1 no XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts NOTEST 0 0 0.316687 0 0.309395 1 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts NOTEST 0 0 0.447285 0 0.00738 1 no XLOC_001221 XLOC_001221 OR4F16 chr1:621097-622034 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001228 XLOC_001228 - chr1:761586-762902 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0.0683875 0 0.68322 1 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts NOTEST 0 0 0.175202 0 0.381765 1 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 0 0.287401 0 0.14779 1 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts NOTEST 0 0 0.832281 0 1e-05 1 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0.190491 0 0.248755 1 no XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 0 0.0391643 0 0.953085 1 no XLOC_001241 XLOC_001241 - chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.282119 0 0.28495 1 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.156799 0 0.55813 1 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 hESC Fibroblasts NOTEST 0 0 0.220815 0 0.30998 1 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts NOTEST 0 0 0.379744 0 0.04752 1 no XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts NOTEST 0 0 0.196471 0 0.41706 1 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts NOTEST 0 0 0.0534642 0 0.310655 1 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts NOTEST 0 0 0.706382 0 0.0631 1 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts NOTEST 0 0 0.0236269 0 0.779525 1 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.208038 0 0.49992 1 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.124267 0 0.816425 1 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0.245891 0 0.09106 1 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts NOTEST 0 0 0.602025 0 1e-05 1 no XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0.0369758 0 0.47493 1 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts NOTEST 0 0 0.319761 0 0.388975 1 no XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts NOTEST 0 0 0.0128738 0 0.82476 1 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts NOTEST 0 0 0.294767 0 0.03039 1 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts NOTEST 0 0 0.186069 0 0.186645 1 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts NOTEST 0 0 0.0280205 0 0.82074 1 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts NOTEST 0 0 0.112189 0 0.241995 1 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts NOTEST 0 0 0.255149 0 0.043565 1 no XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0.00866684 0 0.85155 1 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts NOTEST 0 0 0.00533777 0 0.91595 1 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 0 0 0 0 0 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0.337976 0 0.131285 1 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts NOTEST 0 0 0.131627 0 0.37308 1 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0.0263665 0 0.873175 1 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts NOTEST 0 0 0.0282153 0 0.682365 1 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0.402824 0 0.040425 1 no XLOC_001295 XLOC_001295 - chr1:8412465-8877699 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 0 0 0.0874128 0 0.170185 1 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts NOTEST 0 0 0.141267 0 0.3472 1 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0.545953 0 0.006015 1 no XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts NOTEST 0 0 0.0270079 0 0.74248 1 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts NOTEST 0 0 0.232499 0 0.30262 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 0 0 0.271794 0 5.5e-05 1 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 0 0 0.176795 0 0.1057 1 no XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts NOTEST 0 0 0.0578784 0 0.35525 1 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0.0753864 0 0.34972 1 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 0 0 0.055764 0 0.402675 1 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts NOTEST 0 0 0.0586784 0 0.423535 1 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts NOTEST 0 0 0.161809 0 0.01388 1 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001325 XLOC_001325 - chr1:13182960-13183967 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts NOTEST 0 0 0.15657 0 0.497525 1 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001338 XLOC_001338 - chr1:16133656-16134194 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 0 0 0.13745 0 0.63909 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0.246295 0 0.263845 1 no XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts NOTEST 0 0 0.530918 0 0.018495 1 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts NOTEST 0 0 0.0738089 0 0.287245 1 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 0 0 0.0679762 0 0.817695 1 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts NOTEST 0 0 0.0019828 0 0.979475 1 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts NOTEST 0 0 0.161877 0 0.070045 1 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts NOTEST 0 0 0.071337 0 0.294335 1 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0.24532 0 0.2173 1 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts NOTEST 0 0 0.0973737 0 0.60607 1 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts NOTEST 0 0 0.140626 0 0.277495 1 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0.0425829 0 0.07773 1 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 0 0 0.292243 0 0.236475 1 no XLOC_001374 XLOC_001374 RNF186 chr1:20140522-20141771 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0.0209844 0 0.64209 1 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 0 0 0.539325 0 1e-05 1 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 0 0 0.311235 0 0.171735 1 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0.159638 0 0.48923 1 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0.287623 0 0.001595 1 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 0 0 0.146058 0 0.60998 1 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 0 0 0.533027 0 0.000645 1 no XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0.125322 0 0.616485 1 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0.139105 0 0.30266 1 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts NOTEST 0 0 0.0512331 0 0.159715 1 no XLOC_001396 XLOC_001396 HTR1D chr1:23518388-23521222 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 0 0 0.113768 0 0.102055 1 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts NOTEST 0 0 0.538414 0 0.05996 1 no XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0.167236 0 0.034585 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts NOTEST 0 0 0.192497 0 0.054955 1 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0.143041 0 0.612145 1 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts NOTEST 0 0 0.15244 0 0.05903 1 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts NOTEST 0 0 0.107711 0 0.133475 1 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts NOTEST 0 0 0.663498 0 0.079455 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0.187875 0 0.35403 1 no cummeRbund/inst/extdata/cds.fpkm_tracking0000644000175200017520000033001114516004263021615 0ustar00biocbuildbiocbuildtracking_id class_code nearest_ref_id gene_id gene_short_name tss_id locus length coverage iPS_FPKM iPS_conf_lo iPS_conf_hi iPS_status hESC_FPKM hESC_conf_lo hESC_conf_hi hESC_status Fibroblasts_FPKM Fibroblasts_conf_lo Fibroblasts_conf_hi Fibroblasts_status P1 - - XLOC_000001 - TSS1 chr1:11873-29961 - - 13.1105 0 126.372 OK 0.347386 0 3.15457 OK 0 0 0 OK P10 - - XLOC_000016 KLHL17 TSS13 chr1:895966-901095 - - 34.9548 0 105.595 OK 180.118 104.051 256.186 OK 60.5379 0 193.719 OK P100 - - XLOC_000055 TPRG1L TSS72 chr1:3541555-3546692 - - 0 0 0 OK 0 0 0 OK 20.4274 0 287.534 OK P101 - - XLOC_000056 TP73 TSS73 chr1:3569128-3650467 - - 4.13128 0 13.838 OK 0 0 0 OK 0.438492 0 2.75575 OK P102 - - XLOC_000056 - TSS76 chr1:3569128-3650467 - - 0 0 0 OK 0.923281 0 12.4564 OK 0.0133356 0 1.36251 OK P103 - - XLOC_000056 TP73 TSS75 chr1:3569128-3650467 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P104 - - XLOC_000056 TP73 TSS74 chr1:3569128-3650467 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P105 - - XLOC_000056 TP73 TSS74 chr1:3569128-3650467 - - 0 0 0 OK 4.94475 0 10.8724 OK 0 0 0 OK P106 - - XLOC_000056 - TSS75 chr1:3569128-3650467 - - 3.71815 0 12.9619 OK 0.585598 0 3.51027 OK 0 0 0 OK P107 - - XLOC_000056 TP73 TSS74 chr1:3569128-3650467 - - 0 0 0 OK 0.0344885 0 0.785779 OK 0 0 0 OK P108 - - XLOC_000056 TP73 TSS73 chr1:3569128-3650467 - - 5.30242 0 11.8443 OK 63.3435 47.6627 79.0243 OK 3.93866 0 8.99546 OK P109 - - XLOC_000056 TP73 TSS74 chr1:3569128-3650467 - - 1.53994 0 6.41886 OK 5.31366 0 14.0565 OK 0 0 0 OK P11 - - XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 - - 0 0 0 OK 0 0 0 OK 30.5047 0 67.0591 OK P110 - - XLOC_000057 CCDC27 TSS77 chr1:3668964-3688209 - - 0.580625 0 2.25377 OK 2.99279 0.634917 5.35067 OK 0.344217 0 1.23675 OK P111 - - XLOC_000058 - TSS78 chr1:3689351-3692545 - - 29.1182 1.52983 56.7065 OK 76.8718 48.7695 104.974 OK 58.9016 6.1034 111.7 OK P112 - - XLOC_000059 DFFB TSS79 chr1:3773844-3801992 - - 0 0 0 OK 4.80895 0 22.2279 OK 0 0 0 OK P113 - - XLOC_000059 DFFB TSS79 chr1:3773844-3801992 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P114 - - XLOC_000059 DFFB TSS79 chr1:3773844-3801992 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P115 - - XLOC_000059 DFFB TSS79 chr1:3773844-3801992 - - 62.8589 19.4478 106.27 OK 86.6597 64.6641 108.655 OK 101.804 29.8944 173.713 OK P116 - - XLOC_000059 DFFB TSS79 chr1:3773844-3801992 - - 6.55552 0 29.4468 OK 0 0 0 OK 0 0 0 OK P117 - - XLOC_000059 CAD TSS79 chr1:3773844-3801992 - - 0 0 0 OK 14.4431 4.20032 24.6859 OK 4.99183 0 27.9467 OK P118 - - XLOC_000059 DFFB TSS79 chr1:3773844-3801992 - - 0.00638818 0 1.66332 OK 8.65205 0.595917 16.7082 OK 4.32215 0 28.7398 OK P119 - - XLOC_000063 AJAP1 TSS83 chr1:4715104-4843850 - - 104.444 28.7796 180.108 OK 73.9584 56.8913 91.0255 OK 1.26614 0 3.42947 OK P12 - - XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 - - 0.000108087 0 2.04195 OK 9.40489 3.8758 14.934 OK 22.8971 0 52.1497 OK P120 - - XLOC_000064 - - chr1:4847557-4852182 - - 37.4079 11.2885 63.5273 OK 18.1722 13.5426 22.8018 OK 0.154615 0 0.555523 OK P121 - - XLOC_000065 KCNAB2 TSS87 chr1:6052765-6160523 - - 1.06639 0 6.48726 OK 0 0 0 OK 0 0 0 OK P122 - - XLOC_000065 KCNAB2 TSS85 chr1:6052765-6160523 - - 48.7059 8.83202 88.5798 OK 95.0662 71.8645 118.268 OK 32.7443 0 84.645 OK P123 - - XLOC_000065 KCNAB2 TSS85 chr1:6052765-6160523 - - 4.70189 0 23.6288 OK 14.9138 3.68932 26.1382 OK 1.91789 0 34.113 OK P124 - - XLOC_000065 KCNAB2 TSS84,TSS85,TSS86 chr1:6052765-6160523 - - 16.2452 0 54.3777 OK 21.0828 8.30958 33.8561 OK 68.4146 0.707363 136.122 OK P125 - - XLOC_000065 KCNAB2 TSS87 chr1:6052765-6160523 - - 3.90167 0 29.1169 OK 0.706557 0 4.26385 OK 0 0 0 OK P126 - - XLOC_000066 RNF207 TSS89 chr1:6266188-6296044 - - 15.3246 0 237.481 OK 17.0218 0 66.4273 OK 10.1307 0 1022.49 OK P127 - - XLOC_000066 RNF207 TSS88 chr1:6266188-6296044 - - 37.9114 0 138.554 OK 28.2454 0.993569 55.4972 OK 35.0042 0 351.584 OK P128 - - XLOC_000066 RNF207 TSS88 chr1:6266188-6296044 - - 11.3399 0 85.8279 OK 12.8983 0 50.6886 OK 4.63395 0 104.992 OK P129 - - XLOC_000068 HES3 TSS92 chr1:6304261-6305638 - - 435.49 167.883 703.097 OK 1431.61 1179.29 1683.94 OK 0 0 0 OK P13 - - XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 - - 6.18605 0.40302 11.9691 OK 13.3791 6.94109 19.817 OK 5.90797 0 41.0692 OK P130 - - XLOC_000069 ESPN TSS94 chr1:6484847-6521003 - - 11.3056 0 27.1057 OK 157.325 115.978 198.673 OK 0 0 0 OK P131 - - XLOC_000069 ESPN TSS93 chr1:6484847-6521003 - - 7.69434 0 16.3569 OK 20.3609 6.88119 33.8405 OK 0.205083 0 0.894501 OK P132 - - XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 - - 2.01343 0 6.79721 OK 0.10991 0 1.17006 OK 8.05147e-05 0 1.33365 OK P133 - - XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 - - 0.00440741 0 2.21976 OK 0 0 0 OK 1.29131 0 4.66984 OK P134 - - XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 - - 1.5274 0 4.85725 OK 0.605201 0 1.88579 OK 0 0 0 OK P135 - - XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 - - 0 0 0 OK 0.536804 0 2.90782 OK 4.20431 0 11.5663 OK P136 - - XLOC_000071 - TSS97 chr1:6640055-6649339 - - 23.546 0 68.0149 OK 85.1502 54.8878 115.413 OK 38.1578 0 102.208 OK P137 - - XLOC_000071 ZBTB48 TSS96 chr1:6640055-6649339 - - 157.618 62.2204 253.016 OK 241.107 194.764 287.45 OK 214.473 56.6009 372.345 OK P138 - - XLOC_000072 PHF13 TSS98 chr1:6673755-6684092 - - 277.454 147.158 407.75 OK 660.096 566.862 753.331 OK 769.313 441.751 1096.88 OK P139 - - XLOC_000073 THAP3 TSS100 chr1:6684924-6761966 - - 27.7067 0 193.703 OK 87.2395 8.25456 166.224 OK 129.652 0 629.304 OK P14 - - XLOC_000018 ISG15 TSS15 chr1:948846-949915 - - 550.84 220.139 881.541 OK 987.18 798.765 1175.6 OK 3379.09 1852.53 4905.64 OK P140 - - XLOC_000073 THAP3 TSS99 chr1:6684924-6761966 - - 69.7903 0 270.762 OK 126.801 34.04 219.563 OK 402.426 0 1046.12 OK P141 - - XLOC_000073 THAP3 TSS100 chr1:6684924-6761966 - - 7.22222 0 113.094 OK 19.5526 0 52.1803 OK 26.3763 0 314.839 OK P142 - - XLOC_000074 - TSS104 chr1:6845383-7829763 - - 1.762 0 41.0413 OK 0 0 0 OK 0 0 0 OK P143 - - XLOC_000074 CAMTA1 TSS103 chr1:6845383-7829763 - - 0 0 0 OK 0 0 0 OK 1.97243 0 40.9763 OK P144 - - XLOC_000074 CAMTA1 TSS102 chr1:6845383-7829763 - - 8.87986 0 34.9381 OK 26.1246 14.0847 38.1644 OK 0 0 0 OK P145 - - XLOC_000074 CAMTA1 TSS101 chr1:6845383-7829763 - - 4.74737 0 16.3548 OK 8.2803 2.66768 13.8929 OK 3.72176 0 24.6657 OK P146 - - XLOC_000075 VAMP3 TSS105 chr1:7831328-7841491 - - 1500.64 962.379 2038.91 OK 502.334 419.37 585.299 OK 7098.44 3876.89 10320 OK P147 - - XLOC_000076 PER3 TSS107 chr1:7844379-7973294 - - 26.7829 0 123.208 OK 47.2457 28.5439 65.9475 OK 0 0 0 OK P148 - - XLOC_000076 PER3 TSS106 chr1:7844379-7973294 - - 13.107 0 67.7636 OK 0 0 0 OK 17.4103 0 82.8904 OK P149 - - XLOC_000076 PER3 TSS107 chr1:7844379-7973294 - - 42.7797 0 92.8869 OK 7.06457 1.40267 12.7265 OK 82.6263 4.20638 161.046 OK P15 - - XLOC_000019 AGRN TSS16 chr1:955502-991492 - - 162.844 89.8907 235.797 OK 1857.6 1668.93 2046.27 OK 2553.38 1302.85 3803.9 OK P150 - - XLOC_000076 PER3 TSS106 chr1:7844379-7973294 - - 54.7294 0 200.706 OK 7.32764 0 20.8878 OK 29.553 0 195.596 OK P151 - - XLOC_000076 PER3 TSS107 chr1:7844379-7973294 - - 14.3316 0 50.4134 OK 2.51904 0 7.05031 OK 7.31695 0 43.1988 OK P152 - - XLOC_000076 PER3 TSS107 chr1:7844379-7973294 - - 139.727 47.5836 231.869 OK 53.7103 39.7842 67.6364 OK 221.632 88.7033 354.56 OK P153 - - XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 - - 57.799 0 210.952 OK 27.1603 0 73.3072 OK 17.1487 0 1349.12 OK P154 - - XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 - - 34.9676 0 365.789 OK 35.935 0 132.768 OK 301.624 0 2879.48 OK P155 - - XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 - - 4584.38 2840.27 6328.5 OK 8370.4 7342.31 9398.48 OK 21322.7 10003.9 32641.5 OK P156 - - XLOC_000078 SLC45A1 TSS109 chr1:8384389-8404226 - - 1.80448 0 6.154 OK 29.7198 20.3457 39.0939 OK 142.738 43.7625 241.713 OK P157 - - XLOC_000078 SLC45A1 TSS110 chr1:8384389-8404226 - - 9.62868 0 19.3119 OK 9.9298 1.33427 18.5253 OK 69.3396 0 173.193 OK P158 - - XLOC_000079 CA6 TSS111 chr1:9005921-9035146 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P159 - - XLOC_000079 CA6 TSS111 chr1:9005921-9035146 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P16 - - XLOC_000021 - TSS18 chr1:1072396-1079432 - - 0 0 0 OK 1.64828 0 3.73103 OK 0 0 0 OK P160 - - XLOC_000080 H6PD TSS112 chr1:9294862-9331392 - - 137.324 75.6555 198.993 OK 93.0165 77.025 109.008 OK 1112.18 629.474 1594.88 OK P161 - - XLOC_000081 SPSB1 TSS113,TSS114 chr1:9352940-9429588 - - 87.8037 28.4811 147.126 OK 86.131 64.192 108.07 OK 876.41 453.881 1298.94 OK P162 - - XLOC_000082 SLC25A33 TSS115 chr1:9599527-9642830 - - 0 0 0 OK 21.5619 0 87.518 OK 8.24063 0 65.4945 OK P163 - - XLOC_000082 SLC25A33 TSS115 chr1:9599527-9642830 - - 216.702 89.7467 343.656 OK 207.722 137.586 277.857 OK 258.098 86.8484 429.348 OK P164 - - XLOC_000083 TMEM201 TSS116 chr1:9648976-9674935 - - 68.1769 16.6605 119.693 OK 171.51 130.412 212.609 OK 257.242 112.588 401.896 OK P165 - - XLOC_000083 TMEM201 TSS116 chr1:9648976-9674935 - - 54.5583 7.52987 101.587 OK 230.871 182.65 279.092 OK 73.4533 0 153.58 OK P166 - - XLOC_000084 PIK3CD TSS119 chr1:9711789-9884550 - - 17.0706 0 54.8339 OK 25.5368 0 51.0761 OK 21.2442 0 553.241 OK P167 - - XLOC_000084 PIK3CD TSS117 chr1:9711789-9884550 - - 42.5258 0 112.708 OK 260.118 181.483 338.754 OK 45.2674 0 579.677 OK P168 - - XLOC_000084 PIK3CD TSS118 chr1:9711789-9884550 - - 132.845 26.5593 239.131 OK 155.927 94.5391 217.315 OK 109.373 0 648.449 OK P169 - - XLOC_000085 NMNAT1 TSS120 chr1:10003485-10045555 - - 61.6068 21.6744 101.539 OK 39.4422 30.2486 48.6358 OK 319.369 166.702 472.035 OK P17 - - XLOC_000025 TTLL10 TSS20 chr1:1108435-1133313 - - 0 0 0 OK 6.97279 2.01336 11.9322 OK 0 0 0 OK P170 - - XLOC_000086 RBP7 TSS121 chr1:10057254-10076077 - - 115.178 32.484 197.872 OK 229.575 173.78 285.371 OK 19.7819 0 39.7651 OK P171 - - XLOC_000087 - TSS122 chr1:10093015-10241294 - - 0 0 0 OK 4.50396 0 16.6407 OK 0 0 0 OK P172 - - XLOC_000087 - TSS124 chr1:10093015-10241294 - - 7.8499 0 129.227 OK 10.3213 0 42.9367 OK 200.875 0 653.389 OK P173 - - XLOC_000087 UBE4B TSS122 chr1:10093015-10241294 - - 515.733 327.125 704.341 OK 1102.07 970.856 1233.29 OK 1122.9 618.088 1627.72 OK P174 - - XLOC_000087 - TSS123 chr1:10093015-10241294 - - 171.613 0 479.562 OK 10.087 0 66.4644 OK 70.0715 0 791.741 OK P175 - - XLOC_000087 UBE4B TSS122 chr1:10093015-10241294 - - 15.4936 0 48.4491 OK 20.3244 2.17193 38.4768 OK 40.3364 0 143.901 OK P176 - - XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P177 - - XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 - - 0 0 0 OK 3.19143 0 10.4165 OK 0 0 0 OK P178 - - XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P179 - - XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 - - 76.9201 0 185.844 OK 87.5644 57.3981 117.731 OK 29.2168 0 142.034 OK P18 - - XLOC_000025 TTLL10 TSS19 chr1:1108435-1133313 - - 0 0 0 OK 9.72413 4.39939 15.0489 OK 0 0 0 OK P180 - - XLOC_000088 KIF1B TSS126 chr1:10270763-10441659 - - 0 0 0 OK 1.09608 0 9.00725 OK 5.57672 0 81.5452 OK P181 - - XLOC_000088 KIF1B TSS125 chr1:10270763-10441659 - - 419.379 235.939 602.82 OK 196.401 149.742 243.06 OK 864.235 440.814 1287.66 OK P182 - - XLOC_000088 KIF1B TSS125 chr1:10270763-10441659 - - 410.895 257.554 564.236 OK 346.933 294.33 399.535 OK 143.712 0 291.544 OK P183 - - XLOC_000089 PGD TSS128 chr1:10459084-10480200 - - 1337.23 829.624 1844.83 OK 6778.74 6061.76 7495.72 OK 13482.1 6095.5 20868.7 OK P184 - - XLOC_000089 PGD TSS128 chr1:10459084-10480200 - - 5.58516 0 127.824 OK 2.2212 0 50.1987 OK 4.89393 0 2165.66 OK P185 - - XLOC_000089 PGD TSS128 chr1:10459084-10480200 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P186 - - XLOC_000089 PGD TSS128 chr1:10459084-10480200 - - 74.0847 0 219.053 OK 402.424 216.163 588.686 OK 483.083 0 2470.52 OK P187 - - XLOC_000090 CORT TSS131 chr1:10490158-10512208 - - 33.6985 0 108.268 OK 27.3151 7.59018 47.0399 OK 12.1268 0 127.453 OK P188 - - XLOC_000090 APITD1 TSS130 chr1:10490158-10512208 - - 172.607 47.2749 297.939 OK 138.152 98.4097 177.895 OK 526.06 218.688 833.433 OK P189 - - XLOC_000090 Cort TSS129 chr1:10490158-10512208 - - 5.24611 0 70.1335 OK 9.52176 0 23.3909 OK 3.73278 0 123.626 OK P19 - - XLOC_000026 B3GALT6 - chr1:1167628-1170418 - - 223.432 108.188 338.676 OK 276.214 227.595 324.832 OK 1068.96 617.478 1520.43 OK P190 - - XLOC_000090 APITD1 TSS129 chr1:10490158-10512208 - - 67.0275 0 156.476 OK 84.7865 49.158 120.415 OK 99.6012 0 278.374 OK P191 - - XLOC_000090 APITD1 TSS129 chr1:10490158-10512208 - - 6.3006 0 63.5049 OK 0 0 0 OK 21.9227 0 108.02 OK P192 - - XLOC_000091 PEX14 TSS132 chr1:10535002-10690813 - - 173.496 67.1611 279.831 OK 598.647 499.468 697.826 OK 1041.13 555.011 1527.24 OK P193 - - XLOC_000091 PEX14 TSS132 chr1:10535002-10690813 - - 0 0 0 OK 0 0 0 OK 44.4442 0 165.099 OK P194 - - XLOC_000091 PEX14 TSS132,TSS133 chr1:10535002-10690813 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P195 - - XLOC_000091 Pex14 TSS132 chr1:10535002-10690813 - - 18.0364 0 79.5216 OK 7.51008 0 29.0484 OK 3.68586 0 252.272 OK P196 - - XLOC_000092 TARDBP TSS134 chr1:11072678-11085548 - - 1888.95 1374.83 2403.07 OK 2365.52 2106.77 2624.28 OK 2744.34 1535.58 3953.11 OK P197 - - XLOC_000092 TARDBP TSS134 chr1:11072678-11085548 - - 30.0352 0 104.936 OK 35.6818 0 72.6789 OK 0 0 0 OK P198 - - XLOC_000093 ANGPTL7 TSS135 chr1:11166588-11322608 - - 25.3243 0 101.602 OK 0.912846 0 7.62052 OK 10.571 0 84.7445 OK P199 - - XLOC_000094 UBIAD1 TSS136 chr1:11333254-11348490 - - 358.008 199.441 516.575 OK 307.383 257.097 357.67 OK 332.294 172.345 492.244 OK P2 - - XLOC_000002 OR4F5 - chr1:69090-70008 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P20 - - XLOC_000027 SCNN1D TSS22 chr1:1215815-1227409 - - 0 0 0 OK 30.4263 16.9744 43.8783 OK 12.2197 0 47.6642 OK P200 - - XLOC_000095 PTCHD2 TSS137 chr1:11539294-11597639 - - 14.6751 1.33607 28.0142 OK 61.7115 48.8554 74.5676 OK 0.546235 0 1.46443 OK P201 - - XLOC_000095 PTCHD2 TSS138 chr1:11539294-11597639 - - 12.3118 0 33.4266 OK 0 0 0 OK 7.55415e-05 0 0.868989 OK P202 - - XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 - - 0 0 0 OK 5.92521 0 39.3998 OK 8.07306 0 58.7162 OK P203 - - XLOC_000096 FBXO44 TSS139,TSS140 chr1:11708449-11723383 - - 55.1609 0 128.397 OK 149.919 77.8585 221.979 OK 193.294 42.4851 344.102 OK P204 - - XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 - - 0.00708472 0 1.93513 OK 42.0022 0 99.8437 OK 0 0 0 OK P205 - - XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 - - 41.3995 0 208.17 OK 143.48 16.6133 270.346 OK 66.4903 0 290.353 OK P206 - - XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 - - 74.4128 0.102045 148.723 OK 217.658 142.709 292.608 OK 157.781 27.9354 287.627 OK P207 - - XLOC_000097 FBXO6 TSS141 chr1:11724149-11734407 - - 77.8716 25.4534 130.29 OK 25.5712 17.1689 33.9736 OK 363.317 155.989 570.645 OK P208 - - XLOC_000098 C1orf187 TSS142 chr1:11751780-11780336 - - 200.894 86.0788 315.709 OK 340.257 276.998 403.517 OK 11.5677 0 24.207 OK P209 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 75.7885 0 308.262 OK 48.0216 0 96.4784 OK 31.884 0 211.834 OK P21 - - XLOC_000027 SCNN1D TSS21 chr1:1215815-1227409 - - 0 0 0 OK 2.57257 0 7.31455 OK 9.60499 0 29.932 OK P210 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 0 0 0 OK 9.26798 0 42.3294 OK 41.1964 0 245.026 OK P211 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 326.456 0 660.559 OK 1078.57 872.073 1285.07 OK 1331.71 578.575 2084.84 OK P212 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 107.513 0 339.089 OK 212.87 121.661 304.079 OK 117.552 0 453.857 OK P213 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 238.184 6.58558 469.782 OK 261.965 153.63 370.299 OK 389.478 0 812.01 OK P214 - - XLOC_000102 C1orf167 TSS146 chr1:11832138-11866115 - - 1.75837 0 16.9438 OK 2.17987 0 13.4504 OK 8.96806 0 243.105 OK P215 - - XLOC_000102 C1orf167 TSS145 chr1:11832138-11866115 - - 0 0 0 OK 2.18711 0 8.40798 OK 0 0 0 OK P216 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 0 0 0 OK 7.96239 0 32.3271 OK 11.3029 0 347.528 OK P217 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 4.86566 0 179.821 OK 4.82023 0 33.0013 OK 2.44992 0 534.304 OK P218 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P219 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 22.1488 0 102.377 OK 0.995584 0 7.28035 OK 0 0 0 OK P22 - - XLOC_000027 SCNN1D TSS21,TSS22 chr1:1215815-1227409 - - 8.76465 1.80131 15.728 OK 37.2973 22.3548 52.2398 OK 34.8954 0 69.8046 OK P220 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 108.07 50.2145 165.925 OK 325.683 276.873 374.493 OK 514.96 291.011 738.909 OK P221 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 0.0423122 0 1.29723 OK 0.0955929 0 0.937899 OK 0 0 0 OK P222 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 14.401 0 109.117 OK 18.414 0 54.7231 OK 40.6369 0 309.835 OK P223 - - XLOC_000104 PLOD1 TSS149 chr1:11994745-12035593 - - 16.0046 0 194.844 OK 1.78544 0 12.461 OK 116.452 0 1835.19 OK P224 - - XLOC_000104 PLOD1 TSS149 chr1:11994745-12035593 - - 849.538 480.251 1218.82 OK 954.766 823.617 1085.92 OK 10325.2 4110.35 16540 OK P225 - - XLOC_000105 MFN2 TSS150 chr1:12040237-12073571 - - 647.078 417.464 876.692 OK 942.066 826.307 1057.82 OK 2871.51 1538.86 4204.17 OK P226 - - XLOC_000106 MIIP TSS151 chr1:12079511-12092106 - - 504.143 253.799 754.486 OK 1223.51 1040.45 1406.58 OK 575.01 277.02 872.999 OK P227 - - XLOC_000107 TNFRSF8 TSS153 chr1:12123433-12204262 - - 6.44015 0 62.9259 OK 0 0 0 OK 4.00161 0 15.7775 OK P228 - - XLOC_000107 TNFRSF8 TSS152 chr1:12123433-12204262 - - 178.549 80.9938 276.105 OK 413.544 348.077 479.011 OK 4.49588 0 11.7194 OK P229 - - XLOC_000107 TNFRSF8 TSS152 chr1:12123433-12204262 - - 19.3321 0 72.4532 OK 18.4204 2.92604 33.9147 OK 0.000474981 0 0.677462 OK P23 - - XLOC_000027 SCNN1D TSS22 chr1:1215815-1227409 - - 0 0 0 OK 4.36667 0 10.2072 OK 6.75717 0 24.3184 OK P230 - - XLOC_000107 TNFRSF8 TSS153 chr1:12123433-12204262 - - 0 0 0 OK 9.03791 0 24.7179 OK 0 0 0 OK P231 - - XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 - - 0.000432929 0 1.42456 OK 5.69324 0.759314 10.6272 OK 110.504 0 301.299 OK P232 - - XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 - - 0 0 0 OK 28.1716 20.0823 36.2609 OK 1285.44 700.762 1870.11 OK P233 - - XLOC_000109 - TSS157 chr1:12290112-12572096 - - 39.9995 0 130.49 OK 0 0 0 OK 0 0 0 OK P234 - - XLOC_000109 VPS13D TSS155 chr1:12290112-12572096 - - 12.8407 0 38.8899 OK 0 0 0 OK 0 0 0 OK P235 - - XLOC_000109 - TSS159 chr1:12290112-12572096 - - 0 0 0 OK 4.58204 0 13.0797 OK 2.38321 0 131.228 OK P236 - - XLOC_000109 VPS13D TSS155 chr1:12290112-12572096 - - 315.192 216.361 414.022 OK 71.9285 56.898 86.959 OK 191.792 34.7885 348.795 OK P237 - - XLOC_000109 VPS13D TSS156 chr1:12290112-12572096 - - 19.4784 0 51.136 OK 66.1936 50.8275 81.5597 OK 94.7776 0 253.886 OK P238 - - XLOC_000111 AADACL4 TSS160 chr1:12704565-12727096 - - 0.911079 0 3.43339 OK 1.34969 0 3.25839 OK 0 0 0 OK P239 - - XLOC_000112 AADACL3 TSS161 chr1:12776117-12788726 - - 8.82724 0 26.7047 OK 1.92876 0 4.16682 OK 0 0 0 OK P24 - - XLOC_000028 PUSL1 TSS23 chr1:1227763-1260046 - - 253.688 0 583.851 OK 666.825 418.631 915.019 OK 694.672 0 2057.39 OK P240 - - XLOC_000112 AADACL3 TSS161 chr1:12776117-12788726 - - 47.604 14.4641 80.7439 OK 8.12602 4.87454 11.3775 OK 0 0 0 OK P241 - - XLOC_000113 C1orf158 TSS162 chr1:12806162-12821101 - - 5.40803e-05 0 5.83215 OK 0.592256 0 2.93724 OK 0 0 0 OK P242 - - XLOC_000113 C1orf158 TSS162 chr1:12806162-12821101 - - 1.78172 0 8.60998 OK 0.698209 0 3.4627 OK 0 0 0 OK P243 - - XLOC_000114 PRAMEF12 TSS163 chr1:12834983-12838046 - - 3.60576 0 8.25249 OK 0.853096 0 2.25332 OK 0 0 0 OK P244 - - XLOC_000115 PRAMEF1 TSS164 chr1:12851545-12856223 - - 1.07984 0 3.77465 OK 0 0 0 OK 0 0 0 OK P245 - - XLOC_000116 PRAMEF2 TSS165 chr1:12916940-12921764 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P246 - - XLOC_000117 PRAMEF8 TSS166 chr1:12976449-12980566 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P247 - - XLOC_000118 PRAMEF22 TSS167 chr1:12998301-13117751 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P248 - - XLOC_000119 PRAMEF6 TSS168 chr1:13359818-13369057 - - 0.310672 0 1.64522 OK 0 0 0 OK 0 0 0 OK P249 - - XLOC_000120 PRAMEF9 TSS169 chr1:13421175-13428191 - - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK P25 - - XLOC_000028 PUSL1 TSS24 chr1:1227763-1260046 - - 21.1644 0 123.978 OK 14.7123 0 53.2867 OK 15.8664 0 616.273 OK P250 - - XLOC_000121 PRAMEF16 TSS170 chr1:13495253-13498257 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P251 - - XLOC_000122 PRAMEF20 TSS171 chr1:13516065-13526943 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P252 - - XLOC_000124 PRAMEF9 TSS173 chr1:13641972-13648988 - - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK P253 - - XLOC_000125 PRAMEF17 TSS174 chr1:13716087-13719064 - - 0 0 0 OK 0.330232 0 1.26905 OK 0 0 0 OK P254 - - XLOC_000126 PRAMEF20 TSS175 chr1:13736906-13747803 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P255 - - XLOC_000127 PDPN TSS176 chr1:13910251-13944450 - - 695.717 363.437 1028 OK 816.633 656.551 976.715 OK 40.2891 0 96.477 OK P256 - - XLOC_000127 PDPN TSS176 chr1:13910251-13944450 - - 602.018 287.765 916.272 OK 879.809 709.521 1050.1 OK 70.7232 9.4972 131.949 OK P257 - - XLOC_000127 PDPN TSS178 chr1:13910251-13944450 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P258 - - XLOC_000127 PDPN TSS177,TSS178 chr1:13910251-13944450 - - 0 0 0 OK 6.91549 0 28.1518 OK 0 0 0 OK P259 - - XLOC_000128 PRDM2 TSS180 chr1:14026734-14151572 - - 14.792 0 39.9282 OK 20.5972 11.244 29.9504 OK 14.8538 0 45.2703 OK P26 - - XLOC_000028 PUSL1 TSS23 chr1:1227763-1260046 - - 81.6371 0 261.06 OK 108.47 1.07573 215.865 OK 160.99 0 1191.98 OK P260 - - XLOC_000128 PRDM2 TSS180 chr1:14026734-14151572 - - 47.3072 1.25487 93.3594 OK 9.21056 2.5931 15.828 OK 0 0 0 OK P261 - - XLOC_000128 PRDM2 TSS179 chr1:14026734-14151572 - - 0 0 0 OK 12.8679 0 26.1446 OK 27.8928 0 122.208 OK P262 - - XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 - - 4.006 0 121.226 OK 0 0 0 OK 43.9125 0 174.229 OK P263 - - XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 - - 173.834 83.3001 264.367 OK 111.179 88.5434 133.815 OK 358.942 192.325 525.56 OK P264 - - XLOC_000129 - TSS188 chr1:14925212-15478960 - - 7.67766 0 24.5275 OK 5.19027 0 11.3244 OK 10.0324 0 51.1545 OK P265 - - XLOC_000129 - TSS184 chr1:14925212-15478960 - - 1.99898 0 21.9495 OK 19.5662 6.88158 32.2509 OK 29.388 0 98.7243 OK P266 - - XLOC_000129 - TSS183 chr1:14925212-15478960 - - 0 0 0 OK 9.84787 3.11669 16.579 OK 6.7035 0 37.6764 OK P267 - - XLOC_000129 - TSS183 chr1:14925212-15478960 - - 51.7288 10.5132 92.9443 OK 45.0754 27.3766 62.7741 OK 3.19938 0 58.3721 OK P268 - - XLOC_000129 - TSS187 chr1:14925212-15478960 - - 0 0 0 OK 79.6627 55.0254 104.3 OK 208.608 0 479.942 OK P269 - - XLOC_000129 - TSS185,TSS186 chr1:14925212-15478960 - - 5.70387 0 24.8579 OK 0 0 0 OK 219.237 0 473.092 OK P27 - - XLOC_000029 GLTPD1 TSS25 chr1:1260142-1264275 - - 140.404 57.7844 223.024 OK 187.156 149.818 224.494 OK 781.158 428.727 1133.59 OK P270 - - XLOC_000130 TMEM51 TSS190 chr1:15479027-15546973 - - 0 0 0 OK 17.2845 1.57331 32.9958 OK 65.7759 0 185.612 OK P271 - - XLOC_000130 TMEM51 TSS189,TSS190 chr1:15479027-15546973 - - 145.058 27.4297 262.686 OK 215.094 159.837 270.351 OK 648.261 262.621 1033.9 OK P272 - - XLOC_000131 FHAD1 TSS194 chr1:15573767-15726776 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P273 - - XLOC_000131 - TSS193 chr1:15573767-15726776 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P274 - - XLOC_000131 FHAD1 TSS192 chr1:15573767-15726776 - - 2.21856 0 5.46644 OK 1.79489 0.20316 3.38662 OK 0.862567 0 3.90708 OK P275 - - XLOC_000131 FHAD1 TSS191 chr1:15573767-15726776 - - 3.59181 0.183939 6.99968 OK 6.18974 3.93462 8.44486 OK 2.29329 0 5.69816 OK P276 - - XLOC_000131 FHAD1 TSS195 chr1:15573767-15726776 - - 0 0 0 OK 0.429055 0 2.04463 OK 0.572031 0 3.90272 OK P277 - - XLOC_000132 EFHD2 TSS197 chr1:15736390-15756839 - - 330.754 166.776 494.733 OK 468.604 391.665 545.542 OK 2197 1271.73 3122.27 OK P278 - - XLOC_000133 CTRC TSS198 chr1:15764937-15773153 - - 3.36755e-05 0 6.80907 OK 0 0 0 OK 0 0 0 OK P279 - - XLOC_000133 CTRC TSS198 chr1:15764937-15773153 - - 2.23634 0 10.8068 OK 0 0 0 OK 5.61806 0 14.0003 OK P28 - - XLOC_000030 TAS1R3 TSS26 chr1:1266725-1269843 - - 6.25639 0.748851 11.7639 OK 2.57898 0.558292 4.59967 OK 4.31837 0 8.68841 OK P280 - - XLOC_000134 CELA2A TSS199 chr1:15783222-15798585 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P281 - - XLOC_000135 CELA2B TSS200 chr1:15802595-15851384 - - 0 0 0 OK 1.27477 0 8.01985 OK 0 0 0 OK P282 - - XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 - - 108.544 0 248.389 OK 22.5422 3.21503 41.8694 OK 18.3447 0 120.225 OK P283 - - XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 - - 264.402 137.955 390.849 OK 106.224 82.8924 129.555 OK 279.288 135.236 423.34 OK P284 - - XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 - - 92.0125 11.4082 172.617 OK 24.4409 10.7251 38.1567 OK 78.8225 0 161.552 OK P285 - - XLOC_000137 DDI2 TSS204 chr1:15944069-15988216 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P286 - - XLOC_000137 DDI2 TSS203 chr1:15944069-15988216 - - 45.7332 0 156.435 OK 1.92594 0 13.6556 OK 0.922843 0 14.8423 OK P287 - - XLOC_000137 RSC1A1 - chr1:15944069-15988216 - - 534.708 227.419 841.998 OK 259.157 196.292 322.022 OK 376.086 126.216 625.956 OK P288 - - XLOC_000137 DDI2 TSS203 chr1:15944069-15988216 - - 439.099 149.697 728.502 OK 268.762 203.047 334.476 OK 310.347 73.3654 547.328 OK P2881 - - XLOC_001221 OR4F16 - chr1:621097-622034 - - 1.51396 0 5.87661 OK 0 0 0 OK 0 0 0 OK P2882 - - XLOC_001222 - TSS1915,TSS1916 chr1:661139-679736 - - 176.913 41.1689 312.658 OK 316.357 254.319 378.395 OK 41.5721 1.4562 81.688 OK P2883 - - XLOC_001228 - - chr1:761586-762902 - - 29.1742 7.70701 50.6415 OK 19.6665 11.5626 27.7703 OK 39.9678 6.81386 73.1216 OK P2884 - - XLOC_001231 NOC2L TSS1922 chr1:860529-894679 - - 43.7364 0 260.927 OK 97.2158 0 208.789 OK 72.8474 0 900.598 OK P2885 - - XLOC_001231 NOC2L TSS1922 chr1:860529-894679 - - 328.516 127.865 529.168 OK 547.174 419.441 674.908 OK 646.349 106.239 1186.46 OK P2886 - - XLOC_001231 NOC2L TSS1922 chr1:860529-894679 - - 256.209 73.1015 439.318 OK 1090.31 914.057 1266.57 OK 1445.11 454.626 2435.59 OK P2887 - - XLOC_001231 NOC2L TSS1921 chr1:860529-894679 - - 36.029 0 101.075 OK 100.448 56.5333 144.362 OK 55.7714 0 492.764 OK P2888 - - XLOC_001232 C1orf170 TSS1924 chr1:910578-917473 - - 0 0 0 OK 0.517867 0 2.40899 OK 2.14049 0 8.01859 OK P2889 - - XLOC_001233 HES4 TSS1925 chr1:934341-935552 - - 54.1565 11.0853 97.2278 OK 25.1834 11.4684 38.8983 OK 29.4876 0 65.9328 OK P289 - - XLOC_000139 PLEKHM2 TSS205 chr1:16010826-16061262 - - 363.264 206.673 519.855 OK 779.207 675.262 883.152 OK 2346.33 1341.89 3350.77 OK P2890 - - XLOC_001233 HES4 TSS1925 chr1:934341-935552 - - 0 0 0 OK 12.2395 1.62527 22.8538 OK 4.13955 0 25.7443 OK P2891 - - XLOC_001234 C1orf159 TSS1929 chr1:1017197-1051736 - - 18.8091 0 45.1259 OK 6.807 0 14.8624 OK 19.7743 0 61.3035 OK P2892 - - XLOC_001234 C1orf159 TSS1928,TSS1929 chr1:1017197-1051736 - - 50.4508 0.525248 100.376 OK 91.6026 61.4046 121.8 OK 80.2251 0 210.33 OK P2893 - - XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 - - 16.1923 0 44.6862 OK 14.7307 3.76971 25.6916 OK 0 0 0 OK P2894 - - XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 - - 0.00198038 0 3.09528 OK 11.9017 0 26.3618 OK 53.0677 0 181.473 OK P2895 - - XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 - - 9.95714 0 47.2577 OK 21.5806 4.15913 39.0021 OK 22.7448 0 122.396 OK P2896 - - XLOC_001235 - TSS1930 chr1:1108435-1133313 - - 0.346272 0 1.78395 OK 5.99833 3.26167 8.73498 OK 0 0 0 OK P2897 - - XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 - - 1.73622 0 6.57555 OK 0 0 0 OK 14.2685 0 28.6165 OK P2898 - - XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 - - 0.00252879 0 4.74227 OK 24.8393 13.5618 36.1167 OK 0.00130815 0 2.28068 OK P2899 - - XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P29 - - XLOC_000031 - TSS27 chr1:1334909-1342693 - - 53.2662 0 201.851 OK 152.655 72.5948 232.716 OK 319.473 0 868.813 OK P290 - - XLOC_000140 SLC25A34 TSS206 chr1:16062808-16067885 - - 6.39779 0.605227 12.1903 OK 8.64356 5.26239 12.0247 OK 9.3373 0 19.2115 OK P2900 - - XLOC_001236 TNFRSF18 TSS1931 chr1:1138888-1142089 - - 2.09869 0 9.84106 OK 10.3558 0.808242 19.9033 OK 0 0 0 OK P2901 - - XLOC_001237 TNFRSF4 TSS1933 chr1:1146706-1149512 - - 0 0 0 OK 1.21775 0 2.94864 OK 0 0 0 OK P2902 - - XLOC_001237 TNFRSF4 TSS1933 chr1:1146706-1149512 - - 1.29516 0 6.6725 OK 0 0 0 OK 5.89401 0 12.8778 OK P2903 - - XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 - - 39.6628 0 152.233 OK 17.9039 0 44.1172 OK 539.303 0 1868.4 OK P2904 - - XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2905 - - XLOC_001238 SDF4 TSS1936 chr1:1152288-1167447 - - 32.4396 0 287.775 OK 210.708 62.714 358.702 OK 114.07 0 3312.32 OK P2906 - - XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 - - 829.134 458.508 1199.76 OK 1473.6 1260.01 1687.18 OK 8370.57 4261.26 12479.9 OK P2907 - - XLOC_001239 FAM132A TSS1937 chr1:1177832-1182102 - - 17.131 3.00892 31.2531 OK 41.9198 28.3894 55.4503 OK 75.8216 10.8039 140.839 OK P2908 - - XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 - - 10.1146 0 68.193 OK 21.3064 0 42.9115 OK 95.4488 0 347.781 OK P2909 - - XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 - - 25.4338 0 112.869 OK 55.9053 0 124.26 OK 160.966 0 444.912 OK P291 - - XLOC_000141 TMEM82 TSS208 chr1:16068916-16074475 - - 11.5611 1.91174 21.2104 OK 31.4534 22.0675 40.8392 OK 0 0 0 OK P2910 - - XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 - - 440.007 206.23 673.785 OK 621.812 501.453 742.172 OK 1704.75 892.6 2516.9 OK P2911 - - XLOC_001240 UBE2J2 TSS1938 chr1:1189293-1209234 - - 16.9893 0 75.1996 OK 15.5986 0 34.1698 OK 27.9153 0 219.894 OK P2912 - - XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 - - 5.41455 0 73.5691 OK 0 0 0 OK 2.68872 0 247.792 OK P2913 - - XLOC_001241 - - chr1:1189293-1209234 - - 17.2606 0 51.4891 OK 37.017 16.7475 57.2865 OK 20.3727 0 89.1972 OK P2914 - - XLOC_001242 ACAP3 TSS1942 chr1:1227763-1260046 - - 93.257 0 191.075 OK 181.357 110.619 252.095 OK 810.457 116.624 1504.29 OK P2915 - - XLOC_001242 ACAP3 TSS1940 chr1:1227763-1260046 - - 9.37264 0 74.2674 OK 139.601 71.7322 207.47 OK 101.369 0 437.866 OK P2916 - - XLOC_001242 - TSS1943 chr1:1227763-1260046 - - 26.1554 0 127.888 OK 117.46 33.8827 201.038 OK 131.616 0 709.538 OK P2917 - - XLOC_001242 ACAP3 TSS1941 chr1:1227763-1260046 - - 25.8307 0 74.8109 OK 113.499 67.0995 159.898 OK 86.9123 0 284.304 OK P2918 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2919 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 74.8279 0 206.509 OK 131.639 55.9243 207.355 OK 14.441 0 468.955 OK P292 - - XLOC_000142 FBLIM1 TSS211 chr1:16083153-16114431 - - 256.047 67.5364 444.557 OK 85.4176 40.8827 129.953 OK 333.297 0 860.312 OK P2920 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2921 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 0 0 0 OK 21.2906 0 64.1614 OK 3.63351 0 815.064 OK P2922 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 109.796 0 386.237 OK 428.913 212.206 645.62 OK 407.64 0 1518.33 OK P2923 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 22.9173 0 129.569 OK 99.7638 22.3861 177.141 OK 74.3645 0 666.501 OK P2924 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 11.6979 0 95.8203 OK 37.6829 0 78.8786 OK 23.1589 0 473.017 OK P2925 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 0 0 0 OK 45.4548 0 97.9165 OK 82.7322 0 580.841 OK P2926 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 590.361 257.107 923.615 OK 1597.84 1318.11 1877.56 OK 2355.04 711.934 3998.15 OK P2927 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 15.5849 0 93.1917 OK 41.6009 0 85.6853 OK 16.3417 0 452.747 OK P2928 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 28.1613 0 127.161 OK 4.26182 0 33.6676 OK 3.66246 0 701.004 OK P2929 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 4.09686 0 206.988 OK 41.7594 0 101.862 OK 7.63052 0 864.996 OK P293 - - XLOC_000142 FBLIM1 TSS211 chr1:16083153-16114431 - - 55.3931 0 243.059 OK 23.593 0 59.2406 OK 11.5775 0 662.25 OK P2930 - - XLOC_001244 DVL1 TSS1948 chr1:1270658-1284492 - - 30.2667 0 67.9866 OK 193.963 141.571 246.356 OK 23.7193 0 116.238 OK P2931 - - XLOC_001244 DVL1 TSS1947 chr1:1270658-1284492 - - 173.57 60.0717 287.069 OK 674.206 553.931 794.481 OK 1267.03 652.486 1881.58 OK P2932 - - XLOC_001244 DVL1 TSS1946 chr1:1270658-1284492 - - 63.7322 0 172.039 OK 263.001 102.409 423.593 OK 252.541 0 788.766 OK P2933 - - XLOC_001244 DVL1L1 TSS1946 chr1:1270658-1284492 - - 8.10625 0 61.6261 OK 31.5522 0 186.876 OK 49.6575 0 524.94 OK P2934 - - XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 - - 101.118 0 261.934 OK 0.00314546 0 1.04164 OK 2934.02 0 6584.05 OK P2935 - - XLOC_001245 MXRA8 TSS1950 chr1:1288071-1297157 - - 2.23252 0 130.782 OK 18.5375 6.65185 30.4231 OK 18.6477 0 1565.25 OK P2936 - - XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 - - 721.263 162.336 1280.19 OK 67.479 43.9127 91.0453 OK 8407.76 2732.83 14082.7 OK P2937 - - XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 - - 6.14109 0 154.008 OK 11.8645 0 24.3286 OK 95.5511 0 2206.12 OK P2938 - - XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 - - 248.639 0 768.622 OK 55.4345 31.8089 79.0601 OK 2864.03 0 6496.11 OK P2939 - - XLOC_001246 AURKAIP1 TSS1951,TSS1952,TSS1953 chr1:1309109-1310818 - - 2557.58 1487.24 3627.91 OK 3660.17 3043.99 4276.35 OK 7034.3 3300.38 10768.2 OK P294 - - XLOC_000142 FBLIM1 TSS209,TSS210 chr1:16083153-16114431 - - 583.762 315.598 851.925 OK 850.47 732.271 968.669 OK 2099.12 1047.56 3150.68 OK P2940 - - XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 - - 84.4595 0 188.854 OK 112.752 64.1239 161.381 OK 97.6848 0 339.464 OK P2941 - - XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 - - 17.0885 0 84.7288 OK 96.9882 45.5948 148.382 OK 18.1877 0 191.06 OK P2942 - - XLOC_001247 CCNL2 TSS1955,TSS1956 chr1:1321090-1334718 - - 121.14 0 259.658 OK 217.748 45.6202 389.875 OK 154.351 0 437.975 OK P2943 - - XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 - - 348.681 184.379 512.982 OK 352.289 280.826 423.752 OK 674.159 301.412 1046.91 OK P2944 - - XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 - - 172.404 14.834 329.974 OK 443.979 283.846 604.112 OK 322.484 0 808.388 OK P2945 - - XLOC_001248 MRPL20 TSS1958 chr1:1334909-1342693 - - 108.19 0 340.038 OK 88.7189 11.8203 165.617 OK 37.8673 0 558.576 OK P2946 - - XLOC_001248 MRPL20 TSS1958 chr1:1334909-1342693 - - 3025.74 1703.21 4348.28 OK 4267.92 3599.47 4936.36 OK 8706.81 4659.66 12754 OK P2947 - - XLOC_001249 - TSS1959 chr1:1353801-1356650 - - 6.61991 0 24.912 OK 6.86284 0.223504 13.5022 OK 15.6317 0 48.2588 OK P2948 - - XLOC_001249 - TSS1959 chr1:1353801-1356650 - - 0.00430007 0 3.73508 OK 49.1286 31.229 67.0282 OK 0.00204697 0 1.792 OK P2949 - - XLOC_001250 C1orf70 TSS1960 chr1:1470158-1475740 - - 31.9981 5.39734 58.5989 OK 83.1162 61.5122 104.72 OK 233.834 79.2517 388.416 OK P295 - - XLOC_000143 SPEN TSS212 chr1:16160709-16266950 - - 145.636 81.7357 209.536 OK 241.251 184.702 297.8 OK 293.864 120.858 466.87 OK P2950 - - XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 - - 17.0327 0 174.592 OK 11.4081 0 37.1104 OK 4.14556 0 649.699 OK P2951 - - XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 - - 407.325 161.607 653.043 OK 235.83 159.844 311.816 OK 430.732 0 954.81 OK P2952 - - XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 - - 1955.08 1125.52 2784.63 OK 3166.29 2731.74 3600.84 OK 6236.3 3304.63 9167.98 OK P2953 - - XLOC_001252 CDC2L2 TSS1967 chr1:1571099-1677431 - - 22.682 0 164.01 OK 146.455 30.1265 262.784 OK 84.2667 0 1251.48 OK P2954 - - XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 - - 10.5985 0 122.548 OK 162.241 57.9622 266.52 OK 113.359 0 1003.47 OK P2955 - - XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 - - 44.5894 0 149.251 OK 618 446.673 789.327 OK 1043.7 0 2330.01 OK P2956 - - XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 - - 10.007 0 94.4969 OK 204.998 103.477 306.519 OK 293.354 0 945.749 OK P2957 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 0 0 0 OK 0 0 0 OK 84.1064 0 1001.03 OK P2958 - - XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 - - 8.10282 0 269.633 OK 24.8037 0 84.2873 OK 114.365 0 1772.1 OK P2959 - - XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 - - 0.128652 0 7.38609 OK 1.12006 0 587.32 OK 3.69003 0 2773.47 OK P296 - - XLOC_000143 SPEN TSS213 chr1:16160709-16266950 - - 40.228 5.06363 75.3923 OK 140.357 82.3092 198.405 OK 168.12 40.5038 295.735 OK P2960 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 0 0 0 OK 21.7767 0 84.7472 OK 7.69268 0 2131.71 OK P2961 - - XLOC_001252 CDC2L2 TSS1968 chr1:1571099-1677431 - - 2.85432 0 40.805 OK 17.5163 0 104.005 OK 91.7595 0 2408.44 OK P2962 - - XLOC_001252 CDC2L1 TSS1968 chr1:1571099-1677431 - - 32.4975 0 885.193 OK 12.0452 0 124.703 OK 20.3251 0 3272.99 OK P2963 - - XLOC_001252 CDC2L1 TSS1968 chr1:1571099-1677431 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2964 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 0 0 0 OK 22.1371 0 58.1262 OK 6.57877 0 802.824 OK P2965 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2966 - - XLOC_001252 CDC2L1 TSS1963 chr1:1571099-1677431 - - 0 0 0 OK 123.643 33.6056 213.68 OK 186.844 0 1029.17 OK P2967 - - XLOC_001252 CDC2L1 TSS1963 chr1:1571099-1677431 - - 9.33823 0 135.943 OK 168.137 58.4402 277.834 OK 179.943 0 1110.15 OK P2968 - - XLOC_001252 CDC2L1 TSS1962 chr1:1571099-1677431 - - 33.8277 0 160.618 OK 205.562 59.0219 352.102 OK 286.25 0 1373.22 OK P2969 - - XLOC_001252 CDC2L2 TSS1966 chr1:1571099-1677431 - - 4.69427 0 168.13 OK 110.433 17.4495 203.416 OK 19.8478 0 1069.73 OK P297 - - XLOC_000144 C1orf64 TSS214 chr1:16330730-16333180 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2970 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 10.4083 0 99.9748 OK 0 0 0 OK 0 0 0 OK P2971 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2972 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 23.7584 0 102.845 OK 109.837 33.2422 186.432 OK 182.067 0 861.513 OK P2973 - - XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P2974 - - XLOC_001254 SLC35E2 TSS1972 chr1:1571099-1677431 - - 96.0585 0 298.365 OK 274.135 113.969 434.301 OK 431.974 0 1699.8 OK P2975 - - XLOC_001254 SLC35E2 TSS1972 chr1:1571099-1677431 - - 93.1692 0 248.949 OK 127.494 38.4432 216.546 OK 113.042 0 917.138 OK P2976 - - XLOC_001254 - TSS1971 chr1:1571099-1677431 - - 57.9127 0 130.206 OK 222.366 149.606 295.126 OK 276.724 0 723.736 OK P2977 - - XLOC_001254 SLC35E2 TSS1970 chr1:1571099-1677431 - - 21.1432 0 106.909 OK 37.3588 0 83.0054 OK 25.3689 0 783.128 OK P2978 - - XLOC_001254 SLC35E2 TSS1973 chr1:1571099-1677431 - - 48.2599 0 223.438 OK 122.207 2.4671 241.946 OK 362.567 0 1875.37 OK P2979 - - XLOC_001254 - TSS1970,TSS1972 chr1:1571099-1677431 - - 102.677 24.5984 180.756 OK 356.99 280.663 433.317 OK 499.17 0 1052.95 OK P298 - - XLOC_000145 CLCNKA TSS217 chr1:16340522-16400127 - - 0 0 0 OK 2.91986 0 14.6624 OK 0 0 0 OK P2980 - - XLOC_001254 SLC35E2 TSS1970 chr1:1571099-1677431 - - 19.9963 0 109.14 OK 15.2497 0 54.2933 OK 8.02851 0 815.143 OK P2981 - - XLOC_001256 NADK TSS1978 chr1:1682677-1711508 - - 57.4086 0 205.703 OK 210.14 107.373 312.907 OK 43.7417 0 310.979 OK P2982 - - XLOC_001256 NADK TSS1977 chr1:1682677-1711508 - - 46.8111 0 112.04 OK 91.3616 30.1322 152.591 OK 2.79122 0 112.776 OK P2983 - - XLOC_001256 NADK TSS1974 chr1:1682677-1711508 - - 10.1742 0 60.2712 OK 13.2843 0 31.0456 OK 1.85523 0 157.807 OK P2984 - - XLOC_001256 NADK TSS1975,TSS1976 chr1:1682677-1711508 - - 369.504 192.211 546.797 OK 843.106 712.39 973.821 OK 1204.38 703.991 1704.77 OK P2985 - - XLOC_001257 GNB1 TSS1979 chr1:1716729-1822495 - - 4274.57 3258.02 5291.12 OK 4816.83 4329.66 5303.99 OK 16698 6417.07 26978.8 OK P2986 - - XLOC_001257 GNB1 TSS1979 chr1:1716729-1822495 - - 13.2928 0 153.823 OK 4.54411 0 32.9057 OK 10.8403 0 3346.07 OK P2987 - - XLOC_001258 TMEM52 TSS1981 chr1:1849028-1850740 - - 23.4913 0 76.1659 OK 79.5862 37.1237 122.049 OK 23.4115 2.02793 44.795 OK P2988 - - XLOC_001258 TMEM52 TSS1980 chr1:1849028-1850740 - - 78.6765 14.1773 143.176 OK 212.131 156.646 267.616 OK 0 0 0 OK P2989 - - XLOC_001259 C1orf222 TSS1982,TSS1983 chr1:1853396-1859368 - - 0 0 0 OK 3.06699 0 6.47552 OK 0 0 0 OK P299 - - XLOC_000145 CLCNKA TSS216 chr1:16340522-16400127 - - 0 0 0 OK 9.02387 0.970341 17.0774 OK 0 0 0 OK P2990 - - XLOC_001260 KIAA1751 TSS1984 chr1:1884751-1935276 - - 0.645169 0 3.11763 OK 0 0 0 OK 0 0 0 OK P2991 - - XLOC_001260 KIAA1751 TSS1985 chr1:1884751-1935276 - - 0.437707 0 2.45861 OK 0 0 0 OK 0 0 0 OK P2992 - - XLOC_001260 KIAA1751 TSS1984 chr1:1884751-1935276 - - 0.583424 0 2.09416 OK 0.932315 0.00687002 1.85776 OK 0 0 0 OK P2993 - - XLOC_001262 - TSS1987 chr1:1981908-2139172 - - 13.1667 0 127.959 OK 33.574 0 81.1922 OK 27.1259 0 228.561 OK P2994 - - XLOC_001263 - TSS1989 chr1:1981908-2139172 - - 6.98486 0 67.3153 OK 25.7926 0 54.4134 OK 78.7015 0 223.633 OK P2995 - - XLOC_001263 C1orf86 TSS1988 chr1:1981908-2139172 - - 377.586 0 784.063 OK 1775.08 1335.8 2214.35 OK 2591.54 1130.08 4052.99 OK P2996 - - XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 - - 7.56119 0 32.8798 OK 6.7722 0 22.8762 OK 19.0177 0 81.0934 OK P2997 - - XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 - - 40.4484 0 97.4314 OK 34.0396 0 76.4195 OK 64.133 0 164.932 OK P2998 - - XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 - - 1.30462 0 9.07071 OK 2.05545 0 18.9633 OK 0 0 0 OK P2999 - - XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 - - 5.67183 0 35.428 OK 66.6827 21.3525 112.013 OK 19.3469 0 78.0679 OK P3 - - XLOC_000005 - TSS2,TSS3 chr1:322036-328580 - - 265.93 78.6031 453.257 OK 696.691 593.423 799.96 OK 34.2977 0 68.7669 OK P30 - - XLOC_000031 - TSS27 chr1:1334909-1342693 - - 103.752 0 280.6 OK 308.066 198.426 417.706 OK 185.591 0 637.661 OK P300 - - XLOC_000145 CLCNKA TSS216 chr1:16340522-16400127 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3000 - - XLOC_001266 PEX10 TSS1991 chr1:2323213-2344010 - - 0 0 0 OK 9.44927 0 32.19 OK 23.7899 0 743.415 OK P3001 - - XLOC_001266 PEX10 TSS1991 chr1:2323213-2344010 - - 290.341 47.1703 533.511 OK 452.417 333.158 571.676 OK 893.546 0 2126.46 OK P3002 - - XLOC_001267 PANK4 TSS1992 chr1:2439974-2458035 - - 174.785 79.7438 269.827 OK 361.252 300.101 422.403 OK 500.991 263.612 738.37 OK P3003 - - XLOC_001267 PANK4 TSS1992 chr1:2439974-2458035 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3004 - - XLOC_001268 HES5 TSS1993 chr1:2460184-2461684 - - 6.35744 0 13.7346 OK 2.94754 0 6.09621 OK 0 0 0 OK P3005 - - XLOC_001270 MMEL1 TSS1997 chr1:2518248-2564481 - - 0.931281 0 9.82019 OK 12.7571 0 28.6315 OK 3.38316 0 110.889 OK P3006 - - XLOC_001272 - TSS1999 chr1:2980635-2984289 - - 0 0 0 OK 0 0 0 OK 9.74659 0 22.4902 OK P3007 - - XLOC_001273 MEGF6 TSS2000 chr1:3404512-3528059 - - 69.8392 15.621 124.058 OK 41.8309 24.9788 58.6829 OK 92.849 29.832 155.866 OK P3008 - - XLOC_001273 MEGF6 TSS2001 chr1:3404512-3528059 - - 43.7292 5.09832 82.36 OK 177.762 147.458 208.065 OK 64.5702 7.50835 121.632 OK P3009 - - XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 - - 179.578 39.4838 319.673 OK 319.493 233.421 405.566 OK 402.167 153.034 651.301 OK P301 - - XLOC_000145 CLCNKA TSS216 chr1:16340522-16400127 - - 2.87744 0 54.8139 OK 10.1766 1.3032 19.05 OK 0.308418 0 7.49156 OK P3010 - - XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 - - 62.1764 0 146.868 OK 203.665 141.08 266.249 OK 99.5061 0 260.449 OK P3011 - - XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 - - 23.0108 0 48.264 OK 74.6828 53.6938 95.6717 OK 18.6731 0 47.6274 OK P3012 - - XLOC_001275 KIAA0495 TSS2004 chr1:3652549-3663886 - - 201.581 112.658 290.504 OK 422.204 363.725 480.683 OK 227.555 119.154 335.957 OK P3013 - - XLOC_001276 LRRC47 TSS2005 chr1:3696783-3713068 - - 867.894 535.552 1200.24 OK 1345.43 1168.58 1522.28 OK 1410.28 820.996 1999.56 OK P3014 - - XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 - - 111.609 0 240.837 OK 52.3176 19.7224 84.9128 OK 177.709 0 448.472 OK P3015 - - XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 - - 15.12 0 42.1754 OK 29.6392 17.6112 41.6673 OK 85.1871 0.535191 169.839 OK P3016 - - XLOC_001278 C1orf174 TSS2007 chr1:3805702-3816857 - - 473.292 230.075 716.51 OK 538.523 444.087 632.959 OK 1178.32 645.634 1711.01 OK P3017 - - XLOC_001280 NPHP4 TSS2010 chr1:5922869-6052531 - - 12.3891 0 31.8145 OK 32.7056 18.2592 47.1519 OK 8.76607 0 28.8702 OK P3018 - - XLOC_001280 NPHP4 TSS2009 chr1:5922869-6052531 - - 38.0315 9.02157 67.0413 OK 140.655 113.269 168.041 OK 98.804 39.2818 158.326 OK P3019 - - XLOC_001281 CHD5 TSS2014 chr1:6161852-6240183 - - 6.8891 0.168879 13.6093 OK 13.8631 9.7945 17.9318 OK 0.611774 0 2.53731 OK P302 - - XLOC_000145 CLCNKA TSS217 chr1:16340522-16400127 - - 1.5524 0 22.3485 OK 5.14419 0 17.7705 OK 0 0 0 OK P3020 - - XLOC_001281 CHD5 TSS2012 chr1:6161852-6240183 - - 0 0 0 OK 3.24653 0.180409 6.31265 OK 2.58654 0 6.09219 OK P3021 - - XLOC_001282 RPL22 TSS2017 chr1:6245080-6259679 - - 2222.07 1497.94 2946.2 OK 4302.07 3804.75 4799.39 OK 7509.61 3373.53 11645.7 OK P3022 - - XLOC_001282 RPL22 TSS2017 chr1:6245080-6259679 - - 209.378 0 498.139 OK 72.9481 0 206.297 OK 2365.52 0 4861.9 OK P3023 - - XLOC_001283 ICMT TSS2018 chr1:6266188-6296044 - - 1235.93 850.233 1621.63 OK 1196.78 1047.41 1346.14 OK 2319.74 1196.78 3442.71 OK P3024 - - XLOC_001283 - TSS2018 chr1:6266188-6296044 - - 243.59 70.8457 416.335 OK 137.374 85.5473 189.202 OK 288.283 0 725.553 OK P3025 - - XLOC_001284 GPR153 TSS2019 chr1:6307413-6321035 - - 37.8293 0 81.4618 OK 97.14 67.2326 127.047 OK 268.364 48.4351 488.292 OK P3026 - - XLOC_001284 GPR153 - chr1:6307413-6321035 - - 79.9572 20.6655 139.249 OK 174.868 135.877 213.86 OK 498.6 208.29 788.911 OK P3027 - - XLOC_001285 ACOT7 TSS2024 chr1:6324332-6453826 - - 134.974 0 285.391 OK 731.817 545.98 917.654 FAIL 70.6091 0 498.697 FAIL P3028 - - XLOC_001285 ACOT7 TSS2021 chr1:6324332-6453826 - - 0 0 0 OK 0 0 0 FAIL 39.0287 0 609.432 FAIL P3029 - - XLOC_001285 ACOT7 TSS2023 chr1:6324332-6453826 - - 462.887 122.773 803 OK 1047.97 778.058 1317.89 FAIL 732.481 0 2348.44 FAIL P303 - - XLOC_000145 CLCNKB TSS216,TSS218 chr1:16340522-16400127 - - 5.98972 0 51.8621 OK 4.34296 0 10.6439 OK 0 0 0 OK P3030 - - XLOC_001285 ACOT7 TSS2022 chr1:6324332-6453826 - - 126.845 0 296.16 OK 93.6803 17.9687 169.392 FAIL 110.585 0 588.532 FAIL P3031 - - XLOC_001285 ACOT7 TSS2020 chr1:6324332-6453826 - - 239.832 0 481.175 OK 1356.8 1067.01 1646.59 FAIL 2679.84 926.627 4433.06 FAIL P3032 - - XLOC_001286 HES2 TSS2026 chr1:6472499-6484730 - - 5.92301 1.46722 10.3788 OK 6.44393 3.96808 8.91978 OK 1.41752 0 3.11887 OK P3033 - - XLOC_001286 HES2 TSS2025 chr1:6472499-6484730 - - 0 0 0 OK 2.2157 0 5.31734 OK 0.48661 0 2.81936 OK P3034 - - XLOC_001287 PLEKHG5 TSS2032 chr1:6521220-6580069 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3035 - - XLOC_001287 PLEKHG5 TSS2035 chr1:6521220-6580069 - - 0.00544137 0 1.06121 OK 51.9914 27.3208 76.662 OK 18.3016 0 42.6962 OK P3036 - - XLOC_001287 PLEKHG5 TSS2034 chr1:6521220-6580069 - - 0 0 0 OK 9.71361 0 28.5646 OK 0 0 0 OK P3037 - - XLOC_001287 PLEKHG5 TSS2036 chr1:6521220-6580069 - - 0 0 0 OK 6.79791 0 17.0916 OK 3.95345 0 19.7523 OK P3038 - - XLOC_001287 PLEKHG5 TSS2036 chr1:6521220-6580069 - - 14.4826 0 39.4641 OK 0 0 0 OK 0 0 0 OK P3039 - - XLOC_001287 - TSS2037 chr1:6521220-6580069 - - 30.5163 0 105.072 OK 77.8501 24.5101 131.19 OK 12.5671 0 61.8728 OK P304 - - XLOC_000145 CLCNKB TSS219 chr1:16340522-16400127 - - 12.6409 0 62.956 OK 52.0827 34.1208 70.0445 OK 1.81089 0 20.3662 OK P3040 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 22.6201 0 122.87 OK 112.149 25.1693 199.13 OK 11.3936 0 104.399 OK P3041 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3042 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 0 0 0 OK 0.707673 0 6.70518 OK 6.84793 0 89.8072 OK P3043 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3044 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 0 0 0 OK 10.7434 0 35.0063 OK 0 0 0 OK P3045 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3046 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 23.1541 0 91.8581 OK 166.161 94.6025 237.719 OK 5.81123 0 55.208 OK P3047 - - XLOC_001287 PLEKHG5 TSS2030 chr1:6521220-6580069 - - 14.2602 0 44.3271 OK 62.1096 36.3441 87.8751 OK 0 0 0 OK P3048 - - XLOC_001287 PLEKHG5 TSS2029 chr1:6521220-6580069 - - 2.06233 0 21.2378 OK 38.9511 19.3035 58.5986 OK 2.5797 0 17.2003 OK P3049 - - XLOC_001287 PLEKHG5 TSS2028 chr1:6521220-6580069 - - 12.7468 0 49.9051 OK 35.8901 13.1062 58.674 OK 1.74109 0 24.1775 OK P305 - - XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 - - 407.437 171.903 642.971 OK 532.647 424.229 641.065 OK 1857.43 112.434 3602.43 OK P3050 - - XLOC_001287 PLEKHG5 TSS2031,TSS2032,TSS2033 chr1:6521220-6580069 - - 43.3554 0 87.4659 OK 121.824 88.6728 154.976 OK 34.9295 0.580908 69.278 OK P3051 - - XLOC_001288 NOL9 TSS2038 chr1:6585209-6614581 - - 503.823 285.234 722.412 OK 189.708 153.676 225.74 OK 361.435 179.702 543.168 OK P3052 - - XLOC_001289 KLHL21 TSS2039 chr1:6650778-6662929 - - 0 0 0 OK 154.599 116.614 192.584 OK 378.033 0 871.522 OK P3053 - - XLOC_001289 KLHL21 TSS2039 chr1:6650778-6662929 - - 109.476 28.7693 190.182 OK 62.094 41.7541 82.4338 OK 77.2985 0 177.029 OK P3054 - - XLOC_001289 KLHL21 TSS2040 chr1:6650778-6662929 - - 134.239 0 277.918 OK 151.442 108.192 194.693 OK 601.611 0 1210.3 OK P3055 - - XLOC_001290 DNAJC11 TSS2042 chr1:6684924-6761966 - - 727.027 447.816 1006.24 OK 1331.6 1158.6 1504.6 OK 1673.01 906.2 2439.82 OK P3056 - - XLOC_001290 DNAJC11 TSS2042 chr1:6684924-6761966 - - 11.865 0 73.97 OK 28.6342 0 58.4629 OK 29.7673 0 214.653 OK P3057 - - XLOC_001290 - TSS2042 chr1:6684924-6761966 - - 4.91606 0 73.8295 OK 12.0359 0 32.9772 OK 28.6155 0 208.592 OK P3058 - - XLOC_001290 DNAJC11 TSS2041 chr1:6684924-6761966 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3059 - - XLOC_001291 UTS2 TSS2045 chr1:7844379-7973294 - - 0.0400905 0 10.1271 OK 0 0 0 OK 0 0 0 OK P306 - - XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 - - 422.625 127.467 717.784 OK 574.155 433.204 715.106 OK 1815.92 0 3724.92 OK P3060 - - XLOC_001291 UTS2 TSS2044 chr1:7844379-7973294 - - 2.40953 0 40.4693 OK 0.950535 0 7.59851 OK 0 0 0 OK P3061 - - XLOC_001291 UTS2 TSS2043 chr1:7844379-7973294 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3062 - - XLOC_001292 TNFRSF9 TSS2046 chr1:7979907-8000887 - - 0 0 0 OK 0.267901 0 1.02951 OK 1.38187 0 3.32436 OK P3063 - - XLOC_001293 ERRFI1 TSS2048 chr1:8071779-8086393 - - 137.346 0 301.849 OK 21.342 0.261651 42.4224 OK 71.1003 0 385.659 OK P3064 - - XLOC_001293 ERRFI1 TSS2047 chr1:8071779-8086393 - - 641.313 371.667 910.958 OK 442.172 371.365 512.98 OK 2240.53 1261.49 3219.56 OK P3065 - - XLOC_001294 RERE TSS2049 chr1:8412465-8877699 - - 1.40725 0 34.3439 OK 320.719 249.022 392.416 OK 1692.19 822.22 2562.16 OK P3066 - - XLOC_001294 RERE TSS2051 chr1:8412465-8877699 - - 0 0 0 OK 0 0 0 OK 47.6257 0 611.766 OK P3067 - - XLOC_001294 - TSS2052 chr1:8412465-8877699 - - 85.8783 0 199.024 OK 3.82252 0 23.5895 OK 6.13498 0 577.522 OK P3068 - - XLOC_001294 RERE TSS2050 chr1:8412465-8877699 - - 186.982 103.076 270.889 OK 662.61 571.167 754.054 OK 278.541 0 970.246 OK P3069 - - XLOC_001295 - - chr1:8412465-8877699 - - 20.7508 0 141.351 OK 0 0 0 OK 0 0 0 OK P307 - - XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 - - 351.835 51.5672 652.103 OK 256.538 126.02 387.056 OK 1504.54 115.723 2893.35 OK P3070 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 10.0879 0 576.533 OK 8.52523 0 222.073 OK 0 0 0 OK P3071 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 19439.6 15768 23111.2 OK 29778.1 26125.7 33430.4 OK 33570.6 13951.6 53189.6 OK P3072 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 0 0 0 OK 8898.81 6208.05 11589.6 OK 12912.6 660.911 25164.3 OK P3073 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 0 0 0 OK 54.1427 0 372.14 OK 0 0 0 OK P3074 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 9.70153 0 500.863 OK 3.84797 0 211.467 OK 0 0 0 OK P3075 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 2186.7 687.794 3685.61 OK 12561.6 9264.55 15858.7 OK 24138 5648 42628 OK P3076 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 0 0 0 OK 914.141 0 2799.55 OK 679.817 0 6603.85 OK P3077 - - XLOC_001296 ENO1 TSS2053 chr1:8921062-8938780 - - 444.441 0 984.339 OK 211.161 0 439.419 OK 181.074 0 4449.48 OK P3078 - - XLOC_001297 SLC2A7 TSS2055 chr1:9063358-9086404 - - 0 0 0 OK 0.358204 0 1.3662 OK 0.725244 0 2.31316 OK P3079 - - XLOC_001298 SLC2A5 TSS2058 chr1:9097006-9148510 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P308 - - XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 - - 41.0821 0 213.346 OK 0 0 0 OK 133.313 0 1644.95 OK P3080 - - XLOC_001298 SLC2A5 TSS2057 chr1:9097006-9148510 - - 0 0 0 OK 2.90964 0.310704 5.50857 OK 0 0 0 OK P3081 - - XLOC_001298 SLC2A5 TSS2058 chr1:9097006-9148510 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3082 - - XLOC_001298 SLC2A5 TSS2057 chr1:9097006-9148510 - - 2.34161 0 8.86464 OK 0 0 0 OK 4.17775 0 161.314 OK P3083 - - XLOC_001298 SLC2A5 TSS2056 chr1:9097006-9148510 - - 0 0 0 OK 0.000167835 0 1.02064 OK 7.16648 0 55.0592 OK P3084 - - XLOC_001298 SLC2A5 TSS2058,TSS2059 chr1:9097006-9148510 - - 3.56861 0 8.39941 OK 0 0 0 OK 112.742 0 231.95 OK P3085 - - XLOC_001299 - - chr1:9164475-9189356 - - 9.67107 0 21.2243 OK 5.09214 1.70063 8.48366 OK 1.26783 0 6.71727 OK P3086 - - XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 - - 1.60049 0 5.56287 OK 1.55989 0 3.23101 OK 1.42116 0 6.58612 OK P3087 - - XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 - - 9.05298 0 29.6271 OK 5.68802 0 12.0645 OK 24.4065 0 70.7223 OK P3088 - - XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 - - 16.7212 0 44.5371 OK 50.5863 32.7116 68.4611 OK 72.7269 1.65727 143.797 OK P3089 - - XLOC_001300 - TSS2061 chr1:9208346-9242451 - - 95.9263 41.8317 150.021 OK 212.722 175.801 249.643 OK 69.3907 24.6136 114.168 OK P309 - - XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 - - 272.536 78.2692 466.804 OK 519.227 431.761 606.694 OK 3410.49 1902.97 4918.02 OK P3090 - - XLOC_001301 C1orf200 TSS2062 chr1:9711789-9884550 - - 0 0 0 OK 0.589835 0 7.29737 OK 0 0 0 OK P3091 - - XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 - - 340.016 175.427 504.606 OK 1063.01 901.716 1224.3 OK 1606.44 240.881 2972 OK P3092 - - XLOC_001303 - TSS2064 chr1:9711789-9884550 - - 3.82816 0 142.417 OK 145.676 47.7779 243.573 OK 695.497 0 3185.75 OK P3093 - - XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 - - 134.509 22.6305 246.388 OK 521.539 407.002 636.076 OK 26.3156 0 596.151 OK P3094 - - XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 - - 0 0 0 OK 0 0 0 OK 2515.79 763.811 4267.77 OK P3095 - - XLOC_001304 CTNNBIP1 TSS2066 chr1:9908333-9970316 - - 479.396 234.429 724.362 OK 655.696 562.205 749.188 OK 509.797 250.642 768.951 OK P3096 - - XLOC_001305 LZIC TSS2068 chr1:9989777-10003427 - - 0 0 0 OK 0 0 0 OK 5.13452 0 158.728 OK P3097 - - XLOC_001305 LZIC TSS2068 chr1:9989777-10003427 - - 307.377 118.888 495.866 OK 194.222 147.269 241.175 OK 1009.9 540.122 1479.68 OK P3098 - - XLOC_001305 LZIC TSS2067 chr1:9989777-10003427 - - 14.1134 0 70.9786 OK 3.50582 0 12.2378 OK 7.08002 0 145.74 OK P3099 - - XLOC_001306 DFFA TSS2069 chr1:10520604-10532613 - - 298.378 127.281 469.476 OK 268.726 178.795 358.656 OK 316.625 0 676.964 OK P31 - - XLOC_000032 - TSS28 chr1:1361507-1363166 - - 7.20193 0 21.8767 OK 59.0363 32.2743 85.7983 OK 0 0 0 OK P310 - - XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 - - 302.124 100.097 504.151 OK 0 0 0 OK 0 0 0 OK P3100 - - XLOC_001306 DFFA TSS2069 chr1:10520604-10532613 - - 485.4 200.041 770.758 OK 857.687 677.009 1038.36 OK 848.024 176.304 1519.74 OK P3101 - - XLOC_001307 - TSS2072 chr1:10696667-10856707 - - 2.07597 0 17.4301 OK 1.40186 0 5.909 OK 0 0 0 OK P3102 - - XLOC_001307 CASZ1 TSS2071 chr1:10696667-10856707 - - 8.95125 0 23.0557 OK 49.2697 30.8745 67.6649 OK 6.07219 0 13.3662 OK P3103 - - XLOC_001307 CASZ1 TSS2070 chr1:10696667-10856707 - - 1.21532 0 13.0076 OK 37.729 23.9568 51.5012 OK 1.6466 0 5.85861 OK P3104 - - XLOC_001307 CASZ1 TSS2070 chr1:10696667-10856707 - - 8.71581 0.771074 16.6605 OK 21.1364 13.6543 28.6185 OK 0.352429 0 1.98924 OK P3105 - - XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 - - 1.66784 0 4.93382 OK 0 0 0 OK 0.00205508 0 1.1104 OK P3106 - - XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 - - 0 0 0 OK 0.000964262 0 0.903489 OK 0.331458 0 1.4527 OK P3107 - - XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 - - 0.000832712 0 2.25219 OK 4.32713 1.54357 7.11069 OK 0 0 0 OK P3108 - - XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 - - 68.298 23.2927 113.303 OK 45.371 33.3684 57.3736 OK 15.0124 2.22666 27.7982 OK P3109 - - XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P311 - - XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 - - 0 0 0 OK 16.6368 0 36.7289 OK 100.612 0 439.417 OK P3110 - - XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 - - 0 0 0 OK 1.00455 0 5.94688 OK 0 0 0 OK P3111 - - XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 - - 6.76699 0 21.9887 OK 11.1666 4.74257 17.5906 OK 0 0 0 OK P3112 - - XLOC_001310 SRM TSS2076 chr1:11114648-11120091 - - 1002.98 383.446 1622.51 OK 4481.12 3922.01 5040.24 OK 7820.85 3902.21 11739.5 OK P3113 - - XLOC_001310 SRM TSS2075 chr1:11114648-11120091 - - 1171.02 417.682 1924.36 OK 432.981 192.938 673.023 OK 3003.63 0 6336.11 OK P3114 - - XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 - - 0 0 0 OK 4.49163 0 17.4542 OK 7.79258 0 169.887 OK P3115 - - XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 - - 90.8453 0 232.261 OK 67.2406 24.0681 110.413 OK 33.2215 0 184.285 OK P3116 - - XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 - - 1339.2 881.232 1797.18 OK 1276.69 1105.87 1447.51 OK 1601.03 919.091 2282.96 OK P3117 - - XLOC_001312 MTOR TSS2079 chr1:11166588-11322608 - - 578.796 399.141 758.451 OK 892.477 790.031 994.924 OK 636.873 351.515 922.231 OK P3118 - - XLOC_001312 - TSS2078 chr1:11166588-11322608 - - 59.0429 0 147.043 OK 135.175 73.202 197.149 OK 170.948 0 412.495 OK P3119 - - XLOC_001313 FBXO2 TSS2080 chr1:11708449-11723383 - - 302.813 84.8574 520.768 OK 1488.36 1236.56 1740.16 OK 72.9584 0 190.995 OK P312 - - XLOC_000150 - TSS229 chr1:17066767-17299474 - - 15.9225 0 60.3287 OK 62.5679 17.7392 107.397 OK 49.7705 0 124.533 OK P3120 - - XLOC_001313 FBXO2 TSS2080 chr1:11708449-11723383 - - 0 0 0 OK 7.02688 0 45.4745 OK 0 0 0 OK P3121 - - XLOC_001314 MAD2L2 TSS2082 chr1:11734537-11751678 - - 4485.74 3057.88 5913.6 OK 6757.57 5967.93 7547.22 OK 2368.21 1365.35 3371.08 OK P3122 - - XLOC_001315 MTHFR TSS2083 chr1:11832138-11866115 - - 12.2816 0 32.9022 OK 64.418 46.6473 82.1887 OK 263.856 79.0046 448.707 OK P3123 - - XLOC_001315 MTHFR TSS2084 chr1:11832138-11866115 - - 98.8766 45.0748 152.678 OK 93.2442 71.8689 114.62 OK 277.975 102.778 453.172 OK P3124 - - XLOC_001316 NPPA TSS2086 chr1:11866206-11907840 - - 3.4039 0 32.5388 OK 10.2838 0 34.928 OK 18.088 0 138.237 OK P3125 - - XLOC_001317 NPPB TSS2087 chr1:11917521-11918992 - - 770.486 289.163 1251.81 OK 7.22153 0 14.4521 OK 0 0 0 OK P3126 - - XLOC_001318 KIAA2013 TSS2088 chr1:11980123-11986480 - - 136.358 0 281.585 OK 97.0102 54.1044 139.916 OK 113.009 0 465.303 OK P3127 - - XLOC_001318 KIAA2013 TSS2088 chr1:11980123-11986480 - - 537.636 271.843 803.428 OK 657.437 549.153 765.722 OK 1330.79 700.142 1961.44 OK P3128 - - XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 - - 631.203 278.074 984.333 OK 302.602 228.431 376.772 OK 457.869 181.031 734.707 OK P3129 - - XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 - - 29.3372 0 178.583 OK 28.066 0 58.84 OK 1.34044 0 232.556 OK P313 - - XLOC_000150 - TSS225 chr1:17066767-17299474 - - 2.30684 0 127.542 OK 4.93427 0 28.0652 OK 0 0 0 OK P3130 - - XLOC_001319 DHRS3 TSS2089 chr1:12627939-12677820 - - 664.349 249.834 1078.86 OK 334.324 242.248 426.4 OK 292.677 22.1621 563.193 OK P3131 - - XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 - - 34.783 0 178.53 OK 10.8508 0 33.1405 OK 0 0 0 OK P3132 - - XLOC_001320 PRAMEF11 TSS2092 chr1:12884467-12891264 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3133 - - XLOC_001321 HNRNPCL1 TSS2093 chr1:12907235-12908578 - - 162.796 57.3101 268.281 OK 2184.6 1858.47 2510.73 OK 1951.16 1042.71 2859.6 OK P3134 - - XLOC_001322 PRAMEF4 TSS2094 chr1:12939032-12946025 - - 0.174144 0 1.17777 OK 0 0 0 OK 0 0 0 OK P3135 - - XLOC_001323 PRAMEF10 TSS2095 chr1:12952727-12958094 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3136 - - XLOC_001324 PRAMEF5 TSS2097 chr1:12998301-13117751 - - 0.000123029 0 2.8665 OK 0 0 0 OK 0 0 0 OK P3137 - - XLOC_001324 PRAMEF6 TSS2096 chr1:12998301-13117751 - - 0.337687 0 3.45331 OK 0 0 0 OK 0 0 0 OK P3138 - - XLOC_001324 PRAMEF5 TSS2097 chr1:12998301-13117751 - - 0.334536 0 3.42231 OK 0 0 0 OK 0 0 0 OK P3139 - - XLOC_001325 - - chr1:13182960-13183967 - - 22.2793 4.558 40.0006 OK 275.825 215.388 336.261 OK 207.399 65.638 349.159 OK P314 - - XLOC_000150 CROCC TSS227 chr1:17066767-17299474 - - 47.5917 0 116.051 OK 30.5389 0 76.5493 OK 3.8214 0 60.5204 OK P3140 - - XLOC_001326 PRAMEF22 TSS2098 chr1:13328195-13331692 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3141 - - XLOC_001327 PRAMEF8 TSS2099,TSS2100 chr1:13386648-13390765 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3142 - - XLOC_001328 PRAMEF14 TSS2101 chr1:13447413-13452656 - - 0.200361 0 2.70335 OK 0 0 0 OK 0 0 0 OK P3143 - - XLOC_001328 PRAMEF13 TSS2101 chr1:13447413-13452656 - - 0.000572928 0 2.42333 OK 0 0 0 OK 0 0 0 OK P3144 - - XLOC_001329 PRAMEF18 TSS2102 chr1:13474052-13477569 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3145 - - XLOC_001330 PRAMEF8 TSS2103 chr1:13607430-13611550 - - 0.694912 0 2.69739 OK 0 0 0 OK 0 0 0 OK P3146 - - XLOC_001331 PRAMEF14 TSS2104 chr1:13668268-13673511 - - 0.803811 0 2.80977 OK 0 0 0 OK 0 0 0 OK P3147 - - XLOC_001332 PRAMEF18 TSS2105 chr1:13694888-13698405 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3148 - - XLOC_001333 LRRC38 TSS2106 chr1:13801446-13840242 - - 6.96034 0.720957 13.1997 OK 8.16584 3.94913 12.3826 OK 0 0 0 OK P3149 - - XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 - - 0 0 0 OK 197.024 142.349 251.7 OK 118.428 2.10389 234.752 OK P315 - - XLOC_000150 CROCC TSS226 chr1:17066767-17299474 - - 27.4034 0 57.257 OK 428.259 354.129 502.389 OK 98.6818 31.8198 165.544 OK P3150 - - XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 - - 145.227 0 301.698 OK 132.595 79.0999 186.09 OK 55.404 0 146.221 OK P3151 - - XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 - - 75.4615 15.7292 135.194 OK 32.8483 18.1651 47.5315 OK 25.7553 0 61.4369 OK P3152 - - XLOC_001336 CASP9 TSS2110,TSS2111 chr1:15802595-15851384 - - 173.37 18.8501 327.89 OK 51.7979 20.3228 83.2729 OK 80.6384 0 179.589 OK P3153 - - XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 - - 0 0 0 OK 17.767 0 41.731 OK 8.22122 0 58.9074 OK P3154 - - XLOC_001337 AGMAT TSS2112 chr1:15853351-15918872 - - 122.09 0 265.635 OK 115.866 75.573 156.159 OK 43.2083 0 137.727 OK P3155 - - XLOC_001338 - - chr1:16133656-16134194 - - 7916.63 5112.58 10720.7 OK 16097 14174.7 18019.4 OK 21049.2 11785.6 30312.9 OK P3156 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 15.5862 0 68.4302 OK 20.1751 0 46.6597 OK 2.23494 0 34.7412 OK P3157 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 106.181 28.2893 184.072 OK 259.204 208.882 309.525 OK 560.414 289.763 831.066 OK P3158 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 0 0 0 OK 6.42816 0 17.7481 OK 5.22855 0 85.1743 OK P3159 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 35.4246 0 87.25 OK 24.9031 7.46596 42.3402 OK 48.555 0 140.045 OK P316 - - XLOC_000150 CROCC TSS228 chr1:17066767-17299474 - - 65.6699 18.2084 113.131 OK 100.239 53.167 147.311 OK 17.1632 0 59.7634 OK P3160 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 0 0 0 OK 6.98597 0 17.2731 OK 0 0 0 OK P3161 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3162 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 10.1074 0 49.866 OK 7.07875 0 19.4034 OK 9.63291 0 111.703 OK P3163 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 0.0412124 0 2.86572 OK 2.7664 0 11.5206 OK 13.5911 0 115.327 OK P3164 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 11.9384 0 87.5108 OK 8.33768 0 26.3456 OK 26.7081 0 202.167 OK P3165 - - XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 - - 12.5495 0 51.3328 OK 0 0 0 OK 16.7923 0 87.8912 OK P3166 - - XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 - - 8.04701 0 48.3381 OK 0 0 0 OK 26.6845 0 117.226 OK P3167 - - XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 - - 100.427 13.9433 186.91 OK 3.62862 0 8.34379 OK 235.204 42.3394 428.068 OK P3168 - - XLOC_001342 HSPB7 TSS2116 chr1:16340522-16400127 - - 71.8733 0 160.429 OK 3.46957 0 8.17261 OK 397.66 55.8486 739.472 OK P3169 - - XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 - - 0 0 0 OK 0 0 0 OK 60.3352 0 240.983 OK P317 - - XLOC_000151 - TSS231 chr1:17531620-17572501 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3170 - - XLOC_001343 FAM131C TSS2117 chr1:16340522-16400127 - - 6.09452 0 73.3079 OK 21.4939 8.36523 34.6225 OK 38.8477 0 159.849 OK P3171 - - XLOC_001343 FAM131C TSS2117 chr1:16340522-16400127 - - 7.54529 0 177.61 OK 4.46492 0 16.9523 OK 7.5659 0 322.48 OK P3172 - - XLOC_001344 EPHA2 TSS2118 chr1:16450831-16482564 - - 22.2582 0 172.971 OK 2.16378 0 24.2617 OK 0 0 0 OK P3173 - - XLOC_001344 EPHA2 TSS2118 chr1:16450831-16482564 - - 234.901 119.065 350.737 OK 573.472 491.06 655.885 OK 923.073 511.47 1334.68 OK P3174 - - XLOC_001345 ARHGEF19 TSS2119 chr1:16524598-16539104 - - 17.0126 0 57.3312 OK 324.019 226.134 421.903 OK 132.515 30.4787 234.551 OK P3175 - - XLOC_001345 ARHGEF19 TSS2119 chr1:16524598-16539104 - - 0 0 0 OK 0 0 0 OK 38.3291 0 133.324 OK P3176 - - XLOC_001345 ARHGEF19 TSS2120 chr1:16524598-16539104 - - 156.261 66.9287 245.594 OK 678.385 568.95 787.821 OK 8.10745 0 31.0825 OK P3177 - - XLOC_001346 C1orf89 TSS2121 chr1:16558182-16563659 - - 28.2148 8.31912 48.1105 OK 53.4824 39.5802 67.3846 OK 182.341 64.6878 299.993 OK P3178 - - XLOC_001347 FBXO42 TSS2122 chr1:16576559-16678948 - - 22.2988 0 92.2622 OK 2.24339 0 10.5925 OK 15.5838 0 89.1198 OK P3179 - - XLOC_001347 FBXO42 TSS2124 chr1:16576559-16678948 - - 292.804 138.52 447.089 OK 256.568 210.379 302.757 OK 533.075 280.508 785.642 OK P318 - - XLOC_000151 - TSS231 chr1:17531620-17572501 - - 7.45961 0 20.4336 OK 6.34529e-05 0 0.817224 OK 6.06956e-06 0 1.02954 OK P3180 - - XLOC_001347 FBXO42 TSS2123 chr1:16576559-16678948 - - 11.178 0 57.7157 OK 8.45144 0 18.9118 OK 30.8971 0 157.892 OK P3181 - - XLOC_001347 - TSS2125 chr1:16576559-16678948 - - 27.075 0 81.0616 OK 0.999115 0 3.93364 OK 0 0 0 OK P3182 - - XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 - - 1.25463 0 18.4322 OK 0 0 0 OK 0 0 0 OK P3183 - - XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3184 - - XLOC_001349 - TSS2128 chr1:16793930-16819196 - - 0 0 0 OK 76.9358 17.4498 136.422 OK 33.8911 0 119.733 OK P3185 - - XLOC_001352 NBPF1 TSS2132 chr1:16890411-16939982 - - 0 0 0 OK 120.904 47.2642 194.544 OK 551.679 0 1124.28 OK P3186 - - XLOC_001352 NBPF1 TSS2132 chr1:16890411-16939982 - - 65.4571 0 212.032 OK 27.9922 0.105468 55.8789 OK 232.03 0 638.644 OK P3187 - - XLOC_001352 NBPF1 TSS2133 chr1:16890411-16939982 - - 2.67381 0 115.26 OK 2.13127 0 10.4539 OK 2.38008 0 261.588 OK P3188 - - XLOC_001352 NBPF1 TSS2131 chr1:16890411-16939982 - - 153.181 51.7958 254.565 OK 109.231 81.5872 136.875 OK 592.825 260.015 925.635 OK P3189 - - XLOC_001354 ESPNP TSS2141 chr1:17017712-17046652 - - 0 0 0 OK 3.47275 0 7.65156 OK 0 0 0 OK P319 - - XLOC_000151 PADI1 TSS230 chr1:17531620-17572501 - - 2.7984 0 10.3872 OK 1.50479 0 3.19272 OK 0 0 0 OK P3190 - - XLOC_001354 ESPN TSS2140 chr1:17017712-17046652 - - 2.07327 0 5.81874 OK 11.1097 6.20784 16.0115 OK 0 0 0 OK P3191 - - XLOC_001355 MSTP9 TSS2143 chr1:17066767-17299474 - - 1.90183 0 33.477 OK 3.25841 0 11.095 OK 1.59851 0 32.2719 OK P3192 - - XLOC_001355 MSTP9 TSS2142 chr1:17066767-17299474 - - 14.2231 0 47.6041 OK 38.162 12.8322 63.4919 OK 1.55467 0 34.5536 OK P3193 - - XLOC_001357 MFAP2 TSS2145,TSS2146 chr1:17300999-17308081 - - 1631.49 897.928 2365.06 OK 4040.61 3336.12 4745.1 OK 1992.29 864.406 3120.18 OK P3194 - - XLOC_001357 MFAP2 TSS2145,TSS2146 chr1:17300999-17308081 - - 316.038 0 677.029 OK 825.956 324.309 1327.6 OK 413.367 0 1010.3 OK P3195 - - XLOC_001358 ATP13A2 TSS2150 chr1:17312452-17338423 - - 26.0242 0 105.824 OK 18.4495 0 52.2647 OK 0 0 0 OK P3196 - - XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 - - 4.40168 0 44.0657 OK 12.3556 0 89.4394 OK 24.341 0 75.4891 OK P3197 - - XLOC_001358 ATP13A2 TSS2149 chr1:17312452-17338423 - - 0 0 0 OK 22.7704 0 78.4159 OK 46.6117 0 247.147 OK P3198 - - XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 - - 124.905 20.1141 229.695 OK 537.876 416.048 659.704 OK 177.11 45.9366 308.283 OK P3199 - - XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 - - 125.906 36.644 215.167 OK 472.669 378.005 567.334 OK 205.856 50.6022 361.11 OK P32 - - XLOC_000033 VWA1 TSS29 chr1:1370908-1376145 - - 5.8712 0 55.7043 OK 58.9274 0 140.956 OK 29.8843 0 99.2644 OK P320 - - XLOC_000151 PADI1 TSS231 chr1:17531620-17572501 - - 5.28057 0 16.6213 OK 0.286309 0 1.61701 OK 0 0 0 OK P3200 - - XLOC_001358 ATP13A2 TSS2147 chr1:17312452-17338423 - - 66.6283 0 273.207 OK 366.46 205.875 527.046 OK 231.387 0 528.322 OK P3201 - - XLOC_001359 SDHB TSS2151 chr1:17345226-17380665 - - 1562.94 903.16 2222.73 OK 1548.47 1310.11 1786.83 OK 5372.43 3139.35 7605.51 OK P3202 - - XLOC_001360 PADI2 TSS2152 chr1:17393256-17445948 - - 6.09039 0 25.3573 OK 3.49549 0 12.5172 OK 0 0 0 OK P3203 - - XLOC_001360 PADI2 TSS2152 chr1:17393256-17445948 - - 25.3396 7.16262 43.5166 OK 62.6093 49.0897 76.1288 OK 1.76593e-05 0 0.556858 OK P3204 - - XLOC_001360 - TSS2152 chr1:17393256-17445948 - - 0 0 0 OK 0 0 0 OK 0.887434 0 2.24643 OK P3205 - - XLOC_001362 RCC2 TSS2153,TSS2154 chr1:17733251-17766220 - - 3342.9 2480.41 4205.4 OK 5456.99 4914.17 5999.81 OK 1048.07 598.531 1497.6 OK P3206 - - XLOC_001363 TAS1R2 TSS2155 chr1:19166092-19186155 - - 0.541163 0 2.03937 OK 0 0 0 OK 0 0 0 OK P3207 - - XLOC_001364 ALDH4A1 TSS2157 chr1:19197925-19229293 - - 178.229 62.5565 293.901 OK 434.186 347.596 520.776 OK 406.234 197.354 615.114 OK P3208 - - XLOC_001364 ALDH4A1 TSS2156 chr1:19197925-19229293 - - 85.8408 8.14943 163.532 OK 218.303 159.662 276.944 OK 130.588 7.30382 253.872 OK P3209 - - XLOC_001365 IFFO2 TSS2158 chr1:19230773-19282826 - - 102.06 48.7649 155.355 OK 89.541 72.7006 106.381 OK 303.773 166.199 441.347 OK P321 - - XLOC_000151 - TSS232 chr1:17531620-17572501 - - 0 0 0 OK 2.33196 0 5.25577 OK 0.513935 0 1.74582 OK P3210 - - XLOC_001366 - TSS2164 chr1:19398603-19536746 - - 4.91166 0 122.644 OK 426.519 250.247 602.791 OK 243.59 0 936.189 OK P3211 - - XLOC_001366 - TSS2163 chr1:19398603-19536746 - - 28.2328 0 130.129 OK 557.747 349.643 765.85 OK 470.997 0 1254.8 OK P3212 - - XLOC_001366 UBR4 TSS2169 chr1:19398603-19536746 - - 112.418 0 271.794 OK 4.71016 0 19.6735 OK 7.05837 0 286.173 OK P3213 - - XLOC_001366 - TSS2168 chr1:19398603-19536746 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3214 - - XLOC_001366 - TSS2162 chr1:19398603-19536746 - - 0 0 0 OK 167.676 22.4737 312.879 OK 0 0 0 OK P3215 - - XLOC_001366 UBR4 TSS2167 chr1:19398603-19536746 - - 38.8471 0 153.122 OK 192.593 85.6652 299.52 OK 171.68 0 680.545 OK P3216 - - XLOC_001366 UBR4 TSS2161 chr1:19398603-19536746 - - 0 0 0 OK 22.9292 0 71.3365 OK 22.1323 0 587.311 OK P3217 - - XLOC_001366 - TSS2160 chr1:19398603-19536746 - - 1.68163 0 256.626 OK 92.8871 0 187.884 OK 294.701 0 1031.77 OK P3218 - - XLOC_001366 - TSS2159 chr1:19398603-19536746 - - 14.6135 0 555.378 OK 50.0495 0 160.92 OK 229.039 0 2234.55 OK P3219 - - XLOC_001366 UBR4 TSS2165 chr1:19398603-19536746 - - 623.312 460.643 785.98 OK 765.815 676.786 854.844 OK 666.218 299.375 1033.06 OK P322 - - XLOC_000152 PADI3 TSS233 chr1:17575592-17610725 - - 8.59656 1.07534 16.1178 OK 12.671 8.61879 16.7231 OK 0.32407 0 1.03362 OK P3220 - - XLOC_001366 UBR4 TSS2166 chr1:19398603-19536746 - - 39.3315 0 149.532 OK 5.33048 0 33.5387 OK 5.62521 0 540.505 OK P3221 - - XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 - - 41.707 0 111 OK 112.439 70.4712 154.407 OK 247.27 0 811.52 OK P3222 - - XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 - - 256.033 124.664 387.402 OK 452.421 378.106 526.736 OK 2042.6 992.755 3092.44 OK P3223 - - XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 - - 0 0 0 OK 27.296 0 63.2434 OK 57.4804 0 277.391 OK P3224 - - XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 - - 11.7322 0 80.2288 OK 3.92853 0 13.272 OK 15.2695 0 244.502 OK P3225 - - XLOC_001368 AKR7L TSS2172 chr1:19592475-19600568 - - 8.47305 1.68239 15.2637 OK 11.7019 7.12012 16.2836 OK 10.5092 1.01211 20.0062 OK P3226 - - XLOC_001368 AKR7L TSS2172 chr1:19592475-19600568 - - 0.000354505 0 2.49559 OK 0 0 0 OK 0 0 0 OK P3227 - - XLOC_001369 AKR7A3 TSS2173 chr1:19609056-19615280 - - 16.1619 3.29675 29.0271 OK 17.2325 9.42284 25.0423 OK 15.2534 1.07679 29.43 OK P3228 - - XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 - - 22.0575 0 101.557 OK 2.29939 0 21.9783 OK 3.31248 0 543.905 OK P3229 - - XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 - - 341.159 145.262 537.057 OK 693.277 573.913 812.641 OK 3035.54 1402.19 4668.9 OK P323 - - XLOC_000153 PADI4 TSS234 chr1:17634689-17690495 - - 4.09774 0 8.73756 OK 3.11869 0.278925 5.95846 OK 0 0 0 OK P3230 - - XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 - - 0 0 0 OK 0 0 0 OK 179.738 0 1515.56 OK P3231 - - XLOC_001371 CAPZB TSS2177 chr1:19665273-19811992 - - 2361.48 1372.9 3350.07 OK 5169.04 4581.63 5756.45 OK 19294.6 9080.47 29508.8 OK P3232 - - XLOC_001371 CAPZB TSS2177 chr1:19665273-19811992 - - 17.4929 0 155.419 OK 8.25067 0 35.3494 OK 86.3183 0 2082.15 OK P3233 - - XLOC_001371 CAPZB TSS2176 chr1:19665273-19811992 - - 43.0618 0 207.16 OK 69.4828 6.61671 132.349 OK 70.755 0 2035.05 OK P3234 - - XLOC_001371 CAPZB TSS2175 chr1:19665273-19811992 - - 1302.83 611.827 1993.83 OK 0 0 0 OK 0 0 0 OK P3235 - - XLOC_001373 TMCO4 TSS2178 chr1:20008706-20126758 - - 6.20966 0 29.8202 OK 0 0 0 OK 36.9795 0 220.714 OK P3236 - - XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 - - 16.1889 0 54.1977 OK 9.20491 0.0607255 18.3491 OK 32.2829 0 138.884 OK P3237 - - XLOC_001373 TMCO4 TSS2181 chr1:20008706-20126758 - - 6.08129 0 93.3291 OK 0 0 0 OK 20.9118 0 225.377 OK P3238 - - XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 - - 0 0 0 OK 1.29633 0 7.49683 OK 0 0 0 OK P3239 - - XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 - - 2.72756 0 31.8784 OK 0 0 0 OK 73.4655 0 182.856 OK P324 - - XLOC_000153 PADI4 TSS234 chr1:17634689-17690495 - - 0 0 0 OK 1.38095 0 4.41678 OK 0 0 0 OK P3240 - - XLOC_001373 TMCO4 TSS2179 chr1:20008706-20126758 - - 48.488 10.3098 86.6662 OK 56.5465 42.6732 70.4197 OK 464.48 220.881 708.08 OK P3241 - - XLOC_001374 RNF186 - chr1:20140522-20141771 - - 1.07721 0 4.18133 OK 0.423276 0 1.6266 OK 0 0 0 OK P3242 - - XLOC_001375 PLA2G2E TSS2182 chr1:20246799-20250110 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3243 - - XLOC_001376 PLA2G2A TSS2183,TSS2184 chr1:20301924-20306932 - - 134.324 8.37934 260.269 OK 35.1082 21.8517 48.3647 OK 12.952 0 27.7808 OK P3244 - - XLOC_001377 PLA2G2D TSS2185 chr1:20438440-20446008 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3245 - - XLOC_001378 PLA2G2C TSS2186 chr1:20490483-20501687 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3246 - - XLOC_001380 CAMK2N1 TSS2190 chr1:20808884-20812728 - - 171.705 34.941 308.47 OK 124.278 97.3523 151.204 OK 7835.73 3452.15 12219.3 OK P3247 - - XLOC_001381 MUL1 TSS2191 chr1:20825942-20834674 - - 392.307 205.86 578.753 OK 351.837 291.107 412.567 OK 1509.04 876.74 2141.34 OK P3248 - - XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 - - 4421.99 3255.85 5588.14 OK 4971.96 4436.95 5506.96 OK 12703.4 6275.46 19131.3 OK P3249 - - XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 - - 5.84642 0 210.415 OK 0 0 0 OK 0 0 0 OK P325 - - XLOC_000154 PADI6 TSS235 chr1:17698740-17728195 - - 0 0 0 OK 0.21117 0 0.811504 OK 0 0 0 OK P3250 - - XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 - - 30.3966 0 202.602 OK 19.3729 0 69.8108 OK 13.1454 0 1810.7 OK P3251 - - XLOC_001382 - TSS2192 chr1:20978259-20988037 - - 5.18588 0 224.553 OK 0 0 0 OK 0 0 0 OK P3252 - - XLOC_001383 KIF17 TSS2195 chr1:20990508-21044317 - - 5.15833 0 26.0476 OK 48.9997 30.3712 67.6282 OK 0 0 0 OK P3253 - - XLOC_001383 KIF17 TSS2195 chr1:20990508-21044317 - - 53.8428 17.4593 90.2263 OK 102.304 76.9382 127.669 OK 29.9178 0 69.6045 OK P3254 - - XLOC_001383 KIF17 TSS2194 chr1:20990508-21044317 - - 0 0 0 OK 5.90044 0 16.6955 OK 11.7825 0 46.107 OK P3255 - - XLOC_001383 KIF17 TSS2193 chr1:20990508-21044317 - - 0 0 0 OK 3.5495 0 25.2713 OK 4.98873 0 48.1008 OK P3256 - - XLOC_001383 KIF17 TSS2193 chr1:20990508-21044317 - - 7.59828 0 42.1585 OK 11.229 0 33.6005 OK 82.6962 0 169.515 OK P3257 - - XLOC_001384 SH2D5 TSS2196 chr1:21046224-21059330 - - 0 0 0 OK 16.4694 3.45812 29.4807 OK 89.3077 0 206.086 OK P3258 - - XLOC_001384 SH2D5 TSS2196 chr1:21046224-21059330 - - 17.3446 0 40.3711 OK 129.453 87.7018 171.205 OK 86.3601 0 190.82 OK P3259 - - XLOC_001385 HP1BP3 TSS2200,TSS2202 chr1:21069170-21113799 - - 718.718 282.937 1154.5 OK 520.882 390.724 651.039 OK 2161.72 293.388 4030.05 OK P326 - - XLOC_000155 ARHGEF10L TSS240 chr1:17866329-18024369 - - 0 0 0 OK 5.26 0 16.963 OK 0 0 0 OK P3260 - - XLOC_001385 HP1BP3 TSS2200,TSS2201 chr1:21069170-21113799 - - 487.058 204.642 769.475 OK 240.884 184.89 296.878 OK 1523.73 366.156 2681.31 OK P3261 - - XLOC_001385 HP1BP3 TSS2199 chr1:21069170-21113799 - - 302.536 115.748 489.323 OK 107.411 71.6054 143.216 OK 147.345 0 557.151 OK P3262 - - XLOC_001385 HP1BP3 TSS2198 chr1:21069170-21113799 - - 44.0552 0 166.711 OK 56.1343 22.179 90.0896 OK 89.2902 0 537.056 OK P3263 - - XLOC_001385 HP1BP3 TSS2200 chr1:21069170-21113799 - - 201.731 0 674.317 OK 108.229 17.2266 199.231 OK 286.111 0 2081.98 OK P3264 - - XLOC_001385 HP1BP3 TSS2201 chr1:21069170-21113799 - - 67.7047 0 219.105 OK 19.1563 0 41.1226 OK 234.83 0 794.429 OK P3265 - - XLOC_001386 EIF4G3 TSS2208 chr1:21132975-21503340 - - 99.134 0 274.22 OK 39.0388 0.43254 77.6451 OK 49.7966 0 663.007 OK P3266 - - XLOC_001386 EIF4G3 TSS2207 chr1:21132975-21503340 - - 310.854 9.35684 612.35 OK 0 0 0 OK 0 0 0 OK P3267 - - XLOC_001386 EIF4G3 TSS2206 chr1:21132975-21503340 - - 155.005 39.872 270.137 OK 149.423 107.877 190.97 OK 310.62 0 685.567 OK P3268 - - XLOC_001386 EIF4G3 TSS2205,TSS2206 chr1:21132975-21503340 - - 85.7954 0 185.217 OK 265.087 208.302 321.872 OK 581.509 0 1193.72 OK P3269 - - XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 - - 4.89492 0 61.9213 OK 0 0 0 OK 48.898 0 290.681 OK P327 - - XLOC_000155 ARHGEF10L TSS237 chr1:17866329-18024369 - - 158.893 62.1068 255.68 OK 479.078 400.922 557.233 OK 35.3353 0 117.86 OK P3270 - - XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 - - 494.463 287.514 701.412 OK 247.208 192.013 302.403 OK 640.112 0 1481.42 OK P3271 - - XLOC_001386 EIF4G3 TSS2203 chr1:21132975-21503340 - - 16.2897 0 120.515 OK 6.37526 0 18.3251 OK 487.969 0 1205.32 OK P3272 - - XLOC_001386 EIF4G3 TSS2206 chr1:21132975-21503340 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3273 - - XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3274 - - XLOC_001387 ECE1 TSS2210 chr1:21543739-21672034 - - 90.6691 12.4744 168.864 OK 28.0163 9.22743 46.8052 OK 986.479 0 2727.2 OK P3275 - - XLOC_001387 ECE1 TSS2209 chr1:21543739-21672034 - - 0 0 0 OK 5.98009 0 15.3256 OK 127.783 0 997.551 OK P3276 - - XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 - - 30.7121 0 113.11 OK 14.4148 0 37.8486 OK 87.2531 0 2296.65 OK P3277 - - XLOC_001387 ECE1 TSS2212 chr1:21543739-21672034 - - 67.8265 7.73965 127.913 OK 419.192 327.282 511.102 OK 3871.51 403.938 7339.09 OK P3278 - - XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 - - 39.3564 0 100.319 OK 95.1492 23.9971 166.301 OK 1395.64 0 4874.16 OK P3279 - - XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 - - 0 0 0 OK 4.34987 0 12.4619 OK 15.8926 0 952.608 OK P328 - - XLOC_000155 ARHGEF10L TSS236 chr1:17866329-18024369 - - 28.6581 0 76.133 OK 64.0925 34.8693 93.3157 OK 18.9462 0 74.1161 OK P3280 - - XLOC_001390 RAP1GAP TSS2215 chr1:21922708-21995856 - - 27.4868 0.432069 54.5415 OK 67.9603 40.5951 95.3256 OK 2.12746 0 4.48271 OK P3281 - - XLOC_001390 RAP1GAP TSS2216 chr1:21922708-21995856 - - 14.88 0 38.1777 OK 64.0794 41.797 86.3618 OK 0.00165223 0 0.738614 OK P3282 - - XLOC_001390 RAP1GAP TSS2216 chr1:21922708-21995856 - - 10.5936 0 36.1794 OK 23.1783 8.81449 37.5421 OK 0 0 0 OK P3283 - - XLOC_001390 RAP1GAP TSS2214 chr1:21922708-21995856 - - 3.1394 0 17.0373 OK 23.4017 0 49.5166 OK 0 0 0 OK P3284 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 215.746 0 444.263 OK 175.948 61.9746 289.922 OK 194.761 0 787.418 OK P3285 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 9.73763 0 59.2654 OK 1.61711 0 15.96 OK 0 0 0 OK P3286 - - XLOC_001391 USP48 TSS2219 chr1:22004793-22109688 - - 40.7577 0 143.522 OK 4.47726 0 18.5653 OK 1.54293 0 312.022 OK P3287 - - XLOC_001391 USP48 TSS2217 chr1:22004793-22109688 - - 119.181 0 246.481 OK 49.6025 20.7725 78.4325 OK 49.025 0 192.573 OK P3288 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 330.639 81.3712 579.906 OK 44.7452 8.25987 81.2305 OK 182.168 0 728.664 OK P3289 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 397.254 202.914 591.593 OK 512.56 429.032 596.088 OK 1051.93 551.074 1552.78 OK P329 - - XLOC_000155 ARHGEF10L TSS236 chr1:17866329-18024369 - - 57.9053 0 124.56 OK 55.941 25.7273 86.1546 OK 9.97606 0 80.3509 OK P3290 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3291 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 31.0054 0 101.54 OK 26.2055 6.01966 46.3914 OK 44.2579 0 166.085 OK P3292 - - XLOC_001392 HSPG2 TSS2221 chr1:22138757-22263750 - - 101.632 55.0597 148.203 OK 741.639 657.067 826.212 OK 3722.7 0 7543.35 OK P3293 - - XLOC_001392 HSPG2 TSS2221 chr1:22138757-22263750 - - 15.8513 0 36.9392 OK 124.328 88.932 159.724 OK 771.12 0 2394.37 OK P3294 - - XLOC_001392 HSPG2 TSS2220 chr1:22138757-22263750 - - 8.87162 0 54.733 OK 185.017 95.7889 274.245 OK 262.104 0 7029.42 OK P3295 - - XLOC_001392 HSPG2 TSS2222 chr1:22138757-22263750 - - 32.9146 0 281.74 OK 0 0 0 OK 0 0 0 OK P3296 - - XLOC_001393 WNT4 TSS2223 chr1:22443799-22470385 - - 15.9522 4.85667 27.0478 OK 73.6692 57.8567 89.4816 OK 0.00537242 0 0.631395 OK P3297 - - XLOC_001393 WNT4 TSS2224 chr1:22443799-22470385 - - 0.000222119 0 1.30571 OK 0 0 0 OK 0.782392 0 2.04125 OK P3298 - - XLOC_001394 - TSS2225 chr1:23337326-23342343 - - 3.40123 0 13.2023 OK 1.30651 0 5.02077 OK 0 0 0 OK P3299 - - XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 - - 56.1574 0 173.422 OK 3.29156 0 12.0717 OK 0 0 0 OK P33 - - XLOC_000033 VWA1 TSS29 chr1:1370908-1376145 - - 222.846 102.784 342.907 OK 469.362 387.247 551.477 OK 444.091 214.109 674.073 OK P330 - - XLOC_000155 ARHGEF10L TSS240 chr1:17866329-18024369 - - 0 0 0 OK 0 0 0 OK 381.592 151.451 611.732 OK P3300 - - XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 - - 804.448 563.778 1045.12 OK 432.503 370.127 494.878 OK 885.771 472.058 1299.48 OK P3301 - - XLOC_001396 HTR1D - chr1:23518388-23521222 - - 223.865 107.37 340.36 OK 138.505 110.603 166.407 OK 0 0 0 OK P3302 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 174.016 0 390.278 OK 2.65635 0 28.8201 OK 0 0 0 OK P3303 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 125.856 0 318.777 OK 198.346 108.195 288.497 OK 337.66 0 1029.99 OK P3304 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 46.0789 0 177.045 OK 90.6925 25.2616 156.123 OK 95.6502 0 667.332 OK P3305 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 0.231084 0 7.65235 OK 3.70001 0 26.2717 OK 0 0 0 OK P3306 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 871.304 416.82 1325.79 OK 1176.83 962.635 1391.02 OK 1348.2 0 3245.79 OK P3307 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 1672.29 1040.38 2304.2 OK 1344.32 1027.22 1661.43 OK 2703.15 964.57 4441.73 OK P3308 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 233.679 0 498.711 OK 200.546 6.29924 394.793 OK 618.972 0 2083.69 OK P3309 - - XLOC_001397 HNRNPR TSS2227 chr1:23636276-23670853 - - 18.8159 0 235.337 OK 3.27082 0 45.6852 OK 0 0 0 OK P331 - - XLOC_000155 ARHGEF10L TSS237 chr1:17866329-18024369 - - 0 0 0 OK 0 0 0 OK 208.168 46.1213 370.214 OK P3310 - - XLOC_001398 ZNF436 TSS2229,TSS2230 chr1:23685941-23698278 - - 60.989 7.80842 114.17 OK 18.4192 13.3986 23.4398 OK 386.766 186.05 587.481 OK P3311 - - XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 - - 0 0 0 OK 0 0 0 OK 12.5792 0 311.431 OK P3312 - - XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 - - 61.7872 0 180.091 OK 0 0 0 OK 147.495 0 442.753 OK P3313 - - XLOC_001399 TCEA3 TSS2232 chr1:23707554-23751261 - - 0 0 0 OK 4.90057 0 13.6303 OK 75.1132 0 421.044 OK P3314 - - XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 - - 72.9916 0 148.404 OK 1.36049 0 3.66464 OK 539.056 242.03 836.083 OK P3315 - - XLOC_001400 ASAP3 TSS2237 chr1:23755055-23811057 - - 0 0 0 OK 5.93528 0 78.7546 OK 0 0 0 OK P3316 - - XLOC_001400 ASAP3 TSS2236 chr1:23755055-23811057 - - 0 0 0 OK 24.2074 0 58.75 OK 0 0 0 OK P3317 - - XLOC_001400 ASAP3 TSS2235 chr1:23755055-23811057 - - 181.965 75.926 288.004 OK 557.63 466.323 648.937 OK 591.657 299.448 883.866 OK P3318 - - XLOC_001400 ASAP3 TSS2235 chr1:23755055-23811057 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3319 - - XLOC_001400 - TSS2235 chr1:23755055-23811057 - - 33.3151 0 89.9209 OK 59.9998 15.4729 104.527 OK 61.9722 0 157.329 OK P332 - - XLOC_000155 ARHGEF10L TSS238 chr1:17866329-18024369 - - 0 0 0 OK 2.78634 0 19.6284 OK 5.30615 0 156.718 OK P3320 - - XLOC_001400 ASAP3 TSS2233 chr1:23755055-23811057 - - 57.325 0 142.224 OK 22.8075 0 48.2833 OK 97.6727 0 255.097 OK P3321 - - XLOC_001402 E2F2 TSS2238 chr1:23832921-23857713 - - 17.3678 4.7535 29.9821 OK 95.4288 77.2231 113.634 OK 59.0676 19.8264 98.3088 OK P3322 - - XLOC_001403 ID3 - chr1:23884409-23886322 - - 290.313 0 618.864 OK 130.941 50.7059 211.176 OK 325.332 12.3701 638.294 OK P3323 - - XLOC_001403 ID3 TSS2239 chr1:23884409-23886322 - - 2233.71 1374.86 3092.55 OK 3052.85 2640.31 3465.39 OK 1179.44 550.757 1808.12 OK P3324 - - XLOC_001405 GALE TSS2243 chr1:24122088-24127294 - - 4.49564 0 168.221 OK 5.43458 0 25.3141 OK 0 0 0 OK P3325 - - XLOC_001405 GALE TSS2244 chr1:24122088-24127294 - - 6.56657 0 75.3981 OK 9.86629 0 29.5456 OK 4.63048 0 149.567 OK P3326 - - XLOC_001405 GALE TSS2243 chr1:24122088-24127294 - - 61.4119 0 158.662 OK 43.8262 9.46915 78.1832 OK 155.802 0 410.815 OK P3327 - - XLOC_001405 GALE TSS2243 chr1:24122088-24127294 - - 34.8907 0 103.164 OK 51.369 21.0673 81.6707 OK 64.4525 0 246.749 OK P3328 - - XLOC_001405 GALE TSS2242 chr1:24122088-24127294 - - 17.4871 0 82.9391 OK 17.3703 0 51.7957 OK 39.5664 0 138.771 OK P3329 - - XLOC_001405 GALE TSS2241,TSS2242,TSS2243 chr1:24122088-24127294 - - 184.266 40.0424 328.489 OK 440.531 343.758 537.304 OK 498.222 140.171 856.274 OK P333 - - XLOC_000155 - TSS242 chr1:17866329-18024369 - - 12.7177 0 69.1669 OK 44.6171 10.5906 78.6436 OK 14.6487 0 130.905 OK P3330 - - XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 - - 17.3205 0 60.829 OK 7.27536 0 16.2781 OK 39.9903 0 162.231 OK P3331 - - XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 - - 7.05744 0 57.8374 OK 9.6936 0 23.5795 OK 5.84858 0 211.14 OK P3332 - - XLOC_001406 HMGCL TSS2246 chr1:24128367-24165110 - - 7.68224 0 40.6411 OK 12.5886 0.206477 24.9707 OK 0 0 0 OK P3333 - - XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 - - 184.728 56.5612 312.894 OK 286.755 224.657 348.854 OK 1600.17 868.148 2332.19 OK P3334 - - XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3335 - - XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 - - 0 0 0 OK 42.7613 12.6627 72.8598 OK 114.728 0 386.652 OK P3336 - - XLOC_001407 FUCA1 TSS2247 chr1:24171573-24194821 - - 207.2 93.0962 321.303 OK 122.432 95.3123 149.551 OK 140.427 46.8684 233.985 OK P3337 - - XLOC_001408 CNR2 TSS2248 chr1:24200460-24239817 - - 0.725191 0 2.81492 OK 0 0 0 OK 0 0 0 OK P3338 - - XLOC_001409 SFRS13A TSS2249 chr1:24292938-24306821 - - 177.784 0 423.155 OK 533.444 389.643 677.245 OK 1297.57 432.71 2162.43 OK P3339 - - XLOC_001409 SFRS13A TSS2249 chr1:24292938-24306821 - - 1054.92 628.182 1481.65 OK 767.195 635.873 898.516 OK 1010.81 415.849 1605.77 OK P334 - - XLOC_000155 ARHGEF10L TSS239 chr1:17866329-18024369 - - 24.8197 0 70.9372 OK 25.6249 7.29019 43.9596 OK 0 0 0 OK P3340 - - XLOC_001410 MYOM3 TSS2252 chr1:24382531-24438665 - - 1.49896 0 5.12555 OK 0 0 0 OK 0 0 0 OK P3341 - - XLOC_001410 MYOM3 TSS2252 chr1:24382531-24438665 - - 0.798149 0 2.71878 OK 0.363637 0 1.17831 OK 0 0 0 OK P3342 - - XLOC_001410 MYOM3 TSS2251 chr1:24382531-24438665 - - 0.452065 0 2.23786 OK 1.77127 0.174322 3.36822 OK 0 0 0 OK P3343 - - XLOC_001410 MYOM3 TSS2250 chr1:24382531-24438665 - - 0 0 0 OK 1.19576 0 3.29814 OK 0 0 0 OK P3344 - - XLOC_001410 MYOM3 TSS2253 chr1:24382531-24438665 - - 0.347098 0 1.73564 OK 0.607421 0 1.4623 OK 0 0 0 OK P3345 - - XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 - - 0 0 0 OK 5.55488 2.27978 8.82997 OK 0.000273846 0 0.885686 OK P3346 - - XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P3347 - - XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 - - 0 0 0 OK 0 0 0 OK 3.57838 0 7.4666 OK P3348 - - XLOC_001411 IL22RA1 TSS2254 chr1:24446260-24469611 - - 6.64523 1.2324 12.0581 OK 1.45433 0 3.80055 OK 0 0 0 OK P3349 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 81.6347 33.1208 130.149 OK 44.0625 30.0304 58.0946 OK 0 0 0 OK P335 - - XLOC_000156 ACTL8 TSS243 chr1:18081807-18153556 - - 9.62232 1.18858 18.0561 OK 17.1125 10.9181 23.3069 OK 6.95204 0.2121 13.692 OK P3350 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 0 0 0 OK 0 0 0 OK 0.000702974 0 0.54458 OK P3351 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 13.7311 0 178.337 OK 125.353 57.2073 193.498 OK 0 0 0 OK P3352 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 0 0 0 OK 12.9816 4.46503 21.4982 OK 0.0365025 0 0.585153 OK P3353 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 4.07053 0 23.813 OK 24.4887 13.2913 35.6862 OK 0.0773653 0 0.626928 OK P3354 - - XLOC_001414 C1orf201 TSS2261 chr1:24683489-24741587 - - 8.9548 0 57.0165 OK 2.3477 0 9.37006 OK 15.7206 0 84.2402 OK P3355 - - XLOC_001414 C1orf201 TSS2259 chr1:24683489-24741587 - - 2.86176 0 39.3042 OK 10.1778 0.655751 19.6998 OK 13.0899 0 52.4017 OK P3356 - - XLOC_001414 C1orf201 TSS2259,TSS2260 chr1:24683489-24741587 - - 141.615 53.1116 230.118 OK 132.318 103.304 161.331 OK 209.444 70.2782 348.611 OK P3357 - - XLOC_001414 C1orf201 TSS2258 chr1:24683489-24741587 - - 11.5429 0 42.8324 OK 7.16763 0 15.8409 OK 57.9985 0 135.969 OK P3358 - - XLOC_001414 C1orf201 TSS2257 chr1:24683489-24741587 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P336 - - XLOC_000157 IGSF21 TSS244 chr1:18434239-18704976 - - 58.273 18.1053 98.4407 OK 398.742 315.075 482.408 OK 0 0 0 OK P337 - - XLOC_000157 IGSF21 TSS245 chr1:18434239-18704976 - - 2.74185 0 26.2821 OK 3.24727 0 61.6295 OK 0 0 0 OK P338 - - XLOC_000159 KLHDC7A - chr1:18807423-18812539 - - 104.809 46.7452 162.873 OK 209.176 173.777 244.576 OK 0 0 0 OK P339 - - XLOC_000159 KLHDC7A TSS246 chr1:18807423-18812539 - - 0 0 0 OK 8.37135 0 23.4298 OK 0.745204 0 1.93601 OK P34 - - XLOC_000034 ATAD3C TSS30 chr1:1385068-1405538 - - 12.4598 2.74524 22.1743 OK 69.2663 54.4066 84.1261 OK 15.5201 2.93467 28.1056 OK P340 - - XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 - - 0.593912 0 1.7564 OK 0.969259 0.12168 1.81684 OK 0 0 0 OK P341 - - XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 - - 6.55753e-05 0 2.31943 OK 0 0 0 OK 0 0 0 OK P342 - - XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 - - 5.07852e-05 0 2.31276 OK 7.1892e-05 0 0.910255 OK 0 0 0 OK P343 - - XLOC_000161 MRTO4 TSS248 chr1:19578074-19586621 - - 773.162 453.595 1092.73 OK 961.74 822.192 1101.29 OK 1651.61 939.806 2363.42 OK P344 - - XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 - - 98.9774 8.43809 189.517 OK 246.16 188.836 303.485 OK 406.656 154.571 658.741 OK P345 - - XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 - - 6.84301 0 53.4815 OK 0.0310775 0 1.31621 OK 25.1112 0 111.739 OK P346 - - XLOC_000162 PQLC2 TSS249,TSS250 chr1:19638739-19655793 - - 80.1847 0 162.335 OK 78.4626 41.6144 115.311 OK 156.014 0 344.785 OK P347 - - XLOC_000163 C1orf151 TSS251 chr1:19923466-19984945 - - 246.288 70.507 422.068 OK 618.381 516.011 720.752 OK 1693.34 0 4198.67 OK P348 - - XLOC_000163 NBL1 TSS252 chr1:19923466-19984945 - - 0 0 0 OK 1.64141 0 17.0922 OK 3.52907 0 2423.53 OK P349 - - XLOC_000163 NBL1 TSS251,TSS253 chr1:19923466-19984945 - - 0 0 0 OK 162.125 101.194 223.057 OK 8957.03 2695.13 15218.9 OK P35 - - XLOC_000035 ATAD3B TSS33 chr1:1407163-1431581 - - 35.8479 0 150.016 OK 321.282 129.76 512.804 OK 321.282 0 654.988 OK P350 - - XLOC_000163 NBL1 TSS254 chr1:19923466-19984945 - - 463.905 201.419 726.392 OK 16.9244 0 39.9956 OK 1884.11 0 4561 OK P351 - - XLOC_000164 HTR6 TSS255 chr1:19991779-20006054 - - 3.39355 0 7.66135 OK 22.3161 15.5051 29.1271 OK 0 0 0 OK P352 - - XLOC_000165 OTUD3 TSS256 chr1:20208887-20239429 - - 148.118 78.5111 217.725 OK 157.667 131.532 183.802 OK 87.3998 38.6021 136.198 OK P353 - - XLOC_000166 PLA2G5 TSS258 chr1:20354671-20418393 - - 0 0 0 OK 0.847143 0 2.42832 OK 147.21 39.2714 255.148 OK P354 - - XLOC_000166 PLA2G5 TSS257 chr1:20354671-20418393 - - 0.482643 0 2.4868 OK 0 0 0 OK 0 0 0 OK P355 - - XLOC_000167 PLA2G2F TSS259 chr1:20465822-20476879 - - 0 0 0 OK 0.361045 0 1.08683 OK 0 0 0 OK P356 - - XLOC_000168 UBXN10 TSS260 chr1:20512577-20519941 - - 12.3177 2.70219 21.9333 OK 17.9074 12.8575 22.9573 OK 0.492177 0 1.39458 OK P357 - - XLOC_000169 VWA5B1 TSS262 chr1:20617411-20681387 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P358 - - XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 - - 1.30646 0 3.55729 OK 6.27626 2.78634 9.76618 OK 0.000774709 0 0.542867 OK P359 - - XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 - - 3.74866e-05 0 1.13976 OK 0 0 0 OK 0.572137 0 1.52356 OK P36 - - XLOC_000035 ATAD3B TSS32 chr1:1407163-1431581 - - 77.2479 0 183.718 OK 111.183 59.9484 162.418 OK 43.4345 0 137.441 OK P360 - - XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 - - 1.83014 0 4.5453 OK 11.844 7.05424 16.6339 OK 0 0 0 OK P361 - - XLOC_000170 FAM43B - chr1:20878931-20881512 - - 1.9757 0 4.79309 OK 40.5541 30.5386 50.5696 OK 1.55058 0 3.52437 OK P362 - - XLOC_000171 CDA TSS263 chr1:20915443-20945398 - - 223.547 76.3485 370.746 OK 133.245 98.9045 167.586 OK 232.113 70.0502 394.177 OK P363 - - XLOC_000172 PINK1 TSS265 chr1:20959947-20978003 - - 0 0 0 OK 114.96 63.3891 166.53 OK 832.083 0 1760.82 OK P364 - - XLOC_000172 PINK1 TSS264 chr1:20959947-20978003 - - 640.208 365.853 914.562 OK 326.979 265.85 388.108 OK 2213.85 1142.71 3284.98 OK P365 - - XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 - - 4.87776 0 24.0476 OK 17.0989 7.89884 26.2989 OK 34.3555 0 128.635 OK P366 - - XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 - - 0 0 0 OK 1.81796 0 5.24041 OK 15.9541 0 79.8183 OK P367 - - XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 - - 11.3784 0 34.7448 OK 3.12392 0 7.65375 OK 50.1038 0 137.972 OK P368 - - XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 - - 68.9507 24.2451 113.656 OK 37.3701 26.4183 48.3219 OK 428.32 197.914 658.727 OK P369 - - XLOC_000176 ALPL TSS269,TSS270 chr1:21835857-21904904 - - 877.819 534.019 1221.62 OK 4753.79 4238.97 5268.62 OK 64.4961 3.53815 125.454 OK P37 - - XLOC_000035 ATAD3B TSS31 chr1:1407163-1431581 - - 117.436 0.943989 233.928 OK 409.377 321.924 496.83 OK 275.225 68.8205 481.63 OK P370 - - XLOC_000176 ALPL TSS269 chr1:21835857-21904904 - - 14.1413 0 89.6176 OK 40.1523 0 109.691 OK 0 0 0 OK P371 - - XLOC_000176 ALPL TSS269 chr1:21835857-21904904 - - 46.976 0 190.077 OK 130.881 38.5571 223.204 OK 2.32536 0 35.0427 OK P372 - - XLOC_000176 ALPL TSS269 chr1:21835857-21904904 - - 14.1212 0 99.3224 OK 120.584 28.2118 212.956 OK 0 0 0 OK P373 - - XLOC_000177 LDLRAD2 TSS271 chr1:22138757-22263750 - - 10.8443 0 49.4651 OK 22.0415 0 52.5544 OK 16.2682 0 6109.78 OK P374 - - XLOC_000178 CELA3B TSS273 chr1:22303417-22339033 - - 1.39771 0 7.20083 OK 0 0 0 OK 0 0 0 OK P375 - - XLOC_000178 CELA3A TSS274 chr1:22303417-22339033 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P376 - - XLOC_000178 - TSS273 chr1:22303417-22339033 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P377 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 39.4183 0 171.3 OK 8.77177 0 28.3414 OK 55.0216 0 1056.12 OK P378 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 13.0529 0 226.573 OK 9.59677 0 30.7045 OK 70.2619 0 1686.83 OK P379 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 583.18 0 1347.72 OK 83.254 32.7302 133.778 OK 668.209 0 2096.23 OK P38 - - XLOC_000035 ATAD3B TSS32 chr1:1407163-1431581 - - 202.814 67.8347 337.792 OK 138.44 68.5829 208.298 OK 154.302 0 319.41 OK P380 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 2997.59 1849.36 4145.83 OK 1520.88 1310.21 1731.54 OK 9098.98 4509.42 13688.5 OK P381 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 11.3168 0 162.163 OK 3.95557 0 18.9503 OK 0 0 0 OK P382 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P383 - - XLOC_000181 ZBTB40 TSS278 chr1:22778343-22857650 - - 5.796 0 27.5916 OK 76.4937 55.6987 97.2886 OK 7.15473 0 30.0231 OK P384 - - XLOC_000181 - TSS279 chr1:22778343-22857650 - - 41.9937 0 111.704 OK 23.69 0.441524 46.9385 OK 12.3722 0 108.831 OK P385 - - XLOC_000181 ZBTB40 TSS278 chr1:22778343-22857650 - - 83.12 36.8808 129.359 OK 121.688 96.3739 147.001 OK 210.854 113.724 307.984 OK P386 - - XLOC_000182 EPHA8 TSS280 chr1:22890003-22930087 - - 2.71483 0 7.83431 OK 16.9383 10.421 23.4555 OK 0 0 0 OK P387 - - XLOC_000182 EPHA8 TSS280 chr1:22890003-22930087 - - 30.6745 6.20652 55.1425 OK 69.3632 47.4182 91.3082 OK 0 0 0 OK P388 - - XLOC_000183 C1QA TSS281,TSS282 chr1:22963117-22966174 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P389 - - XLOC_000184 C1QC TSS283 chr1:22970117-22974602 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P39 - - XLOC_000036 ATAD3A TSS35 chr1:1447554-1470064 - - 100.608 0 223.85 OK 542.034 418.405 665.662 OK 1200.71 478.111 1923.3 OK P390 - - XLOC_000185 C1QB TSS284 chr1:22979681-22988028 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P391 - - XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 - - 0 0 0 OK 37.3058 19.4343 55.1772 OK 79.1362 0 246.869 OK P392 - - XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 - - 0.0140869 0 1.26936 OK 80.4755 51.7107 109.24 OK 73.628 0 278.361 OK P393 - - XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 - - 58.1996 24.2193 92.1799 OK 183.879 143.513 224.246 OK 794.32 339.585 1249.05 OK P394 - - XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P395 - - XLOC_000188 - TSS286 chr1:23345940-23410184 - - 2064.11 1426.3 2701.92 OK 3123.43 2750.05 3496.8 OK 1754.94 897.589 2612.29 OK P396 - - XLOC_000188 - TSS286 chr1:23345940-23410184 - - 556.677 175.107 938.247 OK 911.067 698.856 1123.28 OK 597.396 99.5527 1095.24 OK P397 - - XLOC_000189 C1orf213 TSS287 chr1:23685941-23698278 - - 6.87752 0 118.747 OK 2.53326 0 7.75234 OK 73.0221 0 322.578 OK P398 - - XLOC_000189 C1orf213 - chr1:23685941-23698278 - - 8.91818 0 33.4669 OK 4.45377 1.19709 7.71044 OK 27.3759 0 92.7495 OK P399 - - XLOC_000192 RPL11 TSS291 chr1:24018293-24022913 - - 37247.7 28518.8 45976.5 OK 66407.9 60090.9 72724.8 OK 56810.6 5947.22 107674 OK P4 - - XLOC_000006 OR4F16 - chr1:367658-368595 - - 1.51396 0 5.87661 OK 0 0 0 OK 0 0 0 OK P40 - - XLOC_000036 ATAD3A TSS34 chr1:1447554-1470064 - - 470.224 218.199 722.248 OK 790.187 647.172 933.203 OK 819.961 254.633 1385.29 OK P400 - - XLOC_000192 RPL11 TSS290 chr1:24018293-24022913 - - 6878.03 3034.71 10721.3 OK 6624.43 4634.51 8614.36 OK 57034.4 0 120251 OK P401 - - XLOC_000192 RPL11 TSS290 chr1:24018293-24022913 - - 728.583 0 2157.89 OK 1583.34 567.367 2599.31 OK 8804.01 0 36317.8 OK P402 - - XLOC_000192 RPL11 TSS291 chr1:24018293-24022913 - - 227.08 0 558.532 OK 191.396 26.3709 356.421 OK 86.3727 0 5223.64 OK P403 - - XLOC_000193 TCEB3 TSS292 chr1:24069855-24104777 - - 755.461 500.365 1010.56 OK 523.425 449.786 597.064 OK 1232.52 710.214 1754.83 OK P404 - - XLOC_000194 - TSS293 chr1:24104875-24114720 - - 42.6282 0 144.062 OK 57.722 11.6848 103.759 OK 138.236 0 368.919 OK P405 - - XLOC_000194 C1orf128 TSS293 chr1:24104875-24114720 - - 1031.1 585.034 1477.16 OK 1150.34 973.267 1327.41 OK 1578.13 864.273 2291.99 OK P406 - - XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 - - 728.399 345.869 1110.93 OK 738.535 550.861 926.209 OK 245.964 0 503.753 OK P407 - - XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 - - 60.6827 0 192.717 OK 0 0 0 OK 0 0 0 OK P408 - - XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 - - 151.125 0 346.217 OK 1591.41 1317.47 1865.36 OK 801.526 326.057 1277 OK P409 - - XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 - - 107.325 0 260.912 OK 366.517 237.845 495.188 OK 138.908 0 347.561 OK P41 - - XLOC_000036 ATAD3A TSS34 chr1:1447554-1470064 - - 31.4583 0 110.344 OK 54.4924 15.3557 93.6291 OK 39.157 0 219.548 OK P410 - - XLOC_000196 PNRC2 TSS295 chr1:24286300-24289947 - - 2032.12 1397.99 2666.24 OK 1015.28 870.304 1160.25 OK 1795.17 1048.34 2541.99 OK P411 - - XLOC_000198 GRHL3 TSS298 chr1:24645880-24681807 - - 0.00176595 0 2.07322 OK 0 0 0 OK 0.713246 0 2.12472 OK P412 - - XLOC_000198 GRHL3 TSS297 chr1:24645880-24681807 - - 11.6632 0 25.3412 OK 24.5694 18.1154 31.0234 OK 0 0 0 OK P413 - - XLOC_000198 GRHL3 TSS298 chr1:24645880-24681807 - - 9.34923 0 22.3551 OK 0.00104564 0 0.746452 OK 3.65658e-05 0 0.923571 OK P414 - - XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 - - 0 0 0 OK 4.01002 0 8.91311 OK 60.0129 0 394.357 OK P415 - - XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 - - 102.299 0 262.948 OK 55.217 26.4182 84.0158 OK 181.782 0 693.997 OK P416 - - XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 - - 5.7743 0 133.837 OK 0.568882 0 3.14544 OK 2.27352 0 620.8 OK P417 - - XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 - - 340.07 186.719 493.422 OK 80.6785 63.1297 98.2273 OK 1388.46 665.41 2111.5 OK P418 - - XLOC_000199 - TSS300 chr1:24742244-24799472 - - 22.1357 0 89.5964 OK 5.64277 0 12.4566 OK 7.66113 0 322.35 OK P419 - - XLOC_000200 - TSS302 chr1:24829386-24862425 - - 15.7185 0 96.9772 OK 11.8633 0 25.7417 OK 51.8532 0 317.685 OK P42 - - XLOC_000038 - TSS42 chr1:1550883-1565984 - - 20.1981 0 139.654 OK 217.26 11.3877 423.133 OK 0 0 0 OK P420 - - XLOC_000200 - TSS302 chr1:24829386-24862425 - - 0 0 0 OK 4.24998 0 15.5901 OK 46.3362 0 225.029 OK P421 - - XLOC_000200 - TSS302 chr1:24829386-24862425 - - 10.6171 0 119.919 OK 2.64685 0 14.2982 OK 8.94425 0 127.308 OK P422 - - XLOC_000200 RCAN3 TSS301 chr1:24829386-24862425 - - 326.184 141.385 510.982 OK 113.081 85.3306 140.832 OK 219.138 56.3326 381.943 OK P423 - - XLOC_000200 RCAN3 TSS302 chr1:24829386-24862425 - - 20.7252 0 88.5662 OK 0 0 0 OK 77.2898 0 299.924 OK P424 - - XLOC_000201 C1orf130 TSS303 chr1:24882601-24935816 - - 1.31366 0 3.14984 OK 2.35713 0.82725 3.88701 OK 0.128844 0 0.527799 OK P425 - - XLOC_000202 SRRM1 TSS304 chr1:24969593-24999771 - - 0.0198022 0 1.82379 OK 0 0 0 OK 574.066 181.597 966.535 OK P426 - - XLOC_000202 SRRM1 TSS305 chr1:24969593-24999771 - - 41.7106 0 140.057 OK 47.1916 0 141.741 OK 28.5028 0 259.28 OK P427 - - XLOC_000202 SRRM1 TSS304 chr1:24969593-24999771 - - 816.952 510.008 1123.9 OK 805.739 675.901 935.577 OK 789.315 313.429 1265.2 OK P428 - - XLOC_000202 SRRM1 TSS306 chr1:24969593-24999771 - - 347.64 90.4553 604.825 OK 876.963 688.501 1065.42 OK 164.784 0 656.281 OK P43 - - XLOC_000038 - TSS38 chr1:1550883-1565984 - - 0.0361283 0 1.8205 OK 26.2154 7.05147 45.3793 OK 16.9683 0 82.8635 OK P44 - - XLOC_000038 MIB2 TSS39 chr1:1550883-1565984 - - 0 0 0 OK 3.88743 0 11.076 OK 56.0751 0 156.18 OK P45 - - XLOC_000038 MIB2 TSS38 chr1:1550883-1565984 - - 4.60985 0 20.8228 OK 37.6352 4.96135 70.309 OK 44.1025 0 134.088 OK P46 - - XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 - - 13.0332 0 36.1356 OK 0.00352987 0 0.615929 OK 17.092 0 77.2561 OK P47 - - XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P48 - - XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 - - 0 0 0 OK 4.48044 0 17.226 OK 0 0 0 OK P49 - - XLOC_000038 MIB2 TSS41 chr1:1550883-1565984 - - 12.0776 0 40.1051 OK 0 0 0 OK 30.3273 0 284.908 OK P5 - - XLOC_000015 SAMD11 TSS8 chr1:860529-894679 - - 52.9724 0 144.687 OK 1.74761 0 20.2147 OK 3.81714 0 290.443 OK P50 - - XLOC_000038 MIB2 TSS40 chr1:1550883-1565984 - - 0 0 0 OK 100.348 62.3934 138.302 OK 45.3624 0 272.337 OK P51 - - XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 - - 28.9547 0 58.9289 OK 100.346 63.6034 137.089 OK 66.3531 0 172.477 OK P52 - - XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 - - 9.17877 0 28.7895 OK 86.1128 46.7493 125.476 OK 316.769 119.635 513.902 OK P53 - - XLOC_000039 MMP23B TSS43 chr1:1567559-1570029 - - 3.14247 0 12.2684 OK 33.88 18.0044 49.7556 OK 6.12558 0 19.2931 OK P54 - - XLOC_000039 - TSS45 chr1:1567559-1570029 - - 0.730004 0 7.95551 OK 9.67624 0 26.3795 OK 6.24162 0 31.9677 OK P55 - - XLOC_000039 - TSS44 chr1:1567559-1570029 - - 0 0 0 OK 0 0 0 OK 13.8369 0 36.035 OK P56 - - XLOC_000039 - TSS43 chr1:1567559-1570029 - - 9.57879 0 20.9378 OK 23.6518 10.1005 37.203 OK 0 0 0 OK P57 - - XLOC_000040 - TSS47 chr1:1571099-1677431 - - 19.4885 0 121.567 OK 18.0861 0 106.613 OK 2.78903 0 5238.31 OK P58 - - XLOC_000040 - TSS46 chr1:1571099-1677431 - - 0 0 0 OK 73.9259 0 204.54 OK 90.7454 0 2295.13 OK P59 - - XLOC_000042 - TSS49 chr1:1822909-1824112 - - 4.99201 0 13.0756 OK 3.15678 0 7.15379 OK 11.254 0 24.0748 OK P6 - - XLOC_000015 SAMD11 TSS9 chr1:860529-894679 - - 48.0828 0 161.788 OK 4.50533 0 23.9737 OK 34.9169 0 334.708 OK P60 - - XLOC_000043 CALML6 TSS50 chr1:1846265-1848733 - - 5.39767 0 12.9423 OK 26.9908 16.4977 37.4839 OK 1.08118 0 3.44841 OK P61 - - XLOC_000044 GABRD TSS51 chr1:1950767-1962192 - - 12.037 2.28368 21.7903 OK 41.7053 30.9987 52.4118 OK 0.393202 0 1.41275 OK P62 - - XLOC_000045 PRKCZ TSS54 chr1:1981908-2139172 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P63 - - XLOC_000045 PRKCZ TSS58 chr1:1981908-2139172 - - 7.19324 0 87.0707 OK 17.4198 0 48.8643 OK 0 0 0 OK P64 - - XLOC_000045 PRKCZ TSS57 chr1:1981908-2139172 - - 5.19072 0 140.764 OK 3.07856 0 36.4667 OK 0 0 0 OK P65 - - XLOC_000045 PRKCZ TSS56 chr1:1981908-2139172 - - 0 0 0 OK 0 0 0 OK 34.2875 0 174.055 OK P66 - - XLOC_000045 PRKCZ TSS53,TSS55 chr1:1981908-2139172 - - 94.566 0 220.657 OK 60.5588 0 129.341 OK 45.4119 0 156.55 OK P67 - - XLOC_000045 PRKCZ TSS52 chr1:1981908-2139172 - - 199.815 52.1436 347.487 OK 833.609 681.248 985.97 OK 0 0 0 OK P68 - - XLOC_000046 - - chr1:1981908-2139172 - - 66.2174 0 158.32 OK 109.688 49.1409 170.236 OK 100.493 0 256.343 OK P69 - - XLOC_000047 SKI TSS59 chr1:2160133-2241651 - - 246.057 139.664 352.451 OK 740.008 646.624 833.392 OK 1645.91 940.496 2351.32 OK P7 - - XLOC_000015 SAMD11 TSS7 chr1:860529-894679 - - 95.4282 0 619.043 OK 0 0 0 OK 0 0 0 OK P70 - - XLOC_000048 RER1 TSS60 chr1:2323213-2344010 - - 33.4962 0 122.928 OK 30.1072 4.99162 55.2227 OK 143.247 0 575.754 OK P71 - - XLOC_000048 RER1 TSS60 chr1:2323213-2344010 - - 800.086 476.256 1123.92 OK 772.363 649.835 894.891 OK 3798.35 1902.54 5694.16 OK P72 - - XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P73 - - XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 - - 0 0 0 OK 6.36609e-05 0 0.497185 OK 0.593027 0 4.98522 OK P74 - - XLOC_000049 PLCH2 TSS61 chr1:2407753-2436969 - - 0 0 0 OK 1.11603 0 2.44788 OK 0.769693 0 4.06489 OK P75 - - XLOC_000049 PLCH2 TSS63 chr1:2407753-2436969 - - 1.2132 0 5.26466 OK 0 0 0 OK 0 0 0 OK P76 - - XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 - - 1.08359 0 2.87839 OK 1.19958 0 2.40297 OK 1.27131 0 4.08712 OK P77 - - XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 - - 2.28814e-05 0 1.03298 OK 0 0 0 OK 0 0 0 OK P78 - - XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 - - 2.02513 0 7.90803 OK 0.4903 0 1.36247 OK 46.0527 0 106.863 OK P79 - - XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 - - 4.50144 0 23.5184 OK 3.17316 0 7.35148 OK 72.3071 0 222.365 OK P8 - - XLOC_000016 KLHL17 TSS10 chr1:895966-901095 - - 63.5773 9.94217 117.212 OK 180.736 130.393 231.079 OK 138.131 30.5583 245.704 OK P80 - - XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 - - 20.3741 0 52.4313 OK 0 0 0 OK 650.706 280.598 1020.81 OK P81 - - XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 - - 21.3399 0 99.2141 OK 0.103287 0 3.40592 OK 118.524 0 409.04 OK P82 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 222.585 36.4149 408.755 OK 431.86 338.283 525.436 OK 616.77 232.585 1000.95 OK P83 - - XLOC_000051 C1orf93 TSS66 chr1:2518248-2564481 - - 48.0815 0 133.857 OK 46.1049 14.1008 78.109 OK 83.8728 0 255.808 OK P84 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P85 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 20.6279 0 70.2256 OK 15.5461 0 34.9892 OK 21.4195 0 144.599 OK P86 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 147.391 0 297.517 OK 327.266 246.582 407.95 OK 561.382 197.151 925.612 OK P87 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 0 0 0 OK 36.9813 8.66116 65.3015 OK 5.26014 0 132.95 OK P88 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P89 - - XLOC_000052 ACTRT2 - chr1:2938045-2939465 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK P9 - - XLOC_000016 KLHL17 TSS11 chr1:895966-901095 - - 55.6229 0 144.357 OK 151.63 72.2295 231.031 OK 48.7092 0 168.468 OK P90 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 0.000730027 0 0.567201 OK 0 0 0 OK 1.20838 0 7.4165 OK P91 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 0.00101879 0 0.567688 OK 0 0 0 OK 7.0186 0.561578 13.4756 OK P92 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 0.586072 0 1.72703 OK 4.52426 2.56981 6.47872 OK 0 0 0 OK P93 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 0.000653284 0 0.567057 OK 0 0 0 OK 0 0 0 OK P94 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 0.419018 0 1.55957 OK 0.770522 0 2.28146 OK 0 0 0 OK P95 - - XLOC_000054 ARHGEF16 TSS68 chr1:3371146-3397675 - - 135.254 53.9378 216.57 OK 229.313 180.517 278.109 OK 2.38434 0 7.0422 OK P96 - - XLOC_000054 ARHGEF16 TSS71 chr1:3371146-3397675 - - 0 0 0 OK 5.86138 0 18.5419 OK 0 0 0 OK P97 - - XLOC_000054 ARHGEF16 TSS71 chr1:3371146-3397675 - - 8.08924 0 60.6874 OK 11.6052 0 28.8434 OK 0 0 0 OK P98 - - XLOC_000054 ARHGEF16 TSS69,TSS70 chr1:3371146-3397675 - - 23.0853 0 80.9527 OK 120.614 77.7838 163.444 OK 2.4012 0 8.53951 OK P99 - - XLOC_000055 TPRG1L TSS72 chr1:3541555-3546692 - - 546.504 302.59 790.417 OK 498.776 417.899 579.653 OK 2676.03 1552.21 3799.85 OK cummeRbund/inst/extdata/cds.read_group_tracking0000644000175200017520000072647214516004263023033 0ustar00biocbuildbiocbuildtracking_id condition replicate raw_frags internal_scaled_frags external_scaled_frags FPKM effective_length status P1 iPS 0 9 9.3939 16.0613 17.2049 - OK P1 iPS 1 4.89798 4.71882 8.06806 8.6425 - OK P1 hESC 1 1 0.989851 0.654207 0.621918 - OK P1 hESC 0 0 0 0 0 - OK P1 Fibroblasts 1 0 0 0 0 - OK P1 Fibroblasts 0 0 0 0 0 - OK P10 iPS 0 17.9569 18.7428 32.0458 46.1833 - OK P10 iPS 1 9.72988 9.37399 16.0273 23.098 - OK P10 hESC 1 188.786 186.87 123.505 188.186 - OK P10 hESC 0 181.802 183.666 121.388 184.96 - OK P10 Fibroblasts 1 63.5465 53.0231 43.3466 62.9707 - OK P10 Fibroblasts 0 40.0211 47.6206 38.9299 56.5546 - OK P100 iPS 0 0 0 0 0 - OK P100 iPS 1 0 0 0 0 - OK P100 hESC 1 0 0 0 0 - OK P100 hESC 0 0 0 0 0 - OK P100 Fibroblasts 1 20.4822 17.0903 13.9714 9.53494 - OK P100 Fibroblasts 0 39.4147 46.899 38.3401 26.1657 - OK P101 iPS 0 0.00100719 0.00105127 0.00179742 0.00146415 - OK P101 iPS 1 6.8286 6.57882 11.2482 9.16264 - OK P101 hESC 1 0 0 0 0 - OK P101 hESC 0 0.453447 0.458096 0.302762 0.254416 - OK P101 Fibroblasts 1 0 0 0 0 - OK P101 Fibroblasts 0 3.66354 4.35921 3.56366 2.91602 - OK P102 iPS 0 0 0 0 0 - OK P102 iPS 1 1.28379 1.23683 2.11469 1.73257 - OK P102 hESC 1 0 0 0 0 - OK P102 hESC 0 0 0 0 0 - OK P102 Fibroblasts 1 2 1.6688 1.36425 1.12281 - OK P102 Fibroblasts 0 0.000312782 0.000372175 0.000304254 0.000250409 - OK P103 iPS 0 0 0 0 0 - OK P103 iPS 1 0 0 0 0 - OK P103 hESC 1 0 0 0 0 - OK P103 hESC 0 0 0 0 0 - OK P103 Fibroblasts 1 0 0 0 0 - OK P103 Fibroblasts 0 0 0 0 0 - OK P104 iPS 0 0 0 0 0 - OK P104 iPS 1 0 0 0 0 - OK P104 hESC 1 0 0 0 0 - OK P104 hESC 0 0 0 0 0 - OK P104 Fibroblasts 1 0 0 0 0 - OK P104 Fibroblasts 0 0 0 0 0 - OK P105 iPS 0 0 0 0 0 - OK P105 iPS 1 0 0 0 0 - OK P105 hESC 1 26.2886 26.0218 17.1982 9.70256 - OK P105 hESC 0 5.31735 5.37187 3.55035 2.00297 - OK P105 Fibroblasts 1 0 0 0 0 - OK P105 Fibroblasts 0 0 0 0 0 - OK P106 iPS 0 1.97809 2.06467 3.53009 5.40695 - OK P106 iPS 1 1 0.963422 1.64722 2.52301 - OK P106 hESC 1 1.12877 1.11731 0.738447 1.20016 - OK P106 hESC 0 0 0 0 0 - OK P106 Fibroblasts 1 0 0 0 0 - OK P106 Fibroblasts 0 0 0 0 0 - OK P107 iPS 0 0 0 0 0 - OK P107 iPS 1 0 0 0 0 - OK P107 hESC 1 6.77388 6.70513 4.43152 2.55616 - OK P107 hESC 0 0 0 0 0 - OK P107 Fibroblasts 1 0 0 0 0 - OK P107 Fibroblasts 0 0 0 0 0 - OK P108 iPS 0 8.08197 8.43569 14.423 7.61977 - OK P108 iPS 1 0.88761 0.855143 1.46209 0.772431 - OK P108 hESC 1 174.428 172.657 114.112 61.5073 - OK P108 hESC 0 177.891 179.715 118.776 64.0217 - OK P108 Fibroblasts 1 0 0 0 0 - OK P108 Fibroblasts 0 11.3361 13.4887 11.0271 5.84271 - OK P109 iPS 0 1.93893 2.0238 3.46021 3.45294 - OK P109 iPS 1 0 0 0 0 - OK P109 hESC 1 8.38117 8.29611 5.48302 5.68473 - OK P109 hESC 0 7.33782 7.41306 4.8994 5.07964 - OK P109 Fibroblasts 1 0 0 0 0 - OK P109 Fibroblasts 0 0 0 0 0 - OK P11 iPS 0 0 0 0 0 - OK P11 iPS 1 1.99955 1.92641 3.2937 2.19198 - OK P11 hESC 1 0 0 0 0 - OK P11 hESC 0 0.000932932 0.000942497 0.00062291 0.000425187 - OK P11 Fibroblasts 1 24.9724 20.837 17.0343 11.3782 - OK P11 Fibroblasts 0 69.6619 82.8898 67.7627 45.2628 - OK P110 iPS 0 0 0 0 0 - OK P110 iPS 1 1 0.963422 1.64722 1.16125 - OK P110 hESC 1 12 11.8782 7.85048 5.68504 - OK P110 hESC 0 1 1.01025 0.667691 0.483518 - OK P110 Fibroblasts 1 0 0 0 0 - OK P110 Fibroblasts 0 1 1.18989 0.972736 0.688434 - OK P111 iPS 0 3 3.1313 5.35378 20.0596 - OK P111 iPS 1 6 5.78053 9.88334 37.0309 - OK P111 hESC 1 37 36.6245 24.2056 105.561 - OK P111 hESC 0 23 23.2358 15.3569 66.9717 - OK P111 Fibroblasts 1 23 19.1912 15.6888 60.0249 - OK P111 Fibroblasts 0 14 16.6584 13.6183 52.1031 - OK P112 iPS 0 0 0 0 0 - OK P112 iPS 1 0 0 0 0 - OK P112 hESC 1 10.0708 9.96863 6.58841 12.6736 - OK P112 hESC 0 0 0 0 0 - OK P112 Fibroblasts 1 0 0 0 0 - OK P112 Fibroblasts 0 0 0 0 0 - OK P113 iPS 0 0 0 0 0 - OK P113 iPS 1 0 0 0 0 - OK P113 hESC 1 0 0 0 0 - OK P113 hESC 0 0 0 0 0 - OK P113 Fibroblasts 1 15.6777 13.0815 10.6941 25.871 - OK P113 Fibroblasts 0 0 0 0 0 - OK P114 iPS 0 0 0 0 0 - OK P114 iPS 1 0 0 0 0 - OK P114 hESC 1 0 0 0 0 - OK P114 hESC 0 0 0 0 0 - OK P114 Fibroblasts 1 0 0 0 0 - OK P114 Fibroblasts 0 0 0 0 0 - OK P115 iPS 0 74.1905 77.4376 132.4 65.4957 - OK P115 iPS 1 75 72.2567 123.542 61.1137 - OK P115 hESC 1 192.269 190.317 125.783 63.4016 - OK P115 hESC 0 331.316 334.713 221.217 111.505 - OK P115 Fibroblasts 1 295.071 246.207 201.275 99.8396 - OK P115 Fibroblasts 0 240 285.573 233.457 115.803 - OK P116 iPS 0 15.1065 15.7677 26.959 13.1069 - OK P116 iPS 1 0 0 0 0 - OK P116 hESC 1 0 0 0 0 - OK P116 hESC 0 0.00468633 0.00473438 0.00312902 0.00154959 - OK P116 Fibroblasts 1 0 0 0 0 - OK P116 Fibroblasts 0 0 0 0 0 - OK P117 iPS 0 0 0 0 0 - OK P117 iPS 1 0 0 0 0 - OK P117 hESC 1 62.1245 61.4939 40.6422 19.3223 - OK P117 hESC 0 36.6015 36.9768 24.4385 11.6186 - OK P117 Fibroblasts 1 34.9658 29.1754 23.851 11.169 - OK P117 Fibroblasts 0 0 0 0 0 - OK P118 iPS 0 0.0166083 0.0173352 0.029639 0.0143017 - OK P118 iPS 1 0 0 0 0 - OK P118 hESC 1 44.9906 44.534 29.4331 14.4648 - OK P118 hESC 0 0 0 0 0 - OK P118 Fibroblasts 1 0.785353 0.655298 0.535708 0.259186 - OK P118 Fibroblasts 0 0 0 0 0 - OK P119 iPS 0 54 56.3634 96.3681 56.4297 - OK P119 iPS 1 169 162.818 278.381 152.909 - OK P119 hESC 1 204 201.93 133.458 77.1486 - OK P119 hESC 0 184 185.887 122.855 72.7169 - OK P119 Fibroblasts 1 0 0 0 0 - OK P119 Fibroblasts 0 4 4.75955 3.89094 2.53227 - OK P12 iPS 0 0.000203865 0.000212788 0.000363817 0.000215643 - OK P12 iPS 1 0 0 0 0 - OK P12 hESC 1 18.0612 17.8779 11.8158 7.16309 - OK P12 hESC 0 30.0493 30.3574 20.0637 12.1632 - OK P12 Fibroblasts 1 82.025 68.4416 55.9512 33.2725 - OK P12 Fibroblasts 0 28.5292 33.9465 27.7514 16.5029 - OK P120 iPS 0 24 25.0504 42.8302 13.5918 - OK P120 iPS 1 117 112.72 192.725 61.1595 - OK P120 hESC 1 102 100.965 66.7291 21.4315 - OK P120 hESC 0 71 71.728 47.4061 15.2255 - OK P120 Fibroblasts 1 0 0 0 0 - OK P120 Fibroblasts 0 1 1.18989 0.972736 0.309231 - OK P121 iPS 0 0 0 0 0 - OK P121 iPS 1 10.5389 10.1534 17.3599 8.26952 - OK P121 hESC 1 0 0 0 0 - OK P121 hESC 0 0 0 0 0 - OK P121 Fibroblasts 1 0 0 0 0 - OK P121 Fibroblasts 0 0 0 0 0 - OK P122 iPS 0 42.2764 44.1268 75.4463 36.0364 - OK P122 iPS 1 70.2913 67.7202 115.786 55.3042 - OK P122 hESC 1 309.815 306.67 202.683 98.5801 - OK P122 hESC 0 287.917 290.869 192.239 93.5006 - OK P122 Fibroblasts 1 75.9302 63.3561 51.7938 24.8044 - OK P122 Fibroblasts 0 77.0387 91.6674 74.9384 35.8884 - OK P123 iPS 0 1.2931 1.3497 2.30766 1.47006 - OK P123 iPS 1 7.98862 7.69642 13.159 8.38276 - OK P123 hESC 1 39.7217 39.3186 25.9862 16.9602 - OK P123 hESC 0 30.661 30.9754 20.4721 13.3614 - OK P123 Fibroblasts 1 3.6038 3.00701 2.45824 1.57151 - OK P123 Fibroblasts 0 3.59164 4.27364 3.49371 2.23347 - OK P124 iPS 0 29.9084 31.2174 53.3744 25.5025 - OK P124 iPS 1 13.1811 12.699 21.7123 9.37229 - OK P124 hESC 1 88.6692 87.7692 58.008 27.9805 - OK P124 hESC 0 46.4222 46.8981 30.9957 15.0807 - OK P124 Fibroblasts 1 273.466 228.18 186.538 89.3643 - OK P124 Fibroblasts 0 109.37 130.138 106.388 50.967 - OK P125 iPS 0 6.522 6.80745 11.6391 5.05264 - OK P125 iPS 1 0 0 0 0 - OK P125 hESC 1 4.79429 4.74563 3.13645 1.38415 - OK P125 hESC 0 0 0 0 0 - OK P125 Fibroblasts 1 0 0 0 0 - OK P125 Fibroblasts 0 0 0 0 0 - OK P126 iPS 0 6.89352 7.19523 12.3021 13.9828 - OK P126 iPS 1 8.66915 8.35206 14.28 16.2309 - OK P126 hESC 1 23.6167 23.377 15.4502 18.3447 - OK P126 hESC 0 20.842 21.0557 13.916 16.5231 - OK P126 Fibroblasts 1 13.6065 11.3532 9.28128 10.6159 - OK P126 Fibroblasts 0 8.05482 9.58433 7.83521 8.96186 - OK P127 iPS 0 68.1401 71.1224 121.602 45.32 - OK P127 iPS 1 48.9215 47.132 80.5846 30.0331 - OK P127 hESC 1 112.866 111.72 73.8376 27.9095 - OK P127 hESC 0 114.484 115.657 76.4397 28.8931 - OK P127 Fibroblasts 1 158.245 132.04 107.943 40.3122 - OK P127 Fibroblasts 0 80.2224 95.4556 78.0352 29.1429 - OK P128 iPS 0 8.28891 8.6517 14.7923 18.5908 - OK P128 iPS 1 1.33297 1.28422 2.19571 2.75953 - OK P128 hESC 1 20.9199 20.7075 13.6859 18.0531 - OK P128 hESC 0 9.93398 10.0358 6.63283 8.74938 - OK P128 Fibroblasts 1 7.41658 6.18839 5.05903 6.40254 - OK P128 Fibroblasts 0 2.16735 2.5789 2.10826 2.66814 - OK P129 iPS 0 64 66.8011 114.214 310.974 - OK P129 iPS 1 122 117.538 200.961 547.163 - OK P129 hESC 1 746 738.429 488.038 1480.3 - OK P129 hESC 0 778 785.977 519.464 1575.62 - OK P129 Fibroblasts 1 0 0 0 0 - OK P129 Fibroblasts 0 0 0 0 0 - OK P13 iPS 0 8.9998 9.39369 16.061 10.1855 - OK P13 iPS 1 0.000453221 0.000436643 0.000746556 0.00047345 - OK P13 hESC 1 40.9388 40.5233 26.7824 17.3996 - OK P13 hESC 0 21.9497 22.1748 14.6556 9.52126 - OK P13 Fibroblasts 1 0.00254343 0.00212224 0.00173493 0.00110412 - OK P13 Fibroblasts 0 17.8089 21.1906 17.3234 11.0247 - OK P130 iPS 0 5.83028 6.08546 10.4047 8.57926 - OK P130 iPS 1 9.64608 9.29325 15.8893 13.1016 - OK P130 hESC 1 330.713 327.357 216.355 184.103 - OK P130 hESC 0 242.128 244.611 161.667 137.568 - OK P130 Fibroblasts 1 0 0 0 0 - OK P130 Fibroblasts 0 0 0 0 0 - OK P131 iPS 0 14.1697 14.7899 25.2872 10.6379 - OK P131 iPS 1 7.35392 7.08493 12.1135 5.09595 - OK P131 hESC 1 84.2866 83.4311 55.1408 23.5695 - OK P131 hESC 0 61.7049 62.3376 41.1998 17.6105 - OK P131 Fibroblasts 1 0 0 0 0 - OK P131 Fibroblasts 0 1 1.18989 0.972736 0.410165 - OK P132 iPS 0 4 4.17507 7.13837 5.7096 - OK P132 iPS 1 0 0 0 0 - OK P132 hESC 1 0.443143 0.438645 0.289907 0.239069 - OK P132 hESC 0 0 0 0 0 - OK P132 Fibroblasts 1 0 0 0 0 - OK P132 Fibroblasts 0 0 0 0 0 - OK P133 iPS 0 0 0 0 0 - OK P133 iPS 1 1.99995 1.9268 3.29437 2.12156 - OK P133 hESC 1 0 0 0 0 - OK P133 hESC 0 0 0 0 0 - OK P133 Fibroblasts 1 0 0 0 0 - OK P133 Fibroblasts 0 2.99996 3.56962 2.91817 1.88599 - OK P134 iPS 0 0 0 0 0 - OK P134 iPS 1 4.74283e-05 4.56935e-05 7.8125e-05 4.36715e-05 - OK P134 hESC 1 3.32956 3.29577 2.17822 1.24375 - OK P134 hESC 0 0 0 0 0 - OK P134 Fibroblasts 1 0 0 0 0 - OK P134 Fibroblasts 0 3.64792e-05 4.34062e-05 3.54847e-05 1.98972e-05 - OK P135 iPS 0 0 0 0 0 - OK P135 iPS 1 0 0 0 0 - OK P135 hESC 1 0.227296 0.22499 0.148699 0.196149 - OK P135 hESC 0 1 1.01025 0.667691 0.880753 - OK P135 Fibroblasts 1 11 9.1784 7.50336 9.49601 - OK P135 Fibroblasts 0 0 0 0 0 - OK P136 iPS 0 18.1085 18.901 32.3163 19.7419 - OK P136 iPS 1 26.9959 26.0085 44.4683 27.1656 - OK P136 hESC 1 177.618 175.815 116.199 72.6541 - OK P136 hESC 0 238.299 240.742 159.11 99.4845 - OK P136 Fibroblasts 1 92.3477 77.0549 62.9926 38.6123 - OK P136 Fibroblasts 0 62.8794 74.8194 61.165 37.4921 - OK P137 iPS 0 138.892 144.97 247.865 167.607 - OK P137 iPS 1 135.004 130.066 222.382 144.996 - OK P137 hESC 1 589.382 583.4 385.578 264.704 - OK P137 hESC 0 496.701 501.794 331.643 226.31 - OK P137 Fibroblasts 1 443.652 370.183 302.626 203.195 - OK P137 Fibroblasts 0 339.121 403.515 329.875 221.941 - OK P138 iPS 0 310 323.568 553.224 223.493 - OK P138 iPS 1 496 477.858 817.023 330.063 - OK P138 hESC 1 2522 2496.4 1649.91 676.812 - OK P138 hESC 0 2395 2419.56 1599.12 655.977 - OK P138 Fibroblasts 1 3100 2586.64 2114.58 856.164 - OK P138 Fibroblasts 0 1712 2037.09 1665.32 674.265 - OK P139 iPS 0 10.9542 11.4336 19.5487 25.0811 - OK P139 iPS 1 15.8344 15.2552 26.0828 33.4643 - OK P139 hESC 1 97.4272 96.4384 63.7375 85.9191 - OK P139 hESC 0 103.552 104.614 69.1411 93.2031 - OK P139 Fibroblasts 1 147.202 122.825 100.41 129.745 - OK P139 Fibroblasts 0 98.3015 116.968 95.6214 123.558 - OK P14 iPS 0 136 141.952 242.705 694.225 - OK P14 iPS 1 80 77.0738 131.778 376.933 - OK P14 hESC 1 536 530.56 350.655 1123.84 - OK P14 hESC 0 469 473.809 313.147 1003.63 - OK P14 Fibroblasts 1 1854 1546.98 1264.66 3675.44 - OK P14 Fibroblasts 0 998 1187.51 970.791 2821.38 - OK P140 iPS 0 47.0458 49.1048 83.9576 99.3385 - OK P140 iPS 1 18.0188 17.3597 29.6809 35.1184 - OK P140 hESC 1 184.711 182.836 120.839 149.632 - OK P140 hESC 0 136.245 137.642 90.9698 112.645 - OK P140 Fibroblasts 1 503.068 419.759 343.154 408.69 - OK P140 Fibroblasts 0 334.39 397.886 325.273 387.393 - OK P141 iPS 0 5.1296 5.35411 9.15425 6.7215 - OK P141 iPS 1 6.34676 6.11461 10.4545 7.67623 - OK P141 hESC 1 46.9191 46.4429 30.6948 23.1773 - OK P141 hESC 0 33.7029 34.0485 22.5031 16.9919 - OK P141 Fibroblasts 1 18.5677 15.4929 12.6655 9.33748 - OK P141 Fibroblasts 0 60.8505 72.4053 59.1915 43.6382 - OK P142 iPS 0 0.573278 0.598369 1.02307 0.379687 - OK P142 iPS 1 5.15981 4.97108 8.49937 3.15433 - OK P142 hESC 1 0 0 0 0 - OK P142 hESC 0 0 0 0 0 - OK P142 Fibroblasts 1 0 0 0 0 - OK P142 Fibroblasts 0 4.56349 5.43004 4.43907 1.65084 - OK P143 iPS 0 0 0 0 0 - OK P143 iPS 1 0 0 0 0 - OK P143 hESC 1 0 0 0 0 - OK P143 hESC 0 0 0 0 0 - OK P143 Fibroblasts 1 15.8422 13.2187 10.8063 3.06783 - OK P143 Fibroblasts 0 0 0 0 0 - OK P144 iPS 0 25.043 26.1391 44.6916 12.0427 - OK P144 iPS 1 12.6184 12.1568 20.7853 5.60088 - OK P144 hESC 1 160.58 158.95 105.053 28.5975 - OK P144 hESC 0 131.802 133.153 88.0028 23.9562 - OK P144 Fibroblasts 1 0 0 0 0 - OK P144 Fibroblasts 0 0.0113055 0.0134523 0.0109973 0.00296778 - OK P145 iPS 0 17.7728 18.5506 31.7172 5.42281 - OK P145 iPS 1 14.5446 14.0126 23.9582 4.09623 - OK P145 hESC 1 86.8626 85.981 56.8261 9.77862 - OK P145 hESC 0 60.2778 60.8959 40.247 6.92569 - OK P145 Fibroblasts 1 44.6273 37.237 30.4413 5.20959 - OK P145 Fibroblasts 0 11.8059 14.0477 11.484 1.96532 - OK P146 iPS 0 1712 1786.93 3055.22 2122.13 - OK P146 iPS 1 749 721.603 1233.77 856.964 - OK P146 hESC 1 1147 1135.36 750.375 535.176 - OK P146 hESC 0 1022 1032.48 682.38 486.681 - OK P146 Fibroblasts 1 16345 13638.3 11149.3 7774.02 - OK P146 Fibroblasts 0 9280 11042.2 9026.99 6294.2 - OK P147 iPS 0 81.7948 85.3747 145.97 63.6012 - OK P147 iPS 1 0.00711202 0.00685188 0.0117151 0.00510442 - OK P147 hESC 1 221.771 219.52 145.084 64.2675 - OK P147 hESC 0 84.8218 85.6915 56.6347 25.0874 - OK P147 Fibroblasts 1 0 0 0 0 - OK P147 Fibroblasts 0 0 0 0 0 - OK P148 iPS 0 0 0 0 0 - OK P148 iPS 1 24.7916 23.8848 40.8374 17.2102 - OK P148 hESC 1 0 0 0 0 - OK P148 hESC 0 24.1556 24.4033 16.1285 6.9065 - OK P148 Fibroblasts 1 52.5226 43.8248 35.8269 15.1339 - OK P148 Fibroblasts 0 48.0223 57.1412 46.713 19.7324 - OK P149 iPS 0 84.865 88.5793 151.449 35.2154 - OK P149 iPS 1 129.434 124.699 213.206 49.5752 - OK P149 hESC 1 51.4181 50.8962 33.6381 7.89057 - OK P149 hESC 0 53.5377 54.0866 35.7466 8.38518 - OK P149 Fibroblasts 1 625.794 522.162 426.869 99.3841 - OK P149 Fibroblasts 0 253.404 301.523 246.495 57.3894 - OK P15 iPS 0 465 485.352 829.836 164.14 - OK P15 iPS 1 494.333 476.252 814.277 161.062 - OK P15 hESC 1 14186.7 14042.7 9281.01 1849.52 - OK P15 hESC 0 14148 14293.1 9446.49 1882.49 - OK P15 Fibroblasts 1 23277.1 19422.4 15877.9 3144.04 - OK P15 Fibroblasts 0 10113.6 12034 9837.85 1948.03 - OK P150 iPS 0 39.339 41.0608 70.2042 73.2609 - OK P150 iPS 1 21.5691 20.7802 35.5292 37.0761 - OK P150 hESC 1 14.2138 14.0696 9.29878 10.0998 - OK P150 hESC 0 6.65221 6.72042 4.44162 4.82425 - OK P150 Fibroblasts 1 83.9141 70.0179 57.2398 60.0782 - OK P150 Fibroblasts 0 5.79849 6.89955 5.6404 5.9201 - OK P151 iPS 0 64.4462 67.2668 115.01 26.374 - OK P151 iPS 1 0 0 0 0 - OK P151 hESC 1 28.7365 28.4448 18.7996 4.34858 - OK P151 hESC 0 0 0 0 0 - OK P151 Fibroblasts 1 101.668 84.832 69.3504 15.9235 - OK P151 Fibroblasts 0 0 0 0 0 - OK P152 iPS 0 468.555 489.062 836.18 193.571 - OK P152 iPS 1 228.198 219.852 375.894 87.0175 - OK P152 hESC 1 437.861 433.417 286.451 66.8942 - OK P152 hESC 0 253.833 256.435 169.482 39.5786 - OK P152 Fibroblasts 1 1989.1 1659.71 1356.81 314.497 - OK P152 Fibroblasts 0 583.775 694.627 567.859 131.625 - OK P153 iPS 0 24.3374 25.4026 43.4324 46.9514 - OK P153 iPS 1 38.2763 36.8762 63.0495 68.158 - OK P153 hESC 1 33.678 33.3362 22.0324 24.8263 - OK P153 hESC 0 41.0261 41.4467 27.3927 30.8664 - OK P153 Fibroblasts 1 17.3557 14.4816 11.8388 12.8748 - OK P153 Fibroblasts 0 19.7284 23.4746 19.1906 20.87 - OK P154 iPS 0 8.43351 8.80262 15.0504 31.5618 - OK P154 iPS 1 10.6454 10.256 17.5353 36.7729 - OK P154 hESC 1 33.7845 33.4416 22.102 50.3161 - OK P154 hESC 0 19.2458 19.4431 12.8502 29.254 - OK P154 Fibroblasts 1 204.562 170.686 139.536 296.047 - OK P154 Fibroblasts 0 146.177 173.935 142.192 301.681 - OK P155 iPS 0 1532.42 1599.49 2734.75 5220.97 - OK P155 iPS 1 1213.15 1168.78 1998.34 3794.48 - OK P155 hESC 1 6409.04 6344 4192.84 8494.54 - OK P155 hESC 0 6645.73 6713.87 4437.29 9003.63 - OK P155 Fibroblasts 1 15500 12933.2 10572.9 19883.4 - OK P155 Fibroblasts 0 11827.6 14073.5 11505.1 21806.3 - OK P156 iPS 0 0 0 0 0 - OK P156 iPS 1 3.43456 3.30893 5.65749 3.58464 - OK P156 hESC 1 69.4714 68.7663 45.4486 29.4993 - OK P156 hESC 0 71.0395 71.7679 47.4324 30.7869 - OK P156 Fibroblasts 1 386.773 322.723 263.827 167.75 - OK P156 Fibroblasts 0 186.297 221.672 181.218 115.224 - OK P157 iPS 0 6 6.2626 10.7076 9.53485 - OK P157 iPS 1 6.56544 6.32529 10.8147 9.6303 - OK P157 hESC 1 19.5286 19.3304 12.7757 11.7705 - OK P157 hESC 0 13.9605 14.1036 9.3213 8.58788 - OK P157 Fibroblasts 1 101.227 84.4641 69.0496 61.791 - OK P157 Fibroblasts 0 86.7033 103.167 84.3394 75.4735 - OK P158 iPS 0 0 0 0 0 - OK P158 iPS 1 0 0 0 0 - OK P158 hESC 1 0 0 0 0 - OK P158 hESC 0 0 0 0 0 - OK P158 Fibroblasts 1 0 0 0 0 - OK P158 Fibroblasts 0 0 0 0 0 - OK P159 iPS 0 0 0 0 0 - OK P159 iPS 1 0 0 0 0 - OK P159 hESC 1 0 0 0 0 - OK P159 hESC 0 0 0 0 0 - OK P159 Fibroblasts 1 0 0 0 0 - OK P159 Fibroblasts 0 0 0 0 0 - OK P16 iPS 0 0 0 0 0 - OK P16 iPS 1 0 0 0 0 - OK P16 hESC 1 2 1.9797 1.30841 1.32641 - OK P16 hESC 0 3 3.03076 2.00307 2.03063 - OK P16 Fibroblasts 1 0 0 0 0 - OK P16 Fibroblasts 0 0 0 0 0 - OK P160 iPS 0 633 660.705 1129.65 178.631 - OK P160 iPS 1 367 353.576 604.531 95.5945 - OK P160 hESC 1 1007 996.78 658.786 104.797 - OK P160 hESC 0 772 779.916 515.457 81.9967 - OK P160 Fibroblasts 1 11318 9443.73 7720.28 1221.87 - OK P160 Fibroblasts 0 6482 7712.85 6305.28 997.925 - OK P161 iPS 0 108 112.727 192.736 94.0062 - OK P161 iPS 1 102 98.2691 168.017 80.9367 - OK P161 hESC 1 285 282.107 186.449 95.551 - OK P161 hESC 0 233 235.389 155.572 78.9222 - OK P161 Fibroblasts 1 2246 1874.06 1532.05 772.028 - OK P161 Fibroblasts 0 2000 2379.78 1945.47 971.558 - OK P162 iPS 0 0 0 0 0 - OK P162 iPS 1 0 0 0 0 - OK P162 hESC 1 17.3354 17.1595 11.3409 12.1962 - OK P162 hESC 0 40.7448 41.1626 27.205 29.2565 - OK P162 Fibroblasts 1 0 0 0 0 - OK P162 Fibroblasts 0 15.436 18.3671 15.0152 15.6092 - OK P163 iPS 0 93 97.0703 165.967 181.635 - OK P163 iPS 1 138 132.952 227.317 248.776 - OK P163 hESC 1 337.665 334.238 220.902 252.129 - OK P163 hESC 0 234.255 236.657 156.41 178.52 - OK P163 Fibroblasts 1 238 198.587 162.345 178.752 - OK P163 Fibroblasts 0 311.564 370.726 303.07 333.697 - OK P164 iPS 0 81.4277 84.9915 145.315 55.8497 - OK P164 iPS 1 126.579 121.949 208.503 80.1351 - OK P164 hESC 1 678.345 671.46 443.778 173.059 - OK P164 hESC 0 665.819 672.645 444.561 173.365 - OK P164 Fibroblasts 1 595.304 496.721 406.071 156.399 - OK P164 Fibroblasts 0 951.131 1131.74 925.199 356.342 - OK P165 iPS 0 79.5723 83.055 142.004 56.3059 - OK P165 iPS 1 80.4214 77.4797 132.472 52.5262 - OK P165 hESC 1 932.155 922.695 609.822 245.458 - OK P165 hESC 0 819.681 828.086 547.294 220.29 - OK P165 Fibroblasts 1 234.696 195.83 160.092 63.6171 - OK P165 Fibroblasts 0 214.869 255.671 209.011 83.0566 - OK P166 iPS 0 64.8376 67.6753 115.709 30.7979 - OK P166 iPS 1 11.2425 10.8313 18.519 4.92915 - OK P166 hESC 1 163.794 162.131 107.155 28.8094 - OK P166 hESC 0 128.16 129.474 85.5712 23.0065 - OK P166 Fibroblasts 1 151.504 126.415 103.344 27.5474 - OK P166 Fibroblasts 0 62.3362 74.1731 60.6367 16.1633 - OK P167 iPS 0 110.753 115.6 197.648 53.3301 - OK P167 iPS 1 65.2254 62.8396 107.441 28.99 - OK P167 hESC 1 1396.37 1382.2 913.514 249.013 - OK P167 hESC 0 1468.64 1483.7 980.599 267.299 - OK P167 Fibroblasts 1 258.98 216.093 176.657 47.7372 - OK P167 Fibroblasts 0 150.739 179.363 146.63 39.6231 - OK P168 iPS 0 252.41 263.457 450.449 123.282 - OK P168 iPS 1 316.532 304.954 521.399 142.7 - OK P168 hESC 1 1004.86 994.664 657.388 181.788 - OK P168 hESC 0 753.209 760.931 502.911 139.07 - OK P168 Fibroblasts 1 580.628 484.476 396.06 108.56 - OK P168 Fibroblasts 0 416.003 494.997 404.661 110.918 - OK P169 iPS 0 134 139.865 239.136 93.6381 - OK P169 iPS 1 45 43.354 74.1251 29.0251 - OK P169 hESC 1 151 149.467 98.7852 39.2591 - OK P169 hESC 0 152 153.558 101.489 40.3336 - OK P169 Fibroblasts 1 1306 1089.73 890.854 349.587 - OK P169 Fibroblasts 0 749 891.226 728.579 285.907 - OK P17 iPS 0 0 0 0 0 - OK P17 iPS 1 0 0 0 0 - OK P17 hESC 1 12.0337 11.9115 7.8725 5.89099 - OK P17 hESC 0 19.0381 19.2333 12.7115 9.51204 - OK P17 Fibroblasts 1 0 0 0 0 - OK P17 Fibroblasts 0 0 0 0 0 - OK P170 iPS 0 16 16.7003 28.5535 83.0164 - OK P170 iPS 1 30 28.9027 49.4167 143.674 - OK P170 hESC 1 124 122.742 81.1216 264.792 - OK P170 hESC 0 106 107.087 70.7752 231.02 - OK P170 Fibroblasts 1 9 7.5096 6.13911 18.1401 - OK P170 Fibroblasts 0 7 8.32921 6.80915 20.1199 - OK P171 iPS 0 0 0 0 0 - OK P171 iPS 1 0 0 0 0 - OK P171 hESC 1 27.3659 27.0882 17.903 4.88956 - OK P171 hESC 0 23.2912 23.53 15.5513 4.24728 - OK P171 Fibroblasts 1 0 0 0 0 - OK P171 Fibroblasts 0 0 0 0 0 - OK P172 iPS 0 10.2501 10.6987 18.2922 13.8332 - OK P172 iPS 1 0 0 0 0 - OK P172 hESC 1 0 0 0 0 - OK P172 hESC 0 39.9233 40.3326 26.6564 20.7482 - OK P172 Fibroblasts 1 277.148 231.252 189.049 143.564 - OK P172 Fibroblasts 0 357.534 425.425 347.786 264.109 - OK P173 iPS 0 1072.8 1119.75 1914.5 506.435 - OK P173 iPS 1 1202.55 1158.56 1980.87 523.989 - OK P173 hESC 1 6175.62 6112.94 4040.13 1079.45 - OK P173 hESC 0 6379.14 6444.54 4259.29 1138.01 - OK P173 Fibroblasts 1 6573.81 5485.19 4484.15 1187.91 - OK P173 Fibroblasts 0 4024.6 4788.82 3914.87 1037.1 - OK P174 iPS 0 34.6885 36.2067 61.9049 100.939 - OK P174 iPS 1 88.119 84.8958 145.152 236.676 - OK P174 hESC 1 0 0 0 0 - OK P174 hESC 0 18.7304 18.9224 12.5061 21.7232 - OK P174 Fibroblasts 1 78.0099 65.0914 53.2124 87.5535 - OK P174 Fibroblasts 0 33.5142 39.8782 32.6005 53.6395 - OK P175 iPS 0 36.2656 37.8529 64.7194 15.9646 - OK P175 iPS 1 36.8323 35.4851 60.671 14.9659 - OK P175 hESC 1 103.016 101.97 67.3935 16.7798 - OK P175 hESC 0 142.917 144.382 95.4244 23.759 - OK P175 Fibroblasts 1 231.563 193.216 157.954 39.0163 - OK P175 Fibroblasts 0 170.352 202.699 165.707 40.9313 - OK P176 iPS 0 0 0 0 0 - OK P176 iPS 1 0 0 0 0 - OK P176 hESC 1 0 0 0 0 - OK P176 hESC 0 0 0 0 0 - OK P176 Fibroblasts 1 0 0 0 0 - OK P176 Fibroblasts 0 0 0 0 0 - OK P177 iPS 0 0 0 0 0 - OK P177 iPS 1 0 0 0 0 - OK P177 hESC 1 0 0 0 0 - OK P177 hESC 0 52.3787 52.9157 34.9728 5.85708 - OK P177 Fibroblasts 1 0 0 0 0 - OK P177 Fibroblasts 0 0 0 0 0 - OK P178 iPS 0 0 0 0 0 - OK P178 iPS 1 0 0 0 0 - OK P178 hESC 1 0 0 0 0 - OK P178 hESC 0 0 0 0 0 - OK P178 Fibroblasts 1 0 0 0 0 - OK P178 Fibroblasts 0 0 0 0 0 - OK P179 iPS 0 260.373 271.768 464.659 77.006 - OK P179 iPS 1 276.377 266.268 455.255 75.4475 - OK P179 hESC 1 781.646 773.713 511.358 85.2765 - OK P179 hESC 0 815.45 823.811 544.469 90.7981 - OK P179 Fibroblasts 1 237.084 197.823 161.721 26.8258 - OK P179 Fibroblasts 0 149.868 178.327 145.782 24.182 - OK P18 iPS 0 0 0 0 0 - OK P18 iPS 1 0 0 0 0 - OK P18 hESC 1 29.9663 29.6622 19.6042 13.6046 - OK P18 hESC 0 10.9619 11.0743 7.31919 5.07923 - OK P18 Fibroblasts 1 0 0 0 0 - OK P18 Fibroblasts 0 0 0 0 0 - OK P180 iPS 0 0 0 0 0 - OK P180 iPS 1 0 0 0 0 - OK P180 hESC 1 0 0 0 0 - OK P180 hESC 0 23.6385 23.8809 15.7832 2.13723 - OK P180 Fibroblasts 1 373.562 311.7 254.816 34.3558 - OK P180 Fibroblasts 0 0 0 0 0 - OK P181 iPS 0 1325.16 1383.16 2364.87 446.358 - OK P181 iPS 1 1256.83 1210.86 2070.28 390.755 - OK P181 hESC 1 1629.49 1612.95 1066.02 202.645 - OK P181 hESC 0 1514.91 1530.45 1011.49 192.279 - OK P181 Fibroblasts 1 7863.85 6561.59 5364.12 1013.51 - OK P181 Fibroblasts 0 3869.42 4604.18 3763.93 711.164 - OK P182 iPS 0 1439.78 1502.79 2569.42 349.093 - OK P182 iPS 1 2114.79 2037.44 3483.54 473.289 - OK P182 hESC 1 3648.9 3611.86 2387.13 325.991 - OK P182 hESC 0 4056.62 4098.21 2708.57 369.887 - OK P182 Fibroblasts 1 1434.41 1196.87 978.442 133.035 - OK P182 Fibroblasts 0 1026.71 1221.67 998.718 135.792 - OK P183 iPS 0 925.941 966.467 1652.43 1321.69 - OK P183 iPS 1 1012.76 975.713 1668.24 1334.33 - OK P183 hESC 1 12578.2 12450.5 8228.74 6785.75 - OK P183 hESC 0 12746.9 12877.6 8511 7018.51 - OK P183 Fibroblasts 1 18343 15305.4 12512.2 10052.2 - OK P183 Fibroblasts 0 21425.6 25494.1 20841.5 16743.9 - OK P184 iPS 0 0 0 0 0 - OK P184 iPS 1 8.34728 8.04195 13.7498 10.3263 - OK P184 hESC 1 9.36061 9.26561 6.12377 4.73263 - OK P184 hESC 0 0 0 0 0 - OK P184 Fibroblasts 1 8.39479 7.00461 5.72629 4.31842 - OK P184 Fibroblasts 0 7.46912 8.88741 7.26548 5.47918 - OK P185 iPS 0 0 0 0 0 - OK P185 iPS 1 0 0 0 0 - OK P185 hESC 1 0 0 0 0 - OK P185 hESC 0 0 0 0 0 - OK P185 Fibroblasts 1 0 0 0 0 - OK P185 Fibroblasts 0 0 0 0 0 - OK P186 iPS 0 61.0587 63.731 108.965 90.5338 - OK P186 iPS 1 43.8953 42.2897 72.3054 60.0752 - OK P186 hESC 1 608.448 602.273 398.051 341.384 - OK P186 hESC 0 841.091 849.715 561.589 481.64 - OK P186 Fibroblasts 1 548.124 457.355 373.889 312.078 - OK P186 Fibroblasts 0 767.903 913.718 746.967 623.48 - OK P187 iPS 0 12.2827 12.8203 21.9197 30.5023 - OK P187 iPS 1 14.1581 13.6403 23.3216 32.4531 - OK P187 hESC 1 33.9557 33.6111 22.214 32.618 - OK P187 hESC 0 24.8128 25.0672 16.5673 24.3266 - OK P187 Fibroblasts 1 19.5146 16.283 13.3114 18.6668 - OK P187 Fibroblasts 0 5.48206 6.52303 5.3326 7.47801 - OK P188 iPS 0 106.64 111.308 190.31 213.733 - OK P188 iPS 1 68.4561 65.9521 112.762 126.641 - OK P188 hESC 1 193.766 191.799 126.763 148.64 - OK P188 hESC 0 173.706 175.487 115.982 135.998 - OK P188 Fibroblasts 1 636.642 531.214 434.269 490.761 - OK P188 Fibroblasts 0 498.66 593.35 485.065 548.165 - OK P189 iPS 0 10.291 10.7415 18.3653 21.0775 - OK P189 iPS 1 0 0 0 0 - OK P189 hESC 1 9.26177 9.16777 6.05911 7.26745 - OK P189 hESC 0 14.6806 14.8311 9.80209 11.7569 - OK P189 Fibroblasts 1 0.0159719 0.0133269 0.0108948 0.0125835 - OK P189 Fibroblasts 0 4.2711 5.08212 4.15465 4.79862 - OK P19 iPS 0 249 259.898 444.364 239.683 - OK P19 iPS 1 231 222.551 380.509 205.241 - OK P19 hESC 1 744 736.449 486.73 267.968 - OK P19 hESC 0 792 800.121 528.811 291.136 - OK P19 Fibroblasts 1 3028 2526.56 2065.47 1117.41 - OK P19 Fibroblasts 0 1912 2275.07 1859.87 1006.18 - OK P190 iPS 0 16.7858 17.5205 29.9559 39.6935 - OK P190 iPS 1 42.3081 40.7606 69.6909 92.3451 - OK P190 hESC 1 82.0165 81.1841 53.6558 74.8244 - OK P190 hESC 0 106.801 107.896 71.3098 99.4435 - OK P190 Fibroblasts 1 45.7886 38.206 31.2335 41.6915 - OK P190 Fibroblasts 0 120.873 143.825 117.578 156.946 - OK P191 iPS 0 0 0 0 0 - OK P191 iPS 1 4.0777 3.92855 6.71688 7.31138 - OK P191 hESC 1 0 0 0 0 - OK P191 hESC 0 0 0 0 0 - OK P191 Fibroblasts 1 25.0387 20.8923 17.0795 18.7036 - OK P191 Fibroblasts 0 22.7135 27.0265 22.0942 24.1952 - OK P192 iPS 0 132.784 138.596 236.966 190.831 - OK P192 iPS 1 106.981 103.068 176.221 141.913 - OK P192 hESC 1 1106.4 1095.17 723.813 601.09 - OK P192 hESC 0 1110.51 1121.9 741.48 615.762 - OK P192 Fibroblasts 1 1501.33 1252.71 1024.09 828.397 - OK P192 Fibroblasts 0 1545.05 1838.43 1502.92 1215.73 - OK P193 iPS 0 10.2425 10.6908 18.2787 15.8867 - OK P193 iPS 1 0 0 0 0 - OK P193 hESC 1 0 0 0 0 - OK P193 hESC 0 5.79057 5.84994 3.86631 3.47386 - OK P193 Fibroblasts 1 135.65 113.186 92.5298 80.8092 - OK P193 Fibroblasts 0 35.6783 42.4532 34.7056 30.3095 - OK P194 iPS 0 0 0 0 0 - OK P194 iPS 1 0 0 0 0 - OK P194 hESC 1 0 0 0 0 - OK P194 hESC 0 0 0 0 0 - OK P194 Fibroblasts 1 0 0 0 0 - OK P194 Fibroblasts 0 0 0 0 0 - OK P195 iPS 0 4.97308 5.19074 8.87493 13.1108 - OK P195 iPS 1 7.01916 6.76242 11.5621 17.0806 - OK P195 hESC 1 5.95597 5.89552 3.89644 6.0946 - OK P195 hESC 0 8.34769 8.43328 5.57368 8.71805 - OK P195 Fibroblasts 1 4.7624 3.97375 3.24855 4.83851 - OK P195 Fibroblasts 0 1.62697 1.93591 1.58261 2.3572 - OK P196 iPS 0 3071.26 3205.68 5480.96 1915.05 - OK P196 iPS 1 3219.39 3101.63 5303.05 1852.88 - OK P196 hESC 1 8537 8450.36 5584.96 1977.36 - OK P196 hESC 0 11870.5 11992.2 7925.84 2806.14 - OK P196 Fibroblasts 1 10008 8350.67 6826.7 2389.86 - OK P196 Fibroblasts 0 9042 10759 8795.48 3079.08 - OK P197 iPS 0 52.7366 55.0447 94.1134 34.2715 - OK P197 iPS 1 42.6127 41.054 70.1927 25.5607 - OK P197 hESC 1 0 0 0 0 - OK P197 hESC 0 202.484 204.56 135.197 49.9152 - OK P197 Fibroblasts 1 0 0 0 0 - OK P197 Fibroblasts 0 0 0 0 0 - OK P198 iPS 0 21 21.9191 37.4765 25.6157 - OK P198 iPS 1 22 21.1953 36.2389 24.7698 - OK P198 hESC 1 2 1.9797 1.30841 0.917903 - OK P198 hESC 0 2 2.02051 1.33538 0.936822 - OK P198 Fibroblasts 1 22 18.3568 15.0067 10.2962 - OK P198 Fibroblasts 0 16 19.0382 15.5638 10.6784 - OK P199 iPS 0 412 430.032 735.253 298.392 - OK P199 iPS 1 622 599.249 1024.57 415.809 - OK P199 hESC 1 1113 1101.7 728.132 300.08 - OK P199 hESC 0 1164 1175.93 777.192 320.299 - OK P199 Fibroblasts 1 953 795.183 650.064 264.412 - OK P199 Fibroblasts 0 1005 1195.84 977.6 397.637 - OK P2 iPS 0 0 0 0 0 - OK P2 iPS 1 0 0 0 0 - OK P2 hESC 1 0 0 0 0 - OK P2 hESC 0 0 0 0 0 - OK P2 Fibroblasts 1 0 0 0 0 - OK P2 Fibroblasts 0 0 0 0 0 - OK P20 iPS 0 0.000838242 0.000874929 0.00149592 0.000895675 - OK P20 iPS 1 0 0 0 0 - OK P20 hESC 1 71.7237 70.9957 46.9221 28.7413 - OK P20 hESC 0 72.8081 73.5547 48.6133 29.7772 - OK P20 Fibroblasts 1 14.3257 11.9534 9.77191 5.87029 - OK P20 Fibroblasts 0 19.591 23.3111 19.0569 11.4481 - OK P200 iPS 0 21.2549 22.1852 37.9314 10.6344 - OK P200 iPS 1 40.4264 38.9477 66.5913 18.6694 - OK P200 hESC 1 343.772 340.283 224.898 63.7235 - OK P200 hESC 0 319.999 323.28 213.661 60.5395 - OK P200 Fibroblasts 1 0 0 0 0 - OK P200 Fibroblasts 0 3.99971 4.7592 3.89066 1.09247 - OK P201 iPS 0 9.7451 10.1716 17.391 9.21532 - OK P201 iPS 1 17.5736 16.9308 28.9476 15.339 - OK P201 hESC 1 0 0 0 0 - OK P201 hESC 0 0 0 0 0 - OK P201 Fibroblasts 1 0 0 0 0 - OK P201 Fibroblasts 0 0.000292256 0.000347751 0.000284288 0.000151083 - OK P202 iPS 0 0 0 0 0 - OK P202 iPS 1 0 0 0 0 - OK P202 hESC 1 34.9398 34.5852 22.8579 11.9872 - OK P202 hESC 0 0 0 0 0 - OK P202 Fibroblasts 1 0 0 0 0 - OK P202 Fibroblasts 0 24.5084 29.1623 23.8402 12.2956 - OK P203 iPS 0 66.9503 69.8805 119.479 63.6684 - OK P203 iPS 1 42.096 40.5563 69.3416 36.951 - OK P203 hESC 1 543.644 538.126 355.655 192.615 - OK P203 hESC 0 280.829 283.709 187.507 101.119 - OK P203 Fibroblasts 1 408.196 340.599 278.44 148.558 - OK P203 Fibroblasts 0 440.004 523.556 428.008 228.214 - OK P204 iPS 0 0 0 0 0 - OK P204 iPS 1 11.1802 10.7712 18.4162 10.3354 - OK P204 hESC 1 0 0 0 0 - OK P204 hESC 0 248.368 250.915 165.833 95.0734 - OK P204 Fibroblasts 1 0.0251549 0.0209892 0.0171587 0.00965964 - OK P204 Fibroblasts 0 0 0 0 0 - OK P205 iPS 0 12.1317 12.6627 21.6501 49.9161 - OK P205 iPS 1 8.21239 7.912 13.5276 31.189 - OK P205 hESC 1 90.6671 89.7469 59.315 149.732 - OK P205 hESC 0 92.9951 93.9486 62.092 156.742 - OK P205 Fibroblasts 1 62.0331 51.7604 42.3142 98.8168 - OK P205 Fibroblasts 0 14.3489 17.0736 13.9577 32.5956 - OK P206 iPS 0 95.9167 100.115 171.172 76.8302 - OK P206 iPS 1 96.0114 92.4996 158.152 70.9862 - OK P206 hESC 1 742.33 734.796 485.637 229.907 - OK P206 hESC 0 669.918 676.787 447.298 210.511 - OK P206 Fibroblasts 1 572.895 478.023 390.785 196.649 - OK P206 Fibroblasts 0 261.138 310.725 254.019 127.293 - OK P207 iPS 0 52 54.2759 92.7989 95.1547 - OK P207 iPS 1 35 33.7198 57.6528 59.1164 - OK P207 hESC 1 32.5 32.1702 21.2617 22.6755 - OK P207 hESC 0 41.5 41.9255 27.7092 29.5516 - OK P207 Fibroblasts 1 535 446.404 364.936 376.331 - OK P207 Fibroblasts 0 340 404.562 330.73 341.057 - OK P208 iPS 0 111 115.858 198.09 174.527 - OK P208 iPS 1 155 149.33 255.32 224.949 - OK P208 hESC 1 623 616.677 407.571 371.39 - OK P208 hESC 0 533 538.465 355.879 324.287 - OK P208 Fibroblasts 1 4 3.3376 2.7285 2.41569 - OK P208 Fibroblasts 0 24 28.5573 23.3457 20.6692 - OK P209 iPS 0 32.6455 34.0743 58.259 75.5689 - OK P209 iPS 1 33.4383 32.2152 55.0803 71.4458 - OK P209 hESC 1 79.874 79.0633 52.2541 71.2541 - OK P209 hESC 0 35.2399 35.6012 23.5294 32.0848 - OK P209 Fibroblasts 1 55.6713 46.4521 37.9747 49.6131 - OK P209 Fibroblasts 0 14.5562 17.3202 14.1593 18.4988 - OK P21 iPS 0 0 0 0 0 - OK P21 iPS 1 0.000904374 0.000871294 0.00148971 0.000730036 - OK P21 hESC 1 8.10201 8.01978 5.30039 2.64622 - OK P21 hESC 0 6.15981 6.22297 4.11285 2.05334 - OK P21 Fibroblasts 1 29.8138 24.8766 20.3367 9.99311 - OK P21 Fibroblasts 0 17.6955 21.0557 17.2131 8.45822 - OK P210 iPS 0 0 0 0 0 - OK P210 iPS 1 0 0 0 0 - OK P210 hESC 1 0 0 0 0 - OK P210 hESC 0 17.7601 17.9422 11.8583 18.5276 - OK P210 Fibroblasts 1 0 0 0 0 - OK P210 Fibroblasts 0 52.7386 62.753 51.3007 76.3288 - OK P211 iPS 0 123.707 129.121 220.766 307.812 - OK P211 iPS 1 143.188 137.951 235.863 328.861 - OK P211 hESC 1 1139.5 1127.93 745.466 1096.88 - OK P211 hESC 0 1149.65 1161.43 767.608 1129.46 - OK P211 Fibroblasts 1 1435.63 1197.89 979.275 1375.99 - OK P211 Fibroblasts 0 907.801 1080.18 883.051 1240.78 - OK P212 iPS 0 34.8659 36.3919 62.2215 79.184 - OK P212 iPS 1 67.539 65.0686 111.252 141.581 - OK P212 hESC 1 281.025 278.173 183.848 245.723 - OK P212 hESC 0 217.096 219.322 144.953 193.737 - OK P212 Fibroblasts 1 204.96 171.019 139.808 179.181 - OK P212 Fibroblasts 0 61.4772 73.1509 59.8011 76.6423 - OK P213 iPS 0 124.282 129.721 221.793 315.78 - OK P213 iPS 1 67.8345 65.3533 111.739 159.089 - OK P213 hESC 1 346.604 343.087 226.751 341.094 - OK P213 hESC 0 204.258 206.353 136.381 205.154 - OK P213 Fibroblasts 1 389.742 325.2 265.852 381.509 - OK P213 Fibroblasts 0 253.427 301.549 246.517 353.763 - OK P214 iPS 0 1.1068 1.15524 1.97519 1.77902 - OK P214 iPS 1 1.1557 1.11343 1.9037 1.71463 - OK P214 hESC 1 4.67799 4.63051 3.06037 2.85302 - OK P214 hESC 0 2.20873 2.23138 1.47475 1.37483 - OK P214 Fibroblasts 1 23.6964 19.7722 16.1639 14.6313 - OK P214 Fibroblasts 0 4.41645 5.25508 4.29604 3.88872 - OK P215 iPS 0 0 0 0 0 - OK P215 iPS 1 0 0 0 0 - OK P215 hESC 1 6.73468 6.66633 4.40587 2.55177 - OK P215 hESC 0 5.35203 5.40691 3.5735 2.06969 - OK P215 Fibroblasts 1 0 0 0 0 - OK P215 Fibroblasts 0 0 0 0 0 - OK P216 iPS 0 0 0 0 0 - OK P216 iPS 1 0 0 0 0 - OK P216 hESC 1 8.40962 8.32427 5.50163 9.0877 - OK P216 hESC 0 5.80372 5.86323 3.87509 6.40095 - OK P216 Fibroblasts 1 0 0 0 0 - OK P216 Fibroblasts 0 12.8787 15.3242 12.5276 19.6523 - OK P217 iPS 0 0 0 0 0 - OK P217 iPS 1 3.6994 3.56409 6.09374 9.86787 - OK P217 hESC 1 0 0 0 0 - OK P217 hESC 0 8.18594 8.26987 5.46568 9.42449 - OK P217 Fibroblasts 1 0 0 0 0 - OK P217 Fibroblasts 0 2.56951 3.05743 2.49946 4.084 - OK P218 iPS 0 0 0 0 0 - OK P218 iPS 1 0 0 0 0 - OK P218 hESC 1 0 0 0 0 - OK P218 hESC 0 0 0 0 0 - OK P218 Fibroblasts 1 0 0 0 0 - OK P218 Fibroblasts 0 0 0 0 0 - OK P219 iPS 0 4.30271 4.49103 7.6786 10.4992 - OK P219 iPS 1 14.8622 14.3186 24.4814 33.4742 - OK P219 hESC 1 1.17223 1.16034 0.766884 1.1054 - OK P219 hESC 0 1.04099 1.05167 0.695061 1.00187 - OK P219 Fibroblasts 1 0 0 0 0 - OK P219 Fibroblasts 0 0 0 0 0 - OK P22 iPS 0 10.9992 11.4806 19.629 9.94308 - OK P22 iPS 1 8.9991 8.66993 14.8235 7.68992 - OK P22 hESC 1 139.681 138.263 91.3803 51.6656 - OK P22 hESC 0 69.0101 69.7176 46.0774 26.6328 - OK P22 Fibroblasts 1 110.32 92.0508 75.2518 41.2483 - OK P22 Fibroblasts 0 64.0217 76.1786 62.2762 33.2291 - OK P220 iPS 0 0.110835 0.115686 0.197796 0.051099 - OK P220 iPS 1 303.892 292.776 500.578 129.32 - OK P220 hESC 1 1851.72 1832.93 1211.41 316.026 - OK P220 hESC 0 1911.22 1930.81 1276.1 332.903 - OK P220 Fibroblasts 1 3396.65 2834.16 2316.94 599.416 - OK P220 Fibroblasts 0 1700.86 2023.83 1654.49 428.033 - OK P221 iPS 0 187.476 195.681 334.569 86.6863 - OK P221 iPS 1 0.033235 0.0320193 0.0547454 0.0141845 - OK P221 hESC 1 0 0 0 0 - OK P221 hESC 0 37.9419 38.3309 25.3334 6.62842 - OK P221 Fibroblasts 1 0.0380094 0.031715 0.0259271 0.00672731 - OK P221 Fibroblasts 0 0 0 0 0 - OK P222 iPS 0 3.11034 3.24647 5.55068 7.64879 - OK P222 iPS 1 9.18104 8.84522 15.1232 20.8396 - OK P222 hESC 1 8.65289 8.56507 5.66078 8.22662 - OK P222 hESC 0 30.6779 30.9924 20.4833 29.7678 - OK P222 Fibroblasts 1 27.3825 22.848 18.6783 25.9358 - OK P222 Fibroblasts 0 37.4459 44.5564 36.425 50.5781 - OK P223 iPS 0 26.2864 27.4368 46.9105 22.2936 - OK P223 iPS 1 12.2631 11.8146 20.2001 9.59982 - OK P223 hESC 1 0 0 0 0 - OK P223 hESC 0 11.1863 11.3009 7.46896 3.61408 - OK P223 Fibroblasts 1 425.626 355.142 290.33 138.338 - OK P223 Fibroblasts 0 192.82 229.435 187.563 89.3714 - OK P224 iPS 0 1312.71 1370.17 2342.66 1168.68 - OK P224 iPS 1 634.737 611.52 1045.55 521.593 - OK P224 hESC 1 3045.5 3014.59 1992.39 1012.93 - OK P224 hESC 0 2709.81 2737.6 1809.32 919.86 - OK P224 Fibroblasts 1 39954.5 33338.1 27253.9 13633.7 - OK P224 Fibroblasts 0 14095.2 16771.7 13710.9 6858.82 - OK P225 iPS 0 1260 1315.15 2248.59 707.831 - OK P225 iPS 1 1124 1082.89 1851.48 583 - OK P225 hESC 1 4691.5 4643.89 3069.21 978.226 - OK P225 hESC 0 4311.5 4355.71 2878.75 919.556 - OK P225 Fibroblasts 1 12340 10296.5 8417.41 2648.91 - OK P225 Fibroblasts 0 10035 11940.5 9761.41 3074.85 - OK P226 iPS 0 278 290.167 496.117 494.029 - OK P226 iPS 1 309 297.698 508.992 506.85 - OK P226 hESC 1 1805 1786.68 1180.84 1221.6 - OK P226 hESC 0 1856 1875.03 1239.23 1282.01 - OK P226 Fibroblasts 1 671 559.882 457.705 458.299 - OK P226 Fibroblasts 0 699 831.731 679.943 680.824 - OK P227 iPS 0 0 0 0 0 - OK P227 iPS 1 7.38598 7.11582 12.1664 8.67643 - OK P227 hESC 1 0 0 0 0 - OK P227 hESC 0 22.5464 22.7776 15.054 11.0315 - OK P227 Fibroblasts 1 1.99989 1.66871 1.36417 0.976706 - OK P227 Fibroblasts 0 10.0663 11.9777 9.79182 7.01063 - OK P228 iPS 0 230.063 240.133 410.57 165.155 - OK P228 iPS 1 291.038 280.393 479.405 192.845 - OK P228 hESC 1 1656.07 1639.26 1083.41 442.502 - OK P228 hESC 0 1437.39 1452.13 959.732 391.988 - OK P228 Fibroblasts 1 0 0 0 0 - OK P228 Fibroblasts 0 22.9314 27.2857 22.3062 8.99283 - OK P229 iPS 0 27.9366 29.1593 49.8554 20.5876 - OK P229 iPS 1 27.0574 26.0677 44.5696 18.4048 - OK P229 hESC 1 70.0047 69.2942 45.7975 19.21 - OK P229 hESC 0 63.6062 64.2584 42.4693 17.814 - OK P229 Fibroblasts 1 0 0 0 0 - OK P229 Fibroblasts 0 0.00236986 0.00281987 0.00230525 0.000954117 - OK P23 iPS 0 0 0 0 0 - OK P23 iPS 1 0 0 0 0 - OK P23 hESC 1 9.49328 9.39693 6.21057 3.56635 - OK P23 hESC 0 17.022 17.1965 11.3654 6.52646 - OK P23 Fibroblasts 1 29.5407 24.6488 20.1504 11.3619 - OK P23 Fibroblasts 0 7.69176 9.15233 7.48206 4.21879 - OK P230 iPS 0 0 0 0 0 - OK P230 iPS 1 0.0184538 0.0177788 0.0303975 0.0196205 - OK P230 hESC 1 22.4298 22.2022 14.6738 9.70689 - OK P230 hESC 0 0.624429 0.630832 0.416926 0.275802 - OK P230 Fibroblasts 1 0.000108526 9.05542e-05 7.40283e-05 4.79535e-05 - OK P230 Fibroblasts 0 0 0 0 0 - OK P231 iPS 0 0.0662282 0.0691268 0.11819 0.0490783 - OK P231 iPS 1 0 0 0 0 - OK P231 hESC 1 21.7825 21.5614 14.2502 6.01122 - OK P231 hESC 0 38.1005 38.4911 25.4393 10.7311 - OK P231 Fibroblasts 1 339.626 283.384 231.667 96.4203 - OK P231 Fibroblasts 0 256.838 305.608 249.836 103.982 - OK P232 iPS 0 0 0 0 0 - OK P232 iPS 1 0.000940585 0.00090618 0.00154935 0.000625018 - OK P232 hESC 1 123.218 121.967 80.6097 33.0191 - OK P232 hESC 0 68.8983 69.6047 46.0028 18.8435 - OK P232 Fibroblasts 1 6047.37 5045.93 4125.06 1667.79 - OK P232 Fibroblasts 0 2304.16 2741.69 2241.34 906.189 - OK P233 iPS 0 61.4648 64.1549 109.69 39.8411 - OK P233 iPS 1 66.4282 63.9984 109.422 39.7439 - OK P233 hESC 1 0 0 0 0 - OK P233 hESC 0 0 0 0 0 - OK P233 Fibroblasts 1 0 0 0 0 - OK P233 Fibroblasts 0 0 0 0 0 - OK P234 iPS 0 0 0 0 0 - OK P234 iPS 1 400.093 385.459 659.043 57.6943 - OK P234 hESC 1 0.032763 0.0324305 0.0214338 0.00188256 - OK P234 hESC 0 0 0 0 0 - OK P234 Fibroblasts 1 0.203765 0.170021 0.138993 0.0121737 - OK P234 Fibroblasts 0 0 0 0 0 - OK P235 iPS 0 0 0 0 0 - OK P235 iPS 1 0 0 0 0 - OK P235 hESC 1 17.2114 17.0367 11.2598 3.98354 - OK P235 hESC 0 24.4551 24.7058 16.3284 5.77674 - OK P235 Fibroblasts 1 0 0 0 0 - OK P235 Fibroblasts 0 15.898 18.9168 15.4646 5.40974 - OK P236 iPS 0 2341.65 2444.14 4178.9 367.537 - OK P236 iPS 1 1613.1 1554.1 2657.14 233.697 - OK P236 hESC 1 1111.11 1099.84 726.898 64.1432 - OK P236 hESC 0 1357.31 1371.23 906.263 79.9709 - OK P236 Fibroblasts 1 4503.14 3757.42 3071.7 270.289 - OK P236 Fibroblasts 0 1318.3 1568.63 1282.36 112.839 - OK P237 iPS 0 95.0463 99.2062 169.619 17.4137 - OK P237 iPS 1 103.377 99.5954 170.284 17.4821 - OK P237 hESC 1 877.351 868.447 573.969 59.1542 - OK P237 hESC 0 1067.43 1078.37 712.712 73.4533 - OK P237 Fibroblasts 1 1276.67 1065.25 870.844 89.4549 - OK P237 Fibroblasts 0 997.165 1186.51 969.979 99.6383 - OK P238 iPS 0 1 1.04377 1.78459 1.60382 - OK P238 iPS 1 0 0 0 0 - OK P238 hESC 1 2 1.9797 1.30841 1.36757 - OK P238 hESC 0 2 2.02051 1.33538 1.39576 - OK P238 Fibroblasts 1 0 0 0 0 - OK P238 Fibroblasts 0 0 0 0 0 - OK P239 iPS 0 23.2557 24.2735 41.5019 16.0203 - OK P239 iPS 1 0.00117517 0.00113218 0.00193576 0.00074723 - OK P239 hESC 1 1.58661 1.5705 1.03797 0.406568 - OK P239 hESC 0 8.70479 8.79405 5.81211 2.27658 - OK P239 Fibroblasts 1 0 0 0 0 - OK P239 Fibroblasts 0 0 0 0 0 - OK P24 iPS 0 116.855 121.969 208.538 275.295 - OK P24 iPS 1 106.379 102.488 175.23 231.325 - OK P24 hESC 1 803.465 795.311 525.632 730.129 - OK P24 hESC 0 695.059 702.186 464.085 644.637 - OK P24 Fibroblasts 1 520.85 434.597 355.284 472.462 - OK P24 Fibroblasts 0 655.176 779.585 637.313 847.508 - OK P240 iPS 0 92.7443 96.8035 165.511 60.3176 - OK P240 iPS 1 59.9988 57.8042 98.8315 36.0174 - OK P240 hESC 1 35.4134 35.054 23.1677 8.56032 - OK P240 hESC 0 36.2952 36.6674 24.234 8.95431 - OK P240 Fibroblasts 1 0 0 0 0 - OK P240 Fibroblasts 0 0 0 0 0 - OK P241 iPS 0 3.55362e-05 3.70915e-05 6.34177e-05 8.81218e-05 - OK P241 iPS 1 0 0 0 0 - OK P241 hESC 1 0 0 0 0 - OK P241 hESC 0 1 1.01025 0.667691 1.18451 - OK P241 Fibroblasts 1 0 0 0 0 - OK P241 Fibroblasts 0 0 0 0 0 - OK P242 iPS 0 0.999964 1.04373 1.78453 2.81418 - OK P242 iPS 1 0 0 0 0 - OK P242 hESC 1 0 0 0 0 - OK P242 hESC 0 1 1.01025 0.667691 1.39642 - OK P242 Fibroblasts 1 0 0 0 0 - OK P242 Fibroblasts 0 0 0 0 0 - OK P243 iPS 0 0 0 0 0 - OK P243 iPS 1 5 4.81711 8.23612 7.21151 - OK P243 hESC 1 3 2.96955 1.96262 1.55706 - OK P243 hESC 0 0 0 0 0 - OK P243 Fibroblasts 1 0 0 0 0 - OK P243 Fibroblasts 0 0 0 0 0 - OK P244 iPS 0 0 0 0 0 - OK P244 iPS 1 1.33333 1.28456 2.1963 2.15969 - OK P244 hESC 1 0 0 0 0 - OK P244 hESC 0 0 0 0 0 - OK P244 Fibroblasts 1 0 0 0 0 - OK P244 Fibroblasts 0 0 0 0 0 - OK P245 iPS 0 0 0 0 0 - OK P245 iPS 1 0 0 0 0 - OK P245 hESC 1 0 0 0 0 - OK P245 hESC 0 0 0 0 0 - OK P245 Fibroblasts 1 0 0 0 0 - OK P245 Fibroblasts 0 0 0 0 0 - OK P246 iPS 0 0 0 0 0 - OK P246 iPS 1 0 0 0 0 - OK P246 hESC 1 0 0 0 0 - OK P246 hESC 0 0 0 0 0 - OK P246 Fibroblasts 1 0 0 0 0 - OK P246 Fibroblasts 0 0 0 0 0 - OK P247 iPS 0 0 0 0 0 - OK P247 iPS 1 0 0 0 0 - OK P247 hESC 1 0 0 0 0 - OK P247 hESC 0 0 0 0 0 - OK P247 Fibroblasts 1 0 0 0 0 - OK P247 Fibroblasts 0 0 0 0 0 - OK P248 iPS 0 0 0 0 0 - OK P248 iPS 1 0.45 0.43354 0.741251 0.621345 - OK P248 hESC 1 0 0 0 0 - OK P248 hESC 0 0 0 0 0 - OK P248 Fibroblasts 1 0 0 0 0 - OK P248 Fibroblasts 0 0 0 0 0 - OK P249 iPS 0 0 0 0 0 - OK P249 iPS 1 0.2 0.192684 0.329445 0.27485 - OK P249 hESC 1 0 0 0 0 - OK P249 hESC 0 0 0 0 0 - OK P249 Fibroblasts 1 0 0 0 0 - OK P249 Fibroblasts 0 0 0 0 0 - OK P25 iPS 0 17.9684 18.7549 32.0663 25.7063 - OK P25 iPS 1 12.3329 11.8818 20.3151 16.2858 - OK P25 hESC 1 26.8896 26.6167 17.5913 14.5404 - OK P25 hESC 0 27.9675 28.2543 18.6737 15.435 - OK P25 Fibroblasts 1 31.5573 26.3314 21.526 17.3332 - OK P25 Fibroblasts 0 18.485 21.9951 17.981 14.4788 - OK P250 iPS 0 0 0 0 0 - OK P250 iPS 1 0 0 0 0 - OK P250 hESC 1 0 0 0 0 - OK P250 hESC 0 0 0 0 0 - OK P250 Fibroblasts 1 0 0 0 0 - OK P250 Fibroblasts 0 0 0 0 0 - OK P251 iPS 0 0 0 0 0 - OK P251 iPS 1 0 0 0 0 - OK P251 hESC 1 0 0 0 0 - OK P251 hESC 0 0 0 0 0 - OK P251 Fibroblasts 1 0 0 0 0 - OK P251 Fibroblasts 0 0 0 0 0 - OK P252 iPS 0 0 0 0 0 - OK P252 iPS 1 0.2 0.192684 0.329445 0.27485 - OK P252 hESC 1 0 0 0 0 - OK P252 hESC 0 0 0 0 0 - OK P252 Fibroblasts 1 0 0 0 0 - OK P252 Fibroblasts 0 0 0 0 0 - OK P253 iPS 0 0 0 0 0 - OK P253 iPS 1 0 0 0 0 - OK P253 hESC 1 1 0.989851 0.654207 0.594357 - OK P253 hESC 0 0 0 0 0 - OK P253 Fibroblasts 1 0 0 0 0 - OK P253 Fibroblasts 0 0 0 0 0 - OK P254 iPS 0 0 0 0 0 - OK P254 iPS 1 0 0 0 0 - OK P254 hESC 1 0 0 0 0 - OK P254 hESC 0 0 0 0 0 - OK P254 Fibroblasts 1 0 0 0 0 - OK P254 Fibroblasts 0 0 0 0 0 - OK P255 iPS 0 452.657 472.468 807.808 433.406 - OK P255 iPS 1 1078.85 1039.39 1777.11 953.456 - OK P255 hESC 1 2369.32 2345.27 1550.02 848.737 - OK P255 hESC 0 2185.48 2207.89 1459.23 799.02 - OK P255 Fibroblasts 1 58.0335 48.4232 39.5861 21.3019 - OK P255 Fibroblasts 0 111.441 132.603 108.403 58.3333 - OK P256 iPS 0 469.343 489.885 837.587 448.363 - OK P256 iPS 1 854.149 822.907 1406.97 753.158 - OK P256 hESC 1 2420.46 2395.89 1583.48 865.048 - OK P256 hESC 0 2528.26 2554.18 1688.1 922.2 - OK P256 Fibroblasts 1 135.966 113.45 92.746 49.7944 - OK P256 Fibroblasts 0 175.559 208.895 170.772 91.6859 - OK P257 iPS 0 0 0 0 0 - OK P257 iPS 1 0 0 0 0 - OK P257 hESC 1 0 0 0 0 - OK P257 hESC 0 0 0 0 0 - OK P257 Fibroblasts 1 0 0 0 0 - OK P257 Fibroblasts 0 0 0 0 0 - OK P258 iPS 0 0 0 0 0 - OK P258 iPS 1 0 0 0 0 - OK P258 hESC 1 28.2243 27.9379 18.4645 10.5389 - OK P258 hESC 0 9.25743 9.35235 6.1811 3.52794 - OK P258 Fibroblasts 1 0 0 0 0 - OK P258 Fibroblasts 0 0 0 0 0 - OK P259 iPS 0 75.8187 79.137 135.305 24.5774 - OK P259 iPS 1 21.4942 20.708 35.4058 6.43124 - OK P259 hESC 1 189.022 187.103 123.659 22.6164 - OK P259 hESC 0 160.369 162.013 107.077 19.5836 - OK P259 Fibroblasts 1 48.7621 40.687 33.2618 6.04786 - OK P259 Fibroblasts 0 114.435 136.164 111.315 20.2399 - OK P26 iPS 0 37.4756 39.1158 66.8788 93.3404 - OK P26 iPS 1 27.5307 26.5237 45.3493 63.2924 - OK P26 hESC 1 93.428 92.4798 61.1212 90.0279 - OK P26 hESC 0 139.313 140.742 93.0183 137.01 - OK P26 Fibroblasts 1 240.747 200.879 164.219 230.975 - OK P26 Fibroblasts 0 101.825 121.16 99.0486 139.312 - OK P260 iPS 0 79.8807 83.3769 142.555 27.667 - OK P260 iPS 1 205.722 198.197 338.869 65.7677 - OK P260 hESC 1 84.995 84.1324 55.6043 10.871 - OK P260 hESC 0 72.1575 72.8973 48.1789 9.41927 - OK P260 Fibroblasts 1 0 0 0 0 - OK P260 Fibroblasts 0 29.7662 35.4184 28.9547 5.62555 - OK P261 iPS 0 0 0 0 0 - OK P261 iPS 1 0 0 0 0 - OK P261 hESC 1 0 0 0 0 - OK P261 hESC 0 64.2026 64.8609 42.8675 24.4573 - OK P261 Fibroblasts 1 106.059 88.4955 72.3453 40.5337 - OK P261 Fibroblasts 0 38.8498 46.2269 37.7906 21.1734 - OK P262 iPS 0 5.73766 5.98878 10.2394 7.81858 - OK P262 iPS 1 0 0 0 0 - OK P262 hESC 1 0 0 0 0 - OK P262 hESC 0 0 0 0 0 - OK P262 Fibroblasts 1 193.668 161.596 132.105 101.3 - OK P262 Fibroblasts 0 3.56609 4.24325 3.46887 2.65997 - OK P263 iPS 0 456.2 476.167 814.132 188.653 - OK P263 iPS 1 413.582 398.454 681.262 157.864 - OK P263 hESC 1 784.447 776.485 513.19 119.963 - OK P263 hESC 0 648.291 654.938 432.858 101.184 - OK P263 Fibroblasts 1 2616.13 2182.9 1784.53 414.045 - OK P263 Fibroblasts 0 1299.6 1546.38 1264.17 293.311 - OK P264 iPS 0 6.78866 7.08578 12.115 3.9301 - OK P264 iPS 1 16.325 15.7279 26.8909 8.72341 - OK P264 hESC 1 14.1026 13.9595 9.22603 3.02987 - OK P264 hESC 0 31.3239 31.6451 20.9147 6.86848 - OK P264 Fibroblasts 1 100.757 84.0713 68.7285 22.3355 - OK P264 Fibroblasts 0 19.999 23.7966 19.4538 6.32212 - OK P265 iPS 0 8.83086 9.21737 15.7595 6.06681 - OK P265 iPS 1 0 0 0 0 - OK P265 hESC 1 83.2965 82.4511 54.4931 21.2858 - OK P265 hESC 0 64.0713 64.7282 42.7798 16.7104 - OK P265 Fibroblasts 1 134.538 112.258 91.7715 35.4038 - OK P265 Fibroblasts 0 59.5045 70.8037 57.8822 22.3299 - OK P266 iPS 0 6.33921 6.61666 11.3129 2.73386 - OK P266 iPS 1 0 0 0 0 - OK P266 hESC 1 76.0619 75.29 49.7602 12.1352 - OK P266 hESC 0 51.5183 52.0465 34.3983 8.38885 - OK P266 Fibroblasts 1 27.6455 23.0674 18.8577 4.56321 - OK P266 Fibroblasts 0 0 0 0 0 - OK P267 iPS 0 58.3242 60.8769 104.085 39.3934 - OK P267 iPS 1 78 75.1469 128.483 48.6918 - OK P267 hESC 1 149.204 147.69 97.6105 37.4761 - OK P267 hESC 0 209.448 211.596 139.847 53.6921 - OK P267 Fibroblasts 1 0 0 0 0 - OK P267 Fibroblasts 0 51.7136 61.5333 50.3037 19.0785 - OK P268 iPS 0 2.45438 2.5618 4.38007 1.92088 - OK P268 iPS 1 0 0 0 0 - OK P268 hESC 1 307.106 303.989 200.911 89.5863 - OK P268 hESC 0 243.534 246.031 162.605 72.5057 - OK P268 Fibroblasts 1 1070.39 893.135 730.14 320.98 - OK P268 Fibroblasts 0 226.983 270.084 220.794 97.0643 - OK P269 iPS 0 30.7741 32.121 54.9193 22.2883 - OK P269 iPS 1 0 0 0 0 - OK P269 hESC 1 0 0 0 0 - OK P269 hESC 0 0.0140505 0.0141946 0.0093814 0.00387759 - OK P269 Fibroblasts 1 889.777 742.43 606.938 246.871 - OK P269 Fibroblasts 0 445.8 530.452 433.646 176.454 - OK P27 iPS 0 137 142.996 244.489 170.826 - OK P27 iPS 1 94 90.5617 154.839 108.187 - OK P27 hESC 1 380 376.143 248.599 178.383 - OK P27 hESC 0 421 425.317 281.098 201.703 - OK P27 Fibroblasts 1 1474 1229.91 1005.45 705.236 - OK P27 Fibroblasts 0 1239 1474.27 1205.22 845.357 - OK P270 iPS 0 0 0 0 0 - OK P270 iPS 1 0 0 0 0 - OK P270 hESC 1 0 0 0 0 - OK P270 hESC 0 41.8284 42.2573 27.9284 23.8225 - OK P270 Fibroblasts 1 166.919 139.277 113.859 94.5342 - OK P270 Fibroblasts 0 62.847 74.7809 61.1336 50.7576 - OK P271 iPS 0 65 67.8449 115.999 93.8314 - OK P271 iPS 1 150 144.513 247.084 195.176 - OK P271 hESC 1 453 448.402 296.356 242.629 - OK P271 hESC 0 382.172 386.09 255.173 206.385 - OK P271 Fibroblasts 1 1383.08 1154.04 943.433 760.488 - OK P271 Fibroblasts 0 656.153 780.748 638.264 508.474 - OK P272 iPS 0 0 0 0 0 - OK P272 iPS 1 0 0 0 0 - OK P272 hESC 1 0 0 0 0 - OK P272 hESC 0 0 0 0 0 - OK P272 Fibroblasts 1 0 0 0 0 - OK P272 Fibroblasts 0 0 0 0 0 - OK P273 iPS 0 0 0 0 0 - OK P273 iPS 1 0 0 0 0 - OK P273 hESC 1 0 0 0 0 - OK P273 hESC 0 0 0 0 0 - OK P273 Fibroblasts 1 0 0 0 0 - OK P273 Fibroblasts 0 0 0 0 0 - OK P274 iPS 0 2.51518 2.62526 4.48857 1.90183 - OK P274 iPS 1 3.64078 3.50761 5.99718 2.54104 - OK P274 hESC 1 7.96989 7.889 5.21396 2.24494 - OK P274 hESC 0 4.77731 4.82629 3.18976 1.3734 - OK P274 Fibroblasts 1 4.87936 4.07134 3.32833 1.41354 - OK P274 Fibroblasts 0 0 0 0 0 - OK P275 iPS 0 3.48482 3.63734 6.21899 1.78711 - OK P275 iPS 1 11.3592 10.9437 18.7112 5.37691 - OK P275 hESC 1 36.7099 36.3374 24.0159 6.97666 - OK P275 hESC 0 28.2328 28.5223 18.8508 5.47619 - OK P275 Fibroblasts 1 11.9829 9.99849 8.17379 2.35258 - OK P275 Fibroblasts 0 8.66672 10.3124 8.43043 2.42645 - OK P276 iPS 0 0 0 0 0 - OK P276 iPS 1 0 0 0 0 - OK P276 hESC 1 0 0 0 0 - OK P276 hESC 0 1.11969 1.13117 0.74761 0.913746 - OK P276 Fibroblasts 1 0 0 0 0 - OK P276 Fibroblasts 0 1 1.18989 0.972737 1.14406 - OK P277 iPS 0 344 359.056 613.9 385.691 - OK P277 iPS 1 263 253.38 433.22 272.176 - OK P277 hESC 1 1184 1171.98 774.581 498.411 - OK P277 hESC 0 1055 1065.82 704.414 453.262 - OK P277 Fibroblasts 1 4284 3574.57 2922.22 1842.31 - OK P277 Fibroblasts 0 4116 4897.58 4003.78 2524.19 - OK P278 iPS 0 1.89533e-05 1.97828e-05 3.3824e-05 5.32213e-05 - OK P278 iPS 1 0 0 0 0 - OK P278 hESC 1 0 0 0 0 - OK P278 hESC 0 0 0 0 0 - OK P278 Fibroblasts 1 0 0 0 0 - OK P278 Fibroblasts 0 1.45312e-05 1.72905e-05 1.4135e-05 2.76276e-05 - OK P279 iPS 0 0.999981 1.04375 1.78456 3.35241 - OK P279 iPS 1 0 0 0 0 - OK P279 hESC 1 0 0 0 0 - OK P279 hESC 0 0 0 0 0 - OK P279 Fibroblasts 1 5 4.172 3.41062 8.35087 - OK P279 Fibroblasts 0 0.999985 1.18987 0.972722 2.3817 - OK P28 iPS 0 9 9.3939 16.0613 9.50402 - OK P28 iPS 1 3 2.89027 4.94167 2.92415 - OK P28 hESC 1 5 4.94925 3.27103 1.97961 - OK P28 hESC 0 8 8.08203 5.34153 3.23266 - OK P28 Fibroblasts 1 14 11.6816 9.54973 5.66941 - OK P28 Fibroblasts 0 5 5.94944 4.86368 2.88743 - OK P280 iPS 0 0 0 0 0 - OK P280 iPS 1 0 0 0 0 - OK P280 hESC 1 0 0 0 0 - OK P280 hESC 0 0 0 0 0 - OK P280 Fibroblasts 1 0 0 0 0 - OK P280 Fibroblasts 0 0 0 0 0 - OK P281 iPS 0 0 0 0 0 - OK P281 iPS 1 0 0 0 0 - OK P281 hESC 1 1 0.989851 0.654207 1.31945 - OK P281 hESC 0 1.00024 1.01049 0.667851 1.34697 - OK P281 Fibroblasts 1 0 0 0 0 - OK P281 Fibroblasts 0 0 0 0 0 - OK P282 iPS 0 98.327 102.63 175.474 115.636 - OK P282 iPS 1 93.9073 90.4724 154.686 101.938 - OK P282 hESC 1 21.3892 21.1721 13.9929 9.45551 - OK P282 hESC 0 77.6865 78.4831 51.8706 35.0507 - OK P282 Fibroblasts 1 63.286 52.8058 43.1689 28.552 - OK P282 Fibroblasts 0 15.7586 18.751 15.329 10.1386 - OK P283 iPS 0 534.107 557.483 953.164 230.262 - OK P283 iPS 1 733.957 707.11 1208.99 292.063 - OK P283 hESC 1 830.823 822.391 543.53 132.507 - OK P283 hESC 0 566.288 572.095 378.106 92.1784 - OK P283 Fibroblasts 1 2093.87 1747.12 1428.28 345.499 - OK P283 Fibroblasts 0 943.659 1122.85 917.931 222.047 - OK P284 iPS 0 231.591 241.727 413.296 103.1 - OK P284 iPS 1 208.566 200.937 343.554 85.7022 - OK P284 hESC 1 0.0474725 0.0469907 0.0310568 0.00782069 - OK P284 hESC 0 226.683 229.007 151.354 38.1138 - OK P284 Fibroblasts 1 391.444 326.621 267.013 66.7003 - OK P284 Fibroblasts 0 322.786 384.079 313.986 78.4341 - OK P285 iPS 0 0 0 0 0 - OK P285 iPS 1 0 0 0 0 - OK P285 hESC 1 0 0 0 0 - OK P285 hESC 0 0 0 0 0 - OK P285 Fibroblasts 1 0 0 0 0 - OK P285 Fibroblasts 0 0 0 0 0 - OK P286 iPS 0 13.7 14.2997 24.449 26.7158 - OK P286 iPS 1 35.0923 33.8087 57.8049 63.1641 - OK P286 hESC 1 1.80746 1.78912 1.18245 1.34743 - OK P286 hESC 0 3.37536 3.40997 2.2537 2.56813 - OK P286 Fibroblasts 1 0 0 0 0 - OK P286 Fibroblasts 0 1.63442 1.94477 1.58986 1.7478 - OK P287 iPS 0 295.406 308.335 527.18 442.427 - OK P287 iPS 1 450.281 433.811 741.714 622.471 - OK P287 hESC 1 408.423 404.278 267.193 231.542 - OK P287 hESC 0 511.457 516.701 341.495 295.929 - OK P287 Fibroblasts 1 809.745 675.651 552.346 465.705 - OK P287 Fibroblasts 0 337.853 402.007 328.642 277.091 - OK P288 iPS 0 277.894 290.056 495.928 440.78 - OK P288 iPS 1 294.626 283.85 485.315 431.348 - OK P288 hESC 1 456.77 452.134 298.822 274.773 - OK P288 hESC 0 446.168 450.743 297.902 273.927 - OK P288 Fibroblasts 1 628.255 524.216 428.548 382.772 - OK P288 Fibroblasts 0 264.513 314.741 257.301 229.817 - OK P2881 iPS 0 0 0 0 0 - OK P2881 iPS 1 1 0.963422 1.64722 3.02791 - OK P2881 hESC 1 0 0 0 0 - OK P2881 hESC 0 0 0 0 0 - OK P2881 Fibroblasts 1 0 0 0 0 - OK P2881 Fibroblasts 0 0 0 0 0 - OK P2882 iPS 0 258.786 270.113 461.829 158.328 - OK P2882 iPS 1 346.124 333.463 570.143 195.518 - OK P2882 hESC 1 1338.6 1325.01 875.719 304.162 - OK P2882 hESC 0 1435.19 1449.9 958.263 332.782 - OK P2882 Fibroblasts 1 204.855 170.931 139.736 48.0107 - OK P2882 Fibroblasts 0 102.927 122.471 100.121 34.3807 - OK P2883 iPS 0 17 17.744 30.3381 37.3649 - OK P2883 iPS 1 10 9.63422 16.4722 20.2875 - OK P2883 hESC 1 18 17.8173 11.7757 15.2072 - OK P2883 hESC 0 29 29.2973 19.363 25.0055 - OK P2883 Fibroblasts 1 53 44.2232 36.1526 44.831 - OK P2883 Fibroblasts 0 28 33.3169 27.2366 33.7748 - OK P2884 iPS 0 5.50408 5.74498 9.82255 19.0719 - OK P2884 iPS 1 20.774 20.0141 34.2194 66.4418 - OK P2884 hESC 1 76.5525 75.7755 50.0811 104.896 - OK P2884 hESC 0 72.5119 73.2554 48.4156 101.407 - OK P2884 Fibroblasts 1 54.8435 45.7614 37.4101 73.4242 - OK P2884 Fibroblasts 0 40.35 48.0119 39.2499 77.0351 - OK P2885 iPS 0 366.046 382.067 653.243 351.145 - OK P2885 iPS 1 332.157 320.007 547.136 294.108 - OK P2885 hESC 1 1532.67 1517.12 1002.68 550.099 - OK P2885 hESC 0 1548.82 1564.7 1034.13 567.353 - OK P2885 Fibroblasts 1 803.577 670.504 548.139 295.524 - OK P2885 Fibroblasts 0 1827.83 2174.91 1777.99 958.588 - OK P2886 iPS 0 258.495 269.808 461.308 246.567 - OK P2886 iPS 1 306.291 295.088 504.53 269.668 - OK P2886 hESC 1 2754.34 2726.39 1801.91 982.856 - OK P2886 hESC 0 3327.45 3361.57 2221.71 1211.84 - OK P2886 Fibroblasts 1 2959.88 2469.72 2019 1082.34 - OK P2886 Fibroblasts 0 3502.98 4168.16 3407.48 1826.67 - OK P2887 iPS 0 51.5489 53.805 91.9938 31.627 - OK P2887 iPS 1 71.938 69.3067 118.498 40.739 - OK P2887 hESC 1 464.767 460.05 304.054 105.901 - OK P2887 hESC 0 417.681 421.964 278.882 97.1336 - OK P2887 Fibroblasts 1 137.552 114.773 93.8273 32.3187 - OK P2887 Fibroblasts 0 235.171 279.827 228.76 78.796 - OK P2888 iPS 0 0 0 0 0 - OK P2888 iPS 1 0 0 0 0 - OK P2888 hESC 1 0 0 0 0 - OK P2888 hESC 0 3.09078 3.12247 2.06369 1.03541 - OK P2888 Fibroblasts 1 12.6756 10.5766 8.64636 4.26944 - OK P2888 Fibroblasts 0 0 0 0 0 - OK P2889 iPS 0 26 27.1379 46.3994 82.6075 - OK P2889 iPS 1 8 7.70738 13.1778 23.4611 - OK P2889 hESC 1 23.4606 23.2225 15.3481 29.2849 - OK P2889 hESC 0 17.9423 18.1263 11.9799 22.8582 - OK P2889 Fibroblasts 1 36.4606 30.4227 24.8707 44.7182 - OK P2889 Fibroblasts 0 6 7.13933 5.83642 10.4941 - OK P289 iPS 0 722 753.6 1288.48 461.128 - OK P289 iPS 1 446 429.686 734.662 262.925 - OK P289 hESC 1 3288.5 3255.12 2151.36 780.441 - OK P289 hESC 0 3265 3298.48 2180.01 790.835 - OK P289 Fibroblasts 1 9458 7891.75 6451.53 2313.48 - OK P289 Fibroblasts 0 6764.5 8048.99 6580.07 2359.58 - OK P2890 iPS 0 0 0 0 0 - OK P2890 iPS 1 0 0 0 0 - OK P2890 hESC 1 19.5394 19.341 12.7828 22.0683 - OK P2890 hESC 0 4.05771 4.09931 2.70929 4.67735 - OK P2890 Fibroblasts 1 8.53938 7.12525 5.82491 9.52865 - OK P2890 Fibroblasts 0 0 0 0 0 - OK P2891 iPS 0 15.3784 16.0515 27.4442 15.3049 - OK P2891 iPS 1 19.0544 18.3574 31.3868 17.5036 - OK P2891 hESC 1 21.4542 21.2365 14.0355 7.99481 - OK P2891 hESC 0 17.3608 17.5388 11.5917 6.60276 - OK P2891 Fibroblasts 1 49.3723 41.1963 33.6781 18.8394 - OK P2891 Fibroblasts 0 38.7842 46.1489 37.7268 21.1042 - OK P2892 iPS 0 22.5467 23.5335 40.2368 31.4193 - OK P2892 iPS 1 28.1245 27.0957 46.3273 36.1751 - OK P2892 hESC 1 140.969 139.539 92.2232 74.1911 - OK P2892 hESC 0 205.387 207.493 137.135 110.321 - OK P2892 Fibroblasts 1 114.317 95.3864 77.9786 61.1541 - OK P2892 Fibroblasts 0 131.143 156.046 127.568 93.6314 - OK P2893 iPS 0 21.2136 22.142 37.8576 20.8086 - OK P2893 iPS 1 14.5808 14.0475 24.0178 13.2015 - OK P2893 hESC 1 43.2082 42.7697 28.2671 15.865 - OK P2893 hESC 0 36.9024 37.2808 24.6394 13.8289 - OK P2893 Fibroblasts 1 0 0 0 0 - OK P2893 Fibroblasts 0 0 0 0 0 - OK P2894 iPS 0 11.8605 12.3796 21.1662 19.0277 - OK P2894 iPS 1 0 0 0 0 - OK P2894 hESC 1 27.0656 26.7909 17.7065 16.4742 - OK P2894 hESC 0 10.377 10.4834 6.92861 6.44643 - OK P2894 Fibroblasts 1 98.3237 82.0413 67.0689 60.5935 - OK P2894 Fibroblasts 0 54.3856 64.7128 52.9029 47.7952 - OK P2895 iPS 0 0.000765592 0.0007991 0.00136627 0.00122125 - OK P2895 iPS 1 26.4376 25.4706 43.5487 38.9262 - OK P2895 hESC 1 20.333 20.1267 13.302 12.3034 - OK P2895 hESC 0 56.6692 57.2502 37.8375 34.9971 - OK P2895 Fibroblasts 1 38.238 31.9058 26.083 23.4301 - OK P2895 Fibroblasts 0 35.5854 42.3427 34.6153 31.0945 - OK P2896 iPS 0 0 0 0 0 - OK P2896 iPS 1 1 0.963422 1.64722 0.692545 - OK P2896 hESC 1 24 23.7564 15.701 6.70718 - OK P2896 hESC 0 19 19.1948 12.6861 5.4193 - OK P2896 Fibroblasts 1 0 0 0 0 - OK P2896 Fibroblasts 0 0 0 0 0 - OK P2897 iPS 0 5.17384e-05 5.40028e-05 9.23319e-05 0.000129247 - OK P2897 iPS 1 0 0 0 0 - OK P2897 hESC 1 0 0 0 0 - OK P2897 hESC 0 0 0 0 0 - OK P2897 Fibroblasts 1 0 0 0 0 - OK P2897 Fibroblasts 0 14.998 17.846 14.5891 20.5811 - OK P2898 iPS 0 0 0 0 0 - OK P2898 iPS 1 0 0 0 0 - OK P2898 hESC 1 20.3851 20.1782 13.3361 19.2818 - OK P2898 hESC 0 36 36.3691 24.0369 34.7535 - OK P2898 Fibroblasts 1 0 0 0 0 - OK P2898 Fibroblasts 0 0.00195717 0.00232881 0.00190381 0.00263063 - OK P2899 iPS 0 0 0 0 0 - OK P2899 iPS 1 0.999992 0.963414 1.64721 2.83969 - OK P2899 hESC 1 0 0 0 0 - OK P2899 hESC 0 0 0 0 0 - OK P2899 Fibroblasts 1 7.99986 6.67508 5.45689 9.49778 - OK P2899 Fibroblasts 0 0 0 0 0 - OK P29 iPS 0 28.3019 29.5405 50.5073 45.2319 - OK P29 iPS 1 56.9198 54.8378 93.7596 83.9666 - OK P29 hESC 1 352.096 348.523 230.344 213.471 - OK P29 hESC 0 0 0 0 0 - OK P29 Fibroblasts 1 617.066 514.879 420.915 378.825 - OK P29 Fibroblasts 0 311.451 370.592 302.96 272.665 - OK P290 iPS 0 6.58615 6.8744 11.7536 5.72814 - OK P290 iPS 1 8.74409 8.42425 14.4035 7.01957 - OK P290 hESC 1 10.937 10.826 7.15508 3.55212 - OK P290 hESC 0 33 33.3384 22.0338 10.9386 - OK P290 Fibroblasts 1 21.6547 18.0687 14.7712 7.2182 - OK P290 Fibroblasts 0 23.8815 28.4163 23.2304 11.3519 - OK P2900 iPS 0 0.999948 1.04371 1.7845 2.82188 - OK P2900 iPS 1 1.00001 0.96343 1.64724 2.60482 - OK P2900 hESC 1 16.6149 16.4462 10.8696 18.2746 - OK P2900 hESC 0 0 0 0 0 - OK P2900 Fibroblasts 1 0.000142285 0.000118723 9.70561e-05 0.00015483 - OK P2900 Fibroblasts 0 0 0 0 0 - OK P2901 iPS 0 0 0 0 0 - OK P2901 iPS 1 0 0 0 0 - OK P2901 hESC 1 2.4469 2.42206 1.60078 1.53065 - OK P2901 hESC 0 1 1.01025 0.667691 0.638442 - OK P2901 Fibroblasts 1 0 0 0 0 - OK P2901 Fibroblasts 0 0 0 0 0 - OK P2902 iPS 0 0 0 0 0 - OK P2902 iPS 1 1 0.963422 1.64722 2.59032 - OK P2902 hESC 1 0.553101 0.547488 0.361843 0.479707 - OK P2902 hESC 0 0 0 0 0 - OK P2902 Fibroblasts 1 5 4.172 3.41062 5.41031 - OK P2902 Fibroblasts 0 4 4.75955 3.89094 6.17226 - OK P2903 iPS 0 39.4876 41.2158 70.4692 50.6123 - OK P2903 iPS 1 23.8212 22.9499 39.2389 28.1821 - OK P2903 hESC 1 1.00906 0.998815 0.660132 0.487274 - OK P2903 hESC 0 67.5082 68.2004 45.0746 33.2717 - OK P2903 Fibroblasts 1 916.065 764.364 624.87 450.58 - OK P2903 Fibroblasts 0 883.631 1051.42 859.539 619.795 - OK P2904 iPS 0 0 0 0 0 - OK P2904 iPS 1 0 0 0 0 - OK P2904 hESC 1 0 0 0 0 - OK P2904 hESC 0 0 0 0 0 - OK P2904 Fibroblasts 1 0 0 0 0 - OK P2904 Fibroblasts 0 0 0 0 0 - OK P2905 iPS 0 10.6976 11.1658 19.0909 44.7448 - OK P2905 iPS 1 4.81789 4.64166 7.93614 18.6006 - OK P2905 hESC 1 115.869 114.693 75.8022 194.828 - OK P2905 hESC 0 146.151 147.649 97.5835 250.811 - OK P2905 Fibroblasts 1 59.1226 49.3318 40.3289 95.7614 - OK P2905 Fibroblasts 0 54.0399 64.3014 52.5665 124.82 - OK P2906 iPS 0 724.556 756.268 1293.04 986.804 - OK P2906 iPS 1 524.829 505.632 864.511 659.766 - OK P2906 hESC 1 2865.89 2836.8 1874.88 1473.11 - OK P2906 hESC 0 2915.19 2945.08 1946.44 1529.33 - OK P2906 Fibroblasts 1 14050.4 11723.6 9584.09 7345.21 - OK P2906 Fibroblasts 0 12450.5 14814.7 12111.1 9281.87 - OK P2907 iPS 0 7 7.30637 12.4922 20.3456 - OK P2907 iPS 1 5 4.81711 8.23612 13.4139 - OK P2907 hESC 1 49 48.5027 32.0561 55.6135 - OK P2907 hESC 0 28 28.2871 18.6953 32.4342 - OK P2907 Fibroblasts 1 30 25.032 20.4637 33.631 - OK P2907 Fibroblasts 0 73 86.8618 71.0097 116.701 - OK P2908 iPS 0 13.1753 13.752 23.5126 15.0325 - OK P2908 iPS 1 4.62052 4.45151 7.61102 4.86601 - OK P2908 hESC 1 41.3409 40.9214 27.0455 17.717 - OK P2908 hESC 0 56.8183 57.4009 37.9371 24.8518 - OK P2908 Fibroblasts 1 121.474 101.357 82.86 53.1632 - OK P2908 Fibroblasts 0 211.471 251.627 205.705 131.981 - OK P2909 iPS 0 12.8416 13.4036 22.9171 14.6055 - OK P2909 iPS 1 34.3211 33.0657 56.5345 36.0306 - OK P2909 hESC 1 154.455 152.887 101.045 68.9156 - OK P2909 hESC 0 108.361 109.472 72.3518 49.1141 - OK P2909 Fibroblasts 1 359.76 300.183 245.401 169.556 - OK P2909 Fibroblasts 0 263.89 314 256.696 174.133 - OK P291 iPS 0 4 4.17507 7.13837 7.47676 - OK P291 iPS 1 9 8.6708 14.825 15.5278 - OK P291 hESC 1 53 52.4621 34.673 37.805 - OK P291 hESC 0 37 37.3794 24.7046 26.9362 - OK P291 Fibroblasts 1 0 0 0 0 - OK P291 Fibroblasts 0 0 0 0 0 - OK P2910 iPS 0 378.71 395.285 675.843 455.426 - OK P2910 iPS 1 377.487 363.679 621.805 420.124 - OK P2910 hESC 1 1240.82 1228.23 811.754 562.054 - OK P2910 hESC 0 1501.64 1517.04 1002.63 694.37 - OK P2910 Fibroblasts 1 2742.91 2288.68 1871 1269.52 - OK P2910 Fibroblasts 0 3197.85 3805.09 3110.67 2108.98 - OK P2911 iPS 0 8.27318 8.63527 14.7643 9.97114 - OK P2911 iPS 1 21.7352 20.9402 35.8027 24.1796 - OK P2911 hESC 1 44.3818 43.9313 29.0348 20.1196 - OK P2911 hESC 0 28.1807 28.4697 18.816 13.0385 - OK P2911 Fibroblasts 1 0 0 0 0 - OK P2911 Fibroblasts 0 70.7855 84.2268 68.8556 46.6761 - OK P2912 iPS 0 0 0 0 0 - OK P2912 iPS 1 9.83626 9.47647 16.2025 10.7173 - OK P2912 hESC 1 0 0 0 0 - OK P2912 hESC 0 0 0 0 0 - OK P2912 Fibroblasts 1 15.8571 13.2311 10.8165 7.1809 - OK P2912 Fibroblasts 0 0 0 0 0 - OK P2913 iPS 0 18 18.7878 32.1227 13.5659 - OK P2913 iPS 1 30 28.9027 49.4167 20.8694 - OK P2913 hESC 1 143 141.549 93.5516 40.1455 - OK P2913 hESC 0 121 122.241 80.7906 34.6694 - OK P2913 Fibroblasts 1 55 45.892 37.5168 15.8809 - OK P2913 Fibroblasts 0 60 71.3933 58.3642 24.7057 - OK P2914 iPS 0 161.987 169.077 289.081 113.857 - OK P2914 iPS 1 108.453 104.486 178.645 70.3611 - OK P2914 hESC 1 811.742 803.504 531.047 212.301 - OK P2914 hESC 0 539.414 544.944 360.162 143.984 - OK P2914 Fibroblasts 1 2556.81 2133.4 1744.06 688.41 - OK P2914 Fibroblasts 0 2407.08 2864.16 2341.46 924.213 - OK P2915 iPS 0 25.1584 26.2595 44.8974 20.8672 - OK P2915 iPS 1 0 0 0 0 - OK P2915 hESC 1 389.534 385.581 254.836 120.547 - OK P2915 hESC 0 543.832 549.408 363.112 171.766 - OK P2915 Fibroblasts 1 273.615 228.304 186.639 86.9683 - OK P2915 Fibroblasts 0 253.495 301.631 246.584 114.901 - OK P2916 iPS 0 26.1737 27.3193 46.7095 37.1504 - OK P2916 iPS 1 10.9073 10.5084 17.9668 14.2899 - OK P2916 hESC 1 208.706 206.588 136.537 111.941 - OK P2916 hESC 0 235.687 238.103 157.366 129.018 - OK P2916 Fibroblasts 1 211.874 176.788 144.525 115.455 - OK P2916 Fibroblasts 0 187.616 223.242 182.501 145.793 - OK P2917 iPS 0 65.7163 68.5925 117.277 32.1656 - OK P2917 iPS 1 42.7309 41.1679 70.3873 19.3051 - OK P2917 hESC 1 603.687 597.561 394.936 109.448 - OK P2917 hESC 0 645.092 651.706 430.722 119.365 - OK P2917 Fibroblasts 1 495.361 413.329 337.897 92.8157 - OK P2917 Fibroblasts 0 305.242 363.204 296.92 81.5597 - OK P2918 iPS 0 0 0 0 0 - OK P2918 iPS 1 0 0 0 0 - OK P2918 hESC 1 0 0 0 0 - OK P2918 hESC 0 0 0 0 0 - OK P2918 Fibroblasts 1 0 0 0 0 - OK P2918 Fibroblasts 0 0 0 0 0 - OK P2919 iPS 0 65.4244 68.2878 116.756 71.326 - OK P2919 iPS 1 76.996 74.1796 126.83 77.48 - OK P2919 hESC 1 321.575 318.311 210.376 131.539 - OK P2919 hESC 0 324.129 327.452 216.418 135.317 - OK P2919 Fibroblasts 1 19.6777 16.4191 13.4226 8.22763 - OK P2919 Fibroblasts 0 31.4976 37.4787 30.6389 18.7806 - OK P292 iPS 0 196.289 204.88 350.296 188.801 - OK P292 iPS 1 361.181 347.97 594.946 320.661 - OK P292 hESC 1 459.785 455.118 300.794 165.473 - OK P292 hESC 0 100.751 101.784 67.2704 37.0068 - OK P292 Fibroblasts 1 1386.5 1156.89 945.762 511.263 - OK P292 Fibroblasts 0 301.941 359.276 293.709 158.774 - OK P2920 iPS 0 0 0 0 0 - OK P2920 iPS 1 0 0 0 0 - OK P2920 hESC 1 0 0 0 0 - OK P2920 hESC 0 0 0 0 0 - OK P2920 Fibroblasts 1 0 0 0 0 - OK P2920 Fibroblasts 0 0 0 0 0 - OK P2921 iPS 0 0 0 0 0 - OK P2921 iPS 1 0 0 0 0 - OK P2921 hESC 1 55.0225 54.4641 35.9961 31.5997 - OK P2921 hESC 0 24.3848 24.6348 16.2815 14.2929 - OK P2921 Fibroblasts 1 0 0 0 0 - OK P2921 Fibroblasts 0 7.50965 8.93564 7.30491 6.23713 - OK P2922 iPS 0 35.6427 37.2027 63.6078 96.074 - OK P2922 iPS 1 47.9859 46.2307 79.0435 119.388 - OK P2922 hESC 1 486.627 481.688 318.354 509.791 - OK P2922 hESC 0 360.473 364.169 240.685 385.416 - OK P2922 Fibroblasts 1 448.214 373.99 305.738 465.674 - OK P2922 Fibroblasts 0 248.676 295.897 241.896 368.436 - OK P2923 iPS 0 15.9255 16.6225 28.4205 22.9658 - OK P2923 iPS 1 16.9574 16.3371 27.9325 22.5715 - OK P2923 hESC 1 216.39 214.194 141.564 117.977 - OK P2923 hESC 0 159.979 161.619 106.816 89.019 - OK P2923 Fibroblasts 1 172.528 143.957 117.685 95.5243 - OK P2923 Fibroblasts 0 68.8413 81.9134 66.9645 54.3546 - OK P2924 iPS 0 5.80171 6.05563 10.3537 6.25215 - OK P2924 iPS 1 16.9533 16.3332 27.9259 16.8633 - OK P2924 hESC 1 99.9958 98.981 65.4179 40.4206 - OK P2924 hESC 0 87.7413 88.6409 58.584 36.1981 - OK P2924 Fibroblasts 1 105.645 88.1504 72.0632 43.6614 - OK P2924 Fibroblasts 0 23.548 28.0195 22.906 13.8782 - OK P2925 iPS 0 0 0 0 0 - OK P2925 iPS 1 0 0 0 0 - OK P2925 hESC 1 60.4223 59.809 39.5286 27.6623 - OK P2925 hESC 0 165.152 166.845 110.27 77.1676 - OK P2925 Fibroblasts 1 112.85 94.1619 76.9776 52.6869 - OK P2925 Fibroblasts 0 147.294 175.263 143.278 98.0658 - OK P2926 iPS 0 447.633 467.225 798.843 574.327 - OK P2926 iPS 1 522.131 503.033 860.067 618.344 - OK P2926 hESC 1 3429.1 3394.29 2243.34 1657.64 - OK P2926 hESC 0 3190.17 3222.88 2130.05 1573.93 - OK P2926 Fibroblasts 1 3873.42 3231.98 2642.15 1907.14 - OK P2926 Fibroblasts 0 3921.06 4665.62 3814.16 2753.11 - OK P2927 iPS 0 11.8077 12.3245 21.0719 12.2135 - OK P2927 iPS 1 19.7221 19.0007 32.4868 18.8296 - OK P2927 hESC 1 101.381 100.352 66.3239 39.2981 - OK P2927 hESC 0 113.185 114.346 75.5729 44.7784 - OK P2927 Fibroblasts 1 77.9182 65.0149 53.1498 30.905 - OK P2927 Fibroblasts 0 12.8723 15.3165 12.5213 7.28077 - OK P2928 iPS 0 28.6912 29.947 51.2022 38.0894 - OK P2928 iPS 1 0.859475 0.828037 1.41575 1.05318 - OK P2928 hESC 1 9.28771 9.19345 6.07608 4.65004 - OK P2928 hESC 0 7.75954 7.8391 5.18098 3.96502 - OK P2928 Fibroblasts 1 0 0 0 0 - OK P2928 Fibroblasts 0 7.23716 8.61141 7.03985 5.25856 - OK P2929 iPS 0 5.20238 5.43007 9.28413 9.36371 - OK P2929 iPS 1 0 0 0 0 - OK P2929 hESC 1 61.4199 60.7965 40.1813 42.1227 - OK P2929 hESC 0 61.8249 62.4588 41.2799 43.2744 - OK P2929 Fibroblasts 1 0 0 0 0 - OK P2929 Fibroblasts 0 8.2092 9.76803 7.98539 8.09893 - OK P293 iPS 0 10.9584 11.438 19.5563 20.3927 - OK P293 iPS 1 54.0127 52.037 88.9709 92.7763 - OK P293 hESC 1 43.4539 43.0129 28.4278 30.8531 - OK P293 hESC 0 24.9008 25.1561 16.626 18.0444 - OK P293 Fibroblasts 1 19.9801 16.6714 13.6289 14.2942 - OK P293 Fibroblasts 0 8.05004 9.57864 7.83056 8.21278 - OK P2930 iPS 0 49.3747 51.5357 88.1137 29.4346 - OK P2930 iPS 1 56.4872 54.421 93.047 31.0826 - OK P2930 hESC 1 936.881 927.372 612.914 207.349 - OK P2930 hESC 0 819.648 828.052 547.272 185.142 - OK P2930 Fibroblasts 1 87.7291 73.2011 59.8421 20.0274 - OK P2930 Fibroblasts 0 84.656 100.731 82.348 27.5594 - OK P2931 iPS 0 222.901 232.656 397.787 204.205 - OK P2931 iPS 1 168.483 162.32 277.529 142.47 - OK P2931 hESC 1 2100.48 2079.16 1374.15 719.299 - OK P2931 hESC 0 1870.48 1889.66 1248.91 653.742 - OK P2931 Fibroblasts 1 2789.77 2327.78 1902.97 979.669 - OK P2931 Fibroblasts 0 3112.67 3703.73 3027.81 1558.75 - OK P2932 iPS 0 73.7245 76.9513 131.568 92.384 - OK P2932 iPS 1 28.932 27.8738 47.6575 33.4639 - OK P2932 hESC 1 476.749 471.91 311.892 224.94 - OK P2932 hESC 0 611.57 617.841 408.34 294.499 - OK P2932 Fibroblasts 1 217.044 181.101 148.051 104.362 - OK P2932 Fibroblasts 0 538.467 640.716 523.787 369.222 - OK P2933 iPS 0 0 0 0 0 - OK P2933 iPS 1 13.0975 12.6185 21.5746 15.0669 - OK P2933 hESC 1 80.5605 79.7428 52.7032 37.7982 - OK P2933 hESC 0 58.2973 58.8951 38.9246 27.9163 - OK P2933 Fibroblasts 1 105.456 87.9923 71.9339 50.4304 - OK P2933 Fibroblasts 0 79.7046 94.8395 77.5315 54.3547 - OK P2934 iPS 0 115.644 120.705 206.377 160.443 - OK P2934 iPS 1 29.2134 28.1448 48.121 37.4106 - OK P2934 hESC 1 0 0 0 0 - OK P2934 hESC 0 27.7222 28.0064 18.5099 14.8233 - OK P2934 Fibroblasts 1 6717.48 5605.07 4582.16 3577.65 - OK P2934 Fibroblasts 0 3388.16 4031.53 3295.79 2573.28 - OK P2935 iPS 0 4.45588 4.6509 7.95193 4.39301 - OK P2935 iPS 1 0 0 0 0 - OK P2935 hESC 1 42.479 42.0479 27.7901 15.6781 - OK P2935 hESC 0 57.9877 58.5823 38.7179 21.8431 - OK P2935 Fibroblasts 1 76.2886 63.6552 52.0383 28.8363 - OK P2935 Fibroblasts 0 17.4931 20.8148 17.0162 9.42927 - OK P2936 iPS 0 1167.45 1218.54 2083.42 1382.63 - OK P2936 iPS 1 43.4427 41.8536 71.5598 47.4894 - OK P2936 hESC 1 137.916 136.517 90.2258 61.4087 - OK P2936 hESC 0 154.248 155.83 102.99 70.0963 - OK P2936 Fibroblasts 1 11568.8 9652.97 7891.33 5256.21 - OK P2936 Fibroblasts 0 16556.2 19700.1 16104.9 10727 - OK P2937 iPS 0 9.58545 10.005 17.1061 13.1685 - OK P2937 iPS 1 0 0 0 0 - OK P2937 hESC 1 34.5364 34.1859 22.5939 17.9114 - OK P2937 hESC 0 0 0 0 0 - OK P2937 Fibroblasts 1 202.885 169.287 138.393 106.991 - OK P2937 Fibroblasts 0 108.858 129.528 105.89 81.8632 - OK P2938 iPS 0 320.867 334.911 572.618 442.978 - OK P2938 iPS 1 38.3439 36.9414 63.161 48.8614 - OK P2938 hESC 1 141.068 139.636 92.2878 73.5322 - OK P2938 hESC 0 71.0418 71.7702 47.434 37.794 - OK P2938 Fibroblasts 1 8008.24 6682.07 5462.61 4244.01 - OK P2938 Fibroblasts 0 2561.58 3047.99 2491.74 1935.88 - OK P2939 iPS 0 761 794.307 1358.08 2754.03 - OK P2939 iPS 1 661 636.822 1088.81 2273.64 - OK P2939 hESC 1 2762 2733.97 1806.92 4090.26 - OK P2939 hESC 0 2480 2505.43 1655.87 3632.19 - OK P2939 Fibroblasts 1 3704 3090.62 2526.59 5292.73 - OK P2939 Fibroblasts 0 4345 5170.06 4226.54 8511.04 - OK P294 iPS 0 993.752 1037.25 1773.44 786.974 - OK P294 iPS 1 511.806 493.085 843.059 374.836 - OK P294 hESC 1 2754.76 2726.8 1802.18 813.084 - OK P294 hESC 0 2922.35 2952.31 1951.23 881.419 - OK P294 Fibroblasts 1 9253.52 7721.14 6312.05 2806.79 - OK P294 Fibroblasts 0 3122.51 3715.43 3037.38 1353.79 - OK P2940 iPS 0 178.155 185.952 317.934 122.493 - OK P2940 iPS 1 65.9694 63.5564 108.666 41.8666 - OK P2940 hESC 1 371.98 368.204 243.352 95.1355 - OK P2940 hESC 0 485.801 490.782 324.365 126.807 - OK P2940 Fibroblasts 1 580.208 484.125 395.774 152.808 - OK P2940 Fibroblasts 0 171.857 204.49 167.171 64.5446 - OK P2941 iPS 0 18.1219 18.915 32.3402 15.4471 - OK P2941 iPS 1 24.3475 23.4569 40.1057 19.1562 - OK P2941 hESC 1 302.689 299.616 198.021 96.3126 - OK P2941 hESC 0 308.993 312.161 206.312 100.345 - OK P2941 Fibroblasts 1 129.419 107.987 88.2797 42.2777 - OK P2941 Fibroblasts 0 19.4567 23.1513 18.9263 9.06391 - OK P2942 iPS 0 127.072 132.633 226.772 78.6257 - OK P2942 iPS 1 287.716 277.192 473.933 162.451 - OK P2942 hESC 1 719.762 712.457 470.873 189.795 - OK P2942 hESC 0 853.714 862.467 570.017 243.4 - OK P2942 Fibroblasts 1 644.962 538.156 439.944 161.394 - OK P2942 Fibroblasts 0 356.105 423.724 346.396 121.936 - OK P2943 iPS 0 634.503 662.273 1132.33 313.973 - OK P2943 iPS 1 840.827 810.071 1385.03 384.042 - OK P2943 hESC 1 1975.54 1955.49 1292.41 362.136 - OK P2943 hESC 0 1889.76 1909.14 1261.78 353.551 - OK P2943 Fibroblasts 1 4584.83 3825.58 3127.42 868.503 - OK P2943 Fibroblasts 0 1880.69 2237.81 1829.42 508.04 - OK P2944 iPS 0 158.248 165.174 282.409 135.531 - OK P2944 iPS 1 266.125 256.391 438.367 210.378 - OK P2944 hESC 1 1367.47 1353.59 894.609 437.221 - OK P2944 hESC 0 1417.91 1432.45 946.728 462.693 - OK P2944 Fibroblasts 1 740.323 617.725 504.992 242.996 - OK P2944 Fibroblasts 0 715.986 851.942 696.465 335.13 - OK P2945 iPS 0 42.4165 44.273 75.6963 109.202 - OK P2945 iPS 1 43.5855 41.9912 71.795 103.574 - OK P2945 hESC 1 99.5118 98.5019 65.1013 99.3025 - OK P2945 hESC 0 82.8222 83.6714 55.2997 84.3515 - OK P2945 Fibroblasts 1 41.0189 34.2262 27.98 40.6891 - OK P2945 Fibroblasts 0 24.0582 28.6265 23.4023 34.032 - OK P2946 iPS 0 750.602 783.454 1339.52 3356.43 - OK P2946 iPS 1 622.375 599.61 1025.19 2568.81 - OK P2946 hESC 1 2365.75 2341.74 1547.69 4281.29 - OK P2946 hESC 0 2580.43 2606.88 1722.93 4766.04 - OK P2946 Fibroblasts 1 4306.95 3593.72 2937.88 7464.7 - OK P2946 Fibroblasts 0 3837.09 4565.7 3732.47 9483.65 - OK P2947 iPS 0 6.57122 6.85883 11.727 8.97384 - OK P2947 iPS 1 3.30897 3.18793 5.45061 4.17097 - OK P2947 hESC 1 15.1262 14.9726 9.89563 7.79672 - OK P2947 hESC 0 11.9024 12.0245 7.94715 6.26152 - OK P2947 Fibroblasts 1 3.24524 2.70782 2.21365 1.70114 - OK P2947 Fibroblasts 0 39.4829 46.9802 38.4065 29.5145 - OK P2948 iPS 0 0.00440098 0.0045936 0.00785396 0.0084968 - OK P2948 iPS 1 0.00485799 0.0046803 0.00800219 0.00865717 - OK P2948 hESC 1 54.2718 53.721 35.505 40.0393 - OK P2948 hESC 0 99.0933 100.109 66.1637 74.6134 - OK P2948 Fibroblasts 1 0.00529645 0.00441935 0.00361283 0.00393203 - OK P2948 Fibroblasts 0 0.00387995 0.00461671 0.00377417 0.00410762 - OK P2949 iPS 0 19 19.8316 33.9073 50.5661 - OK P2949 iPS 1 5 4.81711 8.23612 12.2826 - OK P2949 hESC 1 107 105.914 70.0001 110.591 - OK P2949 hESC 0 60 60.6152 40.0615 63.2919 - OK P2949 Fibroblasts 1 235 196.084 160.299 241.04 - OK P2949 Fibroblasts 0 149 177.293 144.938 217.941 - OK P295 iPS 0 645.31 673.553 1151.62 135.082 - OK P295 iPS 1 806.699 777.191 1328.81 155.867 - OK P295 hESC 1 2973.2 2943.02 1945.09 229.165 - OK P295 hESC 0 3251.83 3285.17 2171.22 255.807 - OK P295 Fibroblasts 1 5098.49 4254.17 3477.8 408.203 - OK P295 Fibroblasts 0 1397.53 1662.91 1359.43 159.562 - OK P2950 iPS 0 9.30683 9.71416 16.6089 17.671 - OK P2950 iPS 1 9.1948 8.85848 15.1459 16.1144 - OK P2950 hESC 1 11.5186 11.4017 7.53555 8.35143 - OK P2950 hESC 0 19.7756 19.9784 13.204 14.6336 - OK P2950 Fibroblasts 1 6.76923 5.64825 4.61746 4.94176 - OK P2950 Fibroblasts 0 3.16165 3.76201 3.07545 3.29146 - OK P2951 iPS 0 364.574 380.53 650.616 328.393 - OK P2951 iPS 1 579.308 558.118 954.25 481.65 - OK P2951 hESC 1 670.394 663.59 438.577 225.649 - OK P2951 hESC 0 732.179 739.686 488.869 251.525 - OK P2951 Fibroblasts 1 1141.22 952.231 778.451 394.015 - OK P2951 Fibroblasts 0 937.089 1115.03 911.54 461.378 - OK P2952 iPS 0 959.119 1001.1 1711.64 2134.1 - OK P2952 iPS 1 847.497 816.498 1396.02 1740.58 - OK P2952 hESC 1 3779.09 3740.73 2472.3 3234.08 - OK P2952 hESC 0 3765.05 3803.65 2513.89 3288.48 - OK P2952 Fibroblasts 1 7270.01 6066.1 4959.05 6225.88 - OK P2952 Fibroblasts 0 4963.75 5906.3 4828.42 6061.88 - OK P2953 iPS 0 16.6664 17.3959 29.7428 30.2784 - OK P2953 iPS 1 8.95682 8.6292 14.7539 15.0196 - OK P2953 hESC 1 241.949 239.493 158.284 167.546 - OK P2953 hESC 0 199.318 201.361 133.083 140.87 - OK P2953 Fibroblasts 1 480.311 400.771 327.632 335.417 - OK P2953 Fibroblasts 0 9.16173 10.9014 8.91194 9.1237 - OK P2954 iPS 0 3.00465 3.13616 5.36209 4.21731 - OK P2954 iPS 1 13.9312 13.4216 22.9478 18.0486 - OK P2954 hESC 1 378.536 374.694 247.641 200.704 - OK P2954 hESC 0 247.681 250.22 165.374 134.03 - OK P2954 Fibroblasts 1 356.11 297.138 242.911 191.884 - OK P2954 Fibroblasts 0 117.295 139.568 114.097 90.1292 - OK P2955 iPS 0 51.1682 53.4077 91.3144 52.5606 - OK P2955 iPS 1 41.4415 39.9257 68.2634 39.2924 - OK P2955 hESC 1 1608.23 1591.91 1052.12 618.991 - OK P2955 hESC 0 1639.18 1655.99 1094.47 643.906 - OK P2955 Fibroblasts 1 2190.42 1827.68 1494.13 862.766 - OK P2955 Fibroblasts 0 2050.62 2440 1994.71 1151.82 - OK P2956 iPS 0 12.5487 13.0979 22.3944 13.0495 - OK P2956 iPS 1 3.17701 3.0608 5.23324 3.04948 - OK P2956 hESC 1 250.525 247.983 163.895 97.6427 - OK P2956 hESC 0 719.375 726.751 480.32 286.157 - OK P2956 Fibroblasts 1 405.059 337.981 276.3 161.524 - OK P2956 Fibroblasts 0 541.912 644.814 527.137 308.162 - OK P2957 iPS 0 0 0 0 0 - OK P2957 iPS 1 0 0 0 0 - OK P2957 hESC 1 0 0 0 0 - OK P2957 hESC 0 0 0 0 0 - OK P2957 Fibroblasts 1 138.359 115.446 94.3778 76.5179 - OK P2957 Fibroblasts 0 119.571 142.276 116.311 94.3006 - OK P2958 iPS 0 5.20601 5.43386 9.29061 13.3757 - OK P2958 iPS 1 0 0 0 0 - OK P2958 hESC 1 29.0048 28.7104 18.9751 28.8815 - OK P2958 hESC 0 22.249 22.4771 14.8554 22.611 - OK P2958 Fibroblasts 1 114.165 95.2593 77.8747 113.015 - OK P2958 Fibroblasts 0 88.3815 105.164 85.9719 124.765 - OK P2959 iPS 0 0.274124 0.286122 0.489201 0.726484 - OK P2959 iPS 1 0 0 0 0 - OK P2959 hESC 1 0.159912 0.158289 0.104615 0.164544 - OK P2959 hESC 0 1.96468 1.98483 1.3118 2.06326 - OK P2959 Fibroblasts 1 1.11351 0.929115 0.759554 1.1373 - OK P2959 Fibroblasts 0 2.7661 3.29135 2.69069 4.02882 - OK P296 iPS 0 170.69 178.161 304.612 36.7262 - OK P296 iPS 1 220.301 212.243 362.886 43.7521 - OK P296 hESC 1 2008.8 1988.41 1314.17 159.167 - OK P296 hESC 0 1498.17 1513.53 1000.32 121.154 - OK P296 Fibroblasts 1 2166.51 1807.74 1477.83 178.297 - OK P296 Fibroblasts 0 1506.47 1792.53 1465.4 176.796 - OK P2960 iPS 0 0 0 0 0 - OK P2960 iPS 1 0 0 0 0 - OK P2960 hESC 1 11.8416 11.7215 7.74689 12.3494 - OK P2960 hESC 0 29.8539 30.16 19.9332 31.7757 - OK P2960 Fibroblasts 1 21.6997 18.1062 14.8019 22.4483 - OK P2960 Fibroblasts 0 5.24021 6.23526 5.09734 7.73054 - OK P2961 iPS 0 0 0 0 0 - OK P2961 iPS 1 3.85723 3.71614 6.35371 12.4909 - OK P2961 hESC 1 11.3752 11.2597 7.44172 15.7973 - OK P2961 hESC 0 14.5607 14.71 9.72203 20.6379 - OK P2961 Fibroblasts 1 105.077 87.6759 71.6753 142.455 - OK P2961 Fibroblasts 0 41.8924 49.8472 40.7502 80.9911 - OK P2962 iPS 0 2.56821 2.68062 4.58322 11.4436 - OK P2962 iPS 1 9.53232 9.18365 15.7019 40.1034 - OK P2962 hESC 1 8.14984 8.06713 5.33168 14.6913 - OK P2962 hESC 0 0 0 0 0 - OK P2962 Fibroblasts 1 15.3444 12.8033 10.4668 26.4992 - OK P2962 Fibroblasts 0 6.19973 7.37698 6.0307 15.2683 - OK P2963 iPS 0 0 0 0 0 - OK P2963 iPS 1 0 0 0 0 - OK P2963 hESC 1 0 0 0 0 - OK P2963 hESC 0 5.85256 5.91257 3.9077 11.4358 - OK P2963 Fibroblasts 1 0 0 0 0 - OK P2963 Fibroblasts 0 0 0 0 0 - OK P2964 iPS 0 0 0 0 0 - OK P2964 iPS 1 0 0 0 0 - OK P2964 hESC 1 90.4075 89.4899 59.1452 37.8509 - OK P2964 hESC 0 13.5062 13.6447 9.01797 5.77119 - OK P2964 Fibroblasts 1 0 0 0 0 - OK P2964 Fibroblasts 0 0 0 0 0 - OK P2965 iPS 0 0 0 0 0 - OK P2965 iPS 1 0 0 0 0 - OK P2965 hESC 1 0 0 0 0 - OK P2965 hESC 0 0 0 0 0 - OK P2965 Fibroblasts 1 0 0 0 0 - OK P2965 Fibroblasts 0 0 0 0 0 - OK P2966 iPS 0 0 0 0 0 - OK P2966 iPS 1 0 0 0 0 - OK P2966 hESC 1 488.881 483.92 319.829 246.904 - OK P2966 hESC 0 98.897 99.911 66.0326 50.9762 - OK P2966 Fibroblasts 1 210.396 175.554 143.516 108.116 - OK P2966 Fibroblasts 0 349.073 415.358 339.556 255.8 - OK P2967 iPS 0 0 0 0 0 - OK P2967 iPS 1 13.0039 12.5283 21.4204 17.7243 - OK P2967 hESC 1 231.064 228.719 151.164 129.096 - OK P2967 hESC 0 370.563 374.362 247.421 211.301 - OK P2967 Fibroblasts 1 149.158 124.457 101.744 84.5745 - OK P2967 Fibroblasts 0 338.329 402.573 329.105 273.568 - OK P2968 iPS 0 23.3991 24.4232 41.7579 40.4156 - OK P2968 iPS 1 13.7098 13.2083 22.5831 21.8572 - OK P2968 hESC 1 239.531 237.1 156.703 157.392 - OK P2968 hESC 0 334.844 338.278 223.573 224.556 - OK P2968 Fibroblasts 1 178.778 149.173 121.949 118.663 - OK P2968 Fibroblasts 0 496.144 590.356 482.618 469.614 - OK P2969 iPS 0 0 0 0 0 - OK P2969 iPS 1 6.42392 6.18895 10.5816 9.29978 - OK P2969 hESC 1 218.266 216.051 142.791 129.781 - OK P2969 hESC 0 166.04 167.743 110.864 100.762 - OK P2969 Fibroblasts 1 51.4805 42.9553 35.1161 31.0126 - OK P2969 Fibroblasts 0 11.8055 14.0472 11.4837 10.1417 - OK P297 iPS 0 0 0 0 0 - OK P297 iPS 1 0 0 0 0 - OK P297 hESC 1 0 0 0 0 - OK P297 hESC 0 0 0 0 0 - OK P297 Fibroblasts 1 0 0 0 0 - OK P297 Fibroblasts 0 0 0 0 0 - OK P2970 iPS 0 12.7983 13.3585 22.8398 14.1421 - OK P2970 iPS 1 11.4524 11.0335 18.8647 11.6808 - OK P2970 hESC 1 0 0 0 0 - OK P2970 hESC 0 0 0 0 0 - OK P2970 Fibroblasts 1 0 0 0 0 - OK P2970 Fibroblasts 0 0.119056 0.141664 0.11581 0.0719544 - OK P2971 iPS 0 0 0 0 0 - OK P2971 iPS 1 0 0 0 0 - OK P2971 hESC 1 0 0 0 0 - OK P2971 hESC 0 0 0 0 0 - OK P2971 Fibroblasts 1 0 0 0 0 - OK P2971 Fibroblasts 0 0 0 0 0 - OK P2972 iPS 0 22.96 23.9649 40.9743 24.8594 - OK P2972 iPS 1 22.2147 21.4022 36.5926 22.201 - OK P2972 hESC 1 274.047 271.266 179.284 111.311 - OK P2972 hESC 0 261.255 263.934 174.438 108.302 - OK P2972 Fibroblasts 1 421.219 351.465 287.324 174.907 - OK P2972 Fibroblasts 0 316.23 376.278 307.608 187.255 - OK P2973 iPS 0 0 0 0 0 - OK P2973 iPS 1 0 0 0 0 - OK P2973 hESC 1 0 0 0 0 - OK P2973 hESC 0 0 0 0 0 - OK P2973 Fibroblasts 1 0 0 0 0 - OK P2973 Fibroblasts 0 0 0 0 0 - OK P2974 iPS 0 57.3033 59.8113 102.263 114.576 - OK P2974 iPS 1 42.8468 41.2796 70.5783 79.0766 - OK P2974 hESC 1 343.996 340.505 225.044 263.228 - OK P2974 hESC 0 382.236 386.155 255.216 298.518 - OK P2974 Fibroblasts 1 619.586 516.983 422.635 476.471 - OK P2974 Fibroblasts 0 336.683 400.615 327.504 369.223 - OK P2975 iPS 0 69.5144 72.5568 124.055 88.5589 - OK P2975 iPS 1 82.2082 79.2012 135.415 96.6688 - OK P2975 hESC 1 261.59 258.935 171.134 125.536 - OK P2975 hESC 0 273.116 275.916 182.357 133.768 - OK P2975 Fibroblasts 1 284.035 236.999 193.747 138.858 - OK P2975 Fibroblasts 0 121.805 144.934 118.484 84.9166 - OK P2976 iPS 0 57.0396 59.536 101.792 28.9515 - OK P2976 iPS 1 216.467 208.55 356.57 101.415 - OK P2976 hESC 1 928.282 918.86 607.288 174.59 - OK P2976 hESC 0 1445 1459.81 964.81 277.374 - OK P2976 Fibroblasts 1 756.72 631.407 516.177 147.04 - OK P2976 Fibroblasts 0 1574.18 1873.09 1531.26 436.201 - OK P2977 iPS 0 14.6301 15.2705 26.1089 17.4908 - OK P2977 iPS 1 22.979 22.1385 37.8515 25.3574 - OK P2977 hESC 1 76.2565 75.4826 49.8875 34.2839 - OK P2977 hESC 0 90.1585 91.0829 60.198 41.3696 - OK P2977 Fibroblasts 1 56.7995 47.3935 38.7443 26.0519 - OK P2977 Fibroblasts 0 37.8149 44.9955 36.7839 24.7337 - OK P2978 iPS 0 17.391 18.1522 31.0359 41.2793 - OK P2978 iPS 1 23.2414 22.3912 38.2837 50.9193 - OK P2978 hESC 1 120.065 118.847 78.5474 109.97 - OK P2978 hESC 0 151.857 153.414 101.393 141.955 - OK P2978 Fibroblasts 1 472.23 394.028 322.119 431.605 - OK P2978 Fibroblasts 0 235.572 280.304 229.15 307.035 - OK P2979 iPS 0 266.963 278.647 476.42 111.917 - OK P2979 iPS 1 203.568 196.122 335.323 80.0158 - OK P2979 hESC 1 2325.63 2302.02 1521.44 370.915 - OK P2979 hESC 0 2119.67 2141.4 1415.28 342.937 - OK P2979 Fibroblasts 1 1923.19 1604.71 1311.85 320.529 - OK P2979 Fibroblasts 0 2745.7 3267.08 2670.84 644.139 - OK P298 iPS 0 0 0 0 0 - OK P298 iPS 1 1.13975 1.09806 1.87742 2.85703 - OK P298 hESC 1 0 0 0 0 - OK P298 hESC 0 6.45269 6.51885 4.3084 6.95428 - OK P298 Fibroblasts 1 0 0 0 0 - OK P298 Fibroblasts 0 0 0 0 0 - OK P2980 iPS 0 13.9941 14.6066 24.9737 17.0782 - OK P2980 iPS 1 20.8555 20.0927 34.3537 23.4926 - OK P2980 hESC 1 40.685 40.2721 26.6164 18.6817 - OK P2980 hESC 0 27.1366 27.4148 18.1188 12.7174 - OK P2980 Fibroblasts 1 7.0856 5.91222 4.83326 3.31772 - OK P2980 Fibroblasts 0 18.5825 22.111 18.0758 12.4079 - OK P2981 iPS 0 27.5645 28.7709 49.1913 55.0708 - OK P2981 iPS 1 31.877 30.7111 52.5086 58.7846 - OK P2981 hESC 1 288.396 285.469 188.67 220.5 - OK P2981 hESC 0 277.066 279.907 184.995 216.204 - OK P2981 Fibroblasts 1 72.2432 60.2797 49.2788 55.5119 - OK P2981 Fibroblasts 0 26.9589 32.078 26.2239 29.5408 - OK P2982 iPS 0 76.0915 79.4218 135.792 55.2204 - OK P2982 iPS 1 56.0422 53.9924 92.3141 37.5398 - OK P2982 hESC 1 332.249 328.877 217.359 89.762 - OK P2982 hESC 0 342.775 346.29 228.868 94.5147 - OK P2982 Fibroblasts 1 6.11291 5.10061 4.16976 1.69946 - OK P2982 Fibroblasts 0 8.82647 10.5025 8.58583 3.49931 - OK P2983 iPS 0 14.0896 14.7063 25.1443 12.4645 - OK P2983 iPS 1 8.7504 8.43033 14.4139 7.14525 - OK P2983 hESC 1 11.913 11.792 7.79354 3.93678 - OK P2983 hESC 0 66.4 67.0808 44.3346 22.3949 - OK P2983 Fibroblasts 1 13.3676 11.1539 9.11837 4.53257 - OK P2983 Fibroblasts 0 0 0 0 0 - OK P2984 iPS 0 436.754 455.87 779.429 360.726 - OK P2984 iPS 1 493.33 475.285 812.625 377.442 - OK P2984 hESC 1 2536.44 2510.7 1659.36 789.42 - OK P2984 hESC 0 2879.26 2908.78 1922.45 912.12 - OK P2984 Fibroblasts 1 3513.28 2931.48 2396.49 1127.31 - OK P2984 Fibroblasts 0 2821.71 3357.52 2744.78 1271.87 - OK P2985 iPS 0 5762.82 6015.04 10284.3 4915.54 - OK P2985 iPS 1 4569.69 4402.54 7527.29 3597.79 - OK P2985 hESC 1 15988.8 15826.5 10460 5090.99 - OK P2985 hESC 0 14323.7 14470.5 9563.79 4654.8 - OK P2985 Fibroblasts 1 52386.5 43711.3 35734.1 17124.9 - OK P2985 Fibroblasts 0 34492.5 41042.2 33552.1 16079.2 - OK P2986 iPS 0 14.1799 14.8005 25.3054 12.7227 - OK P2986 iPS 1 17.3141 16.6808 28.5202 14.3391 - OK P2986 hESC 1 18.1848 18.0003 11.8966 6.09647 - OK P2986 hESC 0 9.32753 9.42317 6.22791 3.19151 - OK P2986 Fibroblasts 1 14.8101 12.3576 10.1023 5.09328 - OK P2986 Fibroblasts 0 28.696 34.145 27.9136 14.0732 - OK P2987 iPS 0 12.8895 13.4536 23.0025 41.1599 - OK P2987 iPS 1 0 0 0 0 - OK P2987 hESC 1 78.7182 77.9192 51.4979 98.7936 - OK P2987 hESC 0 54.9763 55.54 36.7072 70.419 - OK P2987 Fibroblasts 1 20 16.688 13.6425 24.6549 - OK P2987 Fibroblasts 0 12 14.2787 11.6728 21.0954 - OK P2988 iPS 0 25.1105 26.2095 44.812 66.6878 - OK P2988 iPS 1 38 36.6101 62.5945 93.1511 - OK P2988 hESC 1 210.282 208.148 137.568 216.855 - OK P2988 hESC 0 210.024 212.177 140.231 221.053 - OK P2988 Fibroblasts 1 0 0 0 0 - OK P2988 Fibroblasts 0 0 0 0 0 - OK P2989 iPS 0 0 0 0 0 - OK P2989 iPS 1 0 0 0 0 - OK P2989 hESC 1 7 6.92896 4.57945 2.95009 - OK P2989 hESC 0 7 7.07177 4.67384 3.21215 - OK P2989 Fibroblasts 1 0 0 0 0 - OK P2989 Fibroblasts 0 0 0 0 0 - OK P299 iPS 0 0 0 0 0 - OK P299 iPS 1 0 0 0 0 - OK P299 hESC 1 35.6546 35.2928 23.3255 14.2752 - OK P299 hESC 0 10.9562 11.0686 7.31538 4.47702 - OK P299 Fibroblasts 1 0 0 0 0 - OK P299 Fibroblasts 0 0 0 0 0 - OK P2990 iPS 0 1 1.04377 1.78459 1.17688 - OK P2990 iPS 1 0 0 0 0 - OK P2990 hESC 1 0 0 0 0 - OK P2990 hESC 0 0.000216592 0.000218813 0.000144617 0.000106305 - OK P2990 Fibroblasts 1 0 0 0 0 - OK P2990 Fibroblasts 0 0 0 0 0 - OK P2991 iPS 0 0.000563651 0.000588321 0.00100589 0.000591751 - OK P2991 iPS 1 1 0.963422 1.64722 0.96904 - OK P2991 hESC 1 0.00028917 0.000286235 0.000189177 0.000113807 - OK P2991 hESC 0 0 0 0 0 - OK P2991 Fibroblasts 1 0 0 0 0 - OK P2991 Fibroblasts 0 0 0 0 0 - OK P2992 iPS 0 1.99944 2.08695 3.56818 1.11114 - OK P2992 iPS 1 0 0 0 0 - OK P2992 hESC 1 3.99971 3.95912 2.61664 0.824479 - OK P2992 hESC 0 4.99978 5.05105 3.33831 1.05187 - OK P2992 Fibroblasts 1 0 0 0 0 - OK P2992 Fibroblasts 0 0 0 0 0 - OK P2993 iPS 0 0 0 0 0 - OK P2993 iPS 1 11.4567 11.0377 18.8718 24.5918 - OK P2993 hESC 1 53.3133 52.7722 34.8779 47.7902 - OK P2993 hESC 0 23.713 23.9562 15.833 21.6946 - OK P2993 Fibroblasts 1 26.7216 22.2965 18.2274 23.9242 - OK P2993 Fibroblasts 0 23.3972 27.84 22.7593 29.8724 - OK P2994 iPS 0 5.48239 5.72233 9.78383 6.59497 - OK P2994 iPS 1 7.0498 6.79193 11.6126 7.82769 - OK P2994 hESC 1 66.7793 66.1015 43.6874 30.2139 - OK P2994 hESC 0 46.9877 47.4695 31.3733 21.6975 - OK P2994 Fibroblasts 1 147.776 123.305 100.802 68.2012 - OK P2994 Fibroblasts 0 131.727 156.74 128.136 86.695 - OK P2995 iPS 0 112.905 117.847 201.49 508.474 - OK P2995 iPS 1 54.7279 52.7261 90.1491 227.498 - OK P2995 hESC 1 1090.48 1079.41 713.4 1989 - OK P2995 hESC 0 966.267 976.175 645.168 1798.76 - OK P2995 Fibroblasts 1 1213.06 1012.18 827.458 2117.66 - OK P2995 Fibroblasts 0 1175.61 1398.84 1143.55 2926.63 - OK P2996 iPS 0 4.80232 5.01251 8.57019 8.8974 - OK P2996 iPS 1 3.56593 3.43549 5.87388 6.09814 - OK P2996 hESC 1 12.066 11.9436 7.89369 8.52786 - OK P2996 hESC 0 7.41634 7.49238 4.95182 5.34965 - OK P2996 Fibroblasts 1 27.5876 23.0191 18.8182 19.6493 - OK P2996 Fibroblasts 0 17.6416 20.9916 17.1607 17.9186 - OK P2997 iPS 0 20.5375 21.4364 36.6511 44.0284 - OK P2997 iPS 1 19.2578 18.5534 31.7219 38.107 - OK P2997 hESC 1 24.451 24.2028 15.996 20.1245 - OK P2997 hESC 0 75.6997 76.4759 50.544 63.5892 - OK P2997 Fibroblasts 1 69.0549 57.6194 47.104 56.9632 - OK P2997 Fibroblasts 0 58.8329 70.0046 57.2289 69.2073 - OK P2998 iPS 0 1.66018 1.73285 2.96276 2.52692 - OK P2998 iPS 1 0 0 0 0 - OK P2998 hESC 1 6.57566 6.50892 4.30184 3.79054 - OK P2998 hESC 0 0 0 0 0 - OK P2998 Fibroblasts 1 0 0 0 0 - OK P2998 Fibroblasts 0 0 0 0 0 - OK P2999 iPS 0 0 0 0 0 - OK P2999 iPS 1 6.17628 5.95037 10.1737 9.7665 - OK P2999 hESC 1 143.407 141.952 93.818 93.4345 - OK P2999 hESC 0 49.884 50.3954 33.3071 33.1709 - OK P2999 Fibroblasts 1 29.3574 24.4958 20.0254 19.3263 - OK P2999 Fibroblasts 0 20.5254 24.4229 19.9658 19.2688 - OK P3 iPS 0 350.802 366.156 626.039 278.008 - OK P3 iPS 1 311.869 300.462 513.718 250.994 - OK P3 hESC 1 2535.68 2509.95 1658.86 721.78 - OK P3 hESC 0 2455.07 2480.24 1639.23 687.554 - OK P3 Fibroblasts 1 70.2182 58.5901 47.8975 26.3147 - OK P3 Fibroblasts 0 91.4005 108.756 88.9086 42.5435 - OK P30 iPS 0 74.9964 78.2788 133.838 120.316 - OK P30 iPS 1 44.0372 42.4264 72.539 65.2102 - OK P30 hESC 1 418.288 414.043 273.647 254.603 - OK P30 hESC 0 765.318 773.165 510.996 475.434 - OK P30 Fibroblasts 1 277.299 231.379 189.153 170.89 - OK P30 Fibroblasts 0 199.71 237.633 194.266 175.51 - OK P300 iPS 0 0 0 0 0 - OK P300 iPS 1 0 0 0 0 - OK P300 hESC 1 0 0 0 0 - OK P300 hESC 0 0 0 0 0 - OK P300 Fibroblasts 1 0 0 0 0 - OK P300 Fibroblasts 0 0 0 0 0 - OK P3000 iPS 0 0 0 0 0 - OK P3000 iPS 1 0 0 0 0 - OK P3000 hESC 1 18.0513 17.8681 11.8093 9.02304 - OK P3000 hESC 0 19.9981 20.2031 13.3525 10.2022 - OK P3000 Fibroblasts 1 28.5231 23.7996 19.4563 14.5103 - OK P3000 Fibroblasts 0 41.89 49.8444 40.748 30.3894 - OK P3001 iPS 0 237.448 247.841 423.749 324.969 - OK P3001 iPS 1 199.411 192.117 328.474 251.904 - OK P3001 hESC 1 852.987 844.329 558.029 440.65 - OK P3001 hESC 0 909.606 918.933 607.336 479.585 - OK P3001 Fibroblasts 1 1444.33 1205.15 985.214 758.764 - OK P3001 Fibroblasts 0 1355.39 1612.76 1318.43 1015.4 - OK P3002 iPS 0 186 194.141 331.934 189.749 - OK P3002 iPS 1 168 161.855 276.734 158.193 - OK P3002 hESC 1 993 982.922 649.627 379.511 - OK P3002 hESC 0 905 914.279 604.26 353.008 - OK P3002 Fibroblasts 1 1064 887.801 725.78 416.203 - OK P3002 Fibroblasts 0 1040 1237.48 1011.65 580.134 - OK P3003 iPS 0 0 0 0 0 - OK P3003 iPS 1 0 0 0 0 - OK P3003 hESC 1 0 0 0 0 - OK P3003 hESC 0 0 0 0 0 - OK P3003 Fibroblasts 1 0 0 0 0 - OK P3003 Fibroblasts 0 0 0 0 0 - OK P3004 iPS 0 2 2.08753 3.56919 4.43838 - OK P3004 iPS 1 4 3.85369 6.58889 8.19347 - OK P3004 hESC 1 3 2.96955 1.96262 2.56025 - OK P3004 hESC 0 4 4.04101 2.67076 3.48402 - OK P3004 Fibroblasts 1 0 0 0 0 - OK P3004 Fibroblasts 0 0 0 0 0 - OK P3005 iPS 0 0 0 0 0 - OK P3005 iPS 1 1.03182 0.994078 1.69964 0.879212 - OK P3005 hESC 1 41.9443 41.5186 27.4402 14.4761 - OK P3005 hESC 0 32.3442 32.6758 21.5959 11.393 - OK P3005 Fibroblasts 1 14.3432 11.968 9.78387 5.07563 - OK P3005 Fibroblasts 0 0 0 0 0 - OK P3006 iPS 0 0 0 0 0 - OK P3006 iPS 1 0 0 0 0 - OK P3006 hESC 1 0 0 0 0 - OK P3006 hESC 0 0 0 0 0 - OK P3006 Fibroblasts 1 7 5.8408 4.77487 15.1876 - OK P3006 Fibroblasts 0 1 1.18989 0.972736 3.09402 - OK P3007 iPS 0 335.942 350.645 599.52 134.515 - OK P3007 iPS 1 0 0 0 0 - OK P3007 hESC 1 301.021 297.966 196.93 44.5614 - OK P3007 hESC 0 261.833 264.517 174.823 39.559 - OK P3007 Fibroblasts 1 932.526 778.099 636.098 142.899 - OK P3007 Fibroblasts 0 186.661 222.105 181.572 40.79 - OK P3008 iPS 0 189.058 197.332 337.391 65.6972 - OK P3008 iPS 1 80 77.0738 131.778 25.6599 - OK P3008 hESC 1 1455.98 1441.2 952.511 186.841 - OK P3008 hESC 0 1300.67 1314 868.444 170.351 - OK P3008 Fibroblasts 1 546.474 455.978 372.763 72.663 - OK P3008 Fibroblasts 0 301.839 359.155 293.61 57.2336 - OK P3009 iPS 0 140.95 147.119 251.539 232.478 - OK P3009 iPS 1 79.2816 76.3817 130.595 120.699 - OK P3009 hESC 1 453.906 449.299 296.948 284.324 - OK P3009 hESC 0 573.054 578.929 382.623 366.357 - OK P3009 Fibroblasts 1 531.399 443.399 362.48 336.731 - OK P3009 Fibroblasts 0 510.852 607.857 496.924 461.625 - OK P301 iPS 0 3.50019 3.65338 6.24642 3.94718 - OK P301 iPS 1 0 0 0 0 - OK P301 hESC 1 26.1685 25.9029 17.1196 11.0813 - OK P301 hESC 0 24.9246 25.1801 16.6419 10.7721 - OK P301 Fibroblasts 1 0 0 0 0 - OK P301 Fibroblasts 0 0.999999 1.18989 0.972735 0.616835 - OK P3010 iPS 0 38.6068 40.2965 68.8974 52.019 - OK P3010 iPS 1 59.7459 57.5605 98.4149 74.3052 - OK P3010 hESC 1 392.063 388.084 256.49 199.312 - OK P3010 hESC 0 415.468 419.728 277.404 215.564 - OK P3010 Fibroblasts 1 143.645 119.857 97.9835 74.2892 - OK P3010 Fibroblasts 0 164.911 196.226 160.415 121.624 - OK P3011 iPS 0 46.4427 48.4754 82.8814 21.0996 - OK P3011 iPS 1 58.9725 56.8154 97.1408 24.7297 - OK P3011 hESC 1 464.031 459.322 303.572 78.0288 - OK P3011 hESC 0 420.978 425.295 281.083 72.2483 - OK P3011 Fibroblasts 1 111.957 93.4166 76.3684 19.4689 - OK P3011 Fibroblasts 0 72.2369 85.9538 70.2675 17.9136 - OK P3012 iPS 0 468 488.483 835.19 190.905 - OK P3012 iPS 1 562 541.443 925.74 211.603 - OK P3012 hESC 1 2740.07 2712.26 1792.57 413.292 - OK P3012 hESC 0 2830.53 2859.56 1889.92 435.737 - OK P3012 Fibroblasts 1 1274.08 1063.09 869.081 198.903 - OK P3012 Fibroblasts 0 1116.83 1328.91 1086.38 248.636 - OK P3013 iPS 0 851 888.246 1518.69 866.052 - OK P3013 iPS 1 918 884.422 1512.15 862.324 - OK P3013 hESC 1 3442 3407.07 2251.78 1312.24 - OK P3013 hESC 0 3632 3669.24 2425.05 1413.21 - OK P3013 Fibroblasts 1 3434 2865.33 2342.41 1340.01 - OK P3013 Fibroblasts 0 2628 3127.02 2556.35 1462.4 - OK P3014 iPS 0 88.37 92.2377 157.705 109.325 - OK P3014 iPS 1 98.7766 95.1636 162.707 112.793 - OK P3014 hESC 1 90.8101 89.8885 59.4086 42.2856 - OK P3014 hESC 0 133.572 134.941 89.1848 63.4796 - OK P3014 Fibroblasts 1 522.395 435.886 356.338 247.973 - OK P3014 Fibroblasts 0 154.904 184.318 150.681 104.858 - OK P3015 iPS 0 44.4106 46.3543 79.2548 17.8221 - OK P3015 iPS 1 33.3941 32.1726 55.0076 12.3696 - OK P3015 hESC 1 267.326 264.613 174.886 39.6621 - OK P3015 hESC 0 132.339 133.695 88.3613 20.0393 - OK P3015 Fibroblasts 1 608.537 507.763 415.097 93.4593 - OK P3015 Fibroblasts 0 349.963 416.417 340.422 76.646 - OK P3016 iPS 0 286.769 299.32 511.766 485.029 - OK P3016 iPS 1 290.843 280.205 479.084 454.054 - OK P3016 hESC 1 880.514 871.577 576.038 566.111 - OK P3016 hESC 0 815.858 824.223 544.741 535.353 - OK P3016 Fibroblasts 1 1979.18 1651.43 1350.04 1286.24 - OK P3016 Fibroblasts 0 1123.48 1336.81 1092.85 1041.2 - OK P3017 iPS 0 12.225 12.76 21.8166 7.34337 - OK P3017 iPS 1 31.5486 30.3946 51.9676 17.4921 - OK P3017 hESC 1 146.191 144.708 95.6394 32.6044 - OK P3017 hESC 0 146.592 148.095 97.8783 33.3677 - OK P3017 Fibroblasts 1 35.9814 30.0229 24.5438 8.27673 - OK P3017 Fibroblasts 0 28.0237 33.3451 27.2597 9.1926 - OK P3018 iPS 0 49.2302 51.3848 87.8558 25.7061 - OK P3018 iPS 1 103.108 99.3361 169.841 49.6945 - OK P3018 hESC 1 700.538 693.428 458.297 135.586 - OK P3018 hESC 0 745.457 753.1 497.735 147.254 - OK P3018 Fibroblasts 1 463.361 386.628 316.07 92.6298 - OK P3018 Fibroblasts 0 365.644 435.075 355.675 104.237 - OK P3019 iPS 0 29.6942 30.9939 52.9921 7.90844 - OK P3019 iPS 1 22.7733 21.9403 37.5126 5.59831 - OK P3019 hESC 1 168.426 166.716 110.185 16.5366 - OK P3019 hESC 0 108.905 110.022 72.715 10.9131 - OK P3019 Fibroblasts 1 2.86014 2.3865 1.95097 0.291399 - OK P3019 Fibroblasts 0 4.95861 5.90019 4.82342 0.720431 - OK P302 iPS 0 0 0 0 0 - OK P302 iPS 1 2.3248 2.23976 3.82946 7.36468 - OK P302 hESC 1 9.26048 9.16649 6.05827 12.5589 - OK P302 hESC 0 0 0 0 0 - OK P302 Fibroblasts 1 0 0 0 0 - OK P302 Fibroblasts 0 0 0 0 0 - OK P3020 iPS 0 0 0 0 0 - OK P3020 iPS 1 0 0 0 0 - OK P3020 hESC 1 25.0147 24.7608 16.3648 3.78105 - OK P3020 hESC 0 21.6419 21.8638 14.4501 3.33866 - OK P3020 Fibroblasts 1 20.1399 16.8047 13.7379 3.15076 - OK P3020 Fibroblasts 0 7.73821 9.2076 7.52724 1.72636 - OK P3021 iPS 0 1685.86 1759.64 3008.57 2220.57 - OK P3021 iPS 1 1796.63 1730.91 2959.45 2184.31 - OK P3021 hESC 1 8262.62 8178.76 5405.46 4103.51 - OK P3021 hESC 0 9006.28 9098.63 6013.41 4565.03 - OK P3021 Fibroblasts 1 17739.8 14802.1 12100.8 8967.88 - OK P3021 Fibroblasts 0 8060.11 9590.62 7840.36 5810.49 - OK P3022 iPS 0 146.143 152.539 260.805 194.218 - OK P3022 iPS 1 193.372 186.299 318.526 237.202 - OK P3022 hESC 1 348.384 344.848 227.915 174.613 - OK P3022 hESC 0 105.718 106.802 70.5872 54.0791 - OK P3022 Fibroblasts 1 3538.66 2952.66 2413.81 1804.95 - OK P3022 Fibroblasts 0 4093.73 4871.07 3982.11 2977.67 - OK P3023 iPS 0 2272.3 2371.75 4055.13 1234.78 - OK P3023 iPS 1 2455.14 2365.34 4044.16 1231.44 - OK P3023 hESC 1 5785.9 5727.18 3785.17 1165.92 - OK P3023 hESC 0 6058.78 6120.91 4045.4 1246.08 - OK P3023 Fibroblasts 1 11436.7 9542.77 7801.24 2379.46 - OK P3023 Fibroblasts 0 7575 9013.4 7368.48 2247.47 - OK P3024 iPS 0 454.701 474.602 811.457 241.524 - OK P3024 iPS 1 498.862 480.615 821.737 244.584 - OK P3024 hESC 1 580.099 574.212 379.505 114.235 - OK P3024 hESC 0 796.214 804.378 531.625 160.025 - OK P3024 Fibroblasts 1 1368.75 1142.08 933.657 278.354 - OK P3024 Fibroblasts 0 1005.99 1197.02 978.565 291.742 - OK P3025 iPS 0 43.987 45.9122 78.4989 45.0556 - OK P3025 iPS 1 32.0621 30.8893 52.8134 30.3131 - OK P3025 hESC 1 278.358 275.533 182.104 106.826 - OK P3025 hESC 0 230.512 232.876 153.911 90.2876 - OK P3025 Fibroblasts 1 410.974 342.916 280.335 161.414 - OK P3025 Fibroblasts 0 665.989 792.452 647.832 373.015 - OK P3026 iPS 0 91.013 94.9963 162.421 90.3642 - OK P3026 iPS 1 74.9379 72.1969 123.439 68.6764 - OK P3026 hESC 1 533.642 528.226 349.112 198.38 - OK P3026 hESC 0 412.488 416.717 275.414 156.502 - OK P3026 Fibroblasts 1 822.026 685.898 560.724 312.924 - OK P3026 Fibroblasts 0 1253.01 1490.94 1218.85 680.205 - OK P3027 iPS 0 103.136 107.65 184.056 159.091 - OK P3027 iPS 1 76.8536 74.0425 126.595 109.424 - OK P3027 hESC 1 702.031 694.906 459.273 410.309 - OK P3027 hESC 0 1702.22 1719.67 1136.56 1015.39 - OK P3027 Fibroblasts 1 49.691 41.4621 33.8954 29.4384 - OK P3027 Fibroblasts 0 146.878 174.768 142.874 124.087 - OK P3028 iPS 0 0.00569922 0.00594866 0.0101708 0.0114045 - OK P3028 iPS 1 0.00634237 0.00611038 0.0104473 0.0117145 - OK P3028 hESC 1 0 0 0 0 - OK P3028 hESC 0 0 0 0 0 - OK P3028 Fibroblasts 1 26.3826 22.0136 17.9962 20.3048 - OK P3028 Fibroblasts 0 55.1981 65.6795 53.6932 60.5811 - OK P3029 iPS 0 174.021 181.637 310.556 389.956 - OK P3029 iPS 1 257.062 247.66 423.439 531.699 - OK P3029 hESC 1 1906.97 1887.61 1247.55 1644.11 - OK P3029 hESC 0 1020.03 1030.49 681.068 897.561 - OK P3029 Fibroblasts 1 1039.27 867.17 708.914 896.376 - OK P3029 Fibroblasts 0 299.251 356.075 291.092 368.067 - OK P303 iPS 0 5.33666 5.57023 9.52378 5.69027 - OK P303 iPS 1 7.1705 6.90822 11.8114 7.0571 - OK P303 hESC 1 19.0515 18.8581 12.4636 7.61786 - OK P303 hESC 0 3.10907 3.14095 2.0759 1.26881 - OK P303 Fibroblasts 1 0 0 0 0 - OK P303 Fibroblasts 0 0 0 0 0 - OK P3030 iPS 0 75.1316 78.4199 134.079 130.215 - OK P3030 iPS 1 76.0136 73.2332 125.211 121.603 - OK P3030 hESC 1 110.669 109.546 72.4003 72.9778 - OK P3030 hESC 0 175.149 176.944 116.945 117.878 - OK P3030 Fibroblasts 1 82.6222 68.94 56.3586 55.0294 - OK P3030 Fibroblasts 0 175.932 209.34 171.136 167.1 - OK P3031 iPS 0 118.206 123.379 210.949 239.575 - OK P3031 iPS 1 124.064 119.526 204.361 232.093 - OK P3031 hESC 1 969.031 959.196 633.946 752.081 - OK P3031 hESC 0 2082.37 2103.72 1390.38 1649.47 - OK P3031 Fibroblasts 1 1460.89 1218.97 996.511 1138.88 - OK P3031 Fibroblasts 0 3943.33 4692.12 3835.82 4383.84 - OK P3032 iPS 0 9 9.3939 16.0613 5.55285 - OK P3032 iPS 1 11 10.5976 18.1195 6.2644 - OK P3032 hESC 1 25 24.7463 16.3552 5.72889 - OK P3032 hESC 0 31 31.3179 20.6984 7.25024 - OK P3032 Fibroblasts 1 2 1.6688 1.36425 0.47256 - OK P3032 Fibroblasts 0 7 8.32921 6.80915 2.35862 - OK P3033 iPS 0 0 0 0 0 - OK P3033 iPS 1 0 0 0 0 - OK P3033 hESC 1 5 4.94925 3.27103 3.85589 - OK P3033 hESC 0 0 0 0 0 - OK P3033 Fibroblasts 1 1 0.8344 0.682124 0.804087 - OK P3033 Fibroblasts 0 0 0 0 0 - OK P3034 iPS 0 0 0 0 0 - OK P3034 iPS 1 0 0 0 0 - OK P3034 hESC 1 0 0 0 0 - OK P3034 hESC 0 0 0 0 0 - OK P3034 Fibroblasts 1 0 0 0 0 - OK P3034 Fibroblasts 0 0 0 0 0 - OK P3035 iPS 0 28.4645 29.7103 50.7975 15.6429 - OK P3035 iPS 1 0 0 0 0 - OK P3035 hESC 1 230.114 227.779 150.542 46.9017 - OK P3035 hESC 0 285.068 287.991 190.337 59.2999 - OK P3035 Fibroblasts 1 57.9464 48.3504 39.5266 12.1928 - OK P3035 Fibroblasts 0 69.4901 82.6854 67.5955 20.8512 - OK P3036 iPS 0 0.0254435 0.0265571 0.0454063 0.013916 - OK P3036 iPS 1 0 0 0 0 - OK P3036 hESC 1 0.0441982 0.0437497 0.0289148 0.00896501 - OK P3036 hESC 0 66.6777 67.3614 44.5201 13.8034 - OK P3036 Fibroblasts 1 0.0513583 0.0428534 0.0350327 0.0107549 - OK P3036 Fibroblasts 0 0.0287989 0.0342674 0.0280137 0.00860012 - OK P3037 iPS 0 9.8951 10.3282 17.6587 5.72849 - OK P3037 iPS 1 0 0 0 0 - OK P3037 hESC 1 37.0334 36.6575 24.2275 7.95641 - OK P3037 hESC 0 26.6604 26.9337 17.8009 5.84589 - OK P3037 Fibroblasts 1 0 0 0 0 - OK P3037 Fibroblasts 0 8.42733 10.0276 8.19757 2.66406 - OK P3038 iPS 0 0.0242793 0.0253419 0.0433287 0.0121283 - OK P3038 iPS 1 43.7443 42.1442 72.0566 20.1697 - OK P3038 hESC 1 0 0 0 0 - OK P3038 hESC 0 0 0 0 0 - OK P3038 Fibroblasts 1 32.754 27.3299 22.3423 6.2636 - OK P3038 Fibroblasts 0 0 0 0 0 - OK P3039 iPS 0 19.8868 20.7572 35.4899 36.3645 - OK P3039 iPS 1 14.8732 14.3292 24.4995 25.1033 - OK P3039 hESC 1 134.349 132.986 87.8923 93.6659 - OK P3039 hESC 0 94.3768 95.3445 63.0145 67.1539 - OK P3039 Fibroblasts 1 0 0 0 0 - OK P3039 Fibroblasts 0 20.4554 24.3396 19.8977 20.504 - OK P304 iPS 0 4.662 4.86605 8.31978 6.00285 - OK P304 iPS 1 15.3296 14.7689 25.2512 18.2192 - OK P304 hESC 1 132.114 130.773 86.4298 64.0989 - OK P304 hESC 0 85.2244 86.0982 56.9035 42.2014 - OK P304 Fibroblasts 1 3.00124 2.50423 2.04722 1.48301 - OK P304 Fibroblasts 0 3 3.56966 2.91821 2.11396 - OK P3040 iPS 0 8.38116 8.74798 14.957 29.121 - OK P3040 iPS 1 4.57204 4.4048 7.53117 14.6631 - OK P3040 hESC 1 116.528 115.346 76.2337 160.147 - OK P3040 hESC 0 60.2496 60.8674 40.2281 84.5086 - OK P3040 Fibroblasts 1 3.51306 2.93129 2.39634 4.71635 - OK P3040 Fibroblasts 0 7.23174 8.60496 7.03458 13.8451 - OK P3041 iPS 0 0 0 0 0 - OK P3041 iPS 1 0 0 0 0 - OK P3041 hESC 1 0 0 0 0 - OK P3041 hESC 0 0 0 0 0 - OK P3041 Fibroblasts 1 0 0 0 0 - OK P3041 Fibroblasts 0 0 0 0 0 - OK P3042 iPS 0 0 0 0 0 - OK P3042 iPS 1 0 0 0 0 - OK P3042 hESC 1 55.2071 54.6468 36.1169 60.4348 - OK P3042 hESC 0 0 0 0 0 - OK P3042 Fibroblasts 1 1.98095 1.6529 1.35125 2.14592 - OK P3042 Fibroblasts 0 0.401821 0.478122 0.390866 0.620732 - OK P3043 iPS 0 0 0 0 0 - OK P3043 iPS 1 0 0 0 0 - OK P3043 hESC 1 0 0 0 0 - OK P3043 hESC 0 0 0 0 0 - OK P3043 Fibroblasts 1 0 0 0 0 - OK P3043 Fibroblasts 0 0 0 0 0 - OK P3044 iPS 0 0 0 0 0 - OK P3044 iPS 1 0 0 0 0 - OK P3044 hESC 1 14.1316 13.9881 9.24496 9.20069 - OK P3044 hESC 0 17.1476 17.3234 11.4493 11.3945 - OK P3044 Fibroblasts 1 0 0 0 0 - OK P3044 Fibroblasts 0 0 0 0 0 - OK P3045 iPS 0 0 0 0 0 - OK P3045 iPS 1 0 0 0 0 - OK P3045 hESC 1 0 0 0 0 - OK P3045 hESC 0 0 0 0 0 - OK P3045 Fibroblasts 1 3.17465 2.64893 2.16551 2.3478 - OK P3045 Fibroblasts 0 0 0 0 0 - OK P3046 iPS 0 12.7404 13.298 22.7364 22.2184 - OK P3046 iPS 1 15.428 14.8637 25.4134 24.8344 - OK P3046 hESC 1 224.092 221.818 146.603 148.726 - OK P3046 hESC 0 249.248 251.803 166.42 168.831 - OK P3046 Fibroblasts 1 3.33138 2.7797 2.27242 2.23269 - OK P3046 Fibroblasts 0 0 0 0 0 - OK P3047 iPS 0 0 0 0 0 - OK P3047 iPS 1 56.005 53.9564 92.2527 28.6332 - OK P3047 hESC 1 372.156 368.379 243.467 76.4587 - OK P3047 hESC 0 226.295 228.616 151.095 47.4503 - OK P3047 Fibroblasts 1 0 0 0 0 - OK P3047 Fibroblasts 0 0 0 0 0 - OK P3048 iPS 0 0 0 0 0 - OK P3048 iPS 1 9.64219 9.2895 15.8828 4.61288 - OK P3048 hESC 1 264.739 262.052 173.194 50.8563 - OK P3048 hESC 0 144.831 146.316 96.7022 28.3954 - OK P3048 Fibroblasts 1 9.01567 7.52268 6.14981 1.78897 - OK P3048 Fibroblasts 0 11.5347 13.7249 11.2202 3.26393 - OK P3049 iPS 0 27.9492 29.1724 49.8779 20.0069 - OK P3049 iPS 1 9.53459 9.18583 15.7056 6.2998 - OK P3049 hESC 1 130.122 128.801 85.1264 34.6685 - OK P3049 hESC 0 140.503 141.944 93.8129 38.2061 - OK P3049 Fibroblasts 1 0 0 0 0 - OK P3049 Fibroblasts 0 8.13245 9.6767 7.91072 3.18018 - OK P305 iPS 0 687.854 717.96 1227.54 508.391 - OK P305 iPS 1 422.342 406.894 695.692 288.124 - OK P305 hESC 1 1858.39 1839.53 1215.77 511.48 - OK P305 hESC 0 2010.07 2030.68 1342.11 564.628 - OK P305 Fibroblasts 1 5902.59 4925.12 4026.3 1671.33 - OK P305 Fibroblasts 0 5084.89 6050.45 4946.26 2053.21 - OK P3050 iPS 0 104.755 109.34 186.945 58.5223 - OK P3050 iPS 1 27.7007 26.6875 45.6293 14.4218 - OK P3050 hESC 1 746.292 738.717 488.229 154.231 - OK P3050 hESC 0 455.587 460.258 304.191 95.9743 - OK P3050 Fibroblasts 1 123.233 102.825 84.0599 26.1927 - OK P3050 Fibroblasts 0 153.931 183.16 149.734 46.7834 - OK P3051 iPS 0 492 513.533 878.02 466.126 - OK P3051 iPS 1 615 592.505 1013.04 537.807 - OK P3051 hESC 1 474 469.189 310.094 167.976 - OK P3051 hESC 0 596 602.111 397.944 215.563 - OK P3051 Fibroblasts 1 968.82 808.383 660.855 351.868 - OK P3051 Fibroblasts 0 700 832.921 680.915 362.549 - OK P3052 iPS 0 6.09771 6.36459 10.8819 3.56443 - OK P3052 iPS 1 0 0 0 0 - OK P3052 hESC 1 756.144 748.469 494.674 164.053 - OK P3052 hESC 0 668.141 674.991 446.112 147.948 - OK P3052 Fibroblasts 1 1518.72 1267.22 1035.96 339.947 - OK P3052 Fibroblasts 0 1295.72 1541.76 1260.39 413.595 - OK P3053 iPS 0 215.751 225.193 385.027 88.5521 - OK P3053 iPS 1 341.428 328.939 562.408 129.348 - OK P3053 hESC 1 314.369 311.179 205.663 47.7127 - OK P3053 hESC 0 494.678 499.75 330.292 76.6261 - OK P3053 Fibroblasts 1 463.607 386.833 316.237 72.8236 - OK P3053 Fibroblasts 0 362.14 430.906 352.267 81.1207 - OK P3054 iPS 0 163.152 170.292 291.16 124.522 - OK P3054 iPS 1 198.572 191.309 327.092 139.89 - OK P3054 hESC 1 511.487 506.296 334.618 145.447 - OK P3054 hESC 0 553.181 558.853 369.354 160.545 - OK P3054 Fibroblasts 1 2240.67 1869.62 1528.42 655.216 - OK P3054 Fibroblasts 0 1299.14 1545.84 1263.72 541.745 - OK P3055 iPS 0 830.223 866.56 1481.61 670.549 - OK P3055 iPS 1 1032.52 994.749 1700.78 769.743 - OK P3055 hESC 1 4375.89 4331.48 2862.74 1318.04 - OK P3055 hESC 0 4494.8 4540.89 3001.14 1381.76 - OK P3055 Fibroblasts 1 4600.14 3838.35 3137.86 1423.69 - OK P3055 Fibroblasts 0 4282.39 5095.56 4165.63 1890.01 - OK P3056 iPS 0 16.647 17.3756 29.7082 14.1517 - OK P3056 iPS 1 12.7741 12.3068 21.0417 10.0234 - OK P3056 hESC 1 59.05 58.4507 38.6309 18.7376 - OK P3056 hESC 0 110.862 111.999 74.0218 35.9037 - OK P3056 Fibroblasts 1 97.541 81.3882 66.535 31.778 - OK P3056 Fibroblasts 0 63.1853 75.1834 61.4627 29.3553 - OK P3057 iPS 0 0 0 0 0 - OK P3057 iPS 1 13.2297 12.7458 21.7922 10.1019 - OK P3057 hESC 1 0 0 0 0 - OK P3057 hESC 0 55.8378 56.4103 37.2824 17.589 - OK P3057 Fibroblasts 1 174.485 145.59 119.021 55.3143 - OK P3057 Fibroblasts 0 35.886 42.7003 34.9076 16.2231 - OK P3058 iPS 0 0 0 0 0 - OK P3058 iPS 1 11.2802 10.8676 18.5811 22.096 - OK P3058 hESC 1 0 0 0 0 - OK P3058 hESC 0 0 0 0 0 - OK P3058 Fibroblasts 1 0 0 0 0 - OK P3058 Fibroblasts 0 0 0 0 0 - OK P3059 iPS 0 0 0 0 0 - OK P3059 iPS 1 0.00452118 0.00435581 0.00744739 0.0219686 - OK P3059 hESC 1 0 0 0 0 - OK P3059 hESC 0 0 0 0 0 - OK P3059 Fibroblasts 1 0 0 0 0 - OK P3059 Fibroblasts 0 0 0 0 0 - OK P306 iPS 0 597.814 623.978 1066.85 442.23 - OK P306 iPS 1 609.041 586.764 1003.23 415.855 - OK P306 hESC 1 2109.01 2087.6 1379.73 580.974 - OK P306 hESC 0 2041.53 2062.47 1363.11 573.979 - OK P306 Fibroblasts 1 4073.12 3398.61 2778.37 1154.33 - OK P306 Fibroblasts 0 5435.26 6467.35 5287.08 2196.62 - OK P3060 iPS 0 0 0 0 0 - OK P3060 iPS 1 0.995479 0.959067 1.63978 4.87776 - OK P3060 hESC 1 1.00016 0.990007 0.65431 1.43944 - OK P3060 hESC 0 0 0 0 0 - OK P3060 Fibroblasts 1 0 0 0 0 - OK P3060 Fibroblasts 0 0 0 0 0 - OK P3061 iPS 0 0 0 0 0 - OK P3061 iPS 1 0 0 0 0 - OK P3061 hESC 1 0 0 0 0 - OK P3061 hESC 0 0 0 0 0 - OK P3061 Fibroblasts 1 0 0 0 0 - OK P3061 Fibroblasts 0 0 0 0 0 - OK P3062 iPS 0 0 0 0 0 - OK P3062 iPS 1 0 0 0 0 - OK P3062 hESC 1 1 0.989851 0.654207 0.491457 - OK P3062 hESC 0 0 0 0 0 - OK P3062 Fibroblasts 1 2 1.6688 1.36425 1.13004 - OK P3062 Fibroblasts 0 2 2.37978 1.94547 1.61149 - OK P3063 iPS 0 74.8479 78.1238 133.573 95.0181 - OK P3063 iPS 1 152.642 147.059 251.436 178.861 - OK P3063 hESC 1 42.057 41.6302 27.514 20.11 - OK P3063 hESC 0 48.0231 48.5155 32.0646 23.436 - OK P3063 Fibroblasts 1 221.414 184.748 151.032 107.861 - OK P3063 Fibroblasts 0 50.4173 59.9909 49.0427 35.0244 - OK P3064 iPS 0 559.152 583.624 997.859 476.782 - OK P3064 iPS 1 1019.36 982.072 1679.11 802.286 - OK P3064 hESC 1 1242.94 1230.33 813.142 395.628 - OK P3064 hESC 0 1530.98 1546.67 1022.22 497.354 - OK P3064 Fibroblasts 1 7990.59 6667.34 5450.57 2611.2 - OK P3064 Fibroblasts 0 3945.58 4694.8 3838.01 1838.67 - OK P3065 iPS 0 6.46822 6.75132 11.5431 2.65999 - OK P3065 iPS 1 0 0 0 0 - OK P3065 hESC 1 1734.34 1716.74 1134.62 263.745 - OK P3065 hESC 0 2441.25 2466.28 1630 378.897 - OK P3065 Fibroblasts 1 13661.1 11398.8 9318.59 2150.1 - OK P3065 Fibroblasts 0 5458.83 6495.4 5310.01 1225.19 - OK P3066 iPS 0 0 0 0 0 - OK P3066 iPS 1 0 0 0 0 - OK P3066 hESC 1 7.97023 7.88934 5.21418 3.11034 - OK P3066 hESC 0 0 0 0 0 - OK P3066 Fibroblasts 1 247.921 206.865 169.113 98.9852 - OK P3066 Fibroblasts 0 10.8285 12.8847 10.5333 6.16535 - OK P3067 iPS 0 66.7494 69.6708 119.121 66.2735 - OK P3067 iPS 1 114.963 110.758 189.369 105.357 - OK P3067 hESC 1 4.59208 4.54547 3.00417 1.70709 - OK P3067 hESC 0 15.7819 15.9437 10.5374 5.98779 - OK P3067 Fibroblasts 1 22.4705 18.7494 15.3277 8.55394 - OK P3067 Fibroblasts 0 6.94078 8.25875 6.75155 3.76784 - OK P3068 iPS 0 588.782 614.551 1050.74 189.594 - OK P3068 iPS 1 621.037 598.321 1022.99 183.691 - OK P3068 hESC 1 5632.1 5574.93 3684.55 668.859 - OK P3068 hESC 0 5464.97 5521.01 3648.91 662.278 - OK P3068 Fibroblasts 1 2016.47 1682.54 1375.48 248.438 - OK P3068 Fibroblasts 0 1722.4 2049.46 1675.44 302.159 - OK P3069 iPS 0 3.00026 3.13157 5.35424 18.183 - OK P3069 iPS 1 4 3.85369 6.58889 22.3758 - OK P3069 hESC 1 0 0 0 0 - OK P3069 hESC 0 0 0 0 0 - OK P3069 Fibroblasts 1 0 0 0 0 - OK P3069 Fibroblasts 0 0 0 0 0 - OK P307 iPS 0 554.195 578.451 989.013 403.694 - OK P307 iPS 1 443.65 427.422 730.79 298.293 - OK P307 hESC 1 839.599 831.078 549.271 227.694 - OK P307 hESC 0 1058.4 1069.25 706.682 292.947 - OK P307 Fibroblasts 1 6344.7 5294.02 4327.87 1770.54 - OK P307 Fibroblasts 0 3406.84 4053.76 3313.96 1355.74 - OK P3070 iPS 0 0 0 0 0 - OK P3070 iPS 1 12.3037 11.8536 20.2669 22.388 - OK P3070 hESC 1 20.2645 20.0588 13.2572 15.2791 - OK P3070 hESC 0 6.25669 6.32085 4.17754 4.81468 - OK P3070 Fibroblasts 1 0 0 0 0 - OK P3070 Fibroblasts 0 0 0 0 0 - OK P3071 iPS 0 12791.4 13351.2 22827.4 19635.1 - OK P3071 iPS 1 13402.4 12912.2 22076.8 18989.5 - OK P3071 hESC 1 51956.7 51429.3 33990.4 30213.9 - OK P3071 hESC 0 51603.2 52132.3 34455 30626.9 - OK P3071 Fibroblasts 1 31892.6 26611.2 21754.7 18801.7 - OK P3071 Fibroblasts 0 49086.1 58407 47747.9 41266.6 - OK P3072 iPS 0 0 0 0 0 - OK P3072 iPS 1 0 0 0 0 - OK P3072 hESC 1 12438.9 12312.6 8137.6 7283.83 - OK P3072 hESC 0 16204.6 16370.8 10819.7 9684.53 - OK P3072 Fibroblasts 1 2375.69 1982.27 1620.51 1410.02 - OK P3072 Fibroblasts 0 26963.7 32083.8 26228.6 22821.7 - OK P3073 iPS 0 0 0 0 0 - OK P3073 iPS 1 0 0 0 0 - OK P3073 hESC 1 55.4661 54.9032 36.2863 33.4967 - OK P3073 hESC 0 110.918 112.055 74.0588 68.3653 - OK P3073 Fibroblasts 1 0 0 0 0 - OK P3073 Fibroblasts 0 0 0 0 0 - OK P3074 iPS 0 10.3688 10.8226 18.504 17.7273 - OK P3074 iPS 1 0 0 0 0 - OK P3074 hESC 1 0 0 0 0 - OK P3074 hESC 0 10.0359 10.1388 6.70087 6.65942 - OK P3074 Fibroblasts 1 10138.4 8459.47 6915.63 6660.58 - OK P3074 Fibroblasts 0 0 0 0 0 - OK P3075 iPS 0 1465.54 1529.68 2615.4 2877.89 - OK P3075 iPS 1 799.214 769.981 1316.48 1448.61 - OK P3075 hESC 1 19024.4 18831.4 12445.9 14285.9 - OK P3075 hESC 0 14403.5 14551.2 9617.1 11038.9 - OK P3075 Fibroblasts 1 36050.9 30080.9 24591.2 27224.7 - OK P3075 Fibroblasts 0 19156 22793.5 18633.7 20629.2 - OK P3076 iPS 0 0 0 0 0 - OK P3076 iPS 1 0 0 0 0 - OK P3076 hESC 1 0 0 0 0 - OK P3076 hESC 0 5266.04 5320.03 3516.09 3401.14 - OK P3076 Fibroblasts 1 5303.04 4424.85 3617.33 3393.8 - OK P3076 Fibroblasts 0 0 0 0 0 - OK P3077 iPS 0 237.189 247.57 423.286 285.188 - OK P3077 iPS 1 542.967 523.107 894.388 602.592 - OK P3077 hESC 1 477.018 472.176 312.068 215.718 - OK P3077 hESC 0 464.441 469.203 310.103 214.36 - OK P3077 Fibroblasts 1 433.088 361.369 295.42 199.782 - OK P3077 Fibroblasts 0 238.539 283.835 232.036 156.917 - OK P3078 iPS 0 0 0 0 0 - OK P3078 iPS 1 0 0 0 0 - OK P3078 hESC 1 0 0 0 0 - OK P3078 hESC 0 1 1.01025 0.667691 0.716409 - OK P3078 Fibroblasts 1 2 1.6688 1.36425 1.25394 - OK P3078 Fibroblasts 0 0 0 0 0 - OK P3079 iPS 0 0 0 0 0 - OK P3079 iPS 1 0 0 0 0 - OK P3079 hESC 1 0 0 0 0 - OK P3079 hESC 0 0 0 0 0 - OK P3079 Fibroblasts 1 0 0 0 0 - OK P3079 Fibroblasts 0 19.3779 23.0575 18.8496 11.996 - OK P308 iPS 0 32.1368 33.5434 57.3512 60.9728 - OK P308 iPS 1 9.97849 9.6135 16.4368 17.4748 - OK P308 hESC 1 0 0 0 0 - OK P308 hESC 0 0 0 0 0 - OK P308 Fibroblasts 1 731.822 610.632 499.193 533.851 - OK P308 Fibroblasts 0 0 0 0 0 - OK P3080 iPS 0 2.99939 3.13066 5.35269 4.26686 - OK P3080 iPS 1 0 0 0 0 - OK P3080 hESC 1 6.99934 6.9283 4.57901 3.76288 - OK P3080 hESC 0 3.99937 4.04038 2.67035 2.1944 - OK P3080 Fibroblasts 1 0 0 0 0 - OK P3080 Fibroblasts 0 3.59756 4.2807 3.49948 2.80192 - OK P3081 iPS 0 0 0 0 0 - OK P3081 iPS 1 0.0596582 0.057476 0.0982703 0.12506 - OK P3081 hESC 1 0 0 0 0 - OK P3081 hESC 0 0 0 0 0 - OK P3081 Fibroblasts 1 0 0 0 0 - OK P3081 Fibroblasts 0 0 0 0 0 - OK P3082 iPS 0 1 1.04377 1.78459 3.35453 - OK P3082 iPS 1 0 0 0 0 - OK P3082 hESC 1 0 0 0 0 - OK P3082 hESC 0 0 0 0 0 - OK P3082 Fibroblasts 1 6.84072 5.7079 4.66622 8.86318 - OK P3082 Fibroblasts 0 0 0 0 0 - OK P3083 iPS 0 0.00061045 0.000637168 0.00108941 0.000835455 - OK P3083 iPS 1 0 0 0 0 - OK P3083 hESC 1 0.000663217 0.000656486 0.000433881 0.000342616 - OK P3083 hESC 0 0.000625617 0.000632031 0.000417719 0.000329853 - OK P3083 Fibroblasts 1 25.5048 21.2812 17.3974 13.3987 - OK P3083 Fibroblasts 0 0 0 0 0 - OK P3084 iPS 0 0 0 0 0 - OK P3084 iPS 1 3.94034 3.79621 6.49062 4.09226 - OK P3084 hESC 1 0 0 0 0 - OK P3084 hESC 0 0 0 0 0 - OK P3084 Fibroblasts 1 485.654 405.23 331.276 208.518 - OK P3084 Fibroblasts 0 0.0245503 0.0292121 0.023881 0.0151097 - OK P3085 iPS 0 8.93947 9.33072 15.9533 10.1263 - OK P3085 iPS 1 8.59363 8.27929 14.1556 8.98525 - OK P3085 hESC 1 4.45697 4.41173 2.91578 1.89602 - OK P3085 hESC 0 18.8875 19.0811 12.611 8.20045 - OK P3085 Fibroblasts 1 4.28411 3.57466 2.92229 1.86144 - OK P3085 Fibroblasts 0 1.06629 1.26876 1.03722 0.660685 - OK P3086 iPS 0 2.51199 2.62193 4.48288 2.30967 - OK P3086 iPS 1 1.10439 1.06399 1.81917 0.937275 - OK P3086 hESC 1 4.84292 4.79377 3.16827 1.6646 - OK P3086 hESC 0 4.24395 4.28746 2.83364 1.48879 - OK P3086 Fibroblasts 1 4.70539 3.92617 3.20966 1.6584 - OK P3086 Fibroblasts 0 2.33582 2.77936 2.27214 1.17399 - OK P3087 iPS 0 7.0171 7.32422 12.5227 17.974 - OK P3087 iPS 1 1.35657 1.30695 2.23458 3.20733 - OK P3087 hESC 1 7.95004 7.86935 5.20097 7.89077 - OK P3087 hESC 0 4.22241 4.2657 2.81926 4.27731 - OK P3087 Fibroblasts 1 21.004 17.5258 14.3274 20.7286 - OK P3087 Fibroblasts 0 19.9894 23.7851 19.4444 28.1319 - OK P3088 iPS 0 3.53144 3.686 6.30219 11.2769 - OK P3088 iPS 1 5.94541 5.72794 9.79342 17.524 - OK P3088 hESC 1 49.7501 49.2452 32.5468 62.4378 - OK P3088 hESC 0 34.6462 35.0014 23.1329 44.3782 - OK P3088 Fibroblasts 1 43.0065 35.8846 29.3357 53.0161 - OK P3088 Fibroblasts 0 50.6085 60.2184 49.2287 88.9671 - OK P3089 iPS 0 169 176.397 301.596 113.267 - OK P3089 iPS 1 126 121.391 207.55 77.9474 - OK P3089 hESC 1 735 727.54 480.842 183.171 - OK P3089 hESC 0 965 974.894 644.322 245.446 - OK P3089 Fibroblasts 1 321 267.842 218.962 82.404 - OK P3089 Fibroblasts 0 152 180.863 147.856 55.6441 - OK P309 iPS 0 363.838 379.762 649.302 480.491 - OK P309 iPS 1 48.8589 47.0718 80.4816 59.5572 - OK P309 hESC 1 1063.73 1052.93 695.899 529.708 - OK P309 hESC 0 1035.46 1046.08 691.366 526.257 - OK P309 Fibroblasts 1 6399.03 5339.35 4364.93 3243.35 - OK P309 Fibroblasts 0 4522.38 5381.12 4399.08 3268.72 - OK P3090 iPS 0 0 0 0 0 - OK P3090 iPS 1 0 0 0 0 - OK P3090 hESC 1 0 0 0 0 - OK P3090 hESC 0 2.00011 2.02062 1.33545 1.17967 - OK P3090 Fibroblasts 1 0 0 0 0 - OK P3090 Fibroblasts 0 0 0 0 0 - OK P3091 iPS 0 677.887 707.556 1209.75 342.696 - OK P3091 iPS 1 724.402 697.905 1193.25 338.022 - OK P3091 hESC 1 5741.51 5683.24 3756.14 1075.48 - OK P3091 hESC 0 5566.04 5623.11 3716.39 1064.1 - OK P3091 Fibroblasts 1 6967.89 5814.01 4752.97 1348.52 - OK P3091 Fibroblasts 0 6294.32 7489.53 6122.71 1737.15 - OK P3092 iPS 0 5.46781 5.70712 9.75782 6.67606 - OK P3092 iPS 1 0 0 0 0 - OK P3092 hESC 1 379.326 375.476 248.157 174.265 - OK P3092 hESC 0 262.114 264.802 175.011 122.899 - OK P3092 Fibroblasts 1 1586.09 1323.44 1081.91 743.025 - OK P3092 Fibroblasts 0 957.557 1139.39 931.45 639.692 - OK P3093 iPS 0 197.59 206.238 352.617 100.432 - OK P3093 iPS 1 354.598 341.628 584.102 166.363 - OK P3093 hESC 1 2820.13 2791.51 1844.95 531.162 - OK P3093 hESC 0 2699.84 2727.52 1802.66 518.985 - OK P3093 Fibroblasts 1 91.9707 76.7403 62.7354 17.8963 - OK P3093 Fibroblasts 0 106.186 126.35 103.291 29.4655 - OK P3094 iPS 0 0.0558852 0.0583312 0.0997324 0.0280833 - OK P3094 iPS 1 0 0 0 0 - OK P3094 hESC 1 0 0 0 0 - OK P3094 hESC 0 0 0 0 0 - OK P3094 Fibroblasts 1 15137.9 12631.1 10325.9 2912.17 - OK P3094 Fibroblasts 0 8096.36 9633.76 7875.62 2221.12 - OK P3095 iPS 0 470.5 491.092 839.651 424.835 - OK P3095 iPS 1 638 614.663 1050.93 530.624 - OK P3095 hESC 1 1999 1978.71 1307.76 674.333 - OK P3095 hESC 0 1901 1920.49 1269.28 652.675 - OK P3095 Fibroblasts 1 1509 1259.11 1029.32 521.629 - OK P3095 Fibroblasts 0 998 1187.51 970.791 491.743 - OK P3096 iPS 0 0 0 0 0 - OK P3096 iPS 1 0 0 0 0 - OK P3096 hESC 1 0 0 0 0 - OK P3096 hESC 0 0 0 0 0 - OK P3096 Fibroblasts 1 18.0895 15.0939 12.3393 14.4525 - OK P3096 Fibroblasts 0 0 0 0 0 - OK P3097 iPS 0 176.581 184.309 315.125 339.832 - OK P3097 iPS 1 152.473 146.896 251.157 269.392 - OK P3097 hESC 1 260.328 257.686 170.308 190.68 - OK P3097 hESC 0 280 282.871 186.953 207.194 - OK P3097 Fibroblasts 1 1460.25 1218.43 996.07 1083.43 - OK P3097 Fibroblasts 0 861.016 1024.51 837.541 906.553 - OK P3098 iPS 0 3.41925 3.5689 6.10197 7.3302 - OK P3098 iPS 1 10.5268 10.1417 17.3399 20.8302 - OK P3098 hESC 1 8.67217 8.58416 5.67339 7.13768 - OK P3098 hESC 0 0 0 0 0 - OK P3098 Fibroblasts 1 7.66318 6.39415 5.22724 6.32133 - OK P3098 Fibroblasts 0 5.98425 7.12059 5.8211 7.03949 - OK P3099 iPS 0 381.311 398 680.486 298.612 - OK P3099 iPS 1 409.798 394.808 675.029 296.217 - OK P3099 hESC 1 945.25 935.657 618.389 275.914 - OK P3099 hESC 0 895.212 904.391 597.725 266.694 - OK P3099 Fibroblasts 1 946.202 789.511 645.427 283.915 - OK P3099 Fibroblasts 0 806.995 960.234 784.994 345.309 - OK P31 iPS 0 0 0 0 0 - OK P31 iPS 1 2 1.92684 3.29445 14.4039 - OK P31 hESC 1 23 22.7666 15.0468 78.7253 - OK P31 hESC 0 16 16.1641 10.6831 55.8942 - OK P31 Fibroblasts 1 0 0 0 0 - OK P31 Fibroblasts 0 0 0 0 0 - OK P310 iPS 0 207.162 216.229 369.701 285.221 - OK P310 iPS 1 248.135 239.059 408.733 315.334 - OK P310 hESC 1 0 0 0 0 - OK P310 hESC 0 0 0 0 0 - OK P310 Fibroblasts 1 0 0 0 0 - OK P310 Fibroblasts 0 0 0 0 0 - OK P3100 iPS 0 392.689 409.875 700.79 530.526 - OK P3100 iPS 1 348.202 335.466 573.567 434.213 - OK P3100 hESC 1 1804.75 1786.43 1180.68 920.003 - OK P3100 hESC 0 1592.79 1609.12 1063.49 828.687 - OK P3100 Fibroblasts 1 1589.8 1326.53 1084.44 824.41 - OK P3100 Fibroblasts 0 1161 1381.47 1129.35 858.553 - OK P3101 iPS 0 1.41494 1.47687 2.5251 1.70128 - OK P3101 iPS 1 3.62872 3.49599 5.97731 4.0272 - OK P3101 hESC 1 4.38197 4.3375 2.86672 1.98163 - OK P3101 hESC 0 1.67078 1.68791 1.11556 0.771137 - OK P3101 Fibroblasts 1 0 0 0 0 - OK P3101 Fibroblasts 0 0 0 0 0 - OK P3102 iPS 0 17.8811 18.6637 31.9105 14.6435 - OK P3102 iPS 1 3.65457 3.5209 6.0199 2.7625 - OK P3102 hESC 1 169.673 167.951 111.001 51.8319 - OK P3102 hESC 0 156.907 158.516 104.766 48.9202 - OK P3102 Fibroblasts 1 20.2432 16.8909 13.8084 6.35267 - OK P3102 Fibroblasts 0 12.3226 14.6625 11.9866 5.51457 - OK P3103 iPS 0 1.48905 1.55422 2.65735 0.887067 - OK P3103 iPS 1 1.91788 1.84772 3.15917 1.05458 - OK P3103 hESC 1 176.433 174.643 115.424 39.02 - OK P3103 hESC 0 158.591 160.218 105.89 35.797 - OK P3103 Fibroblasts 1 5.23771 4.37034 3.57277 1.19485 - OK P3103 Fibroblasts 0 7.67741 9.13526 7.4681 2.49757 - OK P3104 iPS 0 35.2149 36.7562 62.8443 11.4506 - OK P3104 iPS 1 19.7988 19.0746 32.6131 5.94228 - OK P3104 hESC 1 110.512 109.39 72.2976 13.2639 - OK P3104 hESC 0 239.83 242.289 160.133 29.3782 - OK P3104 Fibroblasts 1 4.51912 3.77075 3.0826 0.562232 - OK P3104 Fibroblasts 0 0 0 0 0 - OK P3105 iPS 0 0 0 0 0 - OK P3105 iPS 1 2.99846 2.88879 4.93914 3.33568 - OK P3105 hESC 1 0 0 0 0 - OK P3105 hESC 0 3.99858 4.03958 2.66981 1.85004 - OK P3105 Fibroblasts 1 0 0 0 0 - OK P3105 Fibroblasts 0 0.00623317 0.00741678 0.00606323 0.00411017 - OK P3106 iPS 0 0 0 0 0 - OK P3106 iPS 1 0 0 0 0 - OK P3106 hESC 1 15.9993 15.8369 10.4668 7.33925 - OK P3106 hESC 0 0 0 0 0 - OK P3106 Fibroblasts 1 0 0 0 0 - OK P3106 Fibroblasts 0 0.993767 1.18247 0.966673 0.662916 - OK P3107 iPS 0 0 0 0 0 - OK P3107 iPS 1 0.00153566 0.00147949 0.00252957 0.00166542 - OK P3107 hESC 1 0.000732167 0.000724736 0.000478989 0.00032336 - OK P3107 hESC 0 0.0014216 0.00143618 0.000949189 0.000640787 - OK P3107 Fibroblasts 1 0 0 0 0 - OK P3107 Fibroblasts 0 0 0 0 0 - OK P3108 iPS 0 48 50.1008 85.6605 53.2497 - OK P3108 iPS 1 80.9467 77.9859 133.337 82.8874 - OK P3108 hESC 1 120.29 119.069 78.6945 50.0899 - OK P3108 hESC 0 99.1599 100.177 66.2081 42.1422 - OK P3108 Fibroblasts 1 33 27.5352 22.5101 14.0413 - OK P3108 Fibroblasts 0 26 30.9371 25.2911 15.7761 - OK P3109 iPS 0 0 0 0 0 - OK P3109 iPS 1 0 0 0 0 - OK P3109 hESC 1 0 0 0 0 - OK P3109 hESC 0 0 0 0 0 - OK P3109 Fibroblasts 1 0 0 0 0 - OK P3109 Fibroblasts 0 0 0 0 0 - OK P311 iPS 0 0 0 0 0 - OK P311 iPS 1 0.00634246 0.00611046 0.0104474 0.00805133 - OK P311 hESC 1 12.2701 12.1455 8.02715 6.37068 - OK P311 hESC 0 52.5413 53.08 35.0814 27.842 - OK P311 Fibroblasts 1 206.788 172.544 141.055 109.169 - OK P311 Fibroblasts 0 124.621 148.285 121.224 93.8204 - OK P3110 iPS 0 0 0 0 0 - OK P3110 iPS 1 0 0 0 0 - OK P3110 hESC 1 0 0 0 0 - OK P3110 hESC 0 1.10899 1.12036 0.74046 2.09752 - OK P3110 Fibroblasts 1 0 0 0 0 - OK P3110 Fibroblasts 0 0 0 0 0 - OK P3111 iPS 0 7 7.30637 12.4922 8.73699 - OK P3111 iPS 1 4.05327 3.90501 6.67663 4.66962 - OK P3111 hESC 1 17.7101 17.5303 11.586 8.32204 - OK P3111 hESC 0 29.7312 30.036 19.8512 14.2588 - OK P3111 Fibroblasts 1 0 0 0 0 - OK P3111 Fibroblasts 0 0 0 0 0 - OK P3112 iPS 0 384.056 400.865 685.384 876.963 - OK P3112 iPS 1 527.292 508.005 868.568 1111.35 - OK P3112 hESC 1 4608.77 4562 3015.09 4052.8 - OK P3112 hESC 0 5754.45 5813.46 3842.2 5164.57 - OK P3112 Fibroblasts 1 5327.11 4444.94 3633.75 4682.54 - OK P3112 Fibroblasts 0 8593.12 10224.8 8358.84 10771.4 - OK P3113 iPS 0 318.944 332.903 569.185 1218.93 - OK P3113 iPS 1 307.708 296.453 506.864 1085.46 - OK P3113 hESC 1 497.229 492.183 325.291 757.606 - OK P3113 hESC 0 97.0452 98.0402 64.7962 150.911 - OK P3113 Fibroblasts 1 2743.89 2289.5 1871.68 4056.21 - OK P3113 Fibroblasts 0 874.884 1041.01 851.031 1844.31 - OK P3114 iPS 0 0 0 0 0 - OK P3114 iPS 1 0 0 0 0 - OK P3114 hESC 1 0 0 0 0 - OK P3114 hESC 0 20.5783 20.7893 13.7399 7.74536 - OK P3114 Fibroblasts 1 0 0 0 0 - OK P3114 Fibroblasts 0 21.5059 25.5896 20.9196 11.5832 - OK P3115 iPS 0 85.8088 89.5644 153.134 85.9066 - OK P3115 iPS 1 102.248 98.5084 168.426 94.4853 - OK P3115 hESC 1 169.627 167.906 110.971 63.5949 - OK P3115 hESC 0 189.639 191.583 126.62 72.5627 - OK P3115 Fibroblasts 1 102.077 85.1732 69.6293 39.1828 - OK P3115 Fibroblasts 0 50.313 59.8668 48.9413 27.5409 - OK P3116 iPS 0 1513.69 1579.94 2701.32 1448.77 - OK P3116 iPS 1 1379.25 1328.8 2271.94 1218.48 - OK P3116 hESC 1 3364.37 3330.23 2201 1204.72 - OK P3116 hESC 0 3775.28 3813.99 2520.72 1379.72 - OK P3116 Fibroblasts 1 3976.42 3317.93 2712.41 1459.04 - OK P3116 Fibroblasts 0 3301.68 3928.63 3211.66 1727.59 - OK P3117 iPS 0 1783.63 1861.69 3183.05 526.219 - OK P3117 iPS 1 2313.98 2229.34 3811.64 630.137 - OK P3117 hESC 1 7868.07 7788.21 5147.34 856.275 - OK P3117 hESC 0 8422.29 8508.64 5623.49 935.482 - OK P3117 Fibroblasts 1 5758.95 4805.26 3928.31 650.018 - OK P3117 Fibroblasts 0 3857.93 4590.51 3752.75 620.968 - OK P3118 iPS 0 85.3722 89.1087 152.355 55.9409 - OK P3118 iPS 1 102.021 98.2893 168.051 61.7044 - OK P3118 hESC 1 642.931 636.406 420.61 156.599 - OK P3118 hESC 0 464.712 469.477 310.284 115.523 - OK P3118 Fibroblasts 1 425.555 355.083 290.281 106.801 - OK P3118 Fibroblasts 0 655.066 779.455 637.206 234.442 - OK P3119 iPS 0 171.409 178.911 305.895 316.644 - OK P3119 iPS 1 166.494 160.404 274.252 283.89 - OK P3119 hESC 1 2513.24 2487.73 1644.18 1770.86 - OK P3119 hESC 0 1794.7 1813.11 1198.31 1290.64 - OK P3119 Fibroblasts 1 133.851 111.685 91.3029 95.0546 - OK P3119 Fibroblasts 0 47.9997 57.1143 46.6911 48.6097 - OK P312 iPS 0 10.1897 10.6357 18.1845 11.3993 - OK P312 iPS 1 19.6863 18.9663 32.4278 20.3281 - OK P312 hESC 1 143.182 141.729 93.6708 60.1366 - OK P312 hESC 0 155.887 157.485 104.084 66.8221 - OK P312 Fibroblasts 1 123.471 103.024 84.2224 52.98 - OK P312 Fibroblasts 0 74.3219 88.4347 72.2956 45.4774 - OK P3120 iPS 0 0 0 0 0 - OK P3120 iPS 1 0 0 0 0 - OK P3120 hESC 1 11.8943 11.7736 7.78133 8.32384 - OK P3120 hESC 0 8.59557 8.6837 5.73918 6.13931 - OK P3120 Fibroblasts 1 0 0 0 0 - OK P3120 Fibroblasts 0 0 0 0 0 - OK P3121 iPS 0 1588.83 1658.37 2835.42 3981.87 - OK P3121 iPS 1 2092 2015.48 3445.99 4904.84 - OK P3121 hESC 1 7541.67 7465.12 4933.81 7273.6 - OK P3121 hESC 0 6850.33 6920.57 4573.91 6721.97 - OK P3121 Fibroblasts 1 2086.5 1740.97 1423.25 1944.38 - OK P3121 Fibroblasts 0 2147.33 2555.09 2088.79 2727.94 - OK P3122 iPS 0 0.00410908 0.00428892 0.00733303 0.00147752 - OK P3122 iPS 1 85.5158 82.3878 140.864 28.3824 - OK P3122 hESC 1 327.75 324.424 214.416 43.5322 - OK P3122 hESC 0 628.709 635.156 419.784 85.2271 - OK P3122 Fibroblasts 1 2821.72 2354.44 1924.76 388.25 - OK P3122 Fibroblasts 0 789.537 939.461 768.012 154.918 - OK P3123 iPS 0 308.038 321.52 549.723 112.088 - OK P3123 iPS 1 242.655 233.779 399.707 81.5 - OK P3123 hESC 1 719.435 712.133 470.659 96.7082 - OK P3123 hESC 0 664.419 671.231 443.626 91.1537 - OK P3123 Fibroblasts 1 1743.12 1454.46 1189.02 242.714 - OK P3123 Fibroblasts 0 1482.05 1763.48 1441.65 294.282 - OK P3124 iPS 0 0 0 0 0 - OK P3124 iPS 1 2 1.92684 3.29445 6.80779 - OK P3124 hESC 1 11.0013 10.8896 7.19712 16.125 - OK P3124 hESC 0 4 4.04102 2.67077 5.9838 - OK P3124 Fibroblasts 1 16.0001 13.3505 10.914 22.8136 - OK P3124 Fibroblasts 0 6.00085 7.14034 5.83725 12.2016 - OK P3125 iPS 0 41 42.7944 73.1683 195.455 - OK P3125 iPS 1 304 292.88 500.756 1337.67 - OK P3125 hESC 1 5 4.94925 3.27103 9.7133 - OK P3125 hESC 0 3 3.03076 2.00307 5.9481 - OK P3125 Fibroblasts 1 0 0 0 0 - OK P3125 Fibroblasts 0 0 0 0 0 - OK P3126 iPS 0 141.248 147.43 252.07 150.671 - OK P3126 iPS 1 121.84 117.383 200.697 119.963 - OK P3126 hESC 1 201.711 199.664 131.961 80.6904 - OK P3126 hESC 0 289.961 292.934 193.604 118.384 - OK P3126 Fibroblasts 1 232.004 193.584 158.256 94.9078 - OK P3126 Fibroblasts 0 210.848 250.885 205.099 123.001 - OK P3127 iPS 0 530.752 553.982 947.177 616.999 - OK P3127 iPS 1 422.16 406.719 695.392 452.985 - OK P3127 hESC 1 1633.29 1616.71 1068.51 713.507 - OK P3127 hESC 0 1390.04 1404.29 928.116 619.759 - OK P3127 Fibroblasts 1 1681 1402.62 1146.65 749.632 - OK P3127 Fibroblasts 0 3000.15 3569.84 2918.36 1907.91 - OK P3128 iPS 0 465.041 485.394 829.909 716.903 - OK P3128 iPS 1 377.62 363.807 622.024 537.324 - OK P3128 hESC 1 511.122 505.935 334.38 298.542 - OK P3128 hESC 0 533.928 539.403 356.499 318.291 - OK P3128 Fibroblasts 1 523.086 436.463 356.81 309.701 - OK P3128 Fibroblasts 0 702.408 835.786 683.257 593.049 - OK P3129 iPS 0 9.04016 9.43582 16.133 21.6408 - OK P3129 iPS 1 16.5432 15.9381 27.2503 36.5537 - OK P3129 hESC 1 31.7393 31.4172 20.7641 29.332 - OK P3129 hESC 0 30.5638 30.8772 20.4072 28.8278 - OK P3129 Fibroblasts 1 0 0 0 0 - OK P3129 Fibroblasts 0 1.95106 2.32154 1.89787 2.5648 - OK P313 iPS 0 0 0 0 0 - OK P313 iPS 1 3.43769 3.31195 5.66264 5.33818 - OK P313 hESC 1 4.15042 4.1083 2.71523 2.65369 - OK P313 hESC 0 11.8214 11.9426 7.89306 7.71415 - OK P313 Fibroblasts 1 0 0 0 0 - OK P313 Fibroblasts 0 0 0 0 0 - OK P3130 iPS 0 306.66 320.081 547.263 644.824 - OK P3130 iPS 1 345.585 332.945 569.256 670.738 - OK P3130 hESC 1 392.059 388.08 256.488 316.218 - OK P3130 hESC 0 450.116 454.731 300.538 370.526 - OK P3130 Fibroblasts 1 345.983 288.688 236.003 279.897 - OK P3130 Fibroblasts 0 262.062 311.824 254.917 302.328 - OK P3131 iPS 0 11.2592 11.752 20.0931 25.968 - OK P3131 iPS 1 20.08 19.3455 33.0762 42.747 - OK P3131 hESC 1 7.0794 7.00755 4.63139 6.29114 - OK P3131 hESC 0 17.3923 17.5706 11.6127 15.7743 - OK P3131 Fibroblasts 1 0 0 0 0 - OK P3131 Fibroblasts 0 0 0 0 0 - OK P3132 iPS 0 0 0 0 0 - OK P3132 iPS 1 0 0 0 0 - OK P3132 hESC 1 0 0 0 0 - OK P3132 hESC 0 0 0 0 0 - OK P3132 Fibroblasts 1 0 0 0 0 - OK P3132 Fibroblasts 0 0 0 0 0 - OK P3133 iPS 0 46 48.0133 82.0913 139.146 - OK P3133 iPS 1 65.5 63.1042 107.893 182.881 - OK P3133 hESC 1 1657 1640.18 1084.02 1962.48 - OK P3133 hESC 0 2121 2142.75 1416.17 2563.8 - OK P3133 Fibroblasts 1 1112 927.852 758.522 1297.86 - OK P3133 Fibroblasts 0 1533 1824.1 1491.2 2551.5 - OK P3134 iPS 0 0 0 0 0 - OK P3134 iPS 1 0.25 0.240856 0.411806 0.348287 - OK P3134 hESC 1 0 0 0 0 - OK P3134 hESC 0 0 0 0 0 - OK P3134 Fibroblasts 1 0 0 0 0 - OK P3134 Fibroblasts 0 0 0 0 0 - OK P3135 iPS 0 0 0 0 0 - OK P3135 iPS 1 0 0 0 0 - OK P3135 hESC 1 0 0 0 0 - OK P3135 hESC 0 0 0 0 0 - OK P3135 Fibroblasts 1 0 0 0 0 - OK P3135 Fibroblasts 0 0 0 0 0 - OK P3136 iPS 0 0 0 0 0 - OK P3136 iPS 1 0.000178204 0.000171686 0.000293542 0.000246058 - OK P3136 hESC 1 0 0 0 0 - OK P3136 hESC 0 0 0 0 0 - OK P3136 Fibroblasts 1 0 0 0 0 - OK P3136 Fibroblasts 0 0 0 0 0 - OK P3137 iPS 0 0 0 0 0 - OK P3137 iPS 1 0.45 0.43354 0.741251 0.675373 - OK P3137 hESC 1 0 0 0 0 - OK P3137 hESC 0 0 0 0 0 - OK P3137 Fibroblasts 1 0 0 0 0 - OK P3137 Fibroblasts 0 0 0 0 0 - OK P3138 iPS 0 0 0 0 0 - OK P3138 iPS 1 0.449822 0.433368 0.740957 0.669072 - OK P3138 hESC 1 0 0 0 0 - OK P3138 hESC 0 0 0 0 0 - OK P3138 Fibroblasts 1 0 0 0 0 - OK P3138 Fibroblasts 0 0 0 0 0 - OK P3139 iPS 0 5 5.21883 8.92297 15.0345 - OK P3139 iPS 1 10.5 10.1159 17.2958 29.1422 - OK P3139 hESC 1 211 208.859 138.038 248.31 - OK P3139 hESC 0 269 271.758 179.609 323.091 - OK P3139 Fibroblasts 1 175 146.02 119.372 203.021 - OK P3139 Fibroblasts 0 123 146.356 119.647 203.489 - OK P314 iPS 0 46.9292 48.9832 83.7496 48.423 - OK P314 iPS 1 47.8798 46.1285 78.8687 45.6009 - OK P314 hESC 1 84.0245 83.1717 54.9694 32.4887 - OK P314 hESC 0 75.8964 76.6746 50.6754 29.9508 - OK P314 Fibroblasts 1 12.5398 10.4632 8.55368 4.96147 - OK P314 Fibroblasts 0 4.84492 5.76492 4.71283 2.73363 - OK P3140 iPS 0 0 0 0 0 - OK P3140 iPS 1 0 0 0 0 - OK P3140 hESC 1 0 0 0 0 - OK P3140 hESC 0 0 0 0 0 - OK P3140 Fibroblasts 1 0 0 0 0 - OK P3140 Fibroblasts 0 0 0 0 0 - OK P3141 iPS 0 0 0 0 0 - OK P3141 iPS 1 0 0 0 0 - OK P3141 hESC 1 0 0 0 0 - OK P3141 hESC 0 0 0 0 0 - OK P3141 Fibroblasts 1 0 0 0 0 - OK P3141 Fibroblasts 0 0 0 0 0 - OK P3142 iPS 0 0 0 0 0 - OK P3142 iPS 1 0.332352 0.320195 0.547457 0.400722 - OK P3142 hESC 1 0 0 0 0 - OK P3142 hESC 0 0 0 0 0 - OK P3142 Fibroblasts 1 0 0 0 0 - OK P3142 Fibroblasts 0 0 0 0 0 - OK P3143 iPS 0 0 0 0 0 - OK P3143 iPS 1 0.000981826 0.000945913 0.00161729 0.00114586 - OK P3143 hESC 1 0 0 0 0 - OK P3143 hESC 0 0 0 0 0 - OK P3143 Fibroblasts 1 0 0 0 0 - OK P3143 Fibroblasts 0 0 0 0 0 - OK P3144 iPS 0 0 0 0 0 - OK P3144 iPS 1 0 0 0 0 - OK P3144 hESC 1 0 0 0 0 - OK P3144 hESC 0 0 0 0 0 - OK P3144 Fibroblasts 1 0 0 0 0 - OK P3144 Fibroblasts 0 0 0 0 0 - OK P3145 iPS 0 0 0 0 0 - OK P3145 iPS 1 1 0.963422 1.64722 1.38982 - OK P3145 hESC 1 0 0 0 0 - OK P3145 hESC 0 0 0 0 0 - OK P3145 Fibroblasts 1 0 0 0 0 - OK P3145 Fibroblasts 0 0 0 0 0 - OK P3146 iPS 0 0 0 0 0 - OK P3146 iPS 1 1.33333 1.28456 2.1963 1.60762 - OK P3146 hESC 1 0 0 0 0 - OK P3146 hESC 0 0 0 0 0 - OK P3146 Fibroblasts 1 0 0 0 0 - OK P3146 Fibroblasts 0 0 0 0 0 - OK P3147 iPS 0 0 0 0 0 - OK P3147 iPS 1 0 0 0 0 - OK P3147 hESC 1 0 0 0 0 - OK P3147 hESC 0 0 0 0 0 - OK P3147 Fibroblasts 1 0 0 0 0 - OK P3147 Fibroblasts 0 0 0 0 0 - OK P3148 iPS 0 4 4.17507 7.13837 5.80813 - OK P3148 iPS 1 6 5.78053 9.88334 8.04156 - OK P3148 hESC 1 15 14.8478 9.8131 8.23632 - OK P3148 hESC 0 15 15.1538 10.0154 8.40609 - OK P3148 Fibroblasts 1 0 0 0 0 - OK P3148 Fibroblasts 0 0 0 0 0 - OK P3149 iPS 0 0 0 0 0 - OK P3149 iPS 1 0 0 0 0 - OK P3149 hESC 1 470.831 466.053 308.021 246.673 - OK P3149 hESC 0 320.637 323.924 214.086 171.447 - OK P3149 Fibroblasts 1 310.255 258.877 211.632 165.238 - OK P3149 Fibroblasts 0 136.143 161.995 132.431 103.4 - OK P315 iPS 0 72.2641 75.4268 128.962 28.1148 - OK P315 iPS 1 73.9625 71.2572 121.833 26.5606 - OK P315 hESC 1 2885.41 2856.12 1887.65 414.925 - OK P315 hESC 0 3037.49 3068.63 2028.1 445.797 - OK P315 Fibroblasts 1 776.38 647.812 529.588 115.594 - OK P315 Fibroblasts 0 387.688 461.305 377.118 82.3142 - OK P3150 iPS 0 61.9634 64.6754 110.58 114.215 - OK P3150 iPS 1 102.57 98.8183 168.956 174.51 - OK P3150 hESC 1 181.272 179.433 118.59 127.436 - OK P3150 hESC 0 195.452 197.456 130.502 140.236 - OK P3150 Fibroblasts 1 21.7397 18.1396 14.8291 15.4045 - OK P3150 Fibroblasts 0 68.8986 81.9816 67.0201 69.6204 - OK P3151 iPS 0 111.69 116.579 199.322 67.9643 - OK P3151 iPS 1 147.272 141.885 242.589 82.7175 - OK P3151 hESC 1 167.511 165.811 109.587 37.8519 - OK P3151 hESC 0 123.936 125.207 82.7509 28.5825 - OK P3151 Fibroblasts 1 111.6 93.1194 76.1253 26.006 - OK P3151 Fibroblasts 0 76.3382 90.8339 74.2569 25.3677 - OK P3152 iPS 0 91.3461 95.3441 163.016 141.423 - OK P3152 iPS 1 142.158 136.958 234.166 203.149 - OK P3152 hESC 1 32.3289 32.0008 21.1498 18.9668 - OK P3152 hESC 0 120.267 121.5 80.3009 72.0127 - OK P3152 Fibroblasts 1 57.1239 47.6642 38.9656 31.8842 - OK P3152 Fibroblasts 0 127.495 151.704 124.019 106.181 - OK P3153 iPS 0 0 0 0 0 - OK P3153 iPS 1 0 0 0 0 - OK P3153 hESC 1 33.0558 32.7203 21.6253 16.7676 - OK P3153 hESC 0 36.7083 37.0847 24.5098 19.0042 - OK P3153 Fibroblasts 1 28.2809 23.5975 19.2911 14.5948 - OK P3153 Fibroblasts 0 7.1254 8.47843 6.93114 5.24381 - OK P3154 iPS 0 80 83.5014 142.767 99.5559 - OK P3154 iPS 1 125 120.428 205.903 143.582 - OK P3154 hESC 1 247.477 244.966 161.901 115.938 - OK P3154 hESC 0 250 252.563 166.923 119.533 - OK P3154 Fibroblasts 1 72.824 60.7643 49.675 34.7737 - OK P3154 Fibroblasts 0 75 89.2416 72.9552 51.0704 - OK P3155 iPS 0 1175 1226.43 2096.9 8005.09 - OK P3155 iPS 1 1170 1127.2 1927.25 7357.45 - OK P3155 hESC 1 7386 7311.04 4831.97 21537.1 - OK P3155 hESC 0 4898 4948.22 3270.35 14576.6 - OK P3155 Fibroblasts 1 5609 4680.15 3826.03 14920.7 - OK P3155 Fibroblasts 0 6791 8080.53 6605.85 25761.5 - OK P3156 iPS 0 3.18713 3.32662 5.68773 10.9088 - OK P3156 iPS 1 6.16469 5.9392 10.1546 19.476 - OK P3156 hESC 1 17.9536 17.7714 11.7454 24.2773 - OK P3156 hESC 0 13.3696 13.5067 8.92679 18.4514 - OK P3156 Fibroblasts 1 0 0 0 0 - OK P3156 Fibroblasts 0 2.0486 2.4376 1.99274 3.86289 - OK P3157 iPS 0 161.646 168.721 288.472 158.069 - OK P3157 iPS 1 67.045 64.5927 110.438 60.5148 - OK P3157 hESC 1 707.047 699.871 462.555 258.788 - OK P3157 hESC 0 715.329 722.664 477.619 267.216 - OK P3157 Fibroblasts 1 1343.11 1120.69 916.164 503.537 - OK P3157 Fibroblasts 0 1132.17 1347.16 1101.31 605.295 - OK P3158 iPS 0 0 0 0 0 - OK P3158 iPS 1 0.00429962 0.00414235 0.00708244 0.00418041 - OK P3158 hESC 1 32.665 32.3335 21.3697 12.8997 - OK P3158 hESC 0 0 0 0 0 - OK P3158 Fibroblasts 1 0 0 0 0 - OK P3158 Fibroblasts 0 12.6994 15.1108 12.3531 7.31529 - OK P3159 iPS 0 32.3972 33.8151 57.8159 31.4247 - OK P3159 iPS 1 34.9294 33.6518 57.5365 31.2729 - OK P3159 hESC 1 103.517 102.466 67.7213 37.5763 - OK P3159 hESC 0 38.7215 39.1185 25.854 14.3455 - OK P3159 Fibroblasts 1 168.977 140.994 115.263 62.8375 - OK P3159 Fibroblasts 0 81.4323 96.8953 79.2122 43.1838 - OK P316 iPS 0 183.784 191.827 327.979 77.7189 - OK P316 iPS 1 137.034 132.021 225.725 53.4884 - OK P316 hESC 1 583.404 577.483 381.667 91.2537 - OK P316 hESC 0 688.408 695.467 459.644 109.897 - OK P316 Fibroblasts 1 83.2756 69.4851 56.8043 13.4781 - OK P316 Fibroblasts 0 84.8119 100.917 82.4996 19.5749 - OK P3160 iPS 0 0 0 0 0 - OK P3160 iPS 1 0 0 0 0 - OK P3160 hESC 1 0 0 0 0 - OK P3160 hESC 0 32.5577 32.8916 21.7385 12.1814 - OK P3160 Fibroblasts 1 0 0 0 0 - OK P3160 Fibroblasts 0 0 0 0 0 - OK P3161 iPS 0 0 0 0 0 - OK P3161 iPS 1 0 0 0 0 - OK P3161 hESC 1 0 0 0 0 - OK P3161 hESC 0 0 0 0 0 - OK P3161 Fibroblasts 1 0 0 0 0 - OK P3161 Fibroblasts 0 0 0 0 0 - OK P3162 iPS 0 0 0 0 0 - OK P3162 iPS 1 7.8009 7.51556 12.8498 10.3246 - OK P3162 hESC 1 16.3456 16.1798 10.6934 8.85955 - OK P3162 hESC 0 12.9326 13.0652 8.635 7.15413 - OK P3162 Fibroblasts 1 20.6633 17.2414 14.0949 11.3755 - OK P3162 Fibroblasts 0 10.6826 12.7111 10.3914 8.38648 - OK P3163 iPS 0 6.97416 7.2794 12.446 10.1971 - OK P3163 iPS 1 0 0 0 0 - OK P3163 hESC 1 0 0 0 0 - OK P3163 hESC 0 6.67349 6.74191 4.45583 3.76668 - OK P3163 Fibroblasts 1 5.67647 4.73645 3.87206 3.18681 - OK P3163 Fibroblasts 0 27.0622 32.201 26.3244 21.6657 - OK P3164 iPS 0 7.79567 8.13686 13.9121 19.7083 - OK P3164 iPS 1 2.05566 1.98047 3.38614 4.7969 - OK P3164 hESC 1 7.97197 7.89107 5.21532 7.80374 - OK P3164 hESC 0 9.4159 9.51244 6.28691 9.40717 - OK P3164 Fibroblasts 1 21.5783 18.0049 14.7191 21.0158 - OK P3164 Fibroblasts 0 21.9001 26.0587 21.303 30.4164 - OK P3165 iPS 0 24.5568 25.6315 43.8239 22.879 - OK P3165 iPS 1 12.1382 11.6942 19.9943 10.4384 - OK P3165 hESC 1 0 0 0 0 - OK P3165 hESC 0 7.33392 7.40912 4.89679 2.60762 - OK P3165 Fibroblasts 1 54.8425 45.7606 37.4094 19.5866 - OK P3165 Fibroblasts 0 31.8817 37.9356 31.0125 16.2374 - OK P3166 iPS 0 17.3255 18.0838 30.919 15.9825 - OK P3166 iPS 1 0 0 0 0 - OK P3166 hESC 1 0 0 0 0 - OK P3166 hESC 0 0 0 0 0 - OK P3166 Fibroblasts 1 0 0 0 0 - OK P3166 Fibroblasts 0 72.4522 86.2099 70.4769 36.5348 - OK P3167 iPS 0 226.147 236.045 403.58 209.536 - OK P3167 iPS 1 0.0328916 0.0316885 0.0541799 0.0281298 - OK P3167 hESC 1 13.0413 12.909 8.53172 4.51777 - OK P3167 hESC 0 0.0295799 0.0298832 0.0197502 0.0104583 - OK P3167 Fibroblasts 1 636.05 530.72 433.865 225.907 - OK P3167 Fibroblasts 0 503.256 598.818 489.535 254.894 - OK P3168 iPS 0 94.9715 99.1282 169.486 106.671 - OK P3168 iPS 1 12.8287 12.3594 21.1317 13.2999 - OK P3168 hESC 1 15.9588 15.7968 10.4404 6.73019 - OK P3168 hESC 0 1.63616 1.65293 1.09245 0.704227 - OK P3168 Fibroblasts 1 702.228 585.939 479.006 302.529 - OK P3168 Fibroblasts 0 792.088 942.496 770.493 486.625 - OK P3169 iPS 0 0 0 0 0 - OK P3169 iPS 1 0 0 0 0 - OK P3169 hESC 1 0 0 0 0 - OK P3169 hESC 0 0 0 0 0 - OK P3169 Fibroblasts 1 156.876 130.897 107.009 55.4118 - OK P3169 Fibroblasts 0 133.322 158.638 129.687 67.1553 - OK P317 iPS 0 0 0 0 0 - OK P317 iPS 1 0 0 0 0 - OK P317 hESC 1 0 0 0 0 - OK P317 hESC 0 0 0 0 0 - OK P317 Fibroblasts 1 0 0 0 0 - OK P317 Fibroblasts 0 0 0 0 0 - OK P3170 iPS 0 1.59956 1.66957 2.85457 2.63482 - OK P3170 iPS 1 5.50004 5.29886 9.0598 8.36235 - OK P3170 hESC 1 44.1626 43.7144 28.8915 27.6258 - OK P3170 hESC 0 25.691 25.9544 17.1537 16.4022 - OK P3170 Fibroblasts 1 48.6213 40.5696 33.1657 30.7694 - OK P3170 Fibroblasts 0 51.1849 60.9043 49.7894 46.1919 - OK P3171 iPS 0 4.90082 5.11531 8.74597 17.0753 - OK P3171 iPS 1 0 0 0 0 - OK P3171 hESC 1 5.33778 5.2836 3.49201 7.35763 - OK P3171 hESC 0 1.80908 1.82763 1.20791 2.54505 - OK P3171 Fibroblasts 1 5.64787 4.71258 3.85255 7.60353 - OK P3171 Fibroblasts 0 3.81507 4.5395 3.71105 7.32427 - OK P3172 iPS 0 10.7718 11.2432 19.2232 18.5799 - OK P3172 iPS 1 17.8549 17.2018 29.4111 28.4268 - OK P3172 hESC 1 0 0 0 0 - OK P3172 hESC 0 7.41611 7.49215 4.95167 4.9664 - OK P3172 Fibroblasts 1 0 0 0 0 - OK P3172 Fibroblasts 0 0 0 0 0 - OK P3173 iPS 0 321.228 335.287 573.262 214.61 - OK P3173 iPS 1 410.145 395.143 675.601 252.922 - OK P3173 hESC 1 2049 2028.2 1340.47 508.99 - OK P3173 hESC 0 2550.08 2576.23 1702.67 646.52 - OK P3173 Fibroblasts 1 2259 1884.91 1540.92 578.063 - OK P3173 Fibroblasts 0 3461 4118.2 3366.64 1262.97 - OK P3174 iPS 0 0 0 0 0 - OK P3174 iPS 1 44.2745 42.655 72.93 56.0509 - OK P3174 hESC 1 703.736 696.594 460.389 364.361 - OK P3174 hESC 0 561.01 566.762 374.581 296.452 - OK P3174 Fibroblasts 1 233.766 195.054 159.457 123.074 - OK P3174 Fibroblasts 0 181.559 216.035 176.609 136.313 - OK P3175 iPS 0 0 0 0 0 - OK P3175 iPS 1 0.0381138 0.0367196 0.0627819 0.048889 - OK P3175 hESC 1 0 0 0 0 - OK P3175 hESC 0 0 0 0 0 - OK P3175 Fibroblasts 1 82.9927 69.2491 56.6113 44.2742 - OK P3175 Fibroblasts 0 48.1022 57.2362 46.7907 36.5938 - OK P3176 iPS 0 182 189.966 324.796 160.558 - OK P3176 iPS 1 167.687 161.554 276.219 136.545 - OK P3176 hESC 1 2105.76 2084.39 1377.6 693.892 - OK P3176 hESC 0 2017.99 2038.68 1347.39 678.675 - OK P3176 Fibroblasts 1 38.2415 31.9087 26.0854 12.9302 - OK P3176 Fibroblasts 0 4.33866 5.16252 4.22037 2.09199 - OK P3177 iPS 0 17 17.744 30.3381 30.84 - OK P3177 iPS 1 15 14.4513 24.7084 25.1171 - OK P3177 hESC 1 97 96.0155 63.458 67.0708 - OK P3177 hESC 0 61 61.6254 40.7291 43.0479 - OK P3177 Fibroblasts 1 253 211.103 172.577 176.423 - OK P3177 Fibroblasts 0 185 220.129 179.956 183.966 - OK P3178 iPS 0 23.4303 24.4558 41.8136 25.6435 - OK P3178 iPS 1 18.3519 17.6806 30.2297 18.5393 - OK P3178 hESC 1 5.04507 4.99386 3.30052 2.07191 - OK P3178 hESC 0 5.98566 6.04703 3.99657 2.50886 - OK P3178 Fibroblasts 1 44.414 37.059 30.2959 18.643 - OK P3178 Fibroblasts 0 20.706 24.6378 20.1415 12.3944 - OK P3179 iPS 0 373.274 389.611 666.143 335.631 - OK P3179 iPS 1 295.849 285.028 487.33 245.538 - OK P3179 hESC 1 774.747 766.884 506.845 260.3 - OK P3179 hESC 0 752.693 760.411 502.566 258.103 - OK P3179 Fibroblasts 1 1645.34 1372.87 1122.32 567.052 - OK P3179 Fibroblasts 0 996.451 1185.67 969.284 489.73 - OK P318 iPS 0 12.3219 12.8612 21.9895 13.5978 - OK P318 iPS 1 0 0 0 0 - OK P318 hESC 1 0.000308552 0.000305421 0.000201857 0.000127794 - OK P318 hESC 0 0 0 0 0 - OK P318 Fibroblasts 1 2.82618e-05 2.35817e-05 1.92781e-05 1.11079e-05 - OK P318 Fibroblasts 0 0 0 0 0 - OK P3180 iPS 0 6.1265 6.39464 10.9333 5.35606 - OK P3180 iPS 1 23.4595 22.6014 38.643 18.9306 - OK P3180 hESC 1 15.7593 15.5994 10.3098 5.14538 - OK P3180 hESC 0 37.8755 38.2638 25.2891 12.6211 - OK P3180 Fibroblasts 1 133.25 111.184 90.8932 44.6479 - OK P3180 Fibroblasts 0 39.8427 47.4083 38.7564 19.0376 - OK P3181 iPS 0 34.5024 36.0125 61.5728 31.1562 - OK P3181 iPS 1 27.3395 26.3395 45.0342 22.7876 - OK P3181 hESC 1 2.44885 2.424 1.60205 0.826367 - OK P3181 hESC 0 3.44577 3.4811 2.30071 1.18674 - OK P3181 Fibroblasts 1 0 0 0 0 - OK P3181 Fibroblasts 0 0 0 0 0 - OK P3182 iPS 0 0 0 0 0 - OK P3182 iPS 1 1.98872 1.91597 3.27586 2.50951 - OK P3182 hESC 1 0 0 0 0 - OK P3182 hESC 0 0 0 0 0 - OK P3182 Fibroblasts 1 0 0 0 0 - OK P3182 Fibroblasts 0 0 0 0 0 - OK P3183 iPS 0 0 0 0 0 - OK P3183 iPS 1 0 0 0 0 - OK P3183 hESC 1 0 0 0 0 - OK P3183 hESC 0 0 0 0 0 - OK P3183 Fibroblasts 1 0 0 0 0 - OK P3183 Fibroblasts 0 0 0 0 0 - OK P3184 iPS 0 0 0 0 0 - OK P3184 iPS 1 0 0 0 0 - OK P3184 hESC 1 19.9255 19.7233 13.0354 52.1823 - OK P3184 hESC 0 42.5912 43.0279 28.4378 113.84 - OK P3184 Fibroblasts 1 17.2834 14.4212 11.7894 41.8251 - OK P3184 Fibroblasts 0 6.5016 7.73618 6.32434 22.4368 - OK P3185 iPS 0 0 0 0 0 - OK P3185 iPS 1 0 0 0 0 - OK P3185 hESC 1 110.791 109.666 72.4801 79.3946 - OK P3185 hESC 0 222.251 224.529 148.395 162.551 - OK P3185 Fibroblasts 1 898.256 749.505 612.722 648.398 - OK P3185 Fibroblasts 0 431.539 513.483 419.774 444.215 - OK P3186 iPS 0 32.771 34.2053 58.4829 61.5286 - OK P3186 iPS 1 36.9033 35.5535 60.788 63.9537 - OK P3186 hESC 1 35.8705 35.5064 23.4667 25.7054 - OK P3186 hESC 0 44.1596 44.6124 29.485 32.2978 - OK P3186 Fibroblasts 1 293.223 244.665 200.015 211.661 - OK P3186 Fibroblasts 0 232.748 276.944 226.402 239.585 - OK P3187 iPS 0 2.68826 2.80591 4.79744 3.31274 - OK P3187 iPS 1 6.202 5.97515 10.2161 7.05442 - OK P3187 hESC 1 2.28495 2.26176 1.49483 1.05972 - OK P3187 hESC 0 18.7197 18.9116 12.4989 8.86078 - OK P3187 Fibroblasts 1 3.87295 3.23159 2.64183 1.83122 - OK P3187 Fibroblasts 0 9.53692 11.3479 9.27691 6.43042 - OK P3188 iPS 0 343.717 358.76 613.394 211.602 - OK P3188 iPS 1 163.521 157.54 269.355 92.9192 - OK P3188 hESC 1 497.016 491.971 325.151 113.641 - OK P3188 hESC 0 450.044 454.659 300.491 105.022 - OK P3188 Fibroblasts 1 2981.32 2487.61 2033.63 702.878 - OK P3188 Fibroblasts 0 1414.92 1683.59 1376.34 475.701 - OK P3189 iPS 0 0 0 0 0 - OK P3189 iPS 1 0 0 0 0 - OK P3189 hESC 1 6.32936 6.26512 4.14071 6.16319 - OK P3189 hESC 0 1.09428 1.1055 0.730644 1.08752 - OK P3189 Fibroblasts 1 0 0 0 0 - OK P3189 Fibroblasts 0 0 0 0 0 - OK P319 iPS 0 0 0 0 0 - OK P319 iPS 1 5 4.81711 8.23612 3.16629 - OK P319 hESC 1 2.9493 2.91937 1.92945 0.752634 - OK P319 hESC 0 5.99842 6.05992 4.00509 1.56229 - OK P319 Fibroblasts 1 0 0 0 0 - OK P319 Fibroblasts 0 0 0 0 0 - OK P3190 iPS 0 3 3.1313 5.35378 3.75843 - OK P3190 iPS 1 0 0 0 0 - OK P3190 hESC 1 23.6706 23.4304 15.4855 12.2077 - OK P3190 hESC 0 19.9057 20.1098 13.2909 10.4776 - OK P3190 Fibroblasts 1 0 0 0 0 - OK P3190 Fibroblasts 0 0 0 0 0 - OK P3191 iPS 0 0 0 0 0 - OK P3191 iPS 1 6.82711 6.57739 11.2458 3.7629 - OK P3191 hESC 1 18.7425 18.5523 12.2615 4.15502 - OK P3191 hESC 0 10.4596 10.5669 6.98379 2.36658 - OK P3191 Fibroblasts 1 5.35341 4.46688 3.65169 1.22414 - OK P3191 Fibroblasts 0 6.8835 8.19059 6.69583 2.24461 - OK P3192 iPS 0 31 32.3567 55.3223 19.5518 - OK P3192 iPS 1 15.1729 14.6179 24.9931 8.83296 - OK P3192 hESC 1 163.257 161.601 106.804 38.2544 - OK P3192 hESC 0 162.04 163.702 108.193 38.7518 - OK P3192 Fibroblasts 1 7.14659 5.96311 4.87486 1.72622 - OK P3192 Fibroblasts 0 3.1165 3.70828 3.03153 1.07348 - OK P3193 iPS 0 648.699 677.09 1157.66 1756.05 - OK P3193 iPS 1 564.629 543.976 930.07 1410.82 - OK P3193 hESC 1 4206.59 4163.89 2751.98 4426.87 - OK P3193 hESC 0 3675.22 3712.91 2453.91 3947.4 - OK P3193 Fibroblasts 1 836.254 697.77 570.428 872.692 - OK P3193 Fibroblasts 0 2068.36 2461.12 2011.97 3078.88 - OK P3194 iPS 0 100.301 104.691 178.997 272.396 - OK P3194 iPS 1 163.371 157.395 269.109 409.526 - OK P3194 hESC 1 828.415 820.007 541.954 874.78 - OK P3194 hESC 0 796.278 804.442 531.667 858.176 - OK P3194 Fibroblasts 1 190.746 159.159 130.113 199.701 - OK P3194 Fibroblasts 0 415.639 494.564 404.307 620.908 - OK P3195 iPS 0 10.6637 11.1304 19.0304 18.2935 - OK P3195 iPS 1 21.0184 20.2496 34.622 33.2814 - OK P3195 hESC 1 25.3149 25.058 16.5612 16.5167 - OK P3195 hESC 0 31.1574 31.4769 20.8035 20.7477 - OK P3195 Fibroblasts 1 0 0 0 0 - OK P3195 Fibroblasts 0 0 0 0 0 - OK P3196 iPS 0 0 0 0 0 - OK P3196 iPS 1 14.4864 13.9566 23.8624 9.57165 - OK P3196 hESC 1 13.9818 13.8399 9.14698 3.72519 - OK P3196 hESC 0 76.5545 77.3394 51.1147 20.8169 - OK P3196 Fibroblasts 1 0.0776685 0.0648066 0.0529795 0.0212982 - OK P3196 Fibroblasts 0 73.8879 87.9183 71.8735 28.8937 - OK P3197 iPS 0 0.371325 0.387577 0.662664 1.02722 - OK P3197 iPS 1 0 0 0 0 - OK P3197 hESC 1 23.4869 23.2485 15.3653 25.292 - OK P3197 hESC 0 20.591 20.8022 13.7484 22.6306 - OK P3197 Fibroblasts 1 25.2638 21.0801 17.2331 26.9443 - OK P3197 Fibroblasts 0 40.2952 47.9467 39.1966 61.2846 - OK P3198 iPS 0 184.417 192.489 329.11 121.599 - OK P3198 iPS 1 189.23 182.308 311.704 115.167 - OK P3198 hESC 1 2109.66 2088.25 1380.16 517.118 - OK P3198 hESC 0 2270.87 2294.15 1516.24 568.106 - OK P3198 Fibroblasts 1 743.354 620.254 507.059 187.73 - OK P3198 Fibroblasts 0 480.937 572.261 467.825 173.204 - OK P3199 iPS 0 146.318 152.721 261.117 96.8565 - OK P3199 iPS 1 271.859 261.915 447.813 166.107 - OK P3199 hESC 1 2014.49 1994.05 1317.89 495.76 - OK P3199 hESC 0 1821.32 1839.99 1216.08 457.459 - OK P3199 Fibroblasts 1 773.229 645.182 527.438 196.045 - OK P3199 Fibroblasts 0 620.142 737.899 603.235 224.217 - OK P32 iPS 0 9.228 9.63189 16.4682 11.8038 - OK P32 iPS 1 0 0 0 0 - OK P32 hESC 1 190.04 188.111 124.325 91.5793 - OK P32 hESC 0 83.4042 84.2593 55.6882 41.0204 - OK P32 Fibroblasts 1 0 0 0 0 - OK P32 Fibroblasts 0 55.362 65.8746 53.8526 38.7529 - OK P320 iPS 0 14.6781 15.3206 26.1945 15.2325 - OK P320 iPS 1 0 0 0 0 - OK P320 hESC 1 7.50293 7.42678 4.90847 2.91814 - OK P320 hESC 0 0 0 0 0 - OK P320 Fibroblasts 1 0 0 0 0 - OK P320 Fibroblasts 0 0 0 0 0 - OK P3200 iPS 0 24.23 25.2905 43.2408 57.8935 - OK P3200 iPS 1 33.4064 32.1845 55.0278 73.6747 - OK P3200 hESC 1 422.062 417.778 276.116 389.272 - OK P3200 hESC 0 391.511 395.526 261.409 368.538 - OK P3200 Fibroblasts 1 257.075 214.504 175.357 236.528 - OK P3200 Fibroblasts 0 167.737 199.589 163.164 220.082 - OK P3201 iPS 0 678.5 708.196 1210.85 1755.76 - OK P3201 iPS 1 557.5 537.108 918.327 1331.6 - OK P3201 hESC 1 1528 1512.49 999.628 1533.05 - OK P3201 hESC 0 1629 1645.7 1087.67 1668.07 - OK P3201 Fibroblasts 1 5250 4380.6 3581.15 5234.69 - OK P3201 Fibroblasts 0 3746.5 4457.91 3644.36 5327.08 - OK P3202 iPS 0 7.45596 7.78229 13.3059 12.9135 - OK P3202 iPS 1 0 0 0 0 - OK P3202 hESC 1 6.4082 6.34316 4.19229 4.22272 - OK P3202 hESC 0 0.915695 0.925084 0.611401 0.615839 - OK P3202 Fibroblasts 1 0 0 0 0 - OK P3202 Fibroblasts 0 0 0 0 0 - OK P3203 iPS 0 46.544 48.5811 83.0622 28.0117 - OK P3203 iPS 1 35.891 34.5782 59.1205 19.9377 - OK P3203 hESC 1 287.592 284.673 188.144 64.2642 - OK P3203 hESC 0 275.084 277.905 183.671 62.7363 - OK P3203 Fibroblasts 1 0.00015203 0.000126854 0.000103703 3.363e-05 - OK P3203 Fibroblasts 0 0 0 0 0 - OK P3204 iPS 0 0 0 0 0 - OK P3204 iPS 1 4.10899 3.95869 6.76842 2.48908 - OK P3204 hESC 1 0 0 0 0 - OK P3204 hESC 0 0 0 0 0 - OK P3204 Fibroblasts 1 6.99985 5.84067 4.77476 1.68266 - OK P3204 Fibroblasts 0 0 0 0 0 - OK P3205 iPS 0 3325 3470.53 5933.77 2190.88 - OK P3205 iPS 1 7339.5 7071.04 12089.8 4482.7 - OK P3205 hESC 1 23859.5 23617.3 15609 5880.72 - OK P3205 hESC 0 20512 20722.3 13695.7 5133.09 - OK P3205 Fibroblasts 1 3227 2692.61 2201.21 818.689 - OK P3205 Fibroblasts 0 3504 4169.37 3408.47 1270.19 - OK P3206 iPS 0 1 1.04377 1.78459 1.00135 - OK P3206 iPS 1 0 0 0 0 - OK P3206 hESC 1 0 0 0 0 - OK P3206 hESC 0 0 0 0 0 - OK P3206 Fibroblasts 1 0 0 0 0 - OK P3206 Fibroblasts 0 0 0 0 0 - OK P3207 iPS 0 354.976 370.513 633.488 283.939 - OK P3207 iPS 1 78.5516 75.6783 129.392 61.1234 - OK P3207 hESC 1 1218.84 1206.47 797.371 363.783 - OK P3207 hESC 0 1704.62 1722.1 1138.16 511.905 - OK P3207 Fibroblasts 1 1089.75 909.288 743.345 328.008 - OK P3207 Fibroblasts 0 1118.83 1331.28 1088.32 480.233 - OK P3208 iPS 0 0.0237338 0.0247726 0.0423552 0.0194935 - OK P3208 iPS 1 239.448 230.69 394.425 181.529 - OK P3208 hESC 1 915.163 905.875 598.706 280.398 - OK P3208 hESC 0 520.382 525.718 347.454 162.727 - OK P3208 Fibroblasts 1 651.249 543.402 444.232 204.973 - OK P3208 Fibroblasts 0 122.173 145.373 118.842 54.8351 - OK P3209 iPS 0 280 292.255 499.686 124.716 - OK P3209 iPS 1 192 184.977 316.267 78.9369 - OK P3209 hESC 1 524 518.682 342.804 86.3707 - OK P3209 hESC 0 557 562.711 371.904 93.7024 - OK P3209 Fibroblasts 1 2194.5 1831.09 1496.92 374.131 - OK P3209 Fibroblasts 0 951 1131.58 925.072 231.207 - OK P321 iPS 0 0 0 0 0 - OK P321 iPS 1 0 0 0 0 - OK P321 hESC 1 6.54746 6.48101 4.28339 3.24822 - OK P321 hESC 0 0.00158422 0.00160047 0.00105777 0.000802138 - OK P321 Fibroblasts 1 1.99997 1.66878 1.36423 0.925111 - OK P321 Fibroblasts 0 0 0 0 0 - OK P3210 iPS 0 10.4191 10.8751 18.5939 7.94738 - OK P3210 iPS 1 3.13978 3.02494 5.17192 2.21058 - OK P3210 hESC 1 1698.86 1681.61 1111.4 482.791 - OK P3210 hESC 0 1274.82 1287.89 851.183 369.752 - OK P3210 Fibroblasts 1 335.621 280.042 228.935 98.0826 - OK P3210 Fibroblasts 0 940.238 1118.78 914.604 391.844 - OK P3211 iPS 0 27.995 29.2203 49.9598 21.328 - OK P3211 iPS 1 49.1172 47.3206 80.907 34.5394 - OK P3211 hESC 1 1511.72 1496.38 988.977 429.082 - OK P3211 hESC 0 2427.85 2452.75 1621.06 703.319 - OK P3211 Fibroblasts 1 1489.18 1242.57 1015.8 434.674 - OK P3211 Fibroblasts 0 1208.18 1437.59 1175.24 502.897 - OK P3212 iPS 0 187.34 195.54 334.326 84.6997 - OK P3212 iPS 1 351.708 338.843 579.341 146.773 - OK P3212 hESC 1 29.5369 29.2371 19.3232 4.9425 - OK P3212 hESC 0 26.4732 26.7446 17.6759 4.52114 - OK P3212 Fibroblasts 1 31.0003 25.8666 21.146 5.36473 - OK P3212 Fibroblasts 0 26.3342 31.3348 25.6162 6.49883 - OK P3213 iPS 0 0 0 0 0 - OK P3213 iPS 1 0 0 0 0 - OK P3213 hESC 1 0 0 0 0 - OK P3213 hESC 0 0 0 0 0 - OK P3213 Fibroblasts 1 0 0 0 0 - OK P3213 Fibroblasts 0 2.30952 2.74808 2.24656 1.59155 - OK P3214 iPS 0 0 0 0 0 - OK P3214 iPS 1 0 0 0 0 - OK P3214 hESC 1 394.998 390.989 258.41 137.04 - OK P3214 hESC 0 536.685 542.188 358.34 190.035 - OK P3214 Fibroblasts 1 0 0 0 0 - OK P3214 Fibroblasts 0 32.0309 38.1131 31.1576 16.2472 - OK P3215 iPS 0 51.4174 53.6678 91.7592 43.9023 - OK P3215 iPS 1 44.1163 42.5026 72.6694 34.7687 - OK P3215 hESC 1 593.921 587.893 388.547 189.305 - OK P3215 hESC 0 617.353 623.683 412.201 200.83 - OK P3215 Fibroblasts 1 548.362 457.553 374.051 179.439 - OK P3215 Fibroblasts 0 341.659 406.535 332.344 159.431 - OK P3216 iPS 0 0 0 0 0 - OK P3216 iPS 1 0 0 0 0 - OK P3216 hESC 1 32.0869 31.7613 20.9915 11.0166 - OK P3216 hESC 0 103.332 104.392 68.9939 36.2088 - OK P3216 Fibroblasts 1 41.6399 34.7443 28.4036 14.6598 - OK P3216 Fibroblasts 0 49.6479 59.0755 48.2943 24.9259 - OK P3217 iPS 0 3.31221 3.45717 5.91094 3.53168 - OK P3217 iPS 1 0 0 0 0 - OK P3217 hESC 1 320.851 317.594 209.903 128.294 - OK P3217 hESC 0 159.865 161.505 106.741 65.2408 - OK P3217 Fibroblasts 1 910.05 759.345 620.767 372.124 - OK P3217 Fibroblasts 0 351.089 417.756 341.517 204.725 - OK P3218 iPS 0 3.11566 3.25202 5.56018 10.1678 - OK P3218 iPS 1 6.24469 6.01627 10.2864 18.8106 - OK P3218 hESC 1 24.9557 24.7024 16.3262 32.0592 - OK P3218 hESC 0 78.9506 79.7601 52.7146 103.514 - OK P3218 Fibroblasts 1 188.005 156.871 128.243 236.908 - OK P3218 Fibroblasts 0 112.582 133.96 109.513 202.307 - OK P3219 iPS 0 3686.95 3848.32 6579.71 592.354 - OK P3219 iPS 1 4388.19 4227.68 7228.32 650.747 - OK P3219 hESC 1 11372.1 11256.6 7439.68 672.049 - OK P3219 hESC 0 14294.2 14440.8 9544.13 862.15 - OK P3219 Fibroblasts 1 13155.3 10976.7 8973.52 808.264 - OK P3219 Fibroblasts 0 5958.27 7089.67 5795.83 522.042 - OK P322 iPS 0 3 3.1313 5.35378 2.50891 - OK P322 iPS 1 19 18.305 31.2972 14.6666 - OK P322 hESC 1 59 58.4012 38.5982 18.4124 - OK P322 hESC 0 23 23.2358 15.3569 7.32565 - OK P322 Fibroblasts 1 2 1.6688 1.36425 0.605715 - OK P322 Fibroblasts 0 0 0 0 0 - OK P3220 iPS 0 41.4309 43.2442 73.9373 34.9265 - OK P3220 iPS 1 55.7358 53.6971 91.8093 43.3688 - OK P3220 hESC 1 11.1148 11.0019 7.27135 3.49693 - OK P3220 hESC 0 22.0004 22.226 14.6895 7.06446 - OK P3220 Fibroblasts 1 21.2268 17.7116 14.4793 6.85761 - OK P3220 Fibroblasts 0 9.36491 11.1432 9.10958 4.31444 - OK P3221 iPS 0 38.4159 40.0972 68.5567 23.8477 - OK P3221 iPS 1 97.9453 94.3627 161.338 56.1219 - OK P3221 hESC 1 351.41 347.844 229.895 81.0293 - OK P3221 hESC 0 612.438 618.717 408.919 144.128 - OK P3221 Fibroblasts 1 963.689 804.102 657.355 229.103 - OK P3221 Fibroblasts 0 761.309 905.872 740.553 258.099 - OK P3222 iPS 0 454.478 474.369 811.058 281.921 - OK P3222 iPS 1 412.035 396.964 678.714 235.919 - OK P3222 hESC 1 2013.84 1993.4 1317.47 464.011 - OK P3222 hESC 0 1918.98 1938.65 1281.28 451.266 - OK P3222 Fibroblasts 1 8466.08 7064.09 5774.91 2011.2 - OK P3222 Fibroblasts 0 6065.61 7217.39 5900.24 2054.85 - OK P3223 iPS 0 0 0 0 0 - OK P3223 iPS 1 0 0 0 0 - OK P3223 hESC 1 141.726 140.288 92.7184 32.6797 - OK P3223 hESC 0 83.3899 84.2449 55.6787 19.6246 - OK P3223 Fibroblasts 1 346.219 288.885 236.165 82.3087 - OK P3223 Fibroblasts 0 125.122 148.881 121.711 42.4189 - OK P3224 iPS 0 27.4039 28.6033 48.9048 17.2794 - OK P3224 iPS 1 0 0 0 0 - OK P3224 hESC 1 27.2916 27.0147 17.8544 6.39335 - OK P3224 hESC 0 10.0032 10.1058 6.67904 2.39165 - OK P3224 Fibroblasts 1 38.6013 32.2089 26.3309 9.32161 - OK P3224 Fibroblasts 0 54.1513 64.4339 52.6749 18.6479 - OK P3225 iPS 0 9.23083e-05 9.63483e-05 0.000164733 0.000108558 - OK P3225 iPS 1 8.5 8.18909 14.0014 9.22686 - OK P3225 hESC 1 22.4996 22.2712 14.7194 9.94638 - OK P3225 hESC 0 30.5 30.8127 20.3646 13.761 - OK P3225 Fibroblasts 1 22 18.3568 15.0067 9.92548 - OK P3225 Fibroblasts 0 17 20.2281 16.5365 10.9373 - OK P3226 iPS 0 6.49991 6.78439 11.5997 8.41658 - OK P3226 iPS 1 0 0 0 0 - OK P3226 hESC 1 0.000435114 0.000430698 0.000284655 0.000212333 - OK P3226 hESC 0 0 0 0 0 - OK P3226 Fibroblasts 1 0 0 0 0 - OK P3226 Fibroblasts 0 0 0 0 0 - OK P3227 iPS 0 8.5 8.87202 15.169 19.9877 - OK P3227 iPS 1 5.5 5.29882 9.05973 11.9377 - OK P3227 hESC 1 22 21.7767 14.3925 19.9528 - OK P3227 hESC 0 17 17.1743 11.3507 15.7358 - OK P3227 Fibroblasts 1 14 11.6816 9.54973 12.6755 - OK P3227 Fibroblasts 0 13.5 16.0635 13.1319 17.4303 - OK P3228 iPS 0 11.3375 11.8337 20.2328 33.105 - OK P3228 iPS 1 4.35077 4.19163 7.16669 11.7262 - OK P3228 hESC 1 2.07585 2.05479 1.35804 2.36764 - OK P3228 hESC 0 2.07823 2.09954 1.38762 2.41922 - OK P3228 Fibroblasts 1 0 0 0 0 - OK P3228 Fibroblasts 0 4.15034 4.93844 4.03719 6.66589 - OK P3229 iPS 0 193.662 202.139 345.609 409.266 - OK P3229 iPS 1 135.649 130.688 223.445 264.601 - OK P3229 hESC 1 892.424 883.367 583.83 723.574 - OK P3229 hESC 0 849.422 858.131 567.151 702.903 - OK P3229 Fibroblasts 1 2370.41 1977.87 1616.91 1927.33 - OK P3229 Fibroblasts 0 2911.97 3464.91 2832.57 3376.38 - OK P323 iPS 0 4 4.17507 7.13837 4.81405 - OK P323 iPS 1 3 2.89027 4.94167 3.33261 - OK P323 hESC 1 6.24276 6.1794 4.08406 2.82588 - OK P323 hESC 0 7 7.07177 4.67384 3.23397 - OK P323 Fibroblasts 1 0 0 0 0 - OK P323 Fibroblasts 0 0 0 0 0 - OK P3230 iPS 0 0 0 0 0 - OK P3230 iPS 1 0 0 0 0 - OK P3230 hESC 1 0 0 0 0 - OK P3230 hESC 0 0 0 0 0 - OK P3230 Fibroblasts 1 1138.09 949.621 776.318 1015.18 - OK P3230 Fibroblasts 0 75.8846 90.2942 73.8157 96.5278 - OK P3231 iPS 0 1672.22 1745.41 2984.23 2888.3 - OK P3231 iPS 1 1130.23 1088.89 1861.74 1801.89 - OK P3231 hESC 1 8310.66 8226.32 5436.89 5460.8 - OK P3231 hESC 0 7638.42 7716.74 5100.11 5122.54 - OK P3231 Fibroblasts 1 29821.5 24883.1 20342 19793.9 - OK P3231 Fibroblasts 0 19357.2 23032.9 18829.5 18322.2 - OK P3232 iPS 0 2.48512 2.59388 4.43492 3.33422 - OK P3232 iPS 1 25.9071 24.9594 42.6747 32.0833 - OK P3232 hESC 1 0 0 0 0 - OK P3232 hESC 0 31.0195 31.3375 20.7114 16.0239 - OK P3232 Fibroblasts 1 324.545 270.801 221.38 167.13 - OK P3232 Fibroblasts 0 9.04181 10.7587 8.7953 6.63996 - OK P3233 iPS 0 33.7947 35.2738 60.3099 44.5135 - OK P3233 iPS 1 33.7739 32.5385 55.6331 41.0617 - OK P3233 hESC 1 128.835 127.528 84.2849 63.9842 - OK P3233 hESC 0 153.557 155.131 102.528 77.8337 - OK P3233 Fibroblasts 1 37.2376 31.0711 25.4007 18.8245 - OK P3233 Fibroblasts 0 179.712 213.837 174.812 129.553 - OK P3234 iPS 0 537.003 560.506 958.331 963.112 - OK P3234 iPS 1 977.092 941.352 1609.49 1617.52 - OK P3234 hESC 1 0 0 0 0 - OK P3234 hESC 0 0 0 0 0 - OK P3234 Fibroblasts 1 0 0 0 0 - OK P3234 Fibroblasts 0 0 0 0 0 - OK P3235 iPS 0 18.9247 19.7529 33.7728 23.1401 - OK P3235 iPS 1 0 0 0 0 - OK P3235 hESC 1 0 0 0 0 - OK P3235 hESC 0 0 0 0 0 - OK P3235 Fibroblasts 1 249.738 208.381 170.352 117.163 - OK P3235 Fibroblasts 0 0 0 0 0 - OK P3236 iPS 0 13.3657 13.9506 23.8523 21.8027 - OK P3236 iPS 1 6.94564 6.69159 11.441 10.4579 - OK P3236 hESC 1 16.2776 16.1124 10.6489 10.0802 - OK P3236 hESC 0 13.7653 13.9065 9.19098 8.70014 - OK P3236 Fibroblasts 1 50.7223 42.3227 34.5989 31.7863 - OK P3236 Fibroblasts 0 36.4009 43.313 35.4085 32.53 - OK P3237 iPS 0 2.57336 2.68599 4.59241 7.40279 - OK P3237 iPS 1 2.07672 2.00076 3.42083 5.51425 - OK P3237 hESC 1 0 0 0 0 - OK P3237 hESC 0 0.0159428 0.0161062 0.0106448 0.0182659 - OK P3237 Fibroblasts 1 8.68604 7.24763 5.92496 9.63659 - OK P3237 Fibroblasts 0 16.7297 19.9065 16.2736 26.468 - OK P3238 iPS 0 0 0 0 0 - OK P3238 iPS 1 0 0 0 0 - OK P3238 hESC 1 0.0516596 0.0511353 0.033796 0.0219259 - OK P3238 hESC 0 8.52494 8.61235 5.69202 3.69282 - OK P3238 Fibroblasts 1 0 0 0 0 - OK P3238 Fibroblasts 0 0 0 0 0 - OK P3239 iPS 0 3.81222 3.97907 6.80327 4.55332 - OK P3239 iPS 1 0 0 0 0 - OK P3239 hESC 1 0 0 0 0 - OK P3239 hESC 0 0 0 0 0 - OK P3239 Fibroblasts 1 221.595 184.899 151.155 101.541 - OK P3239 Fibroblasts 0 77.6445 92.3882 75.5276 50.737 - OK P324 iPS 0 0 0 0 0 - OK P324 iPS 1 0 0 0 0 - OK P324 hESC 1 4.75724 4.70896 3.11222 3.30918 - OK P324 hESC 0 0 0 0 0 - OK P324 Fibroblasts 1 0 0 0 0 - OK P324 Fibroblasts 0 0 0 0 0 - OK P3240 iPS 0 66.3241 69.2269 118.362 59.6782 - OK P3240 iPS 1 34.9776 33.6982 57.616 29.0501 - OK P3240 hESC 1 192.671 190.715 126.047 64.7807 - OK P3240 hESC 0 142.694 144.157 95.2754 48.9661 - OK P3240 Fibroblasts 1 1083.26 903.871 738.917 373.604 - OK P3240 Fibroblasts 0 1045.22 1243.7 1016.73 514.068 - OK P3241 iPS 0 0 0 0 0 - OK P3241 iPS 1 1 0.963422 1.64722 2.15443 - OK P3241 hESC 1 1 0.989851 0.654207 0.740923 - OK P3241 hESC 0 0 0 0 0 - OK P3241 Fibroblasts 1 0 0 0 0 - OK P3241 Fibroblasts 0 0 0 0 0 - OK P3242 iPS 0 0 0 0 0 - OK P3242 iPS 1 0 0 0 0 - OK P3242 hESC 1 0 0 0 0 - OK P3242 hESC 0 0 0 0 0 - OK P3242 Fibroblasts 1 0 0 0 0 - OK P3242 Fibroblasts 0 0 0 0 0 - OK P3243 iPS 0 64 66.8011 114.214 214.004 - OK P3243 iPS 1 16 15.4148 26.3556 48.502 - OK P3243 hESC 1 34 33.6549 22.243 44.1426 - OK P3243 hESC 0 25 25.2563 16.6923 31.5939 - OK P3243 Fibroblasts 1 4 3.3376 2.7285 5.41525 - OK P3243 Fibroblasts 0 12 14.2787 11.6728 20.8292 - OK P3244 iPS 0 0 0 0 0 - OK P3244 iPS 1 0 0 0 0 - OK P3244 hESC 1 0 0 0 0 - OK P3244 hESC 0 0 0 0 0 - OK P3244 Fibroblasts 1 0 0 0 0 - OK P3244 Fibroblasts 0 0 0 0 0 - OK P3245 iPS 0 0 0 0 0 - OK P3245 iPS 1 0 0 0 0 - OK P3245 hESC 1 0 0 0 0 - OK P3245 hESC 0 0 0 0 0 - OK P3245 Fibroblasts 1 0 0 0 0 - OK P3245 Fibroblasts 0 0 0 0 0 - OK P3246 iPS 0 272.186 284.099 485.741 314.821 - OK P3246 iPS 1 24.1802 23.2957 39.8301 25.8149 - OK P3246 hESC 1 320.615 317.361 209.749 139.338 - OK P3246 hESC 0 255.813 258.436 170.804 113.467 - OK P3246 Fibroblasts 1 19175.5 16000 13080 8507.96 - OK P3246 Fibroblasts 0 10520.7 12518.4 10233.9 6656.64 - OK P3247 iPS 0 386.5 403.416 689.745 426.336 - OK P3247 iPS 1 348 335.271 573.234 354.319 - OK P3247 hESC 1 842 833.454 550.842 348.578 - OK P3247 hESC 0 864 872.859 576.885 365.058 - OK P3247 Fibroblasts 1 3250 2711.8 2216.9 1374.97 - OK P3247 Fibroblasts 0 2690 3200.8 2616.66 1622.91 - OK P3248 iPS 0 3735.55 3899.05 6666.44 4814.86 - OK P3248 iPS 1 3345.05 3222.69 5510.04 3979.64 - OK P3248 hESC 1 10359.9 10254.8 6777.52 5031.68 - OK P3248 hESC 0 10246.7 10351.8 6841.66 5079.3 - OK P3248 Fibroblasts 1 25871 21586.8 17647.2 12796.8 - OK P3248 Fibroblasts 0 17574.2 20911.3 17095.1 12396.4 - OK P3249 iPS 0 0 0 0 0 - OK P3249 iPS 1 9.04952 8.71851 14.9066 10.7171 - OK P3249 hESC 1 0 0 0 0 - OK P3249 hESC 0 0 0 0 0 - OK P3249 Fibroblasts 1 0 0 0 0 - OK P3249 Fibroblasts 0 0 0 0 0 - OK P325 iPS 0 0 0 0 0 - OK P325 iPS 1 0 0 0 0 - OK P325 hESC 1 1 0.989851 0.654207 0.394296 - OK P325 hESC 0 0 0 0 0 - OK P325 Fibroblasts 1 0 0 0 0 - OK P325 Fibroblasts 0 0 0 0 0 - OK P3250 iPS 0 29.4466 30.7354 52.5503 40.2349 - OK P3250 iPS 1 14.6518 14.1159 24.1348 18.4787 - OK P3250 hESC 1 53.1 52.5611 34.7384 27.3855 - OK P3250 hESC 0 25.7538 26.0178 17.1956 13.5558 - OK P3250 Fibroblasts 1 0 0 0 0 - OK P3250 Fibroblasts 0 25.801 30.7003 25.0975 19.2974 - OK P3251 iPS 0 0 0 0 0 - OK P3251 iPS 1 8.25276 7.95089 13.5941 10.0915 - OK P3251 hESC 1 0 0 0 0 - OK P3251 hESC 0 0 0 0 0 - OK P3251 Fibroblasts 1 0 0 0 0 - OK P3251 Fibroblasts 0 0 0 0 0 - OK P3252 iPS 0 0 0 0 0 - OK P3252 iPS 1 37.8353 36.4514 62.3231 24.4309 - OK P3252 hESC 1 72.5104 71.7745 47.4368 18.8735 - OK P3252 hESC 0 231.95 234.328 154.871 61.6179 - OK P3252 Fibroblasts 1 0 0 0 0 - OK P3252 Fibroblasts 0 0.00512307 0.00609588 0.0049834 0.00195775 - OK P3253 iPS 0 66.2933 69.1947 118.307 46.4151 - OK P3253 iPS 1 77.1104 74.2899 127.018 49.8329 - OK P3253 hESC 1 620.759 614.459 406.105 161.712 - OK P3253 hESC 0 229.366 231.717 153.145 60.9828 - OK P3253 Fibroblasts 1 103.541 86.3948 70.628 27.7696 - OK P3253 Fibroblasts 0 84.0429 100.002 81.7516 32.1432 - OK P3254 iPS 0 0 0 0 0 - OK P3254 iPS 1 0 0 0 0 - OK P3254 hESC 1 31.4543 31.135 20.5776 16.5636 - OK P3254 hESC 0 0 0 0 0 - OK P3254 Fibroblasts 1 36.0383 30.0703 24.5826 19.2894 - OK P3254 Fibroblasts 0 4.97463 5.91925 4.839 3.79706 - OK P3255 iPS 0 4.70673 4.91273 8.3996 7.22497 - OK P3255 iPS 1 0 0 0 0 - OK P3255 hESC 1 0 0 0 0 - OK P3255 hESC 0 9.68437 9.78366 6.46616 5.74775 - OK P3255 Fibroblasts 1 22.6568 18.9048 15.4548 13.3569 - OK P3255 Fibroblasts 0 0 0 0 0 - OK P3256 iPS 0 0 0 0 0 - OK P3256 iPS 1 0.054298 0.052312 0.089441 0.0841479 - OK P3256 hESC 1 41.2764 40.8575 27.0033 26.3366 - OK P3256 hESC 0 0 0 0 0 - OK P3256 Fibroblasts 1 211.764 176.695 144.449 136.61 - OK P3256 Fibroblasts 0 22.9773 27.3404 22.3509 21.1379 - OK P3257 iPS 0 0.954074 0.995831 1.70263 0.680834 - OK P3257 iPS 1 0 0 0 0 - OK P3257 hESC 1 0.0373524 0.0369733 0.0244362 0.00992042 - OK P3257 hESC 0 221.496 223.767 147.891 60.0397 - OK P3257 Fibroblasts 1 182.822 152.546 124.707 49.9771 - OK P3257 Fibroblasts 0 330.73 393.532 321.713 128.928 - OK P3258 iPS 0 27.5431 28.7486 49.1533 18.9634 - OK P3258 iPS 1 23.6936 22.827 39.0287 15.0573 - OK P3258 hESC 1 648.361 641.781 424.162 166.051 - OK P3258 hESC 0 279.403 282.267 186.555 73.0323 - OK P3258 Fibroblasts 1 168.79 140.838 115.136 44.5145 - OK P3258 Fibroblasts 0 339.613 404.101 330.354 127.723 - OK P3259 iPS 0 908.209 947.959 1620.78 966.974 - OK P3259 iPS 1 531.558 512.115 875.595 494.981 - OK P3259 hESC 1 898.023 888.909 587.493 497.348 - OK P3259 hESC 0 1064.95 1075.87 711.057 562.862 - OK P3259 Fibroblasts 1 5623.08 4691.9 3835.64 2256.16 - OK P3259 Fibroblasts 0 4071.72 4844.89 3960.71 1945.8 - OK P326 iPS 0 0 0 0 0 - OK P326 iPS 1 0 0 0 0 - OK P326 hESC 1 39.7841 39.3803 26.027 11.2922 - OK P326 hESC 0 0 0 0 0 - OK P326 Fibroblasts 1 0 0 0 0 - OK P326 Fibroblasts 0 0 0 0 0 - OK P3260 iPS 0 926.28 966.821 1653.03 632.581 - OK P3260 iPS 1 489.19 471.296 805.805 298.542 - OK P3260 hESC 1 919.615 910.282 601.618 215.433 - OK P3260 hESC 0 1141.11 1152.81 761.911 270.181 - OK P3260 Fibroblasts 1 7520.81 6275.36 5130.12 1999.18 - OK P3260 Fibroblasts 0 3058.32 3639.05 2974.93 1138.8 - OK P3261 iPS 0 599.67 625.916 1070.17 328.552 - OK P3261 iPS 1 549.096 529.011 904.483 277.685 - OK P3261 hESC 1 506.223 501.085 331.174 102.861 - OK P3261 hESC 0 547.604 553.219 365.63 113.563 - OK P3261 Fibroblasts 1 820.563 684.677 559.726 172.133 - OK P3261 Fibroblasts 0 405.524 482.527 394.467 121.311 - OK P3262 iPS 0 92.6496 96.7046 165.342 78.7086 - OK P3262 iPS 1 12.9241 12.4513 21.2888 10.1342 - OK P3262 hESC 1 201.9 199.851 132.085 64.0226 - OK P3262 hESC 0 163.894 165.574 109.43 53.0419 - OK P3262 Fibroblasts 1 360.578 300.866 245.959 117.394 - OK P3262 Fibroblasts 0 140.412 167.074 136.584 65.1901 - OK P3263 iPS 0 70.0345 73.0998 124.983 232.768 - OK P3263 iPS 1 52.0011 50.099 85.6574 159.528 - OK P3263 hESC 1 61.7957 61.1685 40.4272 80.959 - OK P3263 hESC 0 106.041 107.128 70.8027 141.789 - OK P3263 Fibroblasts 1 208.474 173.951 142.205 267.594 - OK P3263 Fibroblasts 0 156.068 185.704 151.813 285.674 - OK P3264 iPS 0 65.9066 68.7912 117.617 70.2143 - OK P3264 iPS 1 91.6782 88.3248 151.014 90.1521 - OK P3264 hESC 1 59.5546 58.9501 38.961 23.7927 - OK P3264 hESC 0 37.6326 38.0185 25.127 15.3445 - OK P3264 Fibroblasts 1 585.494 488.536 399.38 239.209 - OK P3264 Fibroblasts 0 391.381 465.7 380.711 228.027 - OK P3265 iPS 0 60.9611 63.6292 108.791 80.1291 - OK P3265 iPS 1 98.337 94.74 161.983 119.307 - OK P3265 hESC 1 57.4308 56.8479 37.5716 28.4611 - OK P3265 hESC 0 82.1529 82.9952 54.8527 41.5518 - OK P3265 Fibroblasts 1 168.346 140.468 114.833 84.9247 - OK P3265 Fibroblasts 0 39.2618 46.7172 38.1914 28.2445 - OK P3266 iPS 0 239.383 249.86 427.201 345.801 - OK P3266 iPS 1 194.31 187.203 320.072 259.085 - OK P3266 hESC 1 49.7573 49.2523 32.5516 27.176 - OK P3266 hESC 0 0 0 0 0 - OK P3266 Fibroblasts 1 0 0 0 0 - OK P3266 Fibroblasts 0 0 0 0 0 - OK P3267 iPS 0 343.196 358.216 612.465 141.667 - OK P3267 iPS 1 418.006 402.717 688.55 159.265 - OK P3267 hESC 1 1092.85 1081.76 714.951 166.823 - OK P3267 hESC 0 885.349 894.427 591.14 137.933 - OK P3267 Fibroblasts 1 1973.1 1646.35 1345.9 311.711 - OK P3267 Fibroblasts 0 1300.52 1547.48 1265.07 292.991 - OK P3268 iPS 0 380.477 397.129 678.997 159.922 - OK P3268 iPS 1 4.50145 4.3368 7.4149 1.8458 - OK P3268 hESC 1 1477.21 1462.22 966.402 229.585 - OK P3268 hESC 0 1850.99 1869.97 1235.89 293.607 - OK P3268 Fibroblasts 1 3224.45 2690.48 2199.48 530.295 - OK P3268 Fibroblasts 0 2503.44 2978.81 2435.19 584.972 - OK P3269 iPS 0 17.1769 17.9287 30.6538 9.06855 - OK P3269 iPS 1 0 0 0 0 - OK P3269 hESC 1 0 0 0 0 - OK P3269 hESC 0 0 0 0 0 - OK P3269 Fibroblasts 1 242.123 202.028 165.158 48.9399 - OK P3269 Fibroblasts 0 184.843 219.943 179.804 53.2798 - OK P327 iPS 0 273.846 285.831 488.703 169.538 - OK P327 iPS 1 262.049 252.464 431.653 149.747 - OK P327 hESC 1 2154.78 2132.91 1409.67 495.497 - OK P327 hESC 0 2011.07 2031.69 1342.77 471.983 - OK P327 Fibroblasts 1 0.394163 0.328889 0.268868 0.0934533 - OK P327 Fibroblasts 0 268.325 319.276 261.009 90.7217 - OK P3270 iPS 0 1026.06 1070.96 1831.09 461.008 - OK P3270 iPS 1 1344.85 1295.65 2215.26 557.728 - OK P3270 hESC 1 1455.75 1440.97 952.36 242.063 - OK P3270 hESC 0 1499.2 1514.57 1001 254.426 - OK P3270 Fibroblasts 1 4665.7 3893.06 3182.59 802.383 - OK P3270 Fibroblasts 0 2111.03 2511.89 2053.48 517.716 - OK P3271 iPS 0 39.7499 41.4896 70.9374 20.099 - OK P3271 iPS 1 0 0 0 0 - OK P3271 hESC 1 0 0 0 0 - OK P3271 hESC 0 74.3082 75.0701 49.6149 14.2089 - OK P3271 Fibroblasts 1 3245.28 2707.86 2213.68 628.196 - OK P3271 Fibroblasts 0 1274.4 1516.39 1239.65 351.787 - OK P3272 iPS 0 0 0 0 0 - OK P3272 iPS 1 0 0 0 0 - OK P3272 hESC 1 0 0 0 0 - OK P3272 hESC 0 0 0 0 0 - OK P3272 Fibroblasts 1 0 0 0 0 - OK P3272 Fibroblasts 0 0 0 0 0 - OK P3273 iPS 0 0 0 0 0 - OK P3273 iPS 1 0 0 0 0 - OK P3273 hESC 1 0 0 0 0 - OK P3273 hESC 0 0 0 0 0 - OK P3273 Fibroblasts 1 0 0 0 0 - OK P3273 Fibroblasts 0 0 0 0 0 - OK P3274 iPS 0 146.278 152.68 261.047 75.0611 - OK P3274 iPS 1 400.012 385.38 658.908 189.462 - OK P3274 hESC 1 214.735 212.555 140.481 40.8351 - OK P3274 hESC 0 0 0 0 0 - OK P3274 Fibroblasts 1 5020.8 4189.35 3424.81 986.331 - OK P3274 Fibroblasts 0 3499.15 4163.6 3403.75 980.268 - OK P3275 iPS 0 0 0 0 0 - OK P3275 iPS 1 0 0 0 0 - OK P3275 hESC 1 23.2977 23.0612 15.2415 4.2945 - OK P3275 hESC 0 43.8355 44.285 29.2686 8.24683 - OK P3275 Fibroblasts 1 813.754 678.996 555.081 155.001 - OK P3275 Fibroblasts 0 372.389 443.101 362.236 101.151 - OK P3276 iPS 0 45.5585 47.5525 81.3034 56.6394 - OK P3276 iPS 1 10.4664 10.0836 17.2405 12.0104 - OK P3276 hESC 1 6.75375 6.68521 4.41835 3.16078 - OK P3276 hESC 0 60.9278 61.5525 40.6809 29.1022 - OK P3276 Fibroblasts 1 571.7 477.027 389.97 272.719 - OK P3276 Fibroblasts 0 21.0007 24.9884 20.4281 14.286 - OK P3277 iPS 0 189.417 197.707 338.032 96.2387 - OK P3277 iPS 1 0 0 0 0 - OK P3277 hESC 1 2267.66 2244.64 1483.52 426.931 - OK P3277 hESC 0 2214.16 2236.86 1478.37 425.45 - OK P3277 Fibroblasts 1 18399.9 15352.9 12551 3578.95 - OK P3277 Fibroblasts 0 14769.1 17573.5 14366.4 4096.6 - OK P3278 iPS 0 61.2465 63.927 109.3 31.3706 - OK P3278 iPS 1 0.0221086 0.0212999 0.0364178 0.0104524 - OK P3278 hESC 1 543.511 537.995 355.568 103.166 - OK P3278 hESC 0 482.977 487.929 322.479 93.5654 - OK P3278 Fibroblasts 1 9036.69 7540.21 6164.14 1772 - OK P3278 Fibroblasts 0 3579.9 4259.68 3482.3 1001.05 - OK P3279 iPS 0 0 0 0 0 - OK P3279 iPS 1 0 0 0 0 - OK P3279 hESC 1 28.5437 28.2541 18.6735 5.52684 - OK P3279 hESC 0 18.1024 18.288 12.0868 3.57736 - OK P3279 Fibroblasts 1 89.1175 74.3596 60.7891 17.8227 - OK P3279 Fibroblasts 0 50.4951 60.0835 49.1184 14.401 - OK P328 iPS 0 84.2079 87.8934 150.277 49.1443 - OK P328 iPS 1 11.7759 11.3452 19.3976 6.3435 - OK P328 hESC 1 295.767 292.765 193.493 64.0644 - OK P328 hESC 0 291.446 294.434 194.596 64.4296 - OK P328 Fibroblasts 1 41.7708 34.8535 28.4928 9.33472 - OK P328 Fibroblasts 0 83.0961 98.8751 80.8306 26.4814 - OK P3280 iPS 0 45.7051 47.7055 81.565 36.8323 - OK P3280 iPS 1 0.0547094 0.0527083 0.0901186 0.0406948 - OK P3280 hESC 1 454.833 450.217 297.555 136.687 - OK P3280 hESC 0 118.157 119.368 78.8922 36.2405 - OK P3280 Fibroblasts 1 7.9893 6.66627 5.44969 2.46707 - OK P3280 Fibroblasts 0 3.99285 4.75104 3.88399 1.75827 - OK P3281 iPS 0 0.000873476 0.000911705 0.0015588 0.000696568 - OK P3281 iPS 1 67.8893 65.4061 111.829 49.9721 - OK P3281 hESC 1 0.00921793 0.00912438 0.00603043 0.00274081 - OK P3281 hESC 0 316.547 319.792 211.355 96.0602 - OK P3281 Fibroblasts 1 0.0106965 0.00892518 0.00729636 0.00326853 - OK P3281 Fibroblasts 0 0.00677162 0.00805747 0.006587 0.00295076 - OK P3282 iPS 0 16.9183 17.6588 30.1924 12.8388 - OK P3282 iPS 1 11.056 10.6516 18.2116 7.74421 - OK P3282 hESC 1 79.29 78.4853 51.872 22.4161 - OK P3282 hESC 0 80.5979 81.4243 53.8145 23.2555 - OK P3282 Fibroblasts 1 0 0 0 0 - OK P3282 Fibroblasts 0 0 0 0 0 - OK P3283 iPS 0 5.37569 5.61097 9.59343 4.26672 - OK P3283 iPS 1 0 0 0 0 - OK P3283 hESC 1 106.868 105.783 69.9135 31.623 - OK P3283 hESC 0 50.6987 51.2186 33.8511 15.3114 - OK P3283 Fibroblasts 1 0 0 0 0 - OK P3283 Fibroblasts 0 0.000380988 0.000453333 0.000370601 0.000165232 - OK P3284 iPS 0 191.466 199.846 341.688 246.785 - OK P3284 iPS 1 153.732 148.109 253.232 182.897 - OK P3284 hESC 1 348.771 345.231 228.168 169.394 - OK P3284 hESC 0 379.679 383.572 253.508 188.206 - OK P3284 Fibroblasts 1 384.916 321.174 262.56 190.394 - OK P3284 Fibroblasts 0 273.82 325.815 266.355 193.146 - OK P3285 iPS 0 17.046 17.7921 30.4202 9.93668 - OK P3285 iPS 1 17.7548 17.1053 29.2461 9.55315 - OK P3285 hESC 1 0 0 0 0 - OK P3285 hESC 0 11.4066 11.5235 7.61607 2.51869 - OK P3285 Fibroblasts 1 0 0 0 0 - OK P3285 Fibroblasts 0 0 0 0 0 - OK P3286 iPS 0 31.7785 33.1693 56.7117 41.7489 - OK P3286 iPS 1 32.3387 31.1558 53.2691 39.2146 - OK P3286 hESC 1 9.13456 9.04185 5.97589 4.52441 - OK P3286 hESC 0 9.0707 9.1637 6.05642 4.58538 - OK P3286 Fibroblasts 1 4.25003 3.54623 2.89905 2.14287 - OK P3286 Fibroblasts 0 1.31319 1.56255 1.27738 0.944197 - OK P3287 iPS 0 170.841 178.318 304.882 124.231 - OK P3287 iPS 1 168.667 162.497 277.832 113.209 - OK P3287 hESC 1 169.348 167.629 110.789 45.8456 - OK P3287 hESC 0 196.008 198.018 130.873 54.1566 - OK P3287 Fibroblasts 1 203.066 169.438 138.516 56.5689 - OK P3287 Fibroblasts 0 104.435 124.266 101.588 41.4875 - OK P3288 iPS 0 274.288 286.293 489.493 308.627 - OK P3288 iPS 1 336.118 323.824 553.662 349.086 - OK P3288 hESC 1 77.9186 77.1277 50.9748 32.92 - OK P3288 hESC 0 134.926 136.309 90.0886 58.1801 - OK P3288 Fibroblasts 1 409.221 341.454 279.139 176.613 - OK P3288 Fibroblasts 0 300.286 357.306 292.099 184.813 - OK P3289 iPS 0 739.314 771.672 1319.38 434.583 - OK P3289 iPS 1 661.091 636.91 1088.96 358.689 - OK P3289 hESC 1 2378.09 2353.95 1555.76 518.87 - OK P3289 hESC 0 2338.16 2362.14 1561.17 520.674 - OK P3289 Fibroblasts 1 5067.01 4227.91 3456.33 1140.54 - OK P3289 Fibroblasts 0 2969.62 3533.51 2888.66 953.215 - OK P329 iPS 0 52.493 54.7905 93.6787 37.8662 - OK P329 iPS 1 116.129 111.881 191.29 77.3218 - OK P329 hESC 1 179.391 177.571 117.359 48.1699 - OK P329 hESC 0 230.543 232.907 153.932 63.1812 - OK P329 Fibroblasts 1 60.8969 50.8123 41.5392 16.8283 - OK P329 Fibroblasts 0 10.4129 12.3902 10.129 4.10342 - OK P3290 iPS 0 0 0 0 0 - OK P3290 iPS 1 0 0 0 0 - OK P3290 hESC 1 0 0 0 0 - OK P3290 hESC 0 0 0 0 0 - OK P3290 Fibroblasts 1 0 0 0 0 - OK P3290 Fibroblasts 0 0 0 0 0 - OK P3291 iPS 0 31.2662 32.6347 55.7975 19.2672 - OK P3291 iPS 1 73.2976 70.6166 120.738 41.6914 - OK P3291 hESC 1 26.7396 26.4683 17.4933 6.11996 - OK P3291 hESC 0 171.746 173.506 114.673 40.118 - OK P3291 Fibroblasts 1 237.536 198.2 162.029 56.0565 - OK P3291 Fibroblasts 0 101.028 120.212 98.2736 33.9993 - OK P3292 iPS 0 630.598 658.197 1125.36 112.744 - OK P3292 iPS 1 540.94 521.154 891.049 89.2693 - OK P3292 hESC 1 11491.1 11374.5 7517.56 755.99 - OK P3292 hESC 0 10876.2 10987.7 7261.91 730.281 - OK P3292 Fibroblasts 1 83999.1 70088.8 57297.8 5743.53 - OK P3292 Fibroblasts 0 16575.8 19723.3 16123.9 1616.25 - OK P3293 iPS 0 144.677 151.009 258.189 25.861 - OK P3293 iPS 1 41.5278 40.0088 68.4055 6.85172 - OK P3293 hESC 1 1998.76 1978.47 1307.6 131.468 - OK P3293 hESC 0 1760.67 1778.72 1175.58 118.195 - OK P3293 Fibroblasts 1 18146.1 15141.1 12377.9 1240.5 - OK P3293 Fibroblasts 0 2910.38 3463.03 2831.04 283.723 - OK P3294 iPS 0 12.1492 12.681 21.6814 8.97156 - OK P3294 iPS 1 12.8678 12.3971 21.1961 8.77075 - OK P3294 hESC 1 717.199 709.92 469.197 197.217 - OK P3294 hESC 0 630.088 636.548 420.704 176.834 - OK P3294 Fibroblasts 1 654.973 546.509 446.773 185.294 - OK P3294 Fibroblasts 0 1572.35 1870.91 1529.48 634.332 - OK P3295 iPS 0 9.83732 10.2679 17.5556 36.5985 - OK P3295 iPS 1 8.17343 7.87446 13.4635 28.0675 - OK P3295 hESC 1 0 0 0 0 - OK P3295 hESC 0 0 0 0 0 - OK P3295 Fibroblasts 1 224.404 187.243 153.071 322.826 - OK P3295 Fibroblasts 0 0 0 0 0 - OK P3296 iPS 0 24 25.0504 42.8302 16.2188 - OK P3296 iPS 1 0.0359824 0.0346663 0.0592711 0.0224445 - OK P3296 hESC 1 337 333.58 220.468 84.6913 - OK P3296 hESC 0 249.997 252.561 166.921 64.1217 - OK P3296 Fibroblasts 1 0.0411402 0.0343274 0.0280627 0.0101707 - OK P3296 Fibroblasts 0 0 0 0 0 - OK P3297 iPS 0 0 0 0 0 - OK P3297 iPS 1 24.964 24.0509 41.1213 15.6555 - OK P3297 hESC 1 0 0 0 0 - OK P3297 hESC 0 0.00274652 0.00277468 0.00183383 0.0007083 - OK P3297 Fibroblasts 1 5.95886 4.97207 4.06468 1.48074 - OK P3297 Fibroblasts 0 0 0 0 0 - OK P3298 iPS 0 0 0 0 0 - OK P3298 iPS 1 1 0.963422 1.64722 6.80245 - OK P3298 hESC 1 1 0.989851 0.654207 1.81454 - OK P3298 hESC 0 0 0 0 0 - OK P3298 Fibroblasts 1 0 0 0 0 - OK P3298 Fibroblasts 0 0 0 0 0 - OK P3299 iPS 0 42.0979 43.9404 75.1277 28.3126 - OK P3299 iPS 1 136.905 131.897 225.513 84.9869 - OK P3299 hESC 1 21.153 20.9383 13.8384 5.29009 - OK P3299 hESC 0 5.2886 5.34283 3.53115 1.34987 - OK P3299 Fibroblasts 1 0 0 0 0 - OK P3299 Fibroblasts 0 0 0 0 0 - OK P33 iPS 0 151.772 158.415 270.851 161.76 - OK P33 iPS 1 287 276.502 472.753 282.342 - OK P33 hESC 1 1118.96 1107.6 732.031 447.23 - OK P33 hESC 0 1211.1 1223.51 808.638 494.032 - OK P33 Fibroblasts 1 1437 1199.03 980.212 587.348 - OK P33 Fibroblasts 0 531.638 632.589 517.144 309.875 - OK P330 iPS 0 0 0 0 0 - OK P330 iPS 1 0 0 0 0 - OK P330 hESC 1 0 0 0 0 - OK P330 hESC 0 0 0 0 0 - OK P330 Fibroblasts 1 1878.36 1567.31 1281.28 515.524 - OK P330 Fibroblasts 0 611.75 727.914 595.072 239.428 - OK P3300 iPS 0 2547.9 2659.42 4546.97 761.958 - OK P3300 iPS 1 3063.09 2951.05 5045.6 844.393 - OK P3300 hESC 1 3721.85 3684.07 2434.86 410.216 - OK P3300 hESC 0 4063.71 4105.38 2713.3 457.911 - OK P3300 Fibroblasts 1 9159 7642.27 6247.57 1046.87 - OK P3300 Fibroblasts 0 4420 5259.3 4299.49 720.529 - OK P3301 iPS 0 178 185.791 317.658 168.513 - OK P3301 iPS 1 318 306.368 523.817 277.877 - OK P3301 hESC 1 465 460.281 304.206 164.66 - OK P3301 hESC 0 322 325.302 214.996 116.373 - OK P3301 Fibroblasts 1 0 0 0 0 - OK P3301 Fibroblasts 0 0 0 0 0 - OK P3302 iPS 0 167.218 174.537 298.416 184.857 - OK P3302 iPS 1 2.21883 2.13767 3.65491 2.26407 - OK P3302 hESC 1 0 0 0 0 - OK P3302 hESC 0 15.5389 15.6983 10.3752 6.58024 - OK P3302 Fibroblasts 1 0 0 0 0 - OK P3302 Fibroblasts 0 0 0 0 0 - OK P3303 iPS 0 145.972 152.361 260.501 143.241 - OK P3303 iPS 1 110.029 106.004 181.242 99.6592 - OK P3303 hESC 1 482.769 477.869 315.831 177.331 - OK P3303 hESC 0 596.177 602.289 398.062 223.501 - OK P3303 Fibroblasts 1 770.29 642.73 525.433 289.799 - OK P3303 Fibroblasts 0 710.88 845.868 691.499 381.392 - OK P3304 iPS 0 23.9812 25.0308 42.7968 27.263 - OK P3304 iPS 1 61.8723 59.6091 101.917 64.9249 - OK P3304 hESC 1 178.659 176.845 116.88 76.283 - OK P3304 hESC 0 245.454 247.971 163.887 106.963 - OK P3304 Fibroblasts 1 204.732 170.828 139.653 89.2775 - OK P3304 Fibroblasts 0 169.248 201.387 164.634 105.248 - OK P3305 iPS 0 0.0598283 0.0624468 0.106769 0.061657 - OK P3305 iPS 1 173.822 167.464 286.324 165.346 - OK P3305 hESC 1 0 0 0 0 - OK P3305 hESC 0 23.5842 23.826 15.747 9.29533 - OK P3305 Fibroblasts 1 0 0 0 0 - OK P3305 Fibroblasts 0 0 0 0 0 - OK P3306 iPS 0 824.992 861.099 1472.27 812.4 - OK P3306 iPS 1 850.932 819.807 1401.68 773.443 - OK P3306 hESC 1 3412.7 3378.06 2232.61 1258.05 - OK P3306 hESC 0 2997 3027.73 2001.07 1127.58 - OK P3306 Fibroblasts 1 3125.17 2607.64 2131.75 1179.9 - OK P3306 Fibroblasts 0 2799.91 3331.58 2723.58 1507.46 - OK P3307 iPS 0 1606.9 1677.23 2867.66 1691.94 - OK P3307 iPS 1 1839.79 1772.49 3030.54 1788.03 - OK P3307 hESC 1 3596.16 3559.67 2352.63 1419.55 - OK P3307 hESC 0 3241.06 3274.29 2164.03 1305.74 - OK P3307 Fibroblasts 1 5640.41 4706.35 3847.46 2277.44 - OK P3307 Fibroblasts 0 5367.57 6386.8 5221.23 3090.62 - OK P3308 iPS 0 281.914 294.252 503.102 295.722 - OK P3308 iPS 1 176.73 170.265 291.113 171.116 - OK P3308 hESC 1 444.711 440.197 290.933 174.874 - OK P3308 hESC 0 576.571 582.483 384.971 231.398 - OK P3308 Fibroblasts 1 1265.47 1055.91 863.207 509.044 - OK P3308 Fibroblasts 0 1249.89 1487.23 1215.82 716.981 - OK P3309 iPS 0 6.4626 6.74545 11.5331 11.1016 - OK P3309 iPS 1 15.6097 15.0387 25.7126 24.7506 - OK P3309 hESC 1 0 0 0 0 - OK P3309 hESC 0 8.61787 8.70623 5.75407 5.74673 - OK P3309 Fibroblasts 1 0.429547 0.358414 0.293004 0.283549 - OK P3309 Fibroblasts 0 0 0 0 0 - OK P331 iPS 0 0 0 0 0 - OK P331 iPS 1 0 0 0 0 - OK P331 hESC 1 0 0 0 0 - OK P331 hESC 0 0 0 0 0 - OK P331 Fibroblasts 1 1035.23 863.794 706.154 244.544 - OK P331 Fibroblasts 0 458.496 545.558 445.995 154.45 - OK P3310 iPS 0 181.671 189.623 324.21 108.419 - OK P3310 iPS 1 23.7934 22.9231 39.1931 12.9298 - OK P3310 hESC 1 93.9997 93.0456 61.4952 21.2511 - OK P3310 hESC 0 68.9997 69.7072 46.0705 15.9207 - OK P3310 Fibroblasts 1 1835.85 1531.83 1252.28 423.274 - OK P3310 Fibroblasts 0 1060.6 1262 1031.69 346.952 - OK P3311 iPS 0 0 0 0 0 - OK P3311 iPS 1 1.45636 1.40309 2.39895 7.0913 - OK P3311 hESC 1 0 0 0 0 - OK P3311 hESC 0 0 0 0 0 - OK P3311 Fibroblasts 1 6.37872 5.3224 4.35108 13.0752 - OK P3311 Fibroblasts 0 3.86739 4.60176 3.76195 11.3049 - OK P3312 iPS 0 25.8531 26.9846 46.1372 114.39 - OK P3312 iPS 1 3.64444e-05 3.51113e-05 6.0032e-05 0.00014884 - OK P3312 hESC 1 0 0 0 0 - OK P3312 hESC 0 0 0 0 0 - OK P3312 Fibroblasts 1 98.3224 82.0402 67.0681 168.593 - OK P3312 Fibroblasts 0 54.0794 64.3484 52.605 132.236 - OK P3313 iPS 0 0 0 0 0 - OK P3313 iPS 1 0 0 0 0 - OK P3313 hESC 1 3.63036 3.59352 2.37501 10.5196 - OK P3313 hESC 0 0.358831 0.362511 0.239589 1.06121 - OK P3313 Fibroblasts 1 82.2651 68.6419 56.115 217.637 - OK P3313 Fibroblasts 0 7.43924 8.85186 7.23642 28.0658 - OK P3314 iPS 0 79.1469 82.611 141.245 140.849 - OK P3314 iPS 1 1.5436 1.48714 2.54266 2.53553 - OK P3314 hESC 1 1.36964 1.35574 0.896026 0.92831 - OK P3314 hESC 0 2.64117 2.66825 1.76348 1.82702 - OK P3314 Fibroblasts 1 829.034 691.745 565.504 567.04 - OK P3314 Fibroblasts 0 474.114 564.142 461.188 462.44 - OK P3315 iPS 0 0 0 0 0 - OK P3315 iPS 1 0 0 0 0 - OK P3315 hESC 1 0 0 0 0 - OK P3315 hESC 0 6.97245 7.04394 4.65544 13.8243 - OK P3315 Fibroblasts 1 0.105505 0.0880333 0.0719674 0.195125 - OK P3315 Fibroblasts 0 0 0 0 0 - OK P3316 iPS 0 0 0 0 0 - OK P3316 iPS 1 0 0 0 0 - OK P3316 hESC 1 103.655 102.603 67.8115 61.9915 - OK P3316 hESC 0 0 0 0 0 - OK P3316 Fibroblasts 1 0 0 0 0 - OK P3316 Fibroblasts 0 0 0 0 0 - OK P3317 iPS 0 310.375 323.959 553.893 197.78 - OK P3317 iPS 1 269.708 259.843 444.27 158.637 - OK P3317 hESC 1 2440.3 2415.53 1596.46 577.809 - OK P3317 hESC 0 2250 2273.07 1502.3 543.731 - OK P3317 Fibroblasts 1 2044.57 1705.99 1394.65 498.976 - OK P3317 Fibroblasts 0 1884.64 2242.51 1833.26 655.899 - OK P3318 iPS 0 0 0 0 0 - OK P3318 iPS 1 0 0 0 0 - OK P3318 hESC 1 0 0 0 0 - OK P3318 hESC 0 0 0 0 0 - OK P3318 Fibroblasts 1 0 0 0 0 - OK P3318 Fibroblasts 0 0 0 0 0 - OK P3319 iPS 0 42.149 43.9937 75.2188 27.1395 - OK P3319 iPS 1 76.267 73.4773 125.629 45.3278 - OK P3319 hESC 1 183.048 181.19 119.751 43.8011 - OK P3319 hESC 0 316.426 319.67 211.274 77.2774 - OK P3319 Fibroblasts 1 370.582 309.213 252.783 91.3879 - OK P3319 Fibroblasts 0 160.762 191.289 156.379 56.5353 - OK P332 iPS 0 0 0 0 0 - OK P332 iPS 1 0 0 0 0 - OK P332 hESC 1 6.1377 6.0754 4.01532 3.17249 - OK P332 hESC 0 4.86669 4.91659 3.24944 2.56737 - OK P332 Fibroblasts 1 17.6226 14.7043 12.0208 9.2629 - OK P332 Fibroblasts 0 0 0 0 0 - OK P3320 iPS 0 54.6225 57.0132 97.479 57.8266 - OK P3320 iPS 1 55.5936 53.5602 91.5751 54.3243 - OK P3320 hESC 1 25.7854 25.5237 16.869 10.2353 - OK P3320 hESC 0 78.1707 78.9722 52.1938 31.6687 - OK P3320 Fibroblasts 1 147.427 123.013 100.563 59.8523 - OK P3320 Fibroblasts 0 229.328 272.874 223.075 132.768 - OK P3321 iPS 0 33 34.4443 58.8916 16.5798 - OK P3321 iPS 1 39 37.5735 64.2417 18.086 - OK P3321 hESC 1 560 554.316 366.356 104.243 - OK P3321 hESC 0 463 467.747 309.141 87.9633 - OK P3321 Fibroblasts 1 154 128.498 105.047 29.62 - OK P3321 Fibroblasts 0 322 383.144 313.221 88.3184 - OK P3322 iPS 0 174.389 182.021 311.213 319.113 - OK P3322 iPS 1 153.041 147.443 252.093 258.493 - OK P3322 hESC 1 135.582 134.206 88.699 94.5968 - OK P3322 hESC 0 239.03 241.481 159.598 170.21 - OK P3322 Fibroblasts 1 101.444 84.6446 69.1972 71.3578 - OK P3322 Fibroblasts 0 496.841 591.185 483.295 498.386 - OK P3323 iPS 0 1194.11 1246.37 2131 2692.57 - OK P3323 iPS 1 826.959 796.711 1362.19 1721.15 - OK P3323 hESC 1 3049.42 3018.47 1994.95 2646.35 - OK P3323 hESC 0 4085.97 4127.86 2728.17 3618.98 - OK P3323 Fibroblasts 1 1416.56 1181.97 966.267 1229.48 - OK P3323 Fibroblasts 0 960.159 1142.48 933.981 1188.4 - OK P3324 iPS 0 0 0 0 0 - OK P3324 iPS 1 3.46242 3.33577 5.70338 10.5249 - OK P3324 hESC 1 0 0 0 0 - OK P3324 hESC 0 10.2837 10.3892 6.86636 13.6156 - OK P3324 Fibroblasts 1 0 0 0 0 - OK P3324 Fibroblasts 0 0 0 0 0 - OK P3325 iPS 0 4.47761 4.67359 7.99072 10.4997 - OK P3325 iPS 1 1.31357 1.26553 2.16375 2.84314 - OK P3325 hESC 1 16.2712 16.106 10.6447 14.7138 - OK P3325 hESC 0 7.12591 7.19897 4.75791 6.57668 - OK P3325 Fibroblasts 1 3.95574 3.30067 2.6983 3.57145 - OK P3325 Fibroblasts 0 4.35154 5.17785 4.23291 5.60264 - OK P3326 iPS 0 39.3802 41.1037 70.2776 65.8995 - OK P3326 iPS 1 36.697 35.3547 60.4481 56.6823 - OK P3326 hESC 1 82.3328 81.4972 53.8627 52.3524 - OK P3326 hESC 0 57.549 58.139 38.4249 37.3476 - OK P3326 Fibroblasts 1 188.983 157.688 128.91 121.508 - OK P3326 Fibroblasts 0 209.087 248.79 203.386 191.708 - OK P3327 iPS 0 33.3788 34.8397 59.5676 50.8662 - OK P3327 iPS 1 10.912 10.5128 17.9745 15.3488 - OK P3327 hESC 1 125.264 123.992 81.9484 72.2985 - OK P3327 hESC 0 56.7026 57.284 37.8598 33.4016 - OK P3327 Fibroblasts 1 49.7063 41.4749 33.9059 29.0902 - OK P3327 Fibroblasts 0 114.121 135.791 111.01 95.2429 - OK P3328 iPS 0 0 0 0 0 - OK P3328 iPS 1 15.6672 15.0941 25.8074 26.3479 - OK P3328 hESC 1 13.4855 13.3486 8.82229 9.36654 - OK P3328 hESC 0 35.2793 35.6411 23.5557 25.0089 - OK P3328 Fibroblasts 1 0 0 0 0 - OK P3328 Fibroblasts 0 60.9255 72.4945 59.2645 60.8488 - OK P3329 iPS 0 117.763 122.918 210.16 210.047 - OK P3329 iPS 1 98.9478 95.3286 162.989 164.856 - OK P3329 hESC 1 665.647 658.891 435.471 455.46 - OK P3329 hESC 0 637.059 643.591 425.359 446.062 - OK P3329 Fibroblasts 1 568.355 474.235 387.688 385.354 - OK P3329 Fibroblasts 0 630.015 749.647 612.839 618.308 - OK P333 iPS 0 10.2567 10.7056 18.304 12.3676 - OK P333 iPS 1 11.5775 11.154 19.0707 12.8857 - OK P333 hESC 1 105.747 104.674 69.1806 47.962 - OK P333 hESC 0 91.8262 92.7677 61.3115 42.5065 - OK P333 Fibroblasts 1 45.7231 38.1513 31.1888 21.1525 - OK P333 Fibroblasts 0 11.4206 13.5892 11.1092 7.53435 - OK P3330 iPS 0 16.0986 16.8032 28.7295 21.5419 - OK P3330 iPS 1 9.98552 9.62028 16.4484 12.3333 - OK P3330 hESC 1 12.2528 12.1285 8.01588 6.18476 - OK P3330 hESC 0 16.7284 16.8999 11.1694 8.6179 - OK P3330 Fibroblasts 1 72.7325 60.688 49.6126 37.355 - OK P3330 Fibroblasts 0 56.8547 67.6507 55.3047 41.6408 - OK P3331 iPS 0 5.70138 5.95091 10.1746 11.5739 - OK P3331 iPS 1 1.31845 1.27023 2.17179 2.47047 - OK P3331 hESC 1 16.4635 16.2964 10.7705 12.799 - OK P3331 hESC 0 9.46843 9.56552 6.32199 7.51267 - OK P3331 Fibroblasts 1 6.46728 5.3963 4.41149 5.04991 - OK P3331 Fibroblasts 0 5.58469 6.64515 5.43243 6.2186 - OK P3332 iPS 0 6.18545 6.45617 11.0385 7.83655 - OK P3332 iPS 1 6.46116 6.22482 10.643 7.55574 - OK P3332 hESC 1 30.16 29.8539 19.7309 14.3916 - OK P3332 hESC 0 23.0887 23.3254 15.4161 11.2444 - OK P3332 Fibroblasts 1 0 0 0 0 - OK P3332 Fibroblasts 0 0 0 0 0 - OK P3333 iPS 0 153.015 159.712 273.069 268.33 - OK P3333 iPS 1 60.2297 58.0266 99.2117 97.4902 - OK P3333 hESC 1 443.79 439.286 290.331 296.235 - OK P3333 hESC 0 407.396 411.573 272.014 277.546 - OK P3333 Fibroblasts 1 2365.4 1973.69 1613.5 1594.15 - OK P3333 Fibroblasts 0 1491.85 1775.14 1451.18 1433.78 - OK P3334 iPS 0 0 0 0 0 - OK P3334 iPS 1 0 0 0 0 - OK P3334 hESC 1 0 0 0 0 - OK P3334 hESC 0 0 0 0 0 - OK P3334 Fibroblasts 1 0 0 0 0 - OK P3334 Fibroblasts 0 0 0 0 0 - OK P3335 iPS 0 0 0 0 0 - OK P3335 iPS 1 0.00517895 0.00498952 0.00853089 0.00983862 - OK P3335 hESC 1 100.333 99.3151 65.6388 79.1313 - OK P3335 hESC 0 32.3187 32.6501 21.5789 26.0146 - OK P3335 Fibroblasts 1 413.395 344.937 281.987 327.298 - OK P3335 Fibroblasts 0 46.7057 55.5746 45.4323 52.7327 - OK P3336 iPS 0 153 159.696 273.043 202.266 - OK P3336 iPS 1 172 165.709 283.322 209.881 - OK P3336 hESC 1 236.85 234.446 154.949 118.072 - OK P3336 hESC 0 256.825 259.459 171.48 130.669 - OK P3336 Fibroblasts 1 246 205.262 167.802 124.816 - OK P3336 Fibroblasts 0 212.844 253.261 207.041 154.003 - OK P3337 iPS 0 0 0 0 0 - OK P3337 iPS 1 1 0.963422 1.64722 1.45038 - OK P3337 hESC 1 0 0 0 0 - OK P3337 hESC 0 0 0 0 0 - OK P3337 Fibroblasts 1 0 0 0 0 - OK P3337 Fibroblasts 0 0 0 0 0 - OK P3338 iPS 0 107.645 112.356 192.103 162.278 - OK P3338 iPS 1 141.35 136.179 232.834 196.686 - OK P3338 hESC 1 1052.76 1042.07 688.722 600.875 - OK P3338 hESC 0 845.511 854.18 564.54 492.533 - OK P3338 Fibroblasts 1 2219.48 1851.94 1513.96 1284.91 - OK P3338 Fibroblasts 0 1549.93 1844.24 1507.67 1279.56 - OK P3339 iPS 0 953.721 995.463 1702 873.409 - OK P3339 iPS 1 1454.99 1401.77 2396.7 1229.9 - OK P3339 hESC 1 1996.1 1975.84 1305.86 683.304 - OK P3339 hESC 0 2478.98 2504.4 1655.19 866.093 - OK P3339 Fibroblasts 1 2741.1 2287.17 1869.77 962.225 - OK P3339 Fibroblasts 0 2090.99 2488.05 2033.98 1046.74 - OK P334 iPS 0 47.863 49.9578 85.416 27.265 - OK P334 iPS 1 41.9688 40.4337 69.1321 22.0671 - OK P334 hESC 1 120.46 119.237 78.8055 25.4604 - OK P334 hESC 0 121.37 122.614 81.0376 26.1816 - OK P334 Fibroblasts 1 0 0 0 0 - OK P334 Fibroblasts 0 0 0 0 0 - OK P3340 iPS 0 0 0 0 0 - OK P3340 iPS 1 4.85378 4.67624 7.99526 2.99792 - OK P3340 hESC 1 0 0 0 0 - OK P3340 hESC 0 0 0 0 0 - OK P3340 Fibroblasts 1 0 0 0 0 - OK P3340 Fibroblasts 0 0 0 0 0 - OK P3341 iPS 0 0 0 0 0 - OK P3341 iPS 1 3.85805 3.71693 6.35507 1.5963 - OK P3341 hESC 1 0 0 0 0 - OK P3341 hESC 0 5.21741 5.27091 3.48362 0.883374 - OK P3341 Fibroblasts 1 0 0 0 0 - OK P3341 Fibroblasts 0 0 0 0 0 - OK P3342 iPS 0 0 0 0 0 - OK P3342 iPS 1 1.82042 1.75384 2.99864 0.904129 - OK P3342 hESC 1 14.8365 14.6859 9.70615 2.96008 - OK P3342 hESC 0 1.0683 1.07925 0.713293 0.217532 - OK P3342 Fibroblasts 1 0 0 0 0 - OK P3342 Fibroblasts 0 0 0 0 0 - OK P3343 iPS 0 0 0 0 0 - OK P3343 iPS 1 0 0 0 0 - OK P3343 hESC 1 6.02753 5.96636 3.94325 2.26253 - OK P3343 hESC 0 1.1269 1.13845 0.752418 0.431717 - OK P3343 Fibroblasts 1 0 0 0 0 - OK P3343 Fibroblasts 0 0 0 0 0 - OK P3344 iPS 0 0 0 0 0 - OK P3344 iPS 1 1.46775 1.41406 2.4177 0.694196 - OK P3344 hESC 1 1.13595 1.12442 0.743146 0.215708 - OK P3344 hESC 0 5.58739 5.64468 3.73065 1.08287 - OK P3344 Fibroblasts 1 0 0 0 0 - OK P3344 Fibroblasts 0 0 0 0 0 - OK P3345 iPS 0 0 0 0 0 - OK P3345 iPS 1 0 0 0 0 - OK P3345 hESC 1 23 22.7666 15.0468 8.25825 - OK P3345 hESC 0 10.0559 10.159 6.71422 3.68503 - OK P3345 Fibroblasts 1 0 0 0 0 - OK P3345 Fibroblasts 0 0.00103695 0.00123385 0.00100868 0.000544027 - OK P3346 iPS 0 0 0 0 0 - OK P3346 iPS 1 0 0 0 0 - OK P3346 hESC 1 0 0 0 0 - OK P3346 hESC 0 0 0 0 0 - OK P3346 Fibroblasts 1 0 0 0 0 - OK P3346 Fibroblasts 0 0 0 0 0 - OK P3347 iPS 0 0.0126134 0.0131654 0.0225097 0.01245 - OK P3347 iPS 1 0 0 0 0 - OK P3347 hESC 1 0 0 0 0 - OK P3347 hESC 0 0.000786593 0.000794658 0.000525201 0.000296653 - OK P3347 Fibroblasts 1 0.0156201 0.0130334 0.0106549 0.00591119 - OK P3347 Fibroblasts 0 8.99896 10.7078 8.75362 4.8564 - OK P3348 iPS 0 4.98739 5.20567 8.90046 4.9655 - OK P3348 iPS 1 9 8.6708 14.825 8.27077 - OK P3348 hESC 1 0 0 0 0 - OK P3348 hESC 0 5.94333 6.00427 3.96831 2.26131 - OK P3348 Fibroblasts 1 5.98438 4.99336 4.08209 2.28441 - OK P3348 Fibroblasts 0 0 0 0 0 - OK P3349 iPS 0 131.333 137.081 234.376 75.6844 - OK P3349 iPS 1 160.363 154.497 264.153 85.3001 - OK P3349 hESC 1 226.884 224.582 148.429 48.5196 - OK P3349 hESC 0 180.456 182.306 120.489 39.3861 - OK P3349 Fibroblasts 1 0 0 0 0 - OK P3349 Fibroblasts 0 0 0 0 0 - OK P335 iPS 0 10 10.4377 17.8459 14.9238 - OK P335 iPS 1 3 2.89027 4.94167 4.1325 - OK P335 hESC 1 28 27.7158 18.3178 15.8155 - OK P335 hESC 0 33 33.3384 22.0338 19.0239 - OK P335 Fibroblasts 1 14 11.6816 9.54973 8.02307 - OK P335 Fibroblasts 0 7 8.32921 6.80915 5.72061 - OK P3350 iPS 0 0 0 0 0 - OK P3350 iPS 1 0 0 0 0 - OK P3350 hESC 1 0 0 0 0 - OK P3350 hESC 0 0 0 0 0 - OK P3350 Fibroblasts 1 0.00619619 0.0051701 0.00422657 0.00134022 - OK P3350 Fibroblasts 0 0 0 0 0 - OK P3351 iPS 0 1.64234 1.71422 2.93091 7.99546 - OK P3351 iPS 1 3.6384 3.50531 5.99325 16.3495 - OK P3351 hESC 1 63.9789 63.3296 41.8554 127.227 - OK P3351 hESC 0 69.256 69.9661 46.2416 140.56 - OK P3351 Fibroblasts 1 0 0 0 0 - OK P3351 Fibroblasts 0 0 0 0 0 - OK P3352 iPS 0 0.0247609 0.0258446 0.0441882 0.0146849 - OK P3352 iPS 1 0 0 0 0 - OK P3352 hESC 1 50.4839 49.9715 33.0269 11.1145 - OK P3352 hESC 0 69.2202 69.9299 46.2177 15.5536 - OK P3352 Fibroblasts 1 0.318942 0.266125 0.217558 0.0695635 - OK P3352 Fibroblasts 0 0 0 0 0 - OK P3353 iPS 0 0 0 0 0 - OK P3353 iPS 1 18.9988 18.3039 31.2953 10.4174 - OK P3353 hESC 1 92.6528 91.7124 60.614 20.4325 - OK P3353 hESC 0 130.068 131.402 86.8454 29.2748 - OK P3353 Fibroblasts 1 0.674861 0.563104 0.460339 0.147425 - OK P3353 Fibroblasts 0 0 0 0 0 - OK P3354 iPS 0 4.45108 4.64589 7.94337 7.56384 - OK P3354 iPS 1 7.10004 6.84034 11.6954 11.1366 - OK P3354 hESC 1 0 0 0 0 - OK P3354 hESC 0 7.64494 7.72333 5.10446 5.04101 - OK P3354 Fibroblasts 1 22.7301 18.966 15.5048 14.842 - OK P3354 Fibroblasts 0 17.3076 20.5941 16.8357 16.116 - OK P3355 iPS 0 0 0 0 0 - OK P3355 iPS 1 7.32537 7.05743 12.0665 6.41796 - OK P3355 hESC 1 39.5946 39.1927 25.903 14.0584 - OK P3355 hESC 0 20.506 20.7163 13.6917 7.43093 - OK P3355 Fibroblasts 1 35.2621 29.4227 24.0531 12.8311 - OK P3355 Fibroblasts 0 24.1868 28.7796 23.5274 12.5506 - OK P3356 iPS 0 212.727 222.038 379.632 213.478 - OK P3356 iPS 1 68.801 66.2844 113.331 63.729 - OK P3356 hESC 1 381.747 377.873 249.742 143.47 - OK P3356 hESC 0 322.974 326.286 215.647 123.816 - OK P3356 Fibroblasts 1 643.939 537.303 439.246 247.481 - OK P3356 Fibroblasts 0 284.569 338.605 276.811 156.143 - OK P3357 iPS 0 6.82145 7.12 12.1735 7.39209 - OK P3357 iPS 1 18.7736 18.0869 30.9243 18.7781 - OK P3357 hESC 1 19.658 19.4585 12.8604 7.99159 - OK P3357 hESC 0 15.8749 16.0376 10.5995 6.58664 - OK P3357 Fibroblasts 1 97.0685 80.9939 66.2127 40.3414 - OK P3357 Fibroblasts 0 149.936 178.408 145.849 88.8612 - OK P3358 iPS 0 0 0 0 0 - OK P3358 iPS 1 0 0 0 0 - OK P3358 hESC 1 0 0 0 0 - OK P3358 hESC 0 0 0 0 0 - OK P3358 Fibroblasts 1 0 0 0 0 - OK P3358 Fibroblasts 0 0 0 0 0 - OK P336 iPS 0 36.7035 38.3099 65.5008 52.184 - OK P336 iPS 1 49 47.2077 80.7139 64.3042 - OK P336 hESC 1 761.22 753.494 497.995 408.998 - OK P336 hESC 0 736.058 743.605 491.459 403.63 - OK P336 Fibroblasts 1 0 0 0 0 - OK P336 Fibroblasts 0 0 0 0 0 - OK P337 iPS 0 3.29651 3.44079 5.88293 4.84798 - OK P337 iPS 1 0 0 0 0 - OK P337 hESC 1 6.77975 6.71094 4.43535 3.77191 - OK P337 hESC 0 4.94215 4.99282 3.29983 2.80624 - OK P337 Fibroblasts 1 0 0 0 0 - OK P337 Fibroblasts 0 0 0 0 0 - OK P338 iPS 0 110 114.814 196.305 56.815 - OK P338 iPS 1 320 308.295 527.111 152.557 - OK P338 hESC 1 989.979 979.932 647.651 189.506 - OK P338 hESC 0 1176 1188.05 785.202 229.754 - OK P338 Fibroblasts 1 0 0 0 0 - OK P338 Fibroblasts 0 0 0 0 0 - OK P339 iPS 0 0 0 0 0 - OK P339 iPS 1 0 0 0 0 - OK P339 hESC 1 0.0207428 0.0205323 0.0135701 0.00495709 - OK P339 hESC 0 77.0041 77.7936 51.4149 18.7817 - OK P339 Fibroblasts 1 6 5.0064 4.09274 1.41447 - OK P339 Fibroblasts 0 0 0 0 0 - OK P34 iPS 0 27.6667 28.8776 49.3738 18.9195 - OK P34 iPS 1 9.33333 8.99194 15.3741 5.89119 - OK P34 hESC 1 244.667 242.183 160.063 62.2307 - OK P34 hESC 0 298.167 301.224 199.083 77.4015 - OK P34 Fibroblasts 1 47.4833 39.6201 32.3895 12.4376 - OK P34 Fibroblasts 0 49.5 58.8994 48.1504 18.4899 - OK P340 iPS 0 0 0 0 0 - OK P340 iPS 1 2.99979 2.89007 4.94133 1.18782 - OK P340 hESC 1 0 0 0 0 - OK P340 hESC 0 11 11.1128 7.3446 1.78164 - OK P340 Fibroblasts 1 0 0 0 0 - OK P340 Fibroblasts 0 0 0 0 0 - OK P341 iPS 0 0 0 0 0 - OK P341 iPS 1 0.000117386 0.000113092 0.00019336 0.000131151 - OK P341 hESC 1 0.856326 0.847635 0.560214 0.389918 - OK P341 hESC 0 0 0 0 0 - OK P341 Fibroblasts 1 0 0 0 0 - OK P341 Fibroblasts 0 0 0 0 0 - OK P342 iPS 0 0 0 0 0 - OK P342 iPS 1 9.11716e-05 8.78368e-05 0.00015018 0.00010157 - OK P342 hESC 1 0.143674 0.142216 0.0939927 0.0652279 - OK P342 hESC 0 0 0 0 0 - OK P342 Fibroblasts 1 0 0 0 0 - OK P342 Fibroblasts 0 0 0 0 0 - OK P343 iPS 0 637.5 665.401 1137.68 764.687 - OK P343 iPS 1 699 673.432 1151.41 773.916 - OK P343 hESC 1 2168 2146 1418.32 978.03 - OK P343 hESC 0 2119.5 2141.23 1415.17 975.859 - OK P343 Fibroblasts 1 2660.5 2219.92 1814.79 1224.35 - OK P343 Fibroblasts 0 3138 3733.87 3052.45 2059.34 - OK P344 iPS 0 54.8005 57.1989 97.7966 75.3263 - OK P344 iPS 1 89.5145 86.2403 147.45 114.691 - OK P344 hESC 1 469.42 464.656 307.098 254.786 - OK P344 hESC 0 434.629 439.085 290.198 240.322 - OK P344 Fibroblasts 1 488.844 407.891 333.452 262.138 - OK P344 Fibroblasts 0 602.354 716.734 585.932 469.48 - OK P345 iPS 0 5.99033 6.25251 10.6903 10.2555 - OK P345 iPS 1 0 0 0 0 - OK P345 hESC 1 6.22915 6.16593 4.07515 4.05564 - OK P345 hESC 0 0 0 0 0 - OK P345 Fibroblasts 1 167.557 139.81 114.295 110.23 - OK P345 Fibroblasts 0 17.0885 20.3334 16.6226 16.0314 - OK P346 iPS 0 80.2092 83.7197 143.141 128.762 - OK P346 iPS 1 27.4855 26.4801 45.2747 40.7263 - OK P346 hESC 1 137.35 135.956 89.8556 83.6573 - OK P346 hESC 0 125.371 126.656 83.709 80.4435 - OK P346 Fibroblasts 1 249.598 208.265 170.257 153.917 - OK P346 Fibroblasts 0 184.557 219.603 179.526 163.833 - OK P347 iPS 0 242.291 252.895 432.391 252.584 - OK P347 iPS 1 248.502 239.412 409.338 239.118 - OK P347 hESC 1 1492.83 1477.68 976.619 583.308 - OK P347 hESC 0 1675.72 1692.9 1118.86 668.267 - OK P347 Fibroblasts 1 3482.48 2905.78 2375.48 1392.15 - OK P347 Fibroblasts 0 3484.33 4145.96 3389.33 1986.31 - OK P348 iPS 0 0 0 0 0 - OK P348 iPS 1 0 0 0 0 - OK P348 hESC 1 5.06918 5.01773 3.31629 2.55873 - OK P348 hESC 0 0 0 0 0 - OK P348 Fibroblasts 1 10.9015 9.09622 7.43618 5.59896 - OK P348 Fibroblasts 0 0 0 0 0 - OK P349 iPS 0 0 0 0 0 - OK P349 iPS 1 0 0 0 0 - OK P349 hESC 1 366.881 363.157 240.016 188.164 - OK P349 hESC 0 268.739 271.494 179.435 140.67 - OK P349 Fibroblasts 1 12610.1 10521.8 8601.63 6576.73 - OK P349 Fibroblasts 0 14504.1 17258.2 14108.7 10788.8 - OK P35 iPS 0 14.8152 15.4637 26.4392 37.3051 - OK P35 iPS 1 15.0505 14.5 24.7916 34.9804 - OK P35 hESC 1 424.364 420.057 277.622 413.658 - OK P35 hESC 0 265.688 268.412 177.397 264.323 - OK P35 Fibroblasts 1 230.096 191.992 156.954 223.198 - OK P35 Fibroblasts 0 294.047 349.883 286.03 406.751 - OK P350 iPS 0 542.998 566.763 969.03 739.532 - OK P350 iPS 1 142.998 137.768 235.55 179.764 - OK P350 hESC 1 21.8518 21.6301 14.2956 11.2322 - OK P350 hESC 0 54.4715 55.03 36.3702 28.5763 - OK P350 Fibroblasts 1 1052.8 878.46 718.143 550.382 - OK P350 Fibroblasts 0 4872.27 5797.46 4739.44 3632.29 - OK P351 iPS 0 3 3.1313 5.35378 4.17135 - OK P351 iPS 1 2 1.92684 3.29445 2.56684 - OK P351 hESC 1 49 48.5027 32.0561 25.7298 - OK P351 hESC 0 37 37.3794 24.7046 19.8291 - OK P351 Fibroblasts 1 0 0 0 0 - OK P351 Fibroblasts 0 0 0 0 0 - OK P352 iPS 0 389 406.025 694.207 154.925 - OK P352 iPS 1 383 368.991 630.887 140.794 - OK P352 hESC 1 1009 998.759 660.095 148.558 - OK P352 hESC 0 1120 1131.48 747.814 168.3 - OK P352 Fibroblasts 1 633 528.175 431.784 96.4793 - OK P352 Fibroblasts 0 358 425.98 348.24 77.8118 - OK P353 iPS 0 0 0 0 0 - OK P353 iPS 1 0 0 0 0 - OK P353 hESC 1 0 0 0 0 - OK P353 hESC 0 3 3.03076 2.00307 1.69429 - OK P353 Fibroblasts 1 82 68.4208 55.9342 46.0621 - OK P353 Fibroblasts 0 309.146 367.849 300.718 247.643 - OK P354 iPS 0 0 0 0 0 - OK P354 iPS 1 0.999855 0.963283 1.64698 0.965287 - OK P354 hESC 1 0 0 0 0 - OK P354 hESC 0 0 0 0 0 - OK P354 Fibroblasts 1 0 0 0 0 - OK P354 Fibroblasts 0 0 0 0 0 - OK P355 iPS 0 0 0 0 0 - OK P355 iPS 1 0 0 0 0 - OK P355 hESC 1 2 1.9797 1.30841 0.680701 - OK P355 hESC 0 0 0 0 0 - OK P355 Fibroblasts 1 0 0 0 0 - OK P355 Fibroblasts 0 0 0 0 0 - OK P356 iPS 0 7 7.30637 12.4922 6.30307 - OK P356 iPS 1 22 21.1953 36.2389 18.2848 - OK P356 hESC 1 63 62.3606 41.215 21.1976 - OK P356 hESC 0 44 44.4511 29.3784 15.1098 - OK P356 Fibroblasts 1 0 0 0 0 - OK P356 Fibroblasts 0 2 2.37978 1.94547 0.984354 - OK P357 iPS 0 0 0 0 0 - OK P357 iPS 1 0 0 0 0 - OK P357 hESC 1 0 0 0 0 - OK P357 hESC 0 0 0 0 0 - OK P357 Fibroblasts 1 0 0 0 0 - OK P357 Fibroblasts 0 0 0 0 0 - OK P358 iPS 0 1.53814 1.60546 2.74495 0.90142 - OK P358 iPS 1 0.00593585 0.00571873 0.00977768 0.00321091 - OK P358 hESC 1 22.6823 22.4521 14.8389 4.93388 - OK P358 hESC 0 35.5613 35.9259 23.744 7.89476 - OK P358 Fibroblasts 1 0.00685096 0.00571644 0.00467321 0.00147721 - OK P358 Fibroblasts 0 0 0 0 0 - OK P359 iPS 0 0 0 0 0 - OK P359 iPS 1 3.19225 3.07548 5.25834 1.74954 - OK P359 hESC 1 0 0 0 0 - OK P359 hESC 0 0 0 0 0 - OK P359 Fibroblasts 1 4.99315 4.16628 3.40595 1.09027 - OK P359 Fibroblasts 0 0 0 0 0 - OK P36 iPS 0 77.8533 81.2607 138.936 110.94 - OK P36 iPS 1 32.647 31.4529 53.777 42.9405 - OK P36 hESC 1 199.888 197.859 130.768 107.648 - OK P36 hESC 0 216.78 219.003 144.742 119.152 - OK P36 Fibroblasts 1 106.285 88.6838 72.4992 58.1464 - OK P36 Fibroblasts 0 41.4399 49.3088 40.3101 32.3298 - OK P360 iPS 0 3.46186 3.61338 6.17801 2.44415 - OK P360 iPS 1 1.80182 1.73591 2.968 1.1742 - OK P360 hESC 1 53.6669 53.1222 35.1092 14.0996 - OK P360 hESC 0 35.8685 36.2362 23.949 9.61778 - OK P360 Fibroblasts 1 0 0 0 0 - OK P360 Fibroblasts 0 0 0 0 0 - OK P361 iPS 0 1 1.04377 1.78459 1.04594 - OK P361 iPS 1 3 2.89027 4.94167 2.89628 - OK P361 hESC 1 92 91.0663 60.187 36.0699 - OK P361 hESC 0 115 116.179 76.7845 46.0167 - OK P361 Fibroblasts 1 2 1.6688 1.36425 0.802173 - OK P361 Fibroblasts 0 4 4.75955 3.89094 2.28786 - OK P362 iPS 0 74.0898 77.3324 132.22 236.889 - OK P362 iPS 1 69.0379 66.5126 113.721 203.746 - OK P362 hESC 1 128.138 126.838 83.8289 161.036 - OK P362 hESC 0 89 89.9125 59.4245 114.155 - OK P362 Fibroblasts 1 236 196.918 160.981 291.3 - OK P362 Fibroblasts 0 91 108.28 88.519 160.178 - OK P363 iPS 0 0 0 0 0 - OK P363 iPS 1 4.72093 4.54825 7.77642 7.38003 - OK P363 hESC 1 195.169 193.188 127.681 125.655 - OK P363 hESC 0 167.13 168.843 111.591 109.82 - OK P363 Fibroblasts 1 1701.76 1419.95 1160.81 1107.44 - OK P363 Fibroblasts 0 573.79 682.746 558.146 532.486 - OK P364 iPS 0 913.5 953.481 1630.23 925.553 - OK P364 iPS 1 366.279 352.881 603.343 342.545 - OK P364 hESC 1 924.831 915.445 605.031 350.994 - OK P364 hESC 0 805.87 814.133 538.072 312.15 - OK P364 Fibroblasts 1 6385.24 5327.84 4355.52 2480.6 - OK P364 Fibroblasts 0 3454.21 4110.12 3360.04 1913.64 - OK P365 iPS 0 0 0 0 0 - OK P365 iPS 1 25.4683 24.5368 41.952 17.5182 - OK P365 hESC 1 0 0 0 0 - OK P365 hESC 0 112.581 113.735 75.1691 31.8895 - OK P365 Fibroblasts 1 0.33258 0.277505 0.226861 0.0949508 - OK P365 Fibroblasts 0 49.5371 58.9436 48.1865 20.1681 - OK P366 iPS 0 0 0 0 0 - OK P366 iPS 1 0 0 0 0 - OK P366 hESC 1 0 0 0 0 - OK P366 hESC 0 10.1583 10.2624 6.78258 2.73471 - OK P366 Fibroblasts 1 26.318 21.9597 17.9521 7.14582 - OK P366 Fibroblasts 0 39.877 47.4492 38.7898 15.4403 - OK P367 iPS 0 22.8501 23.8502 40.7782 16.034 - OK P367 iPS 1 0.00476854 0.00459412 0.00785485 0.00308854 - OK P367 hESC 1 37.5733 37.192 24.5807 9.81018 - OK P367 hESC 0 0 0 0 0 - OK P367 Fibroblasts 1 708.466 591.144 483.261 190.433 - OK P367 Fibroblasts 0 0 0 0 0 - OK P368 iPS 0 131.9 137.673 235.388 80.6898 - OK P368 iPS 1 99.5269 95.8864 163.943 56.1989 - OK P368 hESC 1 198.427 196.413 129.812 45.0799 - OK P368 hESC 0 129.928 131.26 86.7515 30.1262 - OK P368 Fibroblasts 1 2241.22 1870.07 1528.79 525.055 - OK P368 Fibroblasts 0 882.669 1050.28 858.604 294.884 - OK P369 iPS 0 775.518 809.461 1383.99 806.467 - OK P369 iPS 1 975.649 939.962 1607.11 936.486 - OK P369 hESC 1 12318.4 12193.4 8058.79 4801.13 - OK P369 hESC 0 12138.1 12262.6 8104.53 4828.38 - OK P369 Fibroblasts 1 277.355 231.425 189.19 110.889 - OK P369 Fibroblasts 0 19.9993 23.7969 19.4541 11.3727 - OK P37 iPS 0 110.185 115.008 196.636 122.83 - OK P37 iPS 1 112.049 107.95 184.57 115.293 - OK P37 hESC 1 824.577 816.209 539.444 345.07 - OK P37 hESC 0 1120.97 1132.47 748.464 478.775 - OK P37 Fibroblasts 1 228.261 190.461 155.702 97.5972 - OK P37 Fibroblasts 0 758.56 902.601 737.879 462.516 - OK P370 iPS 0 14.9357 15.5894 26.6542 15.7986 - OK P370 iPS 1 12.9842 12.5092 21.3878 12.6771 - OK P370 hESC 1 25.3414 25.0842 16.5785 10.0504 - OK P370 hESC 0 156.539 158.144 104.52 63.3631 - OK P370 Fibroblasts 1 0 0 0 0 - OK P370 Fibroblasts 0 0 0 0 0 - OK P371 iPS 0 41.4551 43.2695 73.9805 46.2533 - OK P371 iPS 1 48.3666 46.5975 79.6706 49.8108 - OK P371 hESC 1 563.932 558.209 368.928 236.208 - OK P371 hESC 0 108.626 109.74 72.5287 46.4369 - OK P371 Fibroblasts 1 23.645 19.7294 16.1288 10.1188 - OK P371 Fibroblasts 0 0.000686051 0.000816323 0.000667346 0.000418676 - OK P372 iPS 0 26.5907 27.7545 47.4536 31.2717 - OK P372 iPS 1 0 0 0 0 - OK P372 hESC 1 316.803 313.587 207.254 140.049 - OK P372 hESC 0 236.193 238.614 157.704 106.566 - OK P372 Fibroblasts 1 0 0 0 0 - OK P372 Fibroblasts 0 0 0 0 0 - OK P373 iPS 0 18.4148 19.2207 32.8629 12.0916 - OK P373 iPS 1 15.6222 15.0508 25.7332 9.46828 - OK P373 hESC 1 102.993 101.948 67.3789 25.1391 - OK P373 hESC 0 77.795 78.5926 51.943 19.3799 - OK P373 Fibroblasts 1 92.7857 77.4203 63.2913 23.3348 - OK P373 Fibroblasts 0 23.9138 28.4547 23.2618 8.57636 - OK P374 iPS 0 0 0 0 0 - OK P374 iPS 1 1 0.963422 1.64722 2.79543 - OK P374 hESC 1 0 0 0 0 - OK P374 hESC 0 0 0 0 0 - OK P374 Fibroblasts 1 0 0 0 0 - OK P374 Fibroblasts 0 0 0 0 0 - OK P375 iPS 0 0 0 0 0 - OK P375 iPS 1 0 0 0 0 - OK P375 hESC 1 0 0 0 0 - OK P375 hESC 0 0 0 0 0 - OK P375 Fibroblasts 1 0 0 0 0 - OK P375 Fibroblasts 0 0 0 0 0 - OK P376 iPS 0 0 0 0 0 - OK P376 iPS 1 0 0 0 0 - OK P376 hESC 1 0 0 0 0 - OK P376 hESC 0 0 0 0 0 - OK P376 Fibroblasts 1 0 0 0 0 - OK P376 Fibroblasts 0 0 0 0 0 - OK P377 iPS 0 17.6172 18.3882 31.4395 20.4423 - OK P377 iPS 1 62.0659 59.7957 102.236 66.4752 - OK P377 hESC 1 17.5566 17.3784 11.4856 7.65519 - OK P377 hESC 0 24.5622 24.814 16.3999 10.9306 - OK P377 Fibroblasts 1 121.727 101.569 83.0328 54.1834 - OK P377 Fibroblasts 0 86.9269 103.433 84.5569 55.1779 - OK P378 iPS 0 4.79698 5.00693 8.56066 9.00648 - OK P378 iPS 1 9.83028 9.47072 16.1927 17.036 - OK P378 hESC 1 7.99083 7.90973 5.22766 5.72637 - OK P378 hESC 0 18.9929 19.1877 12.6814 13.8912 - OK P378 Fibroblasts 1 111.944 93.4057 76.3594 80.8054 - OK P378 Fibroblasts 0 57.6492 68.5961 56.0775 59.3426 - OK P379 iPS 0 391.058 408.173 697.879 466.532 - OK P379 iPS 1 605.576 583.426 997.519 690.34 - OK P379 hESC 1 237.935 235.52 155.659 106.813 - OK P379 hESC 0 210.034 212.188 140.238 99.2395 - OK P379 Fibroblasts 1 1364.29 1138.36 930.614 621.614 - OK P379 Fibroblasts 0 1083.27 1288.97 1053.73 703.854 - OK P38 iPS 0 273.313 285.275 487.752 276.033 - OK P38 iPS 1 131.087 126.292 215.929 122.2 - OK P38 hESC 1 462.904 458.205 302.835 175.108 - OK P38 hESC 0 276.558 279.394 184.656 106.773 - OK P38 Fibroblasts 1 267.691 223.361 182.599 103.662 - OK P38 Fibroblasts 0 349.02 415.294 339.504 192.737 - OK P380 iPS 0 2956.15 3085.54 5275.53 3873.55 - OK P380 iPS 1 1724.53 1661.45 2840.68 2085.77 - OK P380 hESC 1 2973.52 2943.34 1945.3 1468.87 - OK P380 hESC 0 3145.62 3177.87 2100.3 1585.92 - OK P380 Fibroblasts 1 16630 13876.1 11343.7 8363.04 - OK P380 Fibroblasts 0 13510.2 16075.6 13141.8 9688.65 - OK P381 iPS 0 10.3746 10.8286 18.5144 12.2695 - OK P381 iPS 1 0 0 0 0 - OK P381 hESC 1 0 0 0 0 - OK P381 hESC 0 15.7918 15.9537 10.5441 7.16606 - OK P381 Fibroblasts 1 0 0 0 0 - OK P381 Fibroblasts 0 0 0 0 0 - OK P382 iPS 0 0 0 0 0 - OK P382 iPS 1 0 0 0 0 - OK P382 hESC 1 0 0 0 0 - OK P382 hESC 0 0 0 0 0 - OK P382 Fibroblasts 1 0 0 0 0 - OK P382 Fibroblasts 0 0 0 0 0 - OK P383 iPS 0 36.9015 38.5166 65.8542 11.3596 - OK P383 iPS 1 0 0 0 0 - OK P383 hESC 1 508.309 503.15 332.539 57.736 - OK P383 hESC 0 826.584 835.059 551.902 95.8222 - OK P383 Fibroblasts 1 0 0 0 0 - OK P383 Fibroblasts 0 78.6883 93.6302 76.5429 13.2159 - OK P384 iPS 0 27.9495 29.1728 49.8785 35.4101 - OK P384 iPS 1 41.4509 39.9347 68.2788 48.4731 - OK P384 hESC 1 27.6707 27.3899 18.1024 13.2037 - OK P384 hESC 0 71.3361 72.0676 47.6305 34.7413 - OK P384 Fibroblasts 1 39.3039 32.7951 26.8101 19.1081 - OK P384 Fibroblasts 0 9.95743 11.8482 9.68596 6.90339 - OK P385 iPS 0 305.149 318.504 544.567 90.2382 - OK P385 iPS 1 278.549 268.36 458.833 75.9092 - OK P385 hESC 1 608.02 601.849 397.771 66.1604 - OK P385 hESC 0 1597.08 1613.46 1066.36 177.58 - OK P385 Fibroblasts 1 2097.7 1750.32 1430.89 237.17 - OK P385 Fibroblasts 0 1144.35 1361.65 1113.15 184.305 - OK P386 iPS 0 4.16534 4.34765 7.43345 2.17769 - OK P386 iPS 1 6.66534 6.42154 10.9793 3.21648 - OK P386 hESC 1 116.763 115.578 76.3869 22.6273 - OK P386 hESC 0 58.4674 59.0669 39.0382 11.5639 - OK P386 Fibroblasts 1 0 0 0 0 - OK P386 Fibroblasts 0 0 0 0 0 - OK P387 iPS 0 20.8347 21.7465 37.1814 31.3714 - OK P387 iPS 1 21.3347 20.5543 35.1429 29.6514 - OK P387 hESC 1 160.237 158.611 104.828 91.3447 - OK P387 hESC 0 87.5326 88.4301 58.4447 50.9272 - OK P387 Fibroblasts 1 0 0 0 0 - OK P387 Fibroblasts 0 0 0 0 0 - OK P388 iPS 0 0 0 0 0 - OK P388 iPS 1 0 0 0 0 - OK P388 hESC 1 0 0 0 0 - OK P388 hESC 0 0 0 0 0 - OK P388 Fibroblasts 1 0 0 0 0 - OK P388 Fibroblasts 0 0 0 0 0 - OK P389 iPS 0 0 0 0 0 - OK P389 iPS 1 0 0 0 0 - OK P389 hESC 1 0 0 0 0 - OK P389 hESC 0 0 0 0 0 - OK P389 Fibroblasts 1 0 0 0 0 - OK P389 Fibroblasts 0 0 0 0 0 - OK P39 iPS 0 38.3303 40.0079 68.4041 44.7651 - OK P39 iPS 1 129.518 124.78 213.345 139.617 - OK P39 hESC 1 1791.79 1773.6 1172.2 786.459 - OK P39 hESC 0 707.886 715.144 472.649 317.113 - OK P39 Fibroblasts 1 2008.65 1676.01 1370.15 899.906 - OK P39 Fibroblasts 0 2343.04 2787.95 2279.16 1496.94 - OK P390 iPS 0 0 0 0 0 - OK P390 iPS 1 0 0 0 0 - OK P390 hESC 1 0 0 0 0 - OK P390 hESC 0 0 0 0 0 - OK P390 Fibroblasts 1 0 0 0 0 - OK P390 Fibroblasts 0 0 0 0 0 - OK P391 iPS 0 0 0 0 0 - OK P391 iPS 1 0 0 0 0 - OK P391 hESC 1 77.0862 76.3039 50.4303 15.3499 - OK P391 hESC 0 284.968 287.889 190.27 57.9142 - OK P391 Fibroblasts 1 0 0 0 0 - OK P391 Fibroblasts 0 464.765 553.018 452.094 136.277 - OK P392 iPS 0 14.3858 15.0154 25.6728 9.39718 - OK P392 iPS 1 0 0 0 0 - OK P392 hESC 1 514.682 509.458 336.708 124.967 - OK P392 hESC 0 168.792 170.523 112.701 41.8281 - OK P392 Fibroblasts 1 375.316 313.164 256.012 93.8993 - OK P392 Fibroblasts 0 219.86 261.609 213.866 78.441 - OK P393 iPS 0 95.6142 99.7989 170.632 51.3821 - OK P393 iPS 1 59.8132 57.6254 98.5257 29.6688 - OK P393 hESC 1 985.732 975.728 644.872 196.412 - OK P393 hESC 0 848.24 856.938 566.362 172.5 - OK P393 Fibroblasts 1 571.271 476.668 389.677 117.538 - OK P393 Fibroblasts 0 4554.38 5419.19 4430.21 1336.28 - OK P394 iPS 0 0 0 0 0 - OK P394 iPS 1 55.1868 53.1682 90.905 28.822 - OK P394 hESC 1 0 0 0 0 - OK P394 hESC 0 0 0 0 0 - OK P394 Fibroblasts 1 650.413 542.705 443.662 140.913 - OK P394 Fibroblasts 0 0 0 0 0 - OK P395 iPS 0 2089.68 2181.14 3729.24 1839.64 - OK P395 iPS 1 2806.11 2703.47 4622.29 2280.18 - OK P395 hESC 1 9150.75 9057.87 5986.48 3008.93 - OK P395 hESC 0 9743.98 9843.89 6505.97 3270.03 - OK P395 Fibroblasts 1 5306.04 4427.36 3619.38 1790.32 - OK P395 Fibroblasts 0 3526.24 4195.83 3430.1 1696.69 - OK P396 iPS 0 625.316 652.684 1115.93 537.008 - OK P396 iPS 1 715.887 689.702 1179.23 567.465 - OK P396 hESC 1 3304.75 3271.21 2161.99 1059.56 - OK P396 hESC 0 2512.02 2537.78 1677.25 821.993 - OK P396 Fibroblasts 1 1867.29 1558.07 1273.72 614.572 - OK P396 Fibroblasts 0 1224.76 1457.33 1191.37 574.837 - OK P397 iPS 0 3.47603 3.62816 6.2033 12.1952 - OK P397 iPS 1 0.170186 0.163961 0.280334 0.551116 - OK P397 hESC 1 4.30731 4.26359 2.81787 5.98178 - OK P397 hESC 0 0 0 0 0 - OK P397 Fibroblasts 1 83.1586 69.3875 56.7245 112.74 - OK P397 Fibroblasts 0 17.736 21.1039 17.2525 34.2893 - OK P398 iPS 0 15.8525 16.5463 28.2903 15.1153 - OK P398 iPS 1 3.03639 2.92532 5.00161 2.67232 - OK P398 hESC 1 12.693 12.5642 8.30387 4.52762 - OK P398 hESC 0 12.0003 12.1233 8.01248 4.36875 - OK P398 Fibroblasts 1 47.9909 40.0436 32.7357 17.5422 - OK P398 Fibroblasts 0 67.6602 80.508 65.8155 35.2688 - OK P399 iPS 0 6841.2 7140.62 12208.8 40488.9 - OK P399 iPS 1 5845.59 5631.78 9629 31933.4 - OK P399 hESC 1 30768.5 30456.2 20129 76262.2 - OK P399 hESC 0 27142.3 27420.6 18122.6 68660.9 - OK P399 Fibroblasts 1 28135.6 23476.3 19191.9 64834.9 - OK P399 Fibroblasts 0 13630.2 16218.4 13258.6 44790.6 - OK P4 iPS 0 0 0 0 0 - OK P4 iPS 1 1 0.963422 1.64722 3.02791 - OK P4 hESC 1 0 0 0 0 - OK P4 hESC 0 0 0 0 0 - OK P4 Fibroblasts 1 0 0 0 0 - OK P4 Fibroblasts 0 0 0 0 0 - OK P40 iPS 0 513.179 535.639 915.815 563.363 - OK P40 iPS 1 382.081 368.106 629.373 387.158 - OK P40 hESC 1 1373.94 1360 898.843 566.011 - OK P40 hESC 0 2456.57 2481.76 1640.23 1032.87 - OK P40 Fibroblasts 1 1248.45 1041.7 851.595 525.643 - OK P40 Fibroblasts 0 1819.87 2165.44 1770.26 1092.68 - OK P400 iPS 0 1133.06 1182.65 2022.05 6507.56 - OK P400 iPS 1 1309.04 1261.16 2156.28 6939.53 - OK P400 hESC 1 3182.66 3150.36 2082.12 7623.06 - OK P400 hESC 0 2780.35 2808.85 1856.41 6796.7 - OK P400 Fibroblasts 1 24077.4 20090.2 16423.8 53812.7 - OK P400 Fibroblasts 0 17255.3 20531.9 16784.9 54995.8 - OK P401 iPS 0 163.08 170.218 291.032 943.061 - OK P401 iPS 1 87.1684 83.98 143.586 465.276 - OK P401 hESC 1 402.695 398.608 263.446 972.076 - OK P401 hESC 0 964.499 974.389 643.987 2376.22 - OK P401 Fibroblasts 1 3182.94 2655.85 2171.16 7163.62 - OK P401 Fibroblasts 0 2947.66 3507.39 2867.3 9460.49 - OK P402 iPS 0 120.157 125.416 214.432 167.812 - OK P402 iPS 1 220.2 212.145 362.718 283.859 - OK P402 hESC 1 313.465 310.283 205.071 165.35 - OK P402 hESC 0 418.4 422.689 279.362 225.252 - OK P402 Fibroblasts 1 127.937 106.75 87.2686 68.5918 - OK P402 Fibroblasts 0 131.861 156.9 128.266 100.815 - OK P403 iPS 0 1409.05 1470.72 2514.58 744.997 - OK P403 iPS 1 1562.26 1505.12 2573.4 762.424 - OK P403 hESC 1 2522.1 2496.5 1649.97 494.345 - OK P403 hESC 0 2794.38 2823.03 1865.78 559.003 - OK P403 Fibroblasts 1 5747.97 4796.1 3920.82 1163.53 - OK P403 Fibroblasts 0 4474.46 5324.1 4352.47 1291.62 - OK P404 iPS 0 20.201 21.0851 36.0505 36.2046 - OK P404 iPS 1 30.8555 29.7268 50.8258 51.0431 - OK P404 hESC 1 152.145 150.601 99.5341 103.881 - OK P404 hESC 0 36.0897 36.4598 24.0968 25.1492 - OK P404 Fibroblasts 1 237.817 198.435 162.221 163.823 - OK P404 Fibroblasts 0 132.285 157.405 128.679 129.949 - OK P405 iPS 0 574.799 599.956 1025.78 998.962 - OK P405 iPS 1 652.145 628.291 1074.23 1046.14 - OK P405 hESC 1 1574.86 1558.87 1030.28 1041.47 - OK P405 hESC 0 1922.91 1942.63 1283.91 1297.85 - OK P405 Fibroblasts 1 2045.18 1706.5 1395.07 1365.94 - OK P405 Fibroblasts 0 1824.71 2171.21 1774.97 1737.9 - OK P406 iPS 0 456.902 476.899 815.384 792.973 - OK P406 iPS 1 395.028 380.579 650.699 632.814 - OK P406 hESC 1 945.604 936.007 618.62 624.445 - OK P406 hESC 0 1195.14 1207.39 797.984 805.497 - OK P406 Fibroblasts 1 297.928 248.591 203.224 198.705 - OK P406 Fibroblasts 0 307.485 365.873 299.102 292.451 - OK P407 iPS 0 35.4679 37.0202 63.2958 58.9617 - OK P407 iPS 1 39.8368 38.3796 65.6201 61.1269 - OK P407 hESC 1 0.305029 0.301933 0.199552 0.192633 - OK P407 hESC 0 0 0 0 0 - OK P407 Fibroblasts 1 0 0 0 0 - OK P407 Fibroblasts 0 0 0 0 0 - OK P408 iPS 0 50.4713 52.6803 90.0707 89.5655 - OK P408 iPS 1 141.047 135.888 232.336 231.032 - OK P408 hESC 1 2228.21 2205.6 1457.71 1505.82 - OK P408 hESC 0 2533.53 2559.51 1691.62 1747.45 - OK P408 Fibroblasts 1 670.688 559.622 457.492 457.438 - OK P408 Fibroblasts 0 1160.93 1381.38 1129.28 1129.15 - OK P409 iPS 0 65.1589 68.0107 116.282 105.405 - OK P409 iPS 1 72.5887 69.9336 119.57 108.385 - OK P409 hESC 1 836.214 827.727 547.057 513.376 - OK P409 hESC 0 496.326 501.414 331.392 310.989 - OK P409 Fibroblasts 1 147.384 122.977 100.534 91.5879 - OK P409 Fibroblasts 0 209.582 249.38 203.868 185.727 - OK P41 iPS 0 38.947 40.6516 69.5045 40.236 - OK P41 iPS 1 23.9342 23.0588 39.425 22.8231 - OK P41 hESC 1 144.347 142.882 94.4326 55.8828 - OK P41 hESC 0 141.377 142.827 94.3965 55.8615 - OK P41 Fibroblasts 1 104.342 87.0626 71.1739 41.3345 - OK P41 Fibroblasts 0 72.7876 86.609 70.8031 41.1192 - OK P410 iPS 0 1826 1905.92 3258.67 2053.69 - OK P410 iPS 1 1918 1847.84 3159.37 1991.11 - OK P410 hESC 1 2013.5 1993.06 1317.25 850.301 - OK P410 hESC 0 2796 2824.67 1866.86 1205.09 - OK P410 Fibroblasts 1 4027 3360.13 2746.91 1737.21 - OK P410 Fibroblasts 0 2970 3533.97 2889.03 1827.09 - OK P411 iPS 0 4.62262 4.82494 8.24951 4.97727 - OK P411 iPS 1 0 0 0 0 - OK P411 hESC 1 0 0 0 0 - OK P411 hESC 0 0 0 0 0 - OK P411 Fibroblasts 1 1.99981 1.66864 1.36412 0.82578 - OK P411 Fibroblasts 0 0.999871 1.18973 0.97261 0.588778 - OK P412 iPS 0 0.000560585 0.00058512 0.00100042 0.000537764 - OK P412 iPS 1 25.7499 24.8081 42.4159 22.8003 - OK P412 hESC 1 63.9885 63.339 41.8617 22.9664 - OK P412 hESC 0 72.9965 73.745 48.7391 26.7396 - OK P412 Fibroblasts 1 0 0 0 0 - OK P412 Fibroblasts 0 0 0 0 0 - OK P413 iPS 0 13.3768 13.9623 23.8722 13.3392 - OK P413 iPS 1 1.25006 1.20434 2.05913 1.15059 - OK P413 hESC 1 0.0115437 0.0114266 0.00755199 0.0043104 - OK P413 hESC 0 0.0034833 0.00351901 0.00232577 0.00132746 - OK P413 Fibroblasts 1 0.000192781 0.000160856 0.0001315 7.37064e-05 - OK P413 Fibroblasts 0 0.000129213 0.000153749 0.000125691 7.04501e-05 - OK P414 iPS 0 0 0 0 0 - OK P414 iPS 1 0 0 0 0 - OK P414 hESC 1 30.5208 30.211 19.9669 5.31471 - OK P414 hESC 0 18.9029 19.0967 12.6213 3.35949 - OK P414 Fibroblasts 1 517.359 431.684 352.903 93.1394 - OK P414 Fibroblasts 0 119.944 142.719 116.674 30.7929 - OK P415 iPS 0 111.424 116.301 198.847 179.785 - OK P415 iPS 1 13.5374 13.0423 22.2992 20.1615 - OK P415 hESC 1 90.7633 89.8421 59.3779 55.5746 - OK P415 hESC 0 91.4322 92.3696 61.0484 57.1381 - OK P415 Fibroblasts 1 300.742 250.939 205.143 186.409 - OK P415 Fibroblasts 0 193.099 229.766 187.835 170.681 - OK P416 iPS 0 7.60848 7.94148 13.578 11.665 - OK P416 iPS 1 0 0 0 0 - OK P416 hESC 1 0 0 0 0 - OK P416 hESC 0 2.00717 2.02775 1.34017 1.18978 - OK P416 Fibroblasts 1 7.9145 6.60386 5.39867 4.66016 - OK P416 Fibroblasts 0 0 0 0 0 - OK P417 iPS 0 1177.14 1228.66 2100.71 565.204 - OK P417 iPS 1 253.933 244.645 418.284 112.541 - OK P417 hESC 1 402.089 398.008 263.049 71.4974 - OK P417 hESC 0 496.766 501.859 331.686 90.153 - OK P417 Fibroblasts 1 9681.61 8078.33 6604.05 1779.49 - OK P417 Fibroblasts 0 3746.35 4457.74 3644.21 981.947 - OK P418 iPS 0 20.8286 21.7402 37.1706 20.4708 - OK P418 iPS 1 27.5297 26.5227 45.3475 24.974 - OK P418 hESC 1 11.627 11.509 7.60648 4.27763 - OK P418 hESC 0 18.8919 19.0856 12.614 7.09368 - OK P418 Fibroblasts 1 25.3773 21.1748 17.3105 9.56238 - OK P418 Fibroblasts 0 10.6042 12.6178 10.315 5.69808 - OK P419 iPS 0 7.44132 7.767 13.2797 17.0534 - OK P419 iPS 1 0.00313918 0.00302436 0.00517093 0.00664035 - OK P419 hESC 1 7.49381 7.41775 4.9025 6.61494 - OK P419 hESC 0 18.529 18.719 12.3717 16.6931 - OK P419 Fibroblasts 1 66.9558 55.8679 45.6721 59.0695 - OK P419 Fibroblasts 0 32.3924 38.5433 31.5092 40.7521 - OK P42 iPS 0 1.12442 1.17363 2.00664 6.7982 - OK P42 iPS 1 3.8372 3.69684 6.32072 21.4137 - OK P42 hESC 1 97.2222 96.2355 63.6034 246.925 - OK P42 hESC 0 86.6367 87.525 57.8466 224.576 - OK P42 Fibroblasts 1 12.8616 10.7317 8.77319 30.2889 - OK P42 Fibroblasts 0 0 0 0 0 - OK P420 iPS 0 0 0 0 0 - OK P420 iPS 1 29.137 28.0713 47.9952 61.5222 - OK P420 hESC 1 14.0411 13.8986 9.18577 12.3708 - OK P420 hESC 0 0 0 0 0 - OK P420 Fibroblasts 1 116.866 97.5133 79.7173 102.913 - OK P420 Fibroblasts 0 0.00654386 0.00778646 0.00636545 0.00821765 - OK P421 iPS 0 4.20595 4.39003 7.50591 11.4224 - OK P421 iPS 1 0 0 0 0 - OK P421 hESC 1 6.5098 6.44373 4.25876 6.87415 - OK P421 hESC 0 0 0 0 0 - OK P421 Fibroblasts 1 20.1925 16.8486 13.7738 21.1384 - OK P421 Fibroblasts 0 0 0 0 0 - OK P422 iPS 0 218.353 227.909 389.671 360.378 - OK P422 iPS 1 146.317 140.965 241.016 222.898 - OK P422 hESC 1 154.955 153.383 101.373 97.129 - OK P422 hESC 0 204.471 206.567 136.523 130.808 - OK P422 Fibroblasts 1 366.42 305.741 249.944 232.342 - OK P422 Fibroblasts 0 213.8 254.398 207.971 193.325 - OK P423 iPS 0 0 0 0 0 - OK P423 iPS 1 45.5432 43.8774 75.0199 85.2002 - OK P423 hESC 1 0 0 0 0 - OK P423 hESC 0 0 0 0 0 - OK P423 Fibroblasts 1 134.565 112.281 91.7901 104.904 - OK P423 Fibroblasts 0 38.8009 46.1687 37.743 43.1353 - OK P424 iPS 0 3 3.1313 5.35378 2.00057 - OK P424 iPS 1 1 0.963422 1.64722 0.615525 - OK P424 hESC 1 10 9.89851 6.54207 2.47943 - OK P424 hESC 0 9 9.09228 6.00922 2.27748 - OK P424 Fibroblasts 1 1 0.8344 0.682124 0.244094 - OK P424 Fibroblasts 0 0 0 0 0 - OK P425 iPS 0 0 0 0 0 - OK P425 iPS 1 202.968 195.544 334.334 124.406 - OK P425 hESC 1 0 0 0 0 - OK P425 hESC 0 0 0 0 0 - OK P425 Fibroblasts 1 1830.94 1527.74 1248.93 465.686 - OK P425 Fibroblasts 0 1813.71 2158.11 1764.26 657.837 - OK P426 iPS 0 43.7934 45.7101 78.1534 49.6746 - OK P426 iPS 1 31.4446 30.2944 51.7962 32.9218 - OK P426 hESC 1 114.443 113.281 74.8691 48.7518 - OK P426 hESC 0 102.86 103.915 68.6787 44.7208 - OK P426 Fibroblasts 1 69.0144 57.5856 47.0764 30.0273 - OK P426 Fibroblasts 0 41.4381 49.3067 40.3084 25.7104 - OK P427 iPS 0 1056.49 1102.73 1885.41 708.271 - OK P427 iPS 1 1327.21 1278.66 2186.21 821.27 - OK P427 hESC 1 3040.53 3009.67 1989.13 757.939 - OK P427 hESC 0 3392.58 3427.36 2265.19 863.129 - OK P427 Fibroblasts 1 2986.33 2491.79 2037.04 766.825 - OK P427 Fibroblasts 0 2245.57 2671.98 2184.35 822.276 - OK P428 iPS 0 339.058 353.897 605.08 365.382 - OK P428 iPS 1 290.01 279.402 477.712 288.47 - OK P428 hESC 1 2523.02 2497.41 1650.58 1019.86 - OK P428 hESC 0 1865.68 1884.81 1245.7 769.696 - OK P428 Fibroblasts 1 338.896 282.775 231.169 140.06 - OK P428 Fibroblasts 0 285.895 340.183 278.101 168.495 - OK P43 iPS 0 0.0239349 0.0249824 0.042714 0.0221931 - OK P43 iPS 1 3.87807 3.73622 6.38805 3.31906 - OK P43 hESC 1 87.0375 86.1542 56.9405 30.1741 - OK P43 hESC 0 71.3715 72.1033 47.6541 25.253 - OK P43 Fibroblasts 1 10.1406 8.46129 6.91713 3.6043 - OK P43 Fibroblasts 0 29.2237 34.7729 28.427 14.8124 - OK P44 iPS 0 0 0 0 0 - OK P44 iPS 1 0 0 0 0 - OK P44 hESC 1 28.7306 28.439 18.7958 8.60342 - OK P44 hESC 0 0 0 0 0 - OK P44 Fibroblasts 1 200.771 167.523 136.951 61.7799 - OK P44 Fibroblasts 0 115.331 137.231 112.187 50.6086 - OK P45 iPS 0 4.20046 4.3843 7.49611 3.83838 - OK P45 iPS 1 3.50387 3.3757 5.77165 2.95538 - OK P45 hESC 1 72.3284 71.5944 47.3178 24.7046 - OK P45 hESC 0 135.731 137.122 90.6262 47.3159 - OK P45 Fibroblasts 1 180.253 150.403 122.955 63.1376 - OK P45 Fibroblasts 0 78.9124 93.8969 76.761 39.4169 - OK P46 iPS 0 19.8662 20.7357 35.4532 16.3063 - OK P46 iPS 1 20.0934 19.3584 33.0983 15.2232 - OK P46 hESC 1 0.0583406 0.0577485 0.0381668 0.0178632 - OK P46 hESC 0 0.019189 0.0193858 0.0128123 0.00599657 - OK P46 Fibroblasts 1 66.2317 55.2637 45.1782 20.8321 - OK P46 Fibroblasts 0 51.7906 61.625 50.3786 23.23 - OK P47 iPS 0 0 0 0 0 - OK P47 iPS 1 0 0 0 0 - OK P47 hESC 1 0 0 0 0 - OK P47 hESC 0 0 0 0 0 - OK P47 Fibroblasts 1 0 0 0 0 - OK P47 Fibroblasts 0 0 0 0 0 - OK P48 iPS 0 0 0 0 0 - OK P48 iPS 1 0 0 0 0 - OK P48 hESC 1 31.2831 30.9656 20.4656 9.6167 - OK P48 hESC 0 0 0 0 0 - OK P48 Fibroblasts 1 0 0 0 0 - OK P48 Fibroblasts 0 0 0 0 0 - OK P49 iPS 0 16.4096 17.1278 29.2844 19.3524 - OK P49 iPS 1 0.247454 0.238403 0.407612 0.269367 - OK P49 hESC 1 0 0 0 0 - OK P49 hESC 0 0 0 0 0 - OK P49 Fibroblasts 1 0 0 0 0 - OK P49 Fibroblasts 0 49.6212 59.0437 48.2684 32.0146 - OK P5 iPS 0 98.2263 102.525 175.294 103.901 - OK P5 iPS 1 0 0 0 0 - OK P5 hESC 1 10.6666 10.5583 6.97813 4.23036 - OK P5 hESC 0 0 0 0 0 - OK P5 Fibroblasts 1 10.883 9.08075 7.42354 4.41456 - OK P5 Fibroblasts 0 0 0 0 0 - OK P50 iPS 0 0 0 0 0 - OK P50 iPS 1 0.197963 0.190722 0.326089 0.190408 - OK P50 hESC 1 242.387 239.927 158.571 94.6701 - OK P50 hESC 0 273.703 276.509 182.749 109.105 - OK P50 Fibroblasts 1 183.559 153.162 125.21 73.3486 - OK P50 Fibroblasts 0 62.1814 73.9889 60.4861 35.4331 - OK P51 iPS 0 38.2071 39.8793 68.1841 33.7411 - OK P51 iPS 1 35.1007 33.8168 57.8187 28.6118 - OK P51 hESC 1 309.827 306.683 202.691 102.204 - OK P51 hESC 0 303.014 306.121 202.32 102.016 - OK P51 Fibroblasts 1 108.038 90.147 73.6954 36.5684 - OK P51 Fibroblasts 0 149.142 177.462 145.076 71.9881 - OK P52 iPS 0 14.1683 14.7884 25.2847 11.7904 - OK P52 iPS 1 0.141314 0.136145 0.232776 0.108545 - OK P52 hESC 1 235.126 232.74 153.821 73.0075 - OK P52 hESC 0 315.525 318.76 210.673 99.9908 - OK P52 Fibroblasts 1 1287.14 1073.99 877.992 410.47 - OK P52 Fibroblasts 0 506.797 603.032 492.98 230.473 - OK P53 iPS 0 0.00046687 0.000487304 0.000833174 0.00109989 - OK P53 iPS 1 5.49971 5.29854 9.05925 11.9593 - OK P53 hESC 1 37.8574 37.4732 24.7666 34.402 - OK P53 hESC 0 39.3254 39.7286 26.2572 36.4726 - OK P53 Fibroblasts 1 9.69795 8.09197 6.6152 8.79699 - OK P53 Fibroblasts 0 1.59183 1.8941 1.54843 2.05912 - OK P54 iPS 0 1.43853 1.50149 2.56719 5.32049 - OK P54 iPS 1 0 0 0 0 - OK P54 hESC 1 8.36824 8.28331 5.47456 12.3046 - OK P54 hESC 0 5.50384 5.56027 3.67487 8.25962 - OK P54 Fibroblasts 1 3.30178 2.755 2.25222 4.72177 - OK P54 Fibroblasts 0 0.0013166 0.0015666 0.0012807 0.00268498 - OK P55 iPS 0 0 0 0 0 - OK P55 iPS 1 0 0 0 0 - OK P55 hESC 1 0 0 0 0 - OK P55 hESC 0 0 0 0 0 - OK P55 Fibroblasts 1 0.000266517 0.000222382 0.000181798 0.000352411 - OK P55 Fibroblasts 0 19.2402 22.8937 18.7156 36.2798 - OK P56 iPS 0 5.06101 5.28251 9.03184 11.2215 - OK P56 iPS 1 0.000290174 0.000279561 0.000477982 0.000593862 - OK P56 hESC 1 35.2744 34.9164 23.0767 30.076 - OK P56 hESC 0 20.6708 20.8827 13.8017 17.9878 - OK P56 Fibroblasts 1 0 0 0 0 - OK P56 Fibroblasts 0 0 0 0 0 - OK P57 iPS 0 7.50053 7.8288 13.3854 27.8227 - OK P57 iPS 1 3.00001 2.89027 4.94168 10.2717 - OK P57 hESC 1 13.7969 13.6569 9.02603 20.3516 - OK P57 hESC 0 11.1694 11.2839 7.4577 16.8154 - OK P57 Fibroblasts 1 9.25985 7.72641 6.31636 13.2816 - OK P57 Fibroblasts 0 0 0 0 0 - OK P58 iPS 0 0 0 0 0 - OK P58 iPS 1 0 0 0 0 - OK P58 hESC 1 79.2032 78.3994 51.8153 106.944 - OK P58 hESC 0 37.3306 37.7134 24.9253 51.4446 - OK P58 Fibroblasts 1 76.242 63.6163 52.0065 100.675 - OK P58 Fibroblasts 0 36.3335 43.2328 35.3429 68.4177 - OK P59 iPS 0 2 2.08753 3.56919 6.70016 - OK P59 iPS 1 1 0.963422 1.64722 3.09221 - OK P59 hESC 1 3 2.96955 1.96262 3.96399 - OK P59 hESC 0 2 2.02051 1.33538 2.69713 - OK P59 Fibroblasts 1 3 2.5032 2.04637 3.88173 - OK P59 Fibroblasts 0 10 11.8989 9.72736 18.4517 - OK P6 iPS 0 72.0849 75.2399 128.642 93.15 - OK P6 iPS 1 5.84031 5.62669 9.6203 6.96607 - OK P6 hESC 1 0 0 0 0 - OK P6 hESC 0 16.5335 16.703 11.0393 8.21721 - OK P6 Fibroblasts 1 73.2685 61.1352 49.9782 36.3346 - OK P6 Fibroblasts 0 51.6691 61.4804 50.2604 36.5397 - OK P60 iPS 0 3 3.1313 5.35378 8.11241 - OK P60 iPS 1 1 0.963422 1.64722 2.49598 - OK P60 hESC 1 30 29.6955 19.6262 31.5351 - OK P60 hESC 0 23 23.2358 15.3569 24.6753 - OK P60 Fibroblasts 1 2 1.6688 1.36425 1.75278 - OK P60 Fibroblasts 0 0 0 0 0 - OK P61 iPS 0 12 12.5252 21.4151 17.236 - OK P61 iPS 1 5 4.81711 8.23612 6.62886 - OK P61 hESC 1 79 78.1982 51.6823 42.8944 - OK P61 hESC 0 76 76.7792 50.7445 42.116 - OK P61 Fibroblasts 1 0 0 0 0 - OK P61 Fibroblasts 0 1 1.18989 0.972736 0.786404 - OK P62 iPS 0 0.00607722 0.0063432 0.0108454 0.008228 - OK P62 iPS 1 0 0 0 0 - OK P62 hESC 1 0 0 0 0 - OK P62 hESC 0 0 0 0 0 - OK P62 Fibroblasts 1 0 0 0 0 - OK P62 Fibroblasts 0 0 0 0 0 - OK P63 iPS 0 8.92532 9.31595 15.9281 13.3199 - OK P63 iPS 1 2.10726 2.03018 3.47113 2.90276 - OK P63 hESC 1 29.8919 29.5885 19.5555 16.8841 - OK P63 hESC 0 32.2258 32.5563 21.5169 18.5776 - OK P63 Fibroblasts 1 0 0 0 0 - OK P63 Fibroblasts 0 0 0 0 0 - OK P64 iPS 0 0 0 0 0 - OK P64 iPS 1 3.41092 3.28615 5.61854 7.60888 - OK P64 hESC 1 1.87587 1.85683 1.22721 1.75108 - OK P64 hESC 0 4.49609 4.54219 3.002 4.2835 - OK P64 Fibroblasts 1 0 0 0 0 - OK P64 Fibroblasts 0 0 0 0 0 - OK P65 iPS 0 0 0 0 0 - OK P65 iPS 1 0 0 0 0 - OK P65 hESC 1 30.6889 30.3774 20.0769 18.6306 - OK P65 hESC 0 0 0 0 0 - OK P65 Fibroblasts 1 96.0027 80.1046 65.4857 59.0124 - OK P65 Fibroblasts 0 12.4633 14.8299 12.1235 10.9251 - OK P66 iPS 0 44.3701 46.312 79.1826 60.8233 - OK P66 iPS 1 92.7775 89.3839 152.825 117.391 - OK P66 hESC 1 132.518 131.173 86.694 68.5732 - OK P66 hESC 0 74.5923 75.3571 49.8046 39.3944 - OK P66 Fibroblasts 1 120.037 100.159 81.8803 59.8043 - OK P66 Fibroblasts 0 43.7116 52.0119 42.5199 31.2974 - OK P67 iPS 0 170.001 177.441 303.382 199 - OK P67 iPS 1 186.632 179.806 307.425 201.652 - OK P67 hESC 1 1884.02 1864.9 1232.54 828.909 - OK P67 hESC 0 1923.55 1943.28 1284.34 863.746 - OK P67 Fibroblasts 1 0 0 0 0 - OK P67 Fibroblasts 0 0 0 0 0 - OK P68 iPS 0 51 53.2321 91.0143 72.5104 - OK P68 iPS 1 45.0002 43.3542 74.1254 59.0552 - OK P68 hESC 1 212 209.848 138.692 113.906 - OK P68 hESC 0 200.001 202.051 133.539 109.674 - OK P68 Fibroblasts 1 206 171.886 140.518 112.444 - OK P68 Fibroblasts 0 111.001 132.078 107.974 86.4024 - OK P69 iPS 0 591 616.866 1054.69 269.372 - OK P69 iPS 1 527 507.724 868.087 221.712 - OK P69 hESC 1 4208 4165.29 2752.9 709.915 - OK P69 hESC 0 4521 4567.35 3018.63 778.44 - OK P69 Fibroblasts 1 8777.5 7323.94 5987.34 1531.34 - OK P69 Fibroblasts 0 7039 8375.62 6847.09 1751.24 - OK P7 iPS 0 22.095 23.062 39.4305 172.931 - OK P7 iPS 1 1.00001 0.963435 1.64724 7.22435 - OK P7 hESC 1 0 0 0 0 - OK P7 hESC 0 0 0 0 0 - OK P7 Fibroblasts 1 0 0 0 0 - OK P7 Fibroblasts 0 1 1.18989 0.972736 4.37202 - OK P70 iPS 0 23.4201 24.4451 41.7953 19.4766 - OK P70 iPS 1 63.9939 61.6532 105.412 49.122 - OK P70 hESC 1 139.556 138.14 91.2986 43.3036 - OK P70 hESC 0 71.3699 72.1017 47.653 22.6022 - OK P70 Fibroblasts 1 282.071 235.36 192.407 89.8929 - OK P70 Fibroblasts 0 375.443 446.735 365.207 170.625 - OK P71 iPS 0 1118.63 1167.59 1996.3 965.254 - OK P71 iPS 1 786.095 757.342 1294.87 626.099 - OK P71 hESC 1 2413.66 2389.16 1579.03 777.628 - OK P71 hESC 0 2373.03 2397.36 1584.45 780.296 - OK P71 Fibroblasts 1 12154.1 10141.4 8290.58 4019.4 - OK P71 Fibroblasts 0 7543.28 8975.65 7337.62 3557.39 - OK P72 iPS 0 0 0 0 0 - OK P72 iPS 1 0 0 0 0 - OK P72 hESC 1 0.000662248 0.000655527 0.000433247 0.000164288 - OK P72 hESC 0 0 0 0 0 - OK P72 Fibroblasts 1 0.124387 0.103788 0.0848471 0.0317876 - OK P72 Fibroblasts 0 0 0 0 0 - OK P73 iPS 0 0 0 0 0 - OK P73 iPS 1 0 0 0 0 - OK P73 hESC 1 0.00165185 0.00163508 0.00108065 0.000411107 - OK P73 hESC 0 0.000123352 0.000124616 8.23607e-05 3.13321e-05 - OK P73 Fibroblasts 1 1.87561 1.56501 1.2794 0.48085 - OK P73 Fibroblasts 0 1.82573 2.17241 1.77595 0.667472 - OK P74 iPS 0 0 0 0 0 - OK P74 iPS 1 0 0 0 0 - OK P74 hESC 1 9.64033 9.54249 6.30677 1.93379 - OK P74 hESC 0 0 0 0 0 - OK P74 Fibroblasts 1 0 0 0 0 - OK P74 Fibroblasts 0 5.21414 6.20424 5.07199 1.54004 - OK P75 iPS 0 0.370352 0.386561 0.660928 0.450882 - OK P75 iPS 1 1.41052 1.35892 2.32344 1.58504 - OK P75 hESC 1 0 0 0 0 - OK P75 hESC 0 0 0 0 0 - OK P75 Fibroblasts 1 0 0 0 0 - OK P75 Fibroblasts 0 0 0 0 0 - OK P76 iPS 0 1.62965 1.70097 2.90826 0.762323 - OK P76 iPS 1 0 0 0 0 - OK P76 hESC 1 6.35735 6.29283 4.15902 1.10103 - OK P76 hESC 0 7.52855 7.60574 5.02675 1.33074 - OK P76 Fibroblasts 1 0 0 0 0 - OK P76 Fibroblasts 0 9.96013 11.8514 9.68858 2.54328 - OK P77 iPS 0 0 0 0 0 - OK P77 iPS 1 3.58948 3.45819 5.91268 1.78465 - OK P77 hESC 1 0 0 0 0 - OK P77 hESC 0 1.47133 1.48641 0.982391 0.299922 - OK P77 Fibroblasts 1 0 0 0 0 - OK P77 Fibroblasts 0 0 0 0 0 - OK P78 iPS 0 6.80441 7.10222 12.1431 4.00163 - OK P78 iPS 1 0 0 0 0 - OK P78 hESC 1 0 0 0 0 - OK P78 hESC 0 3 3.03076 2.00307 0.66837 - OK P78 Fibroblasts 1 220.838 184.267 150.639 49.7318 - OK P78 Fibroblasts 0 129.004 153.5 125.487 41.4281 - OK P79 iPS 0 5.31247 5.54498 9.4806 8.91954 - OK P79 iPS 1 1.68999 1.62818 2.7838 2.82579 - OK P79 hESC 1 8.25248 8.16872 5.39883 4.98035 - OK P79 hESC 0 2 2.02051 1.33538 1.30241 - OK P79 Fibroblasts 1 137.78 114.964 93.9831 92.4229 - OK P79 Fibroblasts 0 61.0223 72.6097 59.3586 57.4276 - OK P8 iPS 0 75.4676 78.7706 134.679 79.6273 - OK P8 iPS 1 47.8616 46.1109 78.8387 46.6124 - OK P8 hESC 1 507.821 502.667 332.22 200.885 - OK P8 hESC 0 413.996 418.241 276.421 167.146 - OK P8 Fibroblasts 1 324.047 270.385 221.04 131.115 - OK P8 Fibroblasts 0 250.618 298.207 243.785 144.607 - OK P80 iPS 0 23.0566 24.0658 41.1467 37.8803 - OK P80 iPS 1 0.000100082 9.64213e-05 0.000164857 0.00015177 - OK P80 hESC 1 0 0 0 0 - OK P80 hESC 0 0 0 0 0 - OK P80 Fibroblasts 1 1210.55 1010.09 825.748 764.08 - OK P80 Fibroblasts 0 568.698 676.687 553.193 511.88 - OK P81 iPS 0 8.62689 9.00446 15.3955 39.2721 - OK P81 iPS 1 0.309906 0.29857 0.510484 1.30218 - OK P81 hESC 1 1.30487 1.29162 0.853653 1.6725 - OK P81 hESC 0 0 0 0 0 - OK P81 Fibroblasts 1 89.9667 75.0682 61.3684 158.78 - OK P81 Fibroblasts 0 30.6693 36.493 29.8331 77.1879 - OK P82 iPS 0 224.73 234.566 401.052 223.216 - OK P82 iPS 1 244.288 235.352 402.397 223.964 - OK P82 hESC 1 1145.15 1133.52 749.163 425.876 - OK P82 hESC 0 1159.4 1171.29 774.122 440.065 - OK P82 Fibroblasts 1 1426.6 1190.35 973.115 543.282 - OK P82 Fibroblasts 0 1254.14 1492.28 1219.95 681.085 - OK P83 iPS 0 3.57802 3.73462 6.38531 3.75796 - OK P83 iPS 1 100.526 96.8493 165.589 97.4546 - OK P83 hESC 1 23.9319 23.689 15.6564 9.42276 - OK P83 hESC 0 233.905 236.304 156.177 93.9943 - OK P83 Fibroblasts 1 142.766 119.124 97.3844 57.5007 - OK P83 Fibroblasts 0 172.037 204.704 167.346 98.8097 - OK P84 iPS 0 0 0 0 0 - OK P84 iPS 1 0 0 0 0 - OK P84 hESC 1 0 0 0 0 - OK P84 hESC 0 0.114773 0.11595 0.0766329 0.0455975 - OK P84 Fibroblasts 1 0 0 0 0 - OK P84 Fibroblasts 0 0 0 0 0 - OK P85 iPS 0 38.8454 40.5456 69.3233 40.296 - OK P85 iPS 1 0 0 0 0 - OK P85 hESC 1 65.2863 64.6237 42.7108 25.3814 - OK P85 hESC 0 17.1286 17.3042 11.4366 6.79634 - OK P85 Fibroblasts 1 0 0 0 0 - OK P85 Fibroblasts 0 60.296 71.7455 58.6521 34.2029 - OK P86 iPS 0 185.788 193.919 331.555 186.889 - OK P86 iPS 1 105.654 101.79 174.036 98.0993 - OK P86 hESC 1 942.829 933.26 616.805 355.202 - OK P86 hESC 0 757.696 765.465 505.907 291.339 - OK P86 Fibroblasts 1 1369.29 1142.54 934.028 528.13 - OK P86 Fibroblasts 0 1108.06 1318.47 1077.85 609.452 - OK P87 iPS 0 0 0 0 0 - OK P87 iPS 1 0 0 0 0 - OK P87 hESC 1 178.114 176.306 116.523 64.833 - OK P87 hESC 0 39.9088 40.318 26.6468 14.8261 - OK P87 Fibroblasts 1 0 0 0 0 - OK P87 Fibroblasts 0 17.1553 20.4128 16.6875 9.1221 - OK P88 iPS 0 0 0 0 0 - OK P88 iPS 1 0 0 0 0 - OK P88 hESC 1 29.9138 29.6102 19.5698 11.1787 - OK P88 hESC 0 0 0 0 0 - OK P88 Fibroblasts 1 0 0 0 0 - OK P88 Fibroblasts 0 0 0 0 0 - OK P89 iPS 0 0 0 0 0 - OK P89 iPS 1 0 0 0 0 - OK P89 hESC 1 0 0 0 0 - OK P89 hESC 0 0 0 0 0 - OK P89 Fibroblasts 1 0 0 0 0 - OK P89 Fibroblasts 0 0 0 0 0 - OK P9 iPS 0 21.2489 22.1789 37.9206 68.1122 - OK P9 iPS 1 14.0147 13.5021 23.0854 41.4654 - OK P9 hESC 1 124.639 123.374 81.5396 157.065 - OK P9 hESC 0 123.429 124.695 82.4125 158.746 - OK P9 Fibroblasts 1 34.9914 29.1968 23.8685 43.3015 - OK P9 Fibroblasts 0 29.2978 34.8611 28.4991 51.7022 - OK P90 iPS 0 0.00558931 0.00583394 0.00997465 0.00164996 - OK P90 iPS 1 0.00637446 0.00614129 0.0105002 0.00173689 - OK P90 hESC 1 0 0 0 0 - OK P90 hESC 0 0 0 0 0 - OK P90 Fibroblasts 1 0 0 0 0 - OK P90 Fibroblasts 0 8.48314 10.094 8.25186 1.36623 - OK P91 iPS 0 0.00754287 0.007873 0.013461 0.00222743 - OK P91 iPS 1 0.00841976 0.00811178 0.0138692 0.00229499 - OK P91 hESC 1 0 0 0 0 - OK P91 hESC 0 0 0 0 0 - OK P91 Fibroblasts 1 0 0 0 0 - OK P91 Fibroblasts 0 34.5169 41.0712 33.5758 5.56099 - OK P92 iPS 0 2.28903 2.38922 4.085 0.680497 - OK P92 iPS 1 1.69702 1.63494 2.79537 0.465665 - OK P92 hESC 1 39.8014 39.3974 26.0383 4.36491 - OK P92 hESC 0 35.9697 36.3385 24.0167 4.02601 - OK P92 Fibroblasts 1 71.8021 59.9116 48.9779 8.16647 - OK P92 Fibroblasts 0 0 0 0 0 - OK P93 iPS 0 0.00505797 0.00527934 0.00902641 0.00149294 - OK P93 iPS 1 0.00580988 0.00559737 0.00957017 0.00158287 - OK P93 hESC 1 0 0 0 0 - OK P93 hESC 0 0 0 0 0 - OK P93 Fibroblasts 1 0 0 0 0 - OK P93 Fibroblasts 0 0 0 0 0 - OK P94 iPS 0 1.69278 1.76686 3.02092 0.50306 - OK P94 iPS 1 1.28238 1.23547 2.11236 0.351763 - OK P94 hESC 1 10.1986 10.0951 6.67201 1.11806 - OK P94 hESC 0 10.0303 10.1331 6.69713 1.12227 - OK P94 Fibroblasts 1 12.1979 10.178 8.32051 1.38685 - OK P94 Fibroblasts 0 0 0 0 0 - OK P95 iPS 0 132.195 137.98 235.914 122.037 - OK P95 iPS 1 172.188 165.89 283.632 146.721 - OK P95 hESC 1 644.582 638.04 421.69 222.463 - OK P95 hESC 0 685.785 692.816 457.892 241.562 - OK P95 Fibroblasts 1 4.94735 4.12806 3.3747 1.75071 - OK P95 Fibroblasts 0 3.92704 4.67274 3.81998 1.98171 - OK P96 iPS 0 0 0 0 0 - OK P96 iPS 1 0 0 0 0 - OK P96 hESC 1 9.16699 9.07395 5.99711 5.31411 - OK P96 hESC 0 13.8453 13.9873 9.24441 8.19158 - OK P96 Fibroblasts 1 0.0526524 0.0439331 0.0359154 0.0309458 - OK P96 Fibroblasts 0 0 0 0 0 - OK P97 iPS 0 4.50409 4.70122 8.03797 9.20262 - OK P97 iPS 1 3.57218 3.44152 5.88417 6.73675 - OK P97 hESC 1 12.2336 12.1094 8.00328 9.57497 - OK P97 hESC 0 17.6599 17.841 11.7914 14.107 - OK P97 Fibroblasts 1 0 0 0 0 - OK P97 Fibroblasts 0 0 0 0 0 - OK P98 iPS 0 11.3013 11.7959 20.1682 13.9198 - OK P98 iPS 1 29.2397 28.1702 48.1643 33.2422 - OK P98 hESC 1 291.017 288.064 190.385 135.117 - OK P98 hESC 0 230.21 232.571 153.709 109.187 - OK P98 Fibroblasts 1 0 0 0 0 - OK P98 Fibroblasts 0 9.07296 10.7958 8.8256 6.1385 - OK P99 iPS 0 598 624.173 1067.19 668.692 - OK P99 iPS 1 405 390.186 667.125 418.016 - OK P99 hESC 1 1231 1218.51 805.328 516.786 - OK P99 hESC 0 1157 1168.86 772.518 495.731 - OK P99 Fibroblasts 1 5969.52 4980.96 4071.95 2560.32 - OK P99 Fibroblasts 0 4509.59 5365.9 4386.64 2758.18 - OK cummeRbund/inst/extdata/cds_exp.diff0000644000175200017520000113460414516004263020575 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 log2(fold_change) test_stat p_value q_value significant P1 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 13.1105 0.347386 -5.23803 0.613852 0.539313 1 no P10 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 34.9548 180.118 2.36538 -1.58829 0.112222 0.299925 no P100 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC NOTEST 0 0 0 0 1 1 no P101 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 4.13128 0 -1.79769e+308 -1.79769e+308 0.197324 1 no P102 XLOC_000056 - chr1:3569128-3650467 iPS hESC NOTEST 0 0.923281 1.79769e+308 1.79769e+308 0.436398 1 no P103 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0 0 1 1 no P104 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0 0 1 1 no P105 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 4.94475 1.79769e+308 1.79769e+308 0.0476228 1 no P106 XLOC_000056 - chr1:3569128-3650467 iPS hESC NOTEST 3.71815 0.585598 -2.6666 0.662621 0.507574 1 no P107 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0.0344885 1.79769e+308 1.79769e+308 0.463424 1 no P108 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC OK 5.30242 63.3435 3.57848 -3.94236 8.06837e-05 0.000749411 yes P109 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 1.53994 5.31366 1.78683 -0.693857 0.487772 1 no P11 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC NOTEST 0 0 0 0 1 1 no P110 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC NOTEST 0.580625 2.99279 2.36581 -1.09786 0.272267 1 no P111 XLOC_000058 - chr1:3689351-3692545 iPS hESC OK 29.1182 76.8718 1.40054 -1.91184 0.0558967 0.170376 no P112 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 4.80895 1.79769e+308 1.79769e+308 0.290423 1 no P113 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no P114 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no P115 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC OK 62.8589 86.6597 0.463245 -0.872812 0.382766 0.686812 no P116 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 6.55552 0 -1.79769e+308 -1.79769e+308 0.283406 1 no P117 XLOC_000059 CAD chr1:3773844-3801992 iPS hESC OK 0 14.4431 1.79769e+308 1.79769e+308 0.00240005 0.0127911 yes P118 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0.00638818 8.65205 10.4034 -0.0556033 0.955658 1 no P119 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC OK 104.444 73.9584 -0.497945 0.907909 0.363926 0.666794 no P12 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC OK 0.000108087 9.40489 16.4089 -0.00120417 0.999039 0.999997 no P120 XLOC_000064 - chr1:4847557-4852182 iPS hESC OK 37.4079 18.1722 -1.04161 1.94277 0.0520441 0.160713 no P121 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 1.06639 0 -1.79769e+308 -1.79769e+308 0.346997 1 no P122 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 48.7059 95.0662 0.964836 -1.56572 0.117415 0.311783 no P123 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 4.70189 14.9138 1.66533 -0.563753 0.572922 0.872345 no P124 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 16.2452 21.0828 0.37605 -0.215044 0.829733 0.999997 no P125 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 3.90167 0.706557 -2.46521 0.41716 0.676561 1 no P126 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 15.3246 17.0218 0.151531 -0.0142087 0.988663 0.999997 no P127 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 37.9114 28.2454 -0.424615 0.2084 0.834917 0.999997 no P128 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 11.3399 12.8983 0.185776 -0.0358069 0.971436 0.999997 no P129 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC OK 435.49 1431.61 1.71693 -3.72325 0.000196678 0.00158221 yes P13 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC OK 6.18605 13.3791 1.11289 -1.46733 0.142286 0.35876 no P130 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 11.3056 157.325 3.79864 -3.70316 0.000212931 0.00169625 yes P131 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 7.69434 20.3609 1.40393 -1.49018 0.136178 0.349777 no P132 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 2.01343 0.10991 -4.19526 0.585451 0.558245 1 no P133 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 0.00440741 0 -1.79769e+308 -1.79769e+308 0.498413 1 no P134 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 1.5274 0.605201 -1.33559 0.609435 0.542236 1 no P135 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 0 0.536804 1.79769e+308 1.79769e+308 0.325344 1 no P136 XLOC_000071 - chr1:6640055-6649339 iPS hESC OK 23.546 85.1502 1.85453 -1.33781 0.18096 0.419695 no P137 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC OK 157.618 241.107 0.61324 -1.33872 0.180662 0.419593 no P138 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC OK 277.454 660.096 1.25043 -3.53483 0.00040804 0.00295113 yes P139 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 27.7067 87.2395 1.65475 -0.378592 0.704991 0.966418 no P14 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC OK 550.84 987.18 0.84168 -1.85219 0.0639988 0.191185 no P140 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 69.7903 126.801 0.861471 -0.401954 0.687718 0.95746 no P141 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 7.22222 19.5526 1.43685 -0.135009 0.892605 0.999997 no P142 XLOC_000074 - chr1:6845383-7829763 iPS hESC NOTEST 1.762 0 -1.79769e+308 -1.79769e+308 0.464256 1 no P143 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0 0 1 1 no P144 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC OK 8.87986 26.1246 1.5568 -0.726538 0.467509 0.769384 no P145 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 4.74737 8.2803 0.802554 -0.4385 0.661024 1 no P146 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC NOTEST 1500.64 502.334 -1.57886 5.54278 2.9771e-08 1 no P147 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 26.7829 47.2457 0.818869 -0.313421 0.753961 1 no P148 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 13.107 0 -1.79769e+308 -1.79769e+308 0.315751 1 no P149 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 42.7797 7.06457 -2.59825 2.53795 0.0111504 0.0477583 yes P15 XLOC_000019 AGRN chr1:955502-991492 iPS hESC OK 162.844 1857.6 3.51188 -10.5984 0 0 yes P150 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 54.7294 7.32764 -2.9009 1.23878 0.215426 0.474283 no P151 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 14.3316 2.51904 -2.50825 1.12376 0.261115 1 no P152 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 139.727 53.7103 -1.37934 2.69854 0.00696444 0.0320792 yes P153 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 57.799 27.1603 -1.08954 0.479851 0.631333 0.920485 no P154 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 34.9676 35.935 0.0393693 -0.00554815 0.995573 0.999997 no P155 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 4584.38 8370.4 0.868568 -3.01187 0.00259644 0.013679 yes P156 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 1.80448 29.7198 4.04176 -2.3049 0.0211723 0.0775848 no P157 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 9.62868 9.9298 0.0444265 -0.0464149 0.96298 0.999997 no P158 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC NOTEST 0 0 0 0 1 1 no P159 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC NOTEST 0 0 0 0 1 1 no P16 XLOC_000021 - chr1:1072396-1079432 iPS hESC NOTEST 0 1.64828 1.79769e+308 1.79769e+308 0.0567344 1 no P160 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC OK 137.324 93.0165 -0.562028 1.6203 0.105167 0.288073 no P161 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC OK 87.8037 86.131 -0.0277493 0.0532772 0.957511 0.999997 no P162 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC OK 0 21.5619 1.79769e+308 1.79769e+308 0.256612 0.542889 no P163 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC OK 216.702 207.722 -0.0610578 0.125179 0.900382 0.999997 no P164 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC OK 68.1769 171.51 1.33094 -2.32755 0.0199362 0.0749892 no P165 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC OK 54.5583 230.871 2.08121 -3.25299 0.00114196 0.00689775 yes P166 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 17.0706 25.5368 0.581065 -0.3318 0.74004 0.978956 no P167 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 42.5258 260.118 2.61276 -2.1588 0.0308659 0.106037 no P168 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 132.845 155.927 0.231123 -0.359322 0.719354 0.97039 no P169 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC OK 61.6068 39.4422 -0.643349 1.29478 0.195395 0.441379 no P17 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 6.97279 1.79769e+308 1.79769e+308 0.00246227 1 no P170 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC OK 115.178 229.575 0.995102 -1.81996 0.0687653 0.202489 no P171 XLOC_000087 - chr1:10093015-10241294 iPS hESC NOTEST 0 4.50396 1.79769e+308 1.79769e+308 0.228983 1 no P172 XLOC_000087 - chr1:10093015-10241294 iPS hESC OK 7.8499 10.3213 0.39488 -0.0346866 0.97233 0.999997 no P173 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC OK 515.733 1102.07 1.09553 -3.94881 7.85416e-05 0.000735882 yes P174 XLOC_000087 - chr1:10093015-10241294 iPS hESC OK 171.613 10.087 -4.08858 0.965569 0.33426 0.637956 no P175 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC OK 15.4936 20.3244 0.391544 -0.235287 0.813986 0.999997 no P176 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0 0 1 1 no P177 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 3.19143 1.79769e+308 1.79769e+308 0.188503 1 no P178 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0 0 1 1 no P179 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 76.9201 87.5644 0.186983 -0.177865 0.858829 0.999997 no P18 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC OK 0 9.72413 1.79769e+308 1.79769e+308 0.000129882 0.00112724 yes P180 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 1.09608 1.79769e+308 1.79769e+308 0.390853 1 no P181 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 419.379 196.401 -1.09445 3.04812 0.00230279 0.0123289 yes P182 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 410.895 346.933 -0.244114 0.840127 0.400837 0.70449 no P183 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC OK 1337.23 6778.74 2.34177 -8.23841 2.22045e-16 1.74358e-14 yes P184 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 5.58516 2.2212 -1.33026 0.0599717 0.952178 1 no P185 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 0 0 0 0 1 1 no P186 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC OK 74.0847 402.424 2.44147 -1.68322 0.0923328 0.25719 no P187 XLOC_000090 CORT chr1:10490158-10512208 iPS hESC OK 33.6985 27.3151 -0.302989 0.180451 0.856799 0.999997 no P188 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC OK 172.607 138.152 -0.321231 0.570177 0.568558 0.869069 no P189 XLOC_000090 Cort chr1:10490158-10512208 iPS hESC OK 5.24611 9.52176 0.85998 -0.0957261 0.923738 0.999997 no P19 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS hESC OK 223.432 276.214 0.305947 -0.778231 0.436433 0.735867 no P190 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC OK 67.0275 84.7865 0.339082 -0.335979 0.736887 0.978363 no P191 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC NOTEST 6.3006 0 -1.79769e+308 -1.79769e+308 0.412825 1 no P192 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC OK 173.496 598.647 1.7868 -3.9015 9.55973e-05 0.000866153 yes P193 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no P194 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no P195 XLOC_000091 Pex14 chr1:10535002-10690813 iPS hESC NOTEST 18.0364 7.51008 -1.26401 0.393342 0.694067 1 no P196 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC NOTEST 1888.95 2365.52 0.324571 -1.53394 0.125044 1 no P197 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC OK 30.0352 35.6818 0.248533 -0.127573 0.898487 0.999997 no P198 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC OK 25.3243 0.912846 -4.794 0.836862 0.40267 0.705977 no P199 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC OK 358.008 307.383 -0.219953 0.645793 0.518413 0.820398 no P2 XLOC_000002 OR4F5 chr1:69090-70008 iPS hESC NOTEST 0 0 0 0 1 1 no P20 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 0 30.4263 1.79769e+308 1.79769e+308 3.03824e-06 4.04037e-05 yes P200 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC OK 14.6751 61.7115 2.07216 -3.08049 0.00206663 0.0112101 yes P201 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC NOTEST 12.3118 0 -1.79769e+308 -1.79769e+308 0.121771 1 no P202 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC NOTEST 0 5.92521 1.79769e+308 1.79769e+308 0.361665 1 no P203 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 55.1609 149.919 1.44246 -1.41619 0.156721 0.383432 no P204 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 0.00708472 42.0022 12.5335 -0.0638449 0.949094 0.999997 no P205 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 41.3995 143.48 1.79316 -0.602746 0.546678 0.844074 no P206 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 74.4128 217.658 1.54844 -2.03213 0.0421404 0.137351 no P207 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC OK 77.8716 25.5712 -1.60658 2.97333 0.00294584 0.015324 yes P208 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC OK 200.894 340.257 0.760192 -1.7535 0.079517 0.228438 no P209 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 75.7885 48.0216 -0.658296 0.282614 0.777473 0.995382 no P21 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 2.57257 1.79769e+308 1.79769e+308 0.138957 1 no P210 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC NOTEST 0 9.26798 1.79769e+308 1.79769e+308 0.287517 1 no P211 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 326.456 1078.57 1.72416 -2.29567 0.021695 0.0793239 no P212 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 107.513 212.87 0.985456 -0.622065 0.533899 0.832375 no P213 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 238.184 261.965 0.137295 -0.180129 0.857051 0.999997 no P214 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 1.75837 2.17987 0.310008 -0.0426967 0.965943 1 no P215 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 0 2.18711 1.79769e+308 1.79769e+308 0.240981 1 no P216 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 7.96239 1.79769e+308 1.79769e+308 0.256685 1 no P217 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 4.86566 4.82023 -0.0135349 0.000515062 0.999589 1 no P218 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no P219 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 22.1488 0.995584 -4.47554 0.852483 0.393946 1 no P22 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 8.76465 37.2973 2.0893 -3.25518 0.00113319 0.00686999 yes P220 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 108.07 325.683 1.5915 -3.96863 7.22874e-05 1 no P221 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0.0423122 0.0955929 1.17583 -0.0526844 0.957983 1 no P222 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC OK 14.401 18.414 0.354638 -0.0716007 0.94292 0.999997 no P223 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC NOTEST 16.0046 1.78544 -3.16414 0.346114 0.729257 1 no P224 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC OK 849.538 954.766 0.16847 -0.512305 0.608438 0.907689 no P225 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC OK 647.078 942.066 0.541888 -2.00047 0.0454496 0.144964 no P226 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC OK 504.143 1223.51 1.27913 -3.41913 0.000628221 0.00416039 yes P227 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 6.44015 0 -1.79769e+308 -1.79769e+308 0.409812 1 no P228 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC OK 178.549 413.544 1.21172 -2.95296 0.00314738 0.0162189 yes P229 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC OK 19.3321 18.4204 -0.0696942 0.0336212 0.973179 0.999997 no P23 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 4.36667 1.79769e+308 1.79769e+308 0.0674182 1 no P230 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 0 9.03791 1.79769e+308 1.79769e+308 0.124497 1 no P231 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC NOTEST 0.000432929 5.69324 13.6828 -0.00576634 0.995399 1 no P232 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC OK 0 28.1716 1.79769e+308 1.79769e+308 1.64047e-12 7.11877e-11 yes P233 XLOC_000109 - chr1:12290112-12572096 iPS hESC OK 39.9995 0 -1.79769e+308 -1.79769e+308 0.188331 0.431108 no P234 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC NOTEST 12.8407 0 -1.79769e+308 -1.79769e+308 0.162096 1 no P235 XLOC_000109 - chr1:12290112-12572096 iPS hESC NOTEST 0 4.58204 1.79769e+308 1.79769e+308 0.140422 1 no P236 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 315.192 71.9285 -2.13159 7.84222 4.44089e-15 2.71223e-13 yes P237 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 19.4784 66.1936 1.76482 -1.4902 0.136171 0.349777 no P238 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC NOTEST 0.911079 1.34969 0.566981 -0.252834 0.800396 1 no P239 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC NOTEST 8.82724 1.92876 -2.19429 1.30325 0.192491 1 no P24 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 253.688 666.825 1.39425 -1.4279 0.153321 0.377761 no P240 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC OK 47.604 8.12602 -2.55046 4.40334 1.06599e-05 0.000125558 yes P241 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC NOTEST 5.40803e-05 0.592256 13.4188 -0.000172498 0.999862 1 no P242 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC NOTEST 1.78172 0.698209 -1.35154 0.340018 0.733843 1 no P243 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC NOTEST 3.60576 0.853096 -2.07952 1.38146 0.167139 1 no P244 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no P245 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC NOTEST 0 0 0 0 1 1 no P246 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC NOTEST 0 0 0 0 1 1 no P247 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC NOTEST 0 0 0 0 1 1 no P248 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no P249 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no P25 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 21.1644 14.7123 -0.524619 0.131747 0.895185 0.999997 no P250 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC NOTEST 0 0 0 0 1 1 no P251 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC NOTEST 0 0 0 0 1 1 no P252 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no P253 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC NOTEST 0 0.330232 1.79769e+308 1.79769e+308 0.240869 1 no P254 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC NOTEST 0 0 0 0 1 1 no P255 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC OK 695.717 816.633 0.231188 -0.620786 0.53474 0.832506 no P256 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC OK 602.018 879.809 0.547383 -1.36302 0.172875 0.40841 no P257 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0 0 1 1 no P258 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 6.91549 1.79769e+308 1.79769e+308 0.25743 1 no P259 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 14.792 20.5972 0.477626 -0.376439 0.706591 0.966638 no P26 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 81.6371 108.47 0.410003 -0.235793 0.813593 0.999997 no P260 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 47.3072 9.21056 -2.3607 2.70488 0.00683282 0.0316498 yes P261 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 0 12.8679 1.79769e+308 1.79769e+308 0.0262866 0.0934194 no P262 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 4.006 0 -1.79769e+308 -1.79769e+308 0.472753 1 no P263 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 173.834 111.179 -0.64482 1.59859 0.109912 0.295915 no P264 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 7.67766 5.19027 -0.564859 0.314148 0.753409 1 no P265 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 1.99898 19.5662 3.29103 -0.45617 0.648268 0.931179 no P266 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 0 9.84787 1.79769e+308 1.79769e+308 0.00171649 0.00974678 yes P267 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 51.7288 45.0754 -0.198627 0.309995 0.756565 0.983415 no P268 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 0 79.6627 1.79769e+308 1.79769e+308 5.00434e-11 1.58695e-09 yes P269 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 5.70387 0 -1.79769e+308 -1.79769e+308 0.275728 1 no P27 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC OK 140.404 187.156 0.414652 -0.925142 0.354892 0.658287 no P270 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 0 17.2845 1.79769e+308 1.79769e+308 0.0138936 0.0574198 no P271 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 145.058 215.094 0.56834 -0.926244 0.354319 0.657965 no P272 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no P273 XLOC_000131 - chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no P274 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 2.21856 1.79489 -0.305726 0.247618 0.80443 1 no P275 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 3.59181 6.18974 0.785167 -1.07098 0.28418 1 no P276 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 0 0.429055 1.79769e+308 1.79769e+308 0.297657 1 no P277 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC OK 330.754 468.604 0.502608 -1.33415 0.182153 0.421869 no P278 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC NOTEST 3.36755e-05 0 -1.79769e+308 -1.79769e+308 0.499996 1 no P279 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC NOTEST 2.23634 0 -1.79769e+308 -1.79769e+308 0.300879 1 no P28 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC NOTEST 6.25639 2.57898 -1.27853 1.50397 0.132589 1 no P280 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC NOTEST 0 0 0 0 1 1 no P281 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC NOTEST 0 1.27477 1.79769e+308 1.79769e+308 0.352721 1 no P282 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC OK 108.544 22.5422 -2.26758 2.03125 0.0422298 0.137351 no P283 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC OK 264.402 106.224 -1.31563 3.46564 0.000528976 0.0036345 yes P284 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC NOTEST 92.0125 24.4409 -1.91253 2.5485 0.0108186 1 no P285 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC NOTEST 0 0 0 0 1 1 no P286 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC OK 45.7332 1.92594 -4.5696 0.966593 0.333747 0.637716 no P287 XLOC_000137 RSC1A1 chr1:15944069-15988216 iPS hESC OK 534.708 259.157 -1.04493 2.32224 0.0202201 0.0755751 no P288 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC OK 439.099 268.762 -0.70822 1.39664 0.162523 0.392778 no P2881 XLOC_001221 OR4F16 chr1:621097-622034 iPS hESC NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P2882 XLOC_001222 - chr1:661139-679736 iPS hESC OK 176.913 316.357 0.838512 -1.46779 0.142162 0.35876 no P2883 XLOC_001228 - chr1:761586-762902 iPS hESC OK 29.1742 19.6665 -0.568958 0.935249 0.34966 0.650778 no P2884 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 43.7364 97.2158 1.15236 -0.313433 0.753952 0.983415 no P2885 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 328.516 547.174 0.736035 -1.56049 0.118644 0.314035 no P2886 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 256.209 1090.31 2.08935 -3.95293 7.72014e-05 0.000731638 yes P2887 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 36.029 100.448 1.47922 -1.10394 0.269618 0.562786 no P2888 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC NOTEST 0 0.517867 1.79769e+308 1.79769e+308 0.291955 1 no P2889 XLOC_001233 HES4 chr1:934341-935552 iPS hESC OK 54.1565 25.1834 -1.10466 1.58874 0.112119 0.299925 no P289 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC OK 363.264 779.207 1.10099 -3.38248 0.000718357 0.0046821 yes P2890 XLOC_001233 HES4 chr1:934341-935552 iPS hESC OK 0 12.2395 1.79769e+308 1.79769e+308 0.0105486 0.0456551 yes P2891 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 18.8091 6.807 -1.46634 1.10929 0.267304 1 no P2892 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 50.4508 91.6026 0.860512 -1.14368 0.252756 0.535725 no P2893 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 16.1923 14.7307 -0.136486 0.099033 0.921112 0.999997 no P2894 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 0.00198038 11.9017 12.5531 -0.0111413 0.991111 0.999997 no P2895 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 9.95714 21.5806 1.11593 -0.403696 0.686436 0.95746 no P2896 XLOC_001235 - chr1:1108435-1133313 iPS hESC NOTEST 0.346272 5.99833 4.11458 -1.36562 0.172057 1 no P2897 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 1.73622 0 -1.79769e+308 -1.79769e+308 0.236518 1 no P2898 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 0.00252879 24.8393 13.2619 -0.00980888 0.992174 0.999997 no P2899 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 0 0 0 0 1 1 no P29 XLOC_000031 - chr1:1334909-1342693 iPS hESC NOTEST 53.2662 152.655 1.51899 -0.741897 0.45815 1 no P290 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC NOTEST 6.39779 8.64356 0.434052 -0.610088 0.541804 1 no P2900 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 2.09869 10.3558 2.30287 -0.839548 0.401162 0.70449 no P2901 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC NOTEST 0 1.21775 1.79769e+308 1.79769e+308 0.0797028 1 no P2902 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC NOTEST 1.29516 0 -1.79769e+308 -1.79769e+308 0.315006 1 no P2903 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 39.6628 17.9039 -1.14751 0.498124 0.618397 0.912108 no P2904 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0 0 1 1 no P2905 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 32.4396 210.708 2.69942 -0.473552 0.635819 0.922134 no P2906 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 829.134 1473.6 0.829663 -2.44759 0.0143816 0.0591405 no P2907 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC OK 17.131 41.9198 1.29102 -2.02163 0.043215 0.139298 no P2908 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 10.1146 21.3064 1.07485 -0.255546 0.798302 0.999997 no P2909 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 25.4338 55.9053 1.13624 -0.431704 0.665957 0.946142 no P291 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC OK 11.5611 31.4534 1.44394 -2.25831 0.0239262 0.0865226 no P2910 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 440.007 621.812 0.498952 -1.22323 0.221242 0.485144 no P2911 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 16.9893 15.5986 -0.123217 0.0470921 0.96244 0.999997 no P2912 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC NOTEST 5.41455 0 -1.79769e+308 -1.79769e+308 0.436878 1 no P2913 XLOC_001241 - chr1:1189293-1209234 iPS hESC OK 17.2606 37.017 1.10071 -0.741718 0.458258 0.760995 no P2914 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 93.257 181.357 0.959549 -1.18867 0.23457 0.509626 no P2915 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 9.37264 139.601 3.89671 -0.778285 0.436401 0.735867 no P2916 XLOC_001242 - chr1:1227763-1260046 iPS hESC OK 26.1554 117.46 2.16699 -0.75974 0.44741 0.749015 no P2917 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 25.8307 113.499 2.13552 -1.52619 0.126964 0.331271 no P2918 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no P2919 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 74.8279 131.639 0.814943 -0.610214 0.54172 0.839564 no P292 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 256.047 85.4176 -1.5838 2.43376 0.014943 0.0608422 no P2920 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no P2921 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 0 21.2906 1.79769e+308 1.79769e+308 0.160295 0.389289 no P2922 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 109.796 428.913 1.96586 -1.06125 0.288575 0.588307 no P2923 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 22.9173 99.7638 2.12208 -0.623542 0.532928 0.832375 no P2924 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 11.6979 37.6829 1.68766 -0.321644 0.747722 0.980902 no P2925 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 0 45.4548 1.79769e+308 1.79769e+308 0.0415592 0.136516 no P2926 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 590.361 1597.84 1.43645 -3.36936 0.00075343 0.00485315 yes P2927 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 15.5849 41.6009 1.41646 -0.385699 0.69972 0.964166 no P2928 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 28.1613 4.26182 -2.72417 0.487684 0.625774 0.915886 no P2929 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 4.09686 41.7594 3.34951 -0.0937218 0.92533 0.999997 no P293 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 55.3931 23.593 -1.23135 0.460168 0.645396 0.928671 no P2930 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 30.2667 193.963 2.67998 -2.91349 0.00357416 0.0179633 yes P2931 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 173.57 674.206 1.95767 -4.00397 6.22872e-05 0.000604186 yes P2932 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 63.7322 263.001 2.04497 -1.56993 0.116431 0.31017 no P2933 XLOC_001244 DVL1L1 chr1:1270658-1284492 iPS hESC OK 8.10625 31.5522 1.96063 -0.330035 0.741373 0.978956 no P2934 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 101.118 0.00314546 -14.9724 0.0628669 0.949872 0.999997 no P2935 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 2.23252 18.5375 3.0537 -0.0735157 0.941396 0.999997 no P2936 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 721.263 67.479 -3.41801 5.57463 2.4806e-08 1 no P2937 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 6.14109 11.8645 0.950088 -0.054649 0.956418 0.999997 no P2938 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 248.639 55.4345 -2.16519 1.40636 0.159619 0.388582 no P2939 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 2557.58 3660.17 0.517133 -1.58926 0.112001 0.299925 no P294 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 583.762 850.47 0.542881 -1.56811 0.116855 0.310797 no P2940 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 84.4595 112.752 0.416826 -0.4414 0.658923 0.94238 no P2941 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 17.0885 96.9882 2.50478 -0.869496 0.384576 0.68707 no P2942 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 121.14 217.748 0.845982 -0.843671 0.398853 0.703432 no P2943 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 348.681 352.289 0.0148537 -0.0401382 0.967983 0.999997 no P2944 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 172.404 443.979 1.3647 -1.92547 0.0541706 0.166345 no P2945 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC OK 108.19 88.7189 -0.286252 0.171667 0.863699 0.999997 no P2946 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC OK 3025.74 4267.92 0.496242 -1.48164 0.138435 0.352828 no P2947 XLOC_001249 - chr1:1353801-1356650 iPS hESC NOTEST 6.61991 6.86284 0.0519944 -0.0246203 0.980358 1 no P2948 XLOC_001249 - chr1:1353801-1356650 iPS hESC OK 0.00430007 49.1286 13.4799 -0.0215387 0.982816 0.999997 no P2949 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC OK 31.9981 83.1162 1.37714 -2.19185 0.0283903 0.0991856 no P295 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 145.636 241.251 0.72817 -2.02925 0.0424326 0.137599 no P2950 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 17.0327 11.4081 -0.578252 0.0841977 0.932899 0.999997 no P2951 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 407.325 235.83 -0.788432 1.59818 0.110004 0.295915 no P2952 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 1955.08 3166.29 0.695569 -2.16226 0.0305979 0.105426 no P2953 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 22.682 146.455 2.69084 -0.593878 0.552594 0.851273 no P2954 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 10.5985 162.241 3.9362 -0.515647 0.606101 0.907388 no P2955 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 44.5894 618 3.79283 -2.22463 0.0261062 0.0929786 no P2956 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 10.007 204.998 4.35653 -0.714084 0.475175 0.775806 no P2957 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no P2958 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 8.10282 24.8037 1.61406 -0.0691344 0.944883 0.999997 no P2959 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0.128652 1.12006 3.12202 -0.008222 0.99344 1 no P296 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 40.228 140.357 1.80283 -2.58447 0.00975277 0.0427721 yes P2960 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 0 21.7767 1.79769e+308 1.79769e+308 0.244579 0.525144 no P2961 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 2.85432 17.5163 2.61748 -0.255839 0.798075 0.999997 no P2962 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 32.4975 12.0452 -1.43187 0.0712591 0.943192 0.999997 no P2963 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no P2964 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 0 22.1371 1.79769e+308 1.79769e+308 0.109309 0.295009 no P2965 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no P2966 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 0 123.643 1.79769e+308 1.79769e+308 0.0030119 0.0156183 yes P2967 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 9.33823 168.137 4.17035 -0.425932 0.670157 0.946949 no P2968 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 33.8277 205.562 2.6033 -0.945911 0.344194 0.644241 no P2969 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 4.69427 110.433 4.55612 -0.181361 0.856084 0.999997 no P297 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC NOTEST 0 0 0 0 1 1 no P2970 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 10.4083 0 -1.79769e+308 -1.79769e+308 0.408108 1 no P2971 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no P2972 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 23.7584 109.837 2.20886 -0.900348 0.367935 0.668771 no P2973 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no P2974 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 96.0585 274.135 1.5129 -0.959605 0.337254 0.642185 no P2975 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 93.1692 127.494 0.452509 -0.346191 0.729199 0.974432 no P2976 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 57.9127 222.366 1.94098 -2.0851 0.0370606 0.124466 no P2977 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 21.1432 37.3588 0.821255 -0.26874 0.78813 0.999997 no P2978 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 48.2599 122.207 1.34043 -0.494235 0.621141 0.913703 no P2979 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 102.677 356.99 1.79777 -3.15507 0.00160461 0.00918752 yes P298 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 0 2.91986 1.79769e+308 1.79769e+308 0.309484 1 no P2980 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 19.9963 15.2497 -0.390952 0.105424 0.916039 0.999997 no P2981 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 57.4086 210.14 1.87201 -0.98712 0.323584 0.628492 no P2982 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 46.8111 91.3616 0.964739 -0.864947 0.387068 0.690774 no P2983 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 10.1742 13.2843 0.384809 -0.104554 0.91673 0.999997 no P2984 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 369.504 843.106 1.19012 -3.27197 0.001068 0.00652273 yes P2985 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC OK 4274.57 4816.83 0.172305 -0.924307 0.355327 0.658353 no P2986 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC NOTEST 13.2928 4.54411 -1.54858 0.174865 0.861186 1 no P2987 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 23.4913 79.5862 1.76039 -1.05879 0.289694 0.588307 no P2988 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 78.6765 212.131 1.43095 -2.30526 0.021152 0.0775848 no P2989 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC NOTEST 0 3.06699 1.79769e+308 1.79769e+308 0.0359621 1 no P299 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 0 9.02387 1.79769e+308 1.79769e+308 0.0125139 1 no P2990 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.645169 0 -1.79769e+308 -1.79769e+308 0.300876 1 no P2991 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.437707 0 -1.79769e+308 -1.79769e+308 0.332442 1 no P2992 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.583424 0.932315 0.676272 -0.338066 0.735314 1 no P2993 XLOC_001262 - chr1:1981908-2139172 iPS hESC OK 13.1667 33.574 1.35045 -0.211947 0.832149 0.999997 no P2994 XLOC_001263 - chr1:1981908-2139172 iPS hESC OK 6.98486 25.7926 1.88466 -0.300022 0.76416 0.984453 no P2995 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC OK 377.586 1775.08 2.233 -2.80248 0.00507108 0.0241482 yes P2996 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 7.56119 6.7722 -0.158988 0.053666 0.957201 1 no P2997 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC OK 40.4484 34.0396 -0.248866 0.183503 0.854403 0.999997 no P2998 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 1.30462 2.05545 0.655827 -0.0895395 0.928653 1 no P2999 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC OK 5.67183 66.6827 3.55543 -0.931702 0.35149 0.653447 no P3 XLOC_000005 - chr1:322036-328580 iPS hESC OK 265.93 696.691 1.38947 -2.67586 0.00745367 0.0338598 yes P30 XLOC_000031 - chr1:1334909-1342693 iPS hESC OK 103.752 308.066 1.57009 -1.25001 0.211296 0.467688 no P300 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no P3000 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC OK 0 9.44927 1.79769e+308 1.79769e+308 0.202975 0.455382 no P3001 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC OK 290.341 452.417 0.639907 -1.01032 0.312342 0.616829 no P3002 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC OK 174.785 361.252 1.04742 -2.54966 0.0107829 0.046547 yes P3003 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC NOTEST 0 0 0 0 1 1 no P3004 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC NOTEST 6.35744 2.94754 -1.10894 0.97469 0.329714 1 no P3005 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC OK 0.931281 12.7571 3.77594 -0.543818 0.586567 0.88414 no P3006 XLOC_001272 - chr1:2980635-2984289 iPS hESC NOTEST 0 0 0 0 1 1 no P3007 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 69.8392 41.8309 -0.739469 1.17206 0.241174 1 no P3008 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC OK 43.7292 177.762 2.02328 -3.11751 0.00182383 0.0101604 yes P3009 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 179.578 319.493 0.831173 -1.3961 0.162685 0.392778 no P301 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC OK 2.87744 10.1766 1.8224 -0.139807 0.888813 0.999997 no P3010 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 62.1764 203.665 1.71176 -1.69943 0.089238 0.251544 no P3011 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 23.0108 74.6828 1.69846 -2.07843 0.0376699 0.125999 no P3012 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC OK 201.581 422.204 1.06658 -3.19792 0.00138423 0.00821949 yes P3013 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC OK 867.894 1345.43 0.632479 -2.16568 0.0303353 0.10509 no P3014 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 111.609 52.3176 -1.09308 1.15248 0.249124 0.531166 no P3015 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 15.12 29.6392 0.971054 -0.733677 0.463146 0.766795 no P3016 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC OK 473.292 538.523 0.186276 -0.475583 0.634371 0.921947 no P3017 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 12.3891 32.7056 1.40046 -1.19183 0.233327 0.507594 no P3018 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 38.0315 140.655 1.8869 -3.32273 0.000891422 0.005547 yes P3019 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC OK 6.8891 13.8631 1.00887 -1.37294 0.169771 0.40478 no P302 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 1.5524 5.14419 1.72845 -0.175939 0.860342 1 no P3020 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC NOTEST 0 3.24653 1.79769e+308 1.79769e+308 0.0171011 1 no P3021 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC OK 2222.07 4302.07 0.953127 -3.8213 0.000132751 0.00114611 yes P3022 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC OK 209.378 72.9481 -1.52117 0.92091 0.357097 0.659864 no P3023 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC OK 1235.93 1196.78 -0.0464449 0.191567 0.848082 0.999997 no P3024 XLOC_001283 - chr1:6266188-6296044 iPS hESC OK 243.59 137.374 -0.826343 1.42612 0.153835 0.378053 no P3025 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC OK 37.8293 97.14 1.36056 -1.57996 0.114116 0.304495 no P3026 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC OK 79.9572 174.868 1.12897 -2.02118 0.0432608 0.139298 no P3027 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 134.974 731.817 0 0 1 1 no P3028 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 0 0 0 0 1 1 no P3029 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 462.887 1047.97 0 0 1 1 no P303 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 5.98972 4.34296 -0.463809 0.0824885 0.934258 1 no P3030 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 126.845 93.6803 0 0 1 1 no P3031 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 239.832 1356.8 0 0 1 1 no P3032 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 5.92301 6.44393 0.121611 -0.19958 0.841809 1 no P3033 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 0 2.2157 1.79769e+308 1.79769e+308 0.0765414 1 no P3034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no P3035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0.00544137 51.9914 13.222 -0.0944698 0.924736 0.999997 no P3036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0 9.71361 1.79769e+308 1.79769e+308 0.151372 0.374231 no P3037 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 6.79791 1.79769e+308 1.79769e+308 0.0932848 1 no P3038 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 14.4826 0 -1.79769e+308 -1.79769e+308 0.123134 1 no P3039 XLOC_001287 - chr1:6521220-6580069 iPS hESC OK 30.5163 77.8501 1.35112 -0.738174 0.460408 0.763796 no P304 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC OK 12.6409 52.0827 2.04271 -0.708787 0.478457 0.777315 no P3040 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 22.6201 112.149 2.30975 -0.711673 0.476667 0.776693 no P3041 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no P3042 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0.707673 1.79769e+308 1.79769e+308 0.406721 1 no P3043 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no P3044 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 0 10.7434 1.79769e+308 1.79769e+308 0.18792 0.431108 no P3045 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no P3046 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 23.1541 166.161 2.84324 -1.31458 0.18865 0.431108 no P3047 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 14.2602 62.1096 2.12282 -1.36949 0.170845 0.405942 no P3048 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 2.06233 38.9511 4.23932 -0.63114 0.527949 0.829922 no P3049 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 12.7468 35.8901 1.49345 -0.693954 0.487711 0.786146 no P305 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 407.437 532.647 0.386603 -0.874478 0.381858 0.686678 no P3050 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 43.3554 121.824 1.49052 -1.96196 0.0497671 0.154841 no P3051 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC OK 503.823 189.708 -1.40913 4.12461 3.71357e-05 0.000387574 yes P3052 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 0 154.599 1.79769e+308 1.79769e+308 1.97652e-16 1.62964e-14 yes P3053 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 109.476 62.094 -0.818087 1.40585 0.159769 0.388582 no P3054 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 134.239 151.442 0.173969 -0.217709 0.827656 0.999997 no P3055 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC OK 727.027 1331.6 0.873077 -2.98537 0.00283235 0.0148271 yes P3056 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC OK 11.865 28.6342 1.27102 -0.330153 0.741284 0.978956 no P3057 XLOC_001290 - chr1:6684924-6761966 iPS hESC OK 4.91606 12.0359 1.29176 -0.126775 0.899119 0.999997 no P3058 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0 0 1 1 no P3059 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 0.0400905 0 -1.79769e+308 -1.79769e+308 0.496829 1 no P306 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 422.625 574.155 0.442061 -0.827828 0.407768 0.710127 no P3060 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 2.40953 0.950535 -1.34194 0.107691 0.914241 1 no P3061 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0 0 1 1 no P3062 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC NOTEST 0 0.267901 1.79769e+308 1.79769e+308 0.240869 1 no P3063 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 137.346 21.342 -2.68605 2.39853 0.0164612 0.0649389 no P3064 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 641.313 442.172 -0.53642 1.65281 0.098369 0.271709 no P3065 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 1.40725 320.719 7.83228 -0.463892 0.642725 0.927256 no P3066 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0 0 1 1 no P3067 XLOC_001294 - chr1:8412465-8877699 iPS hESC OK 85.8783 3.82252 -4.4897 1.16634 0.243478 0.524711 no P3068 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 186.982 662.61 1.82526 -5.38967 7.05863e-08 1.32269e-06 yes P3069 XLOC_001295 - chr1:8412465-8877699 iPS hESC NOTEST 20.7508 0 -1.79769e+308 -1.79769e+308 0.365376 1 no P307 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 351.835 256.538 -0.455728 0.635858 0.524869 0.827446 no P3070 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 10.0879 8.52523 -0.242813 0.00547469 0.995632 1 no P3071 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 19439.6 29778.1 0.615251 -3.78734 0.000152268 0.00128088 yes P3072 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 0 8898.81 1.79769e+308 1.79769e+308 1.86581e-11 6.27901e-10 yes P3073 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 0 54.1427 1.79769e+308 1.79769e+308 0.366732 0.668771 no P3074 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 9.70153 3.84797 -1.33412 0.0249968 0.980058 1 no P3075 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 2186.7 12561.6 2.52219 -4.76364 1.90136e-06 2.72638e-05 yes P3076 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 0 914.141 1.79769e+308 1.79769e+308 0.166098 0.397526 no P3077 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 444.441 211.161 -1.07365 0.915316 0.360026 0.661854 no P3078 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC NOTEST 0 0.358204 1.79769e+308 1.79769e+308 0.238628 1 no P3079 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no P308 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 41.0821 0 -1.79769e+308 -1.79769e+308 0.316693 0.621699 no P3080 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 2.90964 1.79769e+308 1.79769e+308 0.0125747 1 no P3081 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no P3082 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 2.34161 0 -1.79769e+308 -1.79769e+308 0.236394 1 no P3083 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0.000167835 1.79769e+308 1.79769e+308 0.499869 1 no P3084 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 3.56861 0 -1.79769e+308 -1.79769e+308 0.0697784 1 no P3085 XLOC_001299 - chr1:9164475-9189356 iPS hESC NOTEST 9.67107 5.09214 -0.925402 0.937957 0.348267 1 no P3086 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 1.60049 1.55989 -0.0370758 0.0190534 0.984798 1 no P3087 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 9.05298 5.68802 -0.670465 0.366784 0.71378 1 no P3088 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC OK 16.7212 50.5863 1.59707 -1.30188 0.192957 0.437069 no P3089 XLOC_001300 - chr1:9208346-9242451 iPS hESC OK 95.9263 212.722 1.14897 -2.69957 0.00694287 0.0320694 yes P309 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 272.536 519.227 0.929917 -1.76005 0.0784001 0.226401 no P3090 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC NOTEST 0 0.589835 1.79769e+308 1.79769e+308 0.430197 1 no P3091 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC OK 340.016 1063.01 1.64448 -4.49396 6.99092e-06 8.41461e-05 yes P3092 XLOC_001303 - chr1:9711789-9884550 iPS hESC OK 3.82816 145.676 5.24996 -0.201001 0.840698 0.999997 no P3093 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC OK 134.509 521.539 1.95507 -3.15056 0.00162957 0.00929812 yes P3094 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no P3095 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC OK 479.396 655.696 0.45181 -1.18064 0.237746 0.515167 no P3096 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 0 0 0 0 1 1 no P3097 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC OK 307.377 194.222 -0.6623 1.39292 0.163644 0.393951 no P3098 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 14.1134 3.50582 -2.00924 0.588027 0.556514 1 no P3099 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC OK 298.378 268.726 -0.151007 0.315303 0.752532 0.983415 no P31 XLOC_000032 - chr1:1361507-1363166 iPS hESC OK 7.20193 59.0363 3.03515 -2.01569 0.0438326 0.140622 no P310 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 302.124 0 -1.79769e+308 -1.79769e+308 0.00139068 0.00821949 yes P3100 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC OK 485.4 857.687 0.821278 -1.82315 0.0682806 0.201422 no P3101 XLOC_001307 - chr1:10696667-10856707 iPS hESC NOTEST 2.07597 1.40186 -0.566439 0.097369 0.922433 1 no P3102 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 8.95125 49.2697 2.46054 -2.10645 0.0351649 0.119315 no P3103 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 1.21532 37.729 4.95627 -0.707612 0.479186 0.777408 no P3104 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 8.71581 21.1364 1.27802 -1.81184 0.0700114 0.20506 no P3105 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 1.66784 0 -1.79769e+308 -1.79769e+308 0.153547 1 no P3106 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 0 0.000964262 1.79769e+308 1.79769e+308 0.499148 1 no P3107 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 0.000832712 4.32713 12.3433 -0.00632904 0.99495 1 no P3108 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC OK 68.298 45.371 -0.590072 1.15201 0.249316 0.531166 no P3109 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 0 0 0 1 1 no P311 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 0 16.6368 1.79769e+308 1.79769e+308 0.0488547 0.152868 no P3110 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 1.00455 1.79769e+308 1.79769e+308 0.342184 1 no P3111 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC OK 6.76699 11.1666 0.7226 -0.431446 0.666144 0.946143 no P3112 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC OK 1002.98 4481.12 2.15957 -4.75079 2.02625e-06 2.8558e-05 yes P3113 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 1171.02 432.981 -1.43539 2.34312 0.0191233 1 no P3114 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC NOTEST 0 4.49163 1.79769e+308 1.79769e+308 0.244149 1 no P3115 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC OK 90.8453 67.2406 -0.43408 0.357367 0.720817 0.970447 no P3116 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC OK 1339.2 1276.69 -0.0689703 0.260373 0.794576 0.999997 no P3117 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC OK 578.796 892.477 0.624761 -2.6171 0.00886801 0.0393101 yes P3118 XLOC_001312 - chr1:11166588-11322608 iPS hESC OK 59.0429 135.175 1.195 -1.06237 0.288069 0.588307 no P3119 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC OK 302.813 1488.36 2.29722 -4.30714 1.65381e-05 0.000189384 yes P312 XLOC_000150 - chr1:17066767-17299474 iPS hESC OK 15.9225 62.5679 1.97436 -0.950537 0.34184 0.643512 no P3120 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 0 7.02688 1.79769e+308 1.79769e+308 0.357358 1 no P3121 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC OK 4485.74 6757.57 0.59116 -2.41689 0.0156539 0.0628062 no P3122 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 12.2816 64.418 2.39096 -1.94804 0.0514098 1 no P3123 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC OK 98.8766 93.2442 -0.0846153 0.198665 0.842525 0.999997 no P3124 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC OK 3.4039 10.2838 1.59511 -0.248783 0.803529 0.999997 no P3125 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC NOTEST 770.486 7.22153 -6.73732 7.91417 2.44249e-15 1 no P3126 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC OK 136.358 97.0102 -0.491188 0.590457 0.554884 0.853548 no P3127 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC OK 537.636 657.437 0.290224 -0.772108 0.44005 0.738944 no P3128 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 631.203 302.602 -1.06069 2.4074 0.0160665 0.0639945 no P3129 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 29.3372 28.066 -0.0639099 0.0170247 0.986417 0.999997 no P313 XLOC_000150 - chr1:17066767-17299474 iPS hESC NOTEST 2.30684 4.93427 1.09692 -0.0279067 0.977737 1 no P3130 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 664.349 334.324 -0.990695 2.01371 0.0440397 0.141013 no P3131 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 34.783 10.8508 -1.68058 0.504821 0.613685 0.909052 no P3132 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC NOTEST 0 0 0 0 1 1 no P3133 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC OK 162.796 2184.6 3.74623 -7.81032 5.77316e-15 3.39998e-13 yes P3134 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no P3135 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC NOTEST 0 0 0 0 1 1 no P3136 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS hESC NOTEST 0.000123029 0 -1.79769e+308 -1.79769e+308 0.499966 1 no P3137 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS hESC NOTEST 0.337687 0 -1.79769e+308 -1.79769e+308 0.414194 1 no P3138 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS hESC NOTEST 0.334536 0 -1.79769e+308 -1.79769e+308 0.414227 1 no P3139 XLOC_001325 - chr1:13182960-13183967 iPS hESC OK 22.2793 275.825 3.62998 -6.09934 1.0651e-09 2.7443e-08 yes P314 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 47.5917 30.5389 -0.640063 0.42597 0.67013 0.946949 no P3140 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC NOTEST 0 0 0 0 1 1 no P3141 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC NOTEST 0 0 0 0 1 1 no P3142 XLOC_001328 PRAMEF14 chr1:13447413-13452656 iPS hESC NOTEST 0.200361 0 -1.79769e+308 -1.79769e+308 0.436402 1 no P3143 XLOC_001328 PRAMEF13 chr1:13447413-13452656 iPS hESC NOTEST 0.000572928 0 -1.79769e+308 -1.79769e+308 0.499811 1 no P3144 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC NOTEST 0 0 0 0 1 1 no P3145 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P3146 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no P3147 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC NOTEST 0 0 0 0 1 1 no P3148 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC NOTEST 6.96034 8.16584 0.230444 -0.308805 0.75747 1 no P3149 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 0 197.024 1.79769e+308 1.79769e+308 2.85929e-13 1.30971e-11 yes P315 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 27.4034 428.259 3.96606 -4.98435 6.21693e-07 1.01502e-05 yes P3150 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 145.227 132.595 -0.131284 0.158193 0.874304 0.999997 no P3151 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 75.4615 32.8483 -1.19992 1.82987 0.06727 0.199454 no P3152 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 173.37 51.7979 -1.74289 2.23986 0.0250997 0.0899771 no P3153 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 0 17.767 1.79769e+308 1.79769e+308 0.0690623 0.203001 no P3154 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC OK 122.09 115.866 -0.0754893 0.0853533 0.931981 0.999997 no P3155 XLOC_001338 - chr1:16133656-16134194 iPS hESC OK 7916.63 16097 1.02384 -3.79718 0.000146354 0.00125045 yes P3156 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 15.5862 20.1751 0.372302 -0.141959 0.887112 0.999997 no P3157 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 106.181 259.204 1.28756 -2.35224 0.0186609 0.0715468 no P3158 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 6.42816 1.79769e+308 1.79769e+308 0.128036 1 no P3159 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 35.4246 24.9031 -0.508425 0.434566 0.663877 0.945902 no P316 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 65.6699 100.239 0.610141 -0.98137 0.32641 0.62997 no P3160 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 6.98597 1.79769e+308 1.79769e+308 0.0872004 1 no P3161 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 0 0 0 1 1 no P3162 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 10.1074 7.07875 -0.51385 0.165597 0.868474 1 no P3163 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0.0412124 2.7664 6.06879 -0.122625 0.902404 1 no P3164 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 11.9384 8.33768 -0.517888 0.10734 0.914519 1 no P3165 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 12.5495 0 -1.79769e+308 -1.79769e+308 0.258765 1 no P3166 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 8.04701 0 -1.79769e+308 -1.79769e+308 0.344783 1 no P3167 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 100.427 3.62862 -4.79058 4.26019 2.04257e-05 0.000230699 yes P3168 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 71.8733 3.46957 -4.37263 3.30917 0.00093574 0.00577916 yes P3169 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no P317 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 0 0 0 0 1 1 no P3170 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC OK 6.09452 21.4939 1.81834 -0.228218 0.819477 0.999997 no P3171 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC NOTEST 7.54529 4.46492 -0.756942 0.0462021 0.963149 1 no P3172 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC NOTEST 22.2582 2.16378 -3.36271 0.380442 0.703618 1 no P3173 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC OK 234.901 573.472 1.28767 -3.47537 0.000510153 0.00353463 yes P3174 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 17.0126 324.019 4.2514 -2.46691 0.0136284 0.0567504 no P3175 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC NOTEST 0 0 0 0 1 1 no P3176 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 156.261 678.385 2.11814 -4.94328 7.68185e-07 1.21802e-05 yes P3177 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC OK 28.2148 53.4824 0.922611 -1.70186 0.088781 0.251115 no P3178 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 22.2988 2.24339 -3.31321 0.94358 0.345384 1 no P3179 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC OK 292.804 256.568 -0.190597 0.474516 0.635132 0.921947 no P318 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 7.45961 6.34529e-05 -16.8431 0.00181309 0.998553 1 no P3180 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 11.178 8.45144 -0.403399 0.128754 0.897552 1 no P3181 XLOC_001347 - chr1:16576559-16678948 iPS hESC OK 27.075 0.999115 -4.76017 1.85886 0.0630466 0.189087 no P3182 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 1.25463 0 -1.79769e+308 -1.79769e+308 0.44193 1 no P3183 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 0 0 0 0 1 1 no P3184 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 0 76.9358 1.79769e+308 1.79769e+308 0.00484521 0.0232937 yes P3185 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 0 120.904 1.79769e+308 1.79769e+308 0.000512351 0.00353501 yes P3186 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 65.4571 27.9922 -1.22553 0.693202 0.488183 0.786146 no P3187 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 2.67381 2.13127 -0.327187 0.010726 0.991442 1 no P3188 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 153.181 109.231 -0.487846 0.954416 0.339873 0.64294 no P3189 XLOC_001354 ESPNP chr1:17017712-17046652 iPS hESC NOTEST 0 3.47275 1.79769e+308 1.79769e+308 0.0482484 1 no P319 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 2.7984 1.50479 -0.895036 0.422801 0.67244 1 no P3190 XLOC_001354 ESPN chr1:17017712-17046652 iPS hESC OK 2.07327 11.1097 2.42183 -1.80538 0.0710156 0.207265 no P3191 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC NOTEST 1.90183 3.25841 0.776778 -0.0641904 0.948819 1 no P3192 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC OK 14.2231 38.162 1.42391 -0.809323 0.418329 0.72082 no P3193 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC OK 1631.49 4040.61 1.30838 -3.76113 0.000169146 0.00140162 yes P3194 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC OK 316.038 825.956 1.38597 -1.4852 0.137492 0.351772 no P3195 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 26.0242 18.4495 -0.496273 0.192583 0.847286 0.999997 no P3196 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 4.40168 12.3556 1.48903 -0.188342 0.850608 0.999997 no P3197 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 0 22.7704 1.79769e+308 1.79769e+308 0.206562 0.460921 no P3198 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 124.905 537.876 2.10644 -3.36036 0.000778423 0.00497527 yes P3199 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 125.906 472.669 1.90849 -3.59131 0.000329021 0.00243299 yes P32 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC OK 5.8712 58.9274 3.32721 -0.536267 0.591774 0.890361 no P320 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 5.28057 0.286309 -4.20505 1.13856 0.254885 1 no P3200 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 66.6283 366.46 2.45945 -1.08886 0.276215 0.572824 no P3201 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC OK 1562.94 1548.47 -0.0134229 0.0414128 0.966967 0.999997 no P3202 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC NOTEST 6.09039 3.49549 -0.801041 0.27199 0.785629 1 no P3203 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC OK 25.3396 62.6093 1.30498 -2.41491 0.015739 0.0629942 no P3204 XLOC_001360 - chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no P3205 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 3342.9 5456.99 0.707003 -3.54447 0.000393406 1 no P3206 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no P3207 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 178.229 434.186 1.28458 -2.62285 0.00871967 0.0388615 yes P3208 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 85.8408 218.303 1.3466 -1.97734 0.0480029 0.150775 no P3209 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC OK 102.06 89.541 -0.188796 0.471554 0.637245 0.92262 no P321 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 0 2.33196 1.79769e+308 1.79769e+308 0.0553395 1 no P3210 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 4.91166 426.519 6.44026 -0.372414 0.709584 0.966638 no P3211 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 28.2328 557.747 4.30416 -1.6445 0.100073 0.275492 no P3212 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 112.418 4.71016 -4.57695 1.8239 0.0681666 0.201422 no P3213 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no P3214 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 0 167.676 1.79769e+308 1.79769e+308 0.0104565 0.0454956 yes P3215 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 38.8471 192.593 2.30967 -1.06958 0.284809 0.584143 no P3216 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 0 22.9292 1.79769e+308 1.79769e+308 0.171731 0.406874 no P3217 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 1.68163 92.8871 5.78754 -0.0529208 0.957795 0.999997 no P3218 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 14.6135 50.0495 1.77606 -0.0664172 0.947046 0.999997 no P3219 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 623.312 765.815 0.297043 -1.44135 0.149486 0.371238 no P322 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC NOTEST 8.59656 12.671 0.559694 -0.832934 0.404882 1 no P3220 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 39.3315 5.33048 -2.88335 0.667548 0.504422 0.804441 no P3221 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 41.707 112.439 1.43078 -1.16481 0.244095 0.524788 no P3222 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 256.033 452.421 0.821336 -2.11345 0.0345622 0.117512 no P3223 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 0 27.296 1.79769e+308 1.79769e+308 0.0644234 0.192105 no P3224 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC NOTEST 11.7322 3.92853 -1.57841 0.347093 0.728522 1 no P3225 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 8.47305 11.7019 0.465785 -0.723919 0.469116 1 no P3226 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 0.000354505 0 -1.79769e+308 -1.79769e+308 0.499887 1 no P3227 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC OK 16.1619 17.2325 0.0925378 -0.140051 0.88862 0.999997 no P3228 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 22.0575 2.29939 -3.26195 0.486957 0.626289 1 no P3229 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC OK 341.159 693.277 1.02299 -2.36569 0.0179965 0.0693371 no P323 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC NOTEST 4.09774 3.11869 -0.393886 0.375803 0.707063 1 no P3230 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 0 0 0 0 1 1 no P3231 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 2361.48 5169.04 1.1302 -3.61198 0.000303867 0.00226732 yes P3232 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 17.4929 8.25067 -1.08418 0.175966 0.860321 1 no P3233 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 43.0618 69.4828 0.690248 -0.244309 0.806991 0.999997 no P3234 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 1302.83 0 -1.79769e+308 -1.79769e+308 8.13491e-05 0.000749411 yes P3235 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 6.20966 0 -1.79769e+308 -1.79769e+308 0.299442 1 no P3236 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 16.1889 9.20491 -0.81453 0.442929 0.657817 1 no P3237 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 6.08129 0 -1.79769e+308 -1.79769e+308 0.444566 1 no P3238 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 1.29633 1.79769e+308 1.79769e+308 0.337923 1 no P3239 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 2.72756 0 -1.79769e+308 -1.79769e+308 0.425778 1 no P324 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC NOTEST 0 1.38095 1.79769e+308 1.79769e+308 0.181472 1 no P3240 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC OK 48.488 56.5465 0.221808 -0.372847 0.709262 0.966638 no P3241 XLOC_001374 RNF186 chr1:20140522-20141771 iPS hESC NOTEST 1.07721 0.423276 -1.34763 0.461523 0.644423 1 no P3242 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC NOTEST 0 0 0 0 1 1 no P3243 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC OK 134.324 35.1082 -1.93584 2.65499 0.00793108 0.0358311 yes P3244 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC NOTEST 0 0 0 0 1 1 no P3245 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC NOTEST 0 0 0 0 1 1 no P3246 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC OK 171.705 124.278 -0.466364 0.783233 0.43349 0.734661 no P3247 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC OK 392.307 351.837 -0.157076 0.430656 0.666719 0.946144 no P3248 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC OK 4421.99 4971.96 0.169117 -0.82313 0.410434 0.711678 no P3249 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC NOTEST 5.84642 0 -1.79769e+308 -1.79769e+308 0.477209 1 no P325 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC NOTEST 0 0.21117 1.79769e+308 1.79769e+308 0.240869 1 no P3250 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC OK 30.3966 19.3729 -0.649866 0.144494 0.88511 0.999997 no P3251 XLOC_001382 - chr1:20978259-20988037 iPS hESC NOTEST 5.18588 0 -1.79769e+308 -1.79769e+308 0.481145 1 no P3252 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 5.15833 48.9997 3.2478 -1.10694 0.268319 1 no P3253 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 53.8428 102.304 0.926032 -1.78352 0.0745024 1 no P3254 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 5.90044 1.79769e+308 1.79769e+308 0.137159 1 no P3255 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 3.5495 1.79769e+308 1.79769e+308 0.371904 1 no P3256 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC OK 7.59828 11.229 0.563479 -0.157311 0.875 0.999997 no P3257 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 0 16.4694 1.79769e+308 1.79769e+308 0.00567788 1 no P3258 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 17.3446 129.453 2.89987 -2.94251 0.00325558 1 no P3259 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 718.718 520.882 -0.464471 0.981841 0.326178 0.62997 no P326 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 5.26 1.79769e+308 1.79769e+308 0.184349 1 no P3260 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 487.058 240.884 -1.01575 2.2541 0.0241899 0.0872847 no P3261 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 302.536 107.411 -1.49397 2.95173 0.00315996 0.016233 yes P3262 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 44.0552 56.1343 0.34957 -0.170091 0.864938 0.999997 no P3263 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 201.731 108.229 -0.898344 0.500353 0.616827 0.910607 no P3264 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 67.7047 19.1563 -1.82144 1.00477 0.315007 0.619126 no P3265 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 99.134 39.0388 -1.34447 0.920787 0.357162 0.659864 no P3266 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 310.854 0 -1.79769e+308 -1.79769e+308 0.0196006 0.0739619 no P3267 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 155.005 149.423 -0.052907 0.092478 0.926318 0.999997 no P3268 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 85.7954 265.087 1.62749 -1.91453 0.0555528 0.169956 no P3269 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 4.89492 0 -1.79769e+308 -1.79769e+308 0.431848 1 no P327 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 158.893 479.078 1.5922 -3.50027 0.000464792 0.00328945 yes P3270 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 494.463 247.208 -1.00014 2.92283 0.00346871 0.0175457 yes P3271 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 16.2897 6.37526 -1.3534 0.281412 0.778395 1 no P3272 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no P3273 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no P3274 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 90.6691 28.0163 -1.69434 2.15001 0.0315541 1 no P3275 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 5.98009 1.79769e+308 1.79769e+308 0.100311 1 no P3276 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 30.7121 14.4148 -1.09126 0.482243 0.629633 0.918819 no P3277 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 67.8265 419.192 2.62769 -3.99154 6.56469e-05 0.000633051 yes P3278 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 39.3564 95.1492 1.27359 -1.02647 0.304672 0.608975 no P3279 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 4.34987 1.79769e+308 1.79769e+308 0.14176 1 no P328 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 28.6581 64.0925 1.16121 -0.936903 0.348808 0.650662 no P3280 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 27.4868 67.9603 1.30596 -1.7024 0.0886796 0.251115 no P3281 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 14.88 64.0794 2.10648 -1.82075 0.0686453 1 no P3282 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 10.5936 23.1783 1.12958 -0.628018 0.529992 0.831548 no P3283 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 3.1394 23.4017 2.89805 -0.879996 0.378862 0.682779 no P3284 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 215.746 175.948 -0.294181 0.328472 0.742554 0.978956 no P3285 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 9.73763 1.61711 -2.59015 0.351192 0.725444 1 no P3286 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 40.7577 4.47726 -3.18639 1.09552 0.27329 0.569009 no P3287 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 119.181 49.6025 -1.26468 1.44177 0.149366 0.371238 no P3288 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 330.639 44.7452 -2.88545 3.60201 0.000315763 0.00234547 yes P3289 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 397.254 512.56 0.367661 -0.988461 0.322927 0.627956 no P329 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 57.9053 55.941 -0.0497908 0.0542855 0.956708 0.999997 no P3290 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0 0 1 1 no P3291 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 31.0054 26.2055 -0.242649 0.140056 0.888615 0.999997 no P3292 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 101.632 741.639 2.86737 -8.41776 0 0 yes P3293 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 15.8513 124.328 2.97148 -3.02786 0.00246295 0.0130592 yes P3294 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 8.87162 185.017 4.38232 -1.17013 0.24195 0.522218 no P3295 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 32.9146 0 -1.79769e+308 -1.79769e+308 0.395674 0.698573 no P3296 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 15.9522 73.6692 2.2073 -4.20375 2.62532e-05 1 no P3297 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 0.000222119 0 -1.79769e+308 -1.79769e+308 0.499864 1 no P3298 XLOC_001394 - chr1:23337326-23342343 iPS hESC NOTEST 3.40123 1.30651 -1.38034 0.472724 0.63641 1 no P3299 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC OK 56.1574 3.29156 -4.09263 1.67482 0.0939696 0.261308 no P33 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC OK 222.846 469.362 1.07466 -2.63 0.00853858 0.0382612 yes P330 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no P3300 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC OK 804.448 432.503 -0.89529 3.737 0.00018623 0.00151278 yes P3301 XLOC_001396 HTR1D chr1:23518388-23521222 iPS hESC OK 223.865 138.505 -0.692693 1.72089 0.0852712 0.242854 no P3302 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 174.016 2.65635 -6.03364 0.842537 0.399487 0.703797 no P3303 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 125.856 198.346 0.656247 -0.569007 0.569351 0.869315 no P3304 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 46.0789 90.6925 0.976877 -0.461826 0.644206 0.927769 no P3305 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 0.231084 3.70001 4.00104 -0.169677 0.865264 1 no P3306 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 871.304 1176.83 0.433658 -1.08819 0.276512 0.572824 no P3307 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 1672.29 1344.32 -0.314945 0.980136 0.327019 0.62997 no P3308 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 233.679 200.546 -0.220597 0.20504 0.837541 0.999997 no P3309 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 18.8159 3.27082 -2.52423 0.201841 0.840041 1 no P331 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no P3310 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC OK 60.989 18.4192 -1.72734 2.62111 0.00876433 0.0389552 yes P3311 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 0 0 0 1 1 no P3312 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC OK 61.7872 0 -1.79769e+308 -1.79769e+308 0.148114 0.369876 no P3313 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 4.90057 1.79769e+308 1.79769e+308 0.130776 1 no P3314 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC OK 72.9916 1.36049 -5.74553 4.01486 5.948e-05 0.000583824 yes P3315 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 5.93528 1.79769e+308 1.79769e+308 0.435254 1 no P3316 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 0 24.2074 1.79769e+308 1.79769e+308 0.0805175 0.230509 no P3317 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 181.965 557.63 1.61565 -3.70019 0.00021544 0.00170798 yes P3318 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0 0 1 1 no P3319 XLOC_001400 - chr1:23755055-23811057 iPS hESC OK 33.3151 59.9998 0.84878 -0.634626 0.525673 0.827922 no P332 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 2.78634 1.79769e+308 1.79769e+308 0.370368 1 no P3320 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 57.325 22.8075 -1.32966 0.993685 0.320376 0.624469 no P3321 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC OK 17.3678 95.4288 2.45801 -4.53767 5.68796e-06 6.89665e-05 yes P3322 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC OK 290.313 130.941 -1.14869 1.23736 0.215955 0.474813 no P3323 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC OK 2233.71 3052.85 0.450715 -1.53313 0.125244 0.328865 no P3324 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 4.49564 5.43458 0.273642 -0.0103642 0.991731 1 no P3325 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 6.56657 9.86629 0.587369 -0.0763122 0.939171 0.999997 no P3326 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 61.4119 43.8262 -0.486724 0.38186 0.702565 0.964638 no P3327 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 34.8907 51.369 0.558054 -0.378535 0.705034 0.966418 no P3328 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 17.4871 17.3703 -0.00967201 0.00316591 0.997474 0.999997 no P3329 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 184.266 440.531 1.25746 -2.14433 0.0320062 0.109498 no P333 XLOC_000155 - chr1:17866329-18024369 iPS hESC OK 12.7177 44.6171 1.81076 -0.557376 0.57727 0.87573 no P3330 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 17.3205 7.27536 -1.25139 0.619526 0.53557 1 no P3331 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 7.05744 9.6936 0.457888 -0.0865224 0.931051 0.999997 no P3332 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 7.68224 12.5886 0.712515 -0.22441 0.822439 0.999997 no P3333 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 184.728 286.755 0.634418 -1.21005 0.226262 0.494835 no P3334 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 0 0 0 0 1 1 no P3335 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 0 42.7613 1.79769e+308 1.79769e+308 0.00224566 0.0120622 yes P3336 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC OK 207.2 122.432 -0.759046 1.77276 0.0762682 0.220643 no P3337 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P3338 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC OK 177.784 533.444 1.58521 -1.56273 0.118117 0.313143 no P3339 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC OK 1054.92 767.195 -0.459465 1.45011 0.147028 0.367904 no P334 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 24.8197 25.6249 0.0460618 -0.0320703 0.974416 0.999997 no P3340 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 1.49896 0 -1.79769e+308 -1.79769e+308 0.204218 1 no P3341 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.798149 0.363637 -1.13416 0.478214 0.632498 1 no P3342 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.452065 1.77127 1.97018 -0.674069 0.500267 1 no P3343 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0 1.19576 1.79769e+308 1.79769e+308 0.127659 1 no P3344 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.347098 0.607421 0.807353 -0.26392 0.791841 1 no P3345 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 5.55488 1.79769e+308 1.79769e+308 0.000346682 1 no P3346 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 0 0 0 1 1 no P3347 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 0 0 0 1 1 no P3348 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 6.64523 1.45433 -2.19197 1.68141 0.092683 1 no P3349 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 81.6347 44.0625 -0.889632 1.82919 0.0673716 0.199454 no P335 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC OK 9.62232 17.1125 0.830595 -1.21425 0.224654 0.491972 no P3350 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC NOTEST 0 0 0 0 1 1 no P3351 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 13.7311 125.353 3.19048 -0.368573 0.712446 0.966638 no P3352 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 0 12.9816 1.79769e+308 1.79769e+308 0.00114974 0.00691941 yes P3353 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 4.07053 24.4887 2.58883 -0.736693 0.461309 0.764521 no P3354 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 8.9548 2.3477 -1.93141 0.435766 0.663007 1 no P3355 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC OK 2.86176 10.1778 1.83045 -0.198733 0.842471 0.999997 no P3356 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC OK 141.615 132.318 -0.0979634 0.20505 0.837533 0.999997 no P3357 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 11.5429 7.16763 -0.687434 0.321028 0.748189 1 no P3358 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no P336 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC OK 58.273 398.742 2.77455 -5.33822 9.38643e-08 1.73913e-06 yes P337 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC NOTEST 2.74185 3.24727 0.244078 -0.0169831 0.98645 1 no P338 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC OK 104.809 209.176 0.996955 -2.38589 0.0170378 0.0665765 no P339 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC NOTEST 0 8.37135 1.79769e+308 1.79769e+308 0.133101 1 no P34 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC OK 12.4598 69.2663 2.47488 -4.24277 2.20774e-05 0.000242704 yes P340 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 0.593912 0.969259 0.706634 -0.456947 0.647709 1 no P341 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 6.55753e-05 0 -1.79769e+308 -1.79769e+308 0.499977 1 no P342 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 5.07852e-05 7.1892e-05 0.501423 -1.47065e-05 0.999988 1 no P343 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC OK 773.162 961.74 0.314877 -0.996481 0.319017 0.623094 no P344 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 98.9774 246.16 1.31443 -1.93043 0.0535533 0.165064 no P345 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC NOTEST 6.84301 0.0310775 -7.78262 0.25743 0.796847 1 no P346 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 80.1847 78.4626 -0.0313207 0.0385259 0.969268 0.999997 no P347 XLOC_000163 C1orf151 chr1:19923466-19984945 iPS hESC OK 246.288 618.381 1.32815 -2.51302 0.0119702 0.0510049 no P348 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 1.64141 1.79769e+308 1.79769e+308 0.415871 1 no P349 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC OK 0 162.125 1.79769e+308 1.79769e+308 5.14347e-08 1.00971e-06 yes P35 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 35.8479 321.282 3.16388 -1.35368 0.175839 0.412748 no P350 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC OK 463.905 16.9244 -4.77666 4.48648 7.24109e-06 8.59033e-05 yes P351 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC OK 3.39355 22.3161 2.71722 -2.91074 0.00360573 0.0179633 yes P352 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC OK 148.118 157.667 0.0901342 -0.250748 0.802009 0.999997 no P353 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0 0.847143 1.79769e+308 1.79769e+308 0.141964 1 no P354 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0.482643 0 -1.79769e+308 -1.79769e+308 0.31503 1 no P355 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC NOTEST 0 0.361045 1.79769e+308 1.79769e+308 0.159889 1 no P356 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC OK 12.3177 17.9074 0.539819 -0.901624 0.367257 0.668771 no P357 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 0 0 0 1 1 no P358 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 1.30646 6.27626 2.26425 -1.73385 0.0829441 1 no P359 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 3.74866e-05 0 -1.79769e+308 -1.79769e+308 0.499974 1 no P36 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 77.2479 111.183 0.525371 -0.501154 0.616263 0.910589 no P360 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC OK 1.83014 11.844 2.69413 -2.42885 0.0151468 0.0610688 no P361 XLOC_000170 FAM43B chr1:20878931-20881512 iPS hESC OK 1.9757 40.5541 4.35941 -4.17581 2.96933e-05 0.000320028 yes P362 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC OK 223.547 133.245 -0.746493 1.46351 0.143329 0.360838 no P363 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 0 114.96 1.79769e+308 1.79769e+308 4.12982e-06 5.15915e-05 yes P364 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 640.208 326.979 -0.969343 2.87415 0.00405111 0.0199412 yes P365 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 4.87776 17.0989 1.80961 -0.632426 0.527109 1 no P366 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 0 1.81796 1.79769e+308 1.79769e+308 0.144033 1 no P367 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 11.3784 3.12392 -1.86487 1.02838 0.30377 1 no P368 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC OK 68.9507 37.3701 -0.883681 1.72171 0.0851222 0.242849 no P369 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 877.819 4753.79 2.43708 -8.31431 0 0 yes P37 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 117.436 409.377 1.80156 -2.4613 0.0138435 0.0573568 no P370 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 14.1413 40.1523 1.50557 -0.37196 0.709923 0.966638 no P371 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 46.976 130.881 1.47826 -0.655383 0.512221 0.81463 no P372 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 14.1212 120.584 3.09411 -0.705248 0.480656 0.777822 no P373 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC OK 10.8443 22.0415 1.02328 -0.37126 0.710444 0.966638 no P374 XLOC_000178 CELA3B chr1:22303417-22339033 iPS hESC NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no P375 XLOC_000178 CELA3A chr1:22303417-22339033 iPS hESC NOTEST 0 0 0 0 1 1 no P376 XLOC_000178 - chr1:22303417-22339033 iPS hESC NOTEST 0 0 0 0 1 1 no P377 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 39.4183 8.77177 -2.16793 0.747364 0.454844 0.758379 no P378 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 13.0529 9.59677 -0.443746 0.0372706 0.970269 0.999997 no P379 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 583.18 83.254 -2.80835 2.69496 0.00703975 0.0323358 yes P38 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 202.814 138.44 -0.550889 0.914385 0.360514 0.662014 no P380 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 2997.59 1520.88 -0.978902 3.3316 0.000863478 0.00541398 yes P381 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 11.3168 3.95557 -1.51651 0.151706 0.879419 1 no P382 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 0 0 0 0 1 1 no P383 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC OK 5.796 76.4937 3.72221 -1.36863 0.171116 0.406001 no P384 XLOC_000181 - chr1:22778343-22857650 iPS hESC OK 41.9937 23.69 -0.825896 0.593722 0.552698 0.851273 no P385 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 83.12 121.688 0.549915 -1.28359 0.199287 1 no P386 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC OK 2.71483 16.9383 2.64135 -1.90258 0.0570959 0.17371 no P387 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC OK 30.6745 69.3632 1.17713 -1.90166 0.0572152 0.173753 no P388 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC NOTEST 0 0 0 0 1 1 no P389 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC NOTEST 0 0 0 0 1 1 no P39 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 100.608 542.034 2.42964 -2.70315 0.00686854 1 no P390 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC NOTEST 0 0 0 0 1 1 no P391 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 37.3058 1.79769e+308 1.79769e+308 1.49063e-05 1 no P392 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0.0140869 80.4755 12.48 -0.194153 0.846056 1 no P393 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC OK 58.1996 183.879 1.65968 -3.68857 0.000225515 0.00176244 yes P394 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 0 0 0 1 1 no P395 XLOC_000188 - chr1:23345940-23410184 iPS hESC OK 2064.11 3123.43 0.59761 -2.50051 0.0124013 0.0525701 no P396 XLOC_000188 - chr1:23345940-23410184 iPS hESC OK 556.677 911.067 0.710716 -1.36098 0.173521 0.409351 no P397 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 6.87752 2.53326 -1.44089 0.121829 0.903035 1 no P398 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 8.91818 4.45377 -1.00172 0.487577 0.625849 1 no P399 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 37247.7 66407.9 0.834204 -4.57248 4.81975e-06 5.97577e-05 yes P4 XLOC_000006 OR4F16 chr1:367658-368595 iPS hESC NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P40 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 470.224 790.187 0.748847 -1.83511 0.0664896 1 no P400 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 6878.03 6624.43 -0.0541976 0.118432 0.905726 0.999997 no P401 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 728.583 1583.34 1.1198 -0.752109 0.451986 0.755141 no P402 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 227.08 191.396 -0.246637 0.201686 0.840162 0.999997 no P403 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC OK 755.461 523.425 -0.529375 2.00618 0.0448371 0.143288 no P404 XLOC_000194 - chr1:24104875-24114720 iPS hESC OK 42.6282 57.722 0.437312 -0.241569 0.809114 0.999997 no P405 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC OK 1031.1 1150.34 0.157876 -0.476639 0.633619 0.921947 no P406 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 728.399 738.535 0.0199373 -0.0473745 0.962215 0.999997 no P407 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 60.6827 0 -1.79769e+308 -1.79769e+308 0.178997 0.416313 no P408 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 151.125 1591.41 3.3965 -3.61538 0.000299906 0.00224793 yes P409 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 107.325 366.517 1.77189 -1.66705 0.0955036 0.265127 no P41 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC OK 31.4583 54.4924 0.792616 -0.421243 0.673578 0.949342 no P410 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC OK 2032.12 1015.28 -1.00111 4.04417 5.25091e-05 0.000521611 yes P411 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 0.00176595 0 -1.79769e+308 -1.79769e+308 0.49932 1 no P412 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC OK 11.6632 24.5694 1.0749 -1.2399 0.215012 0.474004 no P413 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 9.34923 0.00104564 -13.1262 0.0255261 0.979635 1 no P414 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 0 4.01002 1.79769e+308 1.79769e+308 0.0509497 1 no P415 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC OK 102.299 55.217 -0.889614 0.745301 0.45609 0.759689 no P416 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 5.7743 0.568882 -3.34345 0.204764 0.837756 1 no P417 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 340.07 80.6785 -2.07558 5.74714 9.07673e-09 1 no P418 XLOC_000199 - chr1:24742244-24799472 iPS hESC NOTEST 22.1357 5.64277 -1.9719 0.833904 0.404335 1 no P419 XLOC_000200 - chr1:24829386-24862425 iPS hESC OK 15.7185 11.8633 -0.40595 0.106175 0.915443 0.999997 no P42 XLOC_000038 - chr1:1550883-1565984 iPS hESC OK 20.1981 217.26 3.42713 -0.793207 0.427657 0.729272 no P420 XLOC_000200 - chr1:24829386-24862425 iPS hESC NOTEST 0 4.24998 1.79769e+308 1.79769e+308 0.226762 1 no P421 XLOC_000200 - chr1:24829386-24862425 iPS hESC NOTEST 10.6171 2.64685 -2.00404 0.24813 0.804034 1 no P422 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC OK 326.184 113.081 -1.52832 3.43158 0.000600074 0.00400616 yes P423 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC NOTEST 20.7252 0 -1.79769e+308 -1.79769e+308 0.270602 1 no P424 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC NOTEST 1.31366 2.35713 0.84344 -0.758715 0.448023 1 no P425 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0.0198022 0 -1.79769e+308 -1.79769e+308 0.491242 1 no P426 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 41.7106 47.1916 0.178117 -0.0798044 0.936393 0.999997 no P427 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 816.952 805.739 -0.019938 0.0676096 0.946096 0.999997 no P428 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 347.64 876.963 1.33492 -2.40217 0.0162981 0.0646046 no P43 XLOC_000038 - chr1:1550883-1565984 iPS hESC OK 0.0361283 26.2154 9.50307 -0.266707 0.789695 0.999997 no P44 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 3.88743 1.79769e+308 1.79769e+308 0.139724 1 no P45 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 4.60985 37.6352 3.02929 -1.15925 0.246354 0.526214 no P46 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 13.0332 0.00352987 -11.8503 0.0946862 0.924564 1 no P47 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0 0 1 1 no P48 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 4.48044 1.79769e+308 1.79769e+308 0.24101 1 no P49 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 12.0776 0 -1.79769e+308 -1.79769e+308 0.194388 1 no P5 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 52.9724 1.74761 -4.92178 0.637194 0.523999 0.826865 no P50 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 0 100.348 1.79769e+308 1.79769e+308 6.18945e-08 1.17315e-06 yes P51 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 28.9547 100.346 1.79312 -2.2638 0.0235863 0.085481 no P52 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 9.17877 86.1128 3.22986 -2.04932 0.0404306 0.133876 no P53 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC OK 3.14247 33.88 3.43046 -1.61667 0.105949 0.288668 no P54 XLOC_000039 - chr1:1567559-1570029 iPS hESC OK 0.730004 9.67624 3.72847 -0.514442 0.606943 0.907388 no P55 XLOC_000039 - chr1:1567559-1570029 iPS hESC NOTEST 0 0 0 0 1 1 no P56 XLOC_000039 - chr1:1567559-1570029 iPS hESC OK 9.57879 23.6518 1.30403 -1.37264 0.169865 0.40478 no P57 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 19.4885 18.0861 -0.107739 0.020834 0.983378 0.999997 no P58 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 0 73.9259 1.79769e+308 1.79769e+308 0.128822 0.334532 no P59 XLOC_000042 - chr1:1822909-1824112 iPS hESC NOTEST 4.99201 3.15678 -0.661169 0.445901 0.655669 1 no P6 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 48.0828 4.50533 -3.41582 0.961307 0.336398 0.641295 no P60 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC OK 5.39767 26.9908 2.32206 -2.21879 0.0265012 0.0937779 no P61 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC OK 12.037 41.7053 1.79275 -2.92395 0.0034562 0.0175362 yes P62 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no P63 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 7.19324 17.4198 1.27601 -0.157234 0.87506 0.999997 no P64 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 5.19072 3.07856 -0.75368 0.0369448 0.970529 1 no P65 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no P66 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 94.566 60.5588 -0.642985 0.508906 0.610818 0.909052 no P67 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 199.815 833.609 2.0607 -3.75242 0.000175133 0.00144397 yes P68 XLOC_000046 - chr1:1981908-2139172 iPS hESC OK 66.2174 109.688 0.728127 -0.674534 0.499972 0.798889 no P69 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC OK 246.057 740.008 1.58855 -4.88907 1.01312e-06 1.57608e-05 yes P7 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 95.4282 0 -1.79769e+308 -1.79769e+308 0.357743 0.659864 no P70 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC OK 33.4962 30.1072 -0.153891 0.076269 0.939205 0.999997 no P71 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC OK 800.086 772.363 -0.0508767 0.162241 0.871116 0.999997 no P72 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 0 0 0 1 1 no P73 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 6.36609e-05 1.79769e+308 1.79769e+308 0.499898 1 no P74 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 1.11603 1.79769e+308 1.79769e+308 0.046878 1 no P75 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 1.2132 0 -1.79769e+308 -1.79769e+308 0.274622 1 no P76 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 1.08359 1.19958 0.146708 -0.105028 0.916353 1 no P77 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 2.28814e-05 0 -1.79769e+308 -1.79769e+308 0.499982 1 no P78 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 2.02513 0.4903 -2.04628 0.832791 0.404962 1 no P79 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 4.50144 3.17316 -0.504465 0.158039 0.874426 1 no P8 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 63.5773 180.736 1.5073 -2.35201 0.0186723 0.0715468 no P80 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 20.3741 0 -1.79769e+308 -1.79769e+308 0.101844 1 no P81 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 21.3399 0.103287 -7.69076 0.331283 0.740431 1 no P82 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 222.585 431.86 0.956207 -1.53422 0.124976 0.328684 no P83 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 48.0815 46.1049 -0.0605623 0.0438589 0.965017 0.999997 no P84 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no P85 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 20.6279 15.5461 -0.408049 0.20872 0.834667 0.999997 no P86 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 147.391 327.266 1.15082 -1.52234 0.127924 0.332724 no P87 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 0 36.9813 1.79769e+308 1.79769e+308 0.00450519 0.0218389 yes P88 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no P89 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS hESC NOTEST 0 0 0 0 1 1 no P9 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 55.6229 151.63 1.44681 -1.19456 0.23226 0.50594 no P90 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.000730027 0 -1.79769e+308 -1.79769e+308 0.498972 1 no P91 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.00101879 0 -1.79769e+308 -1.79769e+308 0.498566 1 no P92 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.586072 4.52426 2.94853 -2.04977 0.0403869 1 no P93 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.000653284 0 -1.79769e+308 -1.79769e+308 0.49908 1 no P94 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.419018 0.770522 0.878825 -0.363159 0.716486 1 no P95 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 135.254 229.313 0.761647 -1.65559 0.0978046 0.271059 no P96 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 5.86138 1.79769e+308 1.79769e+308 0.177621 1 no P97 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 8.08924 11.6052 0.520697 -0.108226 0.913816 0.999997 no P98 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 23.0853 120.614 2.38535 -1.30615 0.191501 0.434367 no P99 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC OK 546.504 498.776 -0.131839 0.384888 0.700321 0.964166 no P1 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts NOTEST 13.1105 0 -1.79769e+308 -1.79769e+308 0.40846 1 no P10 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 34.9548 60.5379 0.792348 -0.367699 0.713097 0.966638 no P100 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts OK 0 20.4274 1.79769e+308 1.79769e+308 0.439218 0.738297 no P101 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 4.13128 0.438492 -3.23597 0.775671 0.437944 1 no P102 XLOC_000056 - chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0.0133356 1.79769e+308 1.79769e+308 0.492114 1 no P103 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P104 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P105 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P106 XLOC_000056 - chr1:3569128-3650467 iPS Fibroblasts NOTEST 3.71815 0 -1.79769e+308 -1.79769e+308 0.210562 1 no P107 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P108 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 5.30242 3.93866 -0.428943 0.333958 0.738411 1 no P109 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 1.53994 0 -1.79769e+308 -1.79769e+308 0.263934 1 no P11 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts OK 0 30.5047 1.79769e+308 1.79769e+308 0.0475585 0.14995 no P110 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts NOTEST 0.580625 0.344217 -0.754289 0.269747 0.787355 1 no P111 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts OK 29.1182 58.9016 1.01639 -1.08029 0.280014 0.577179 no P112 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P113 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P114 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P115 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts OK 62.8589 101.804 0.695605 -0.976158 0.328986 0.632198 no P116 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 6.55552 0 -1.79769e+308 -1.79769e+308 0.283406 1 no P117 XLOC_000059 CAD chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 4.99183 1.79769e+308 1.79769e+308 0.331808 1 no P118 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0.00638818 4.32215 9.40213 -0.0502401 0.959931 1 no P119 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts OK 104.444 1.26614 -6.36615 4.75544 1.98018e-06 2.81492e-05 yes P12 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts OK 0.000108087 22.8971 17.6926 -0.00129837 0.998964 0.999997 no P120 XLOC_000064 - chr1:4847557-4852182 iPS Fibroblasts OK 37.4079 0.154615 -7.91852 4.08795 4.35194e-05 0.000437583 yes P121 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 1.06639 0 -1.79769e+308 -1.79769e+308 0.346997 1 no P122 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 48.7059 32.7443 -0.572852 0.445155 0.656208 0.940529 no P123 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 4.70189 1.91789 -1.29372 0.103894 0.917254 1 no P124 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 16.2452 68.4146 2.07429 -1.12883 0.258971 0.545393 no P125 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 3.90167 0 -1.79769e+308 -1.79769e+308 0.378482 1 no P126 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 15.3246 10.1307 -0.597112 0.00819778 0.993459 1 no P127 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts OK 37.9114 35.0042 -0.115102 0.0169289 0.986493 0.999997 no P128 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 11.3399 4.63395 -1.29109 0.0790859 0.936964 1 no P129 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts OK 435.49 0 -1.79769e+308 -1.79769e+308 0.000567569 0.00382009 yes P13 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts NOTEST 6.18605 5.90797 -0.0663546 0.0152689 0.987818 1 no P130 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 11.3056 0 -1.79769e+308 -1.79769e+308 0.0762027 1 no P131 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 7.69434 0.205083 -5.22952 2.04494 0.0408612 1 no P132 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 2.01343 8.05147e-05 -14.61 0.00122283 0.999024 1 no P133 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 0.00440741 1.29131 8.19469 -0.0226007 0.981969 1 no P134 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 1.5274 0 -1.79769e+308 -1.79769e+308 0.179466 1 no P135 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 0 4.20431 1.79769e+308 1.79769e+308 0.126691 1 no P136 XLOC_000071 - chr1:6640055-6649339 iPS Fibroblasts OK 23.546 38.1578 0.696497 -0.382135 0.702361 0.964638 no P137 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts OK 157.618 214.473 0.444361 -0.646415 0.51801 0.820398 no P138 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts OK 277.454 769.313 1.47132 -3.21767 0.00129234 0.00772129 yes P139 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 27.7067 129.652 2.22634 -0.433258 0.664827 0.945902 no P14 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts OK 550.84 3379.09 2.61693 -4.82844 1.37606e-06 2.06284e-05 yes P140 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 69.7903 402.426 2.52763 -1.06374 0.287445 0.588086 no P141 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 7.22222 26.3763 1.86873 -0.141646 0.887359 0.999997 no P142 XLOC_000074 - chr1:6845383-7829763 iPS Fibroblasts NOTEST 1.762 0 -1.79769e+308 -1.79769e+308 0.464256 1 no P143 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 1.97243 1.79769e+308 1.79769e+308 0.459719 1 no P144 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 8.87986 0 -1.79769e+308 -1.79769e+308 0.247765 1 no P145 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 4.74737 3.72176 -0.351146 0.0793382 0.936764 1 no P146 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts NOTEST 1500.64 7098.44 2.24192 -5.37272 7.75556e-08 1 no P147 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 26.7829 0 -1.79769e+308 -1.79769e+308 0.289271 0.588307 no P148 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 13.107 17.4103 0.409598 -0.101117 0.919458 0.999997 no P149 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 42.7797 82.6263 0.949674 -0.873295 0.382502 0.686812 no P15 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts OK 162.844 2553.38 3.97085 -8.29349 0 0 yes P150 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 54.7294 29.553 -0.889013 0.198158 0.842922 0.999997 no P151 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts NOTEST 14.3316 7.31695 -0.969883 0.24391 0.807301 1 no P152 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 139.727 221.632 0.665557 -1.03506 0.300641 0.603814 no P153 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 57.799 17.1487 -1.75294 0.0312684 0.975055 0.999997 no P154 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 34.9676 301.624 3.10866 -0.338014 0.735353 0.978363 no P155 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 4584.38 21322.7 2.21759 -4.70724 2.51095e-06 3.45047e-05 yes P156 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 1.80448 142.738 6.30564 -3.48523 0.000491717 0.00343577 yes P157 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 9.62868 69.3396 2.84827 -2.1887 0.0286188 0.0997725 no P158 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P159 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P16 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P160 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts OK 137.324 1112.18 3.01773 -6.69857 2.10465e-11 6.94114e-10 yes P161 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts OK 87.8037 876.41 3.31925 -5.5439 2.95804e-08 5.94855e-07 yes P162 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts NOTEST 0 8.24063 1.79769e+308 1.79769e+308 0.386726 1 no P163 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts OK 216.702 258.098 0.25221 -0.39501 0.692836 0.961419 no P164 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts OK 68.1769 257.242 1.91577 -2.81963 0.00480787 0.0231818 yes P165 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts OK 54.5583 73.4533 0.429028 -0.427787 0.668806 0.946949 no P166 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 17.0706 21.2442 0.315552 -0.0174008 0.986117 0.999997 no P167 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 42.5258 45.2674 0.0901354 -0.0104824 0.991636 0.999997 no P168 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 132.845 109.373 -0.280493 0.0778734 0.937929 0.999997 no P169 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts OK 61.6068 319.369 2.37406 -4.08642 4.38084e-05 0.000437819 yes P17 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P170 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts OK 115.178 19.7819 -2.54161 2.84301 0.00446892 0.0217382 yes P171 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P172 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts OK 7.8499 200.875 4.67748 -0.414985 0.678153 0.952533 no P173 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts OK 515.733 1122.9 1.12254 -2.68525 0.00724762 0.0331981 yes P174 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts OK 171.613 70.0715 -1.29225 0.171361 0.86394 0.999997 no P175 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts OK 15.4936 40.3364 1.38041 -0.573959 0.565996 0.868211 no P176 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P177 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P178 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P179 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 76.9201 29.2168 -1.39656 0.470731 0.637833 0.92262 no P18 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P180 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 5.57672 1.79769e+308 1.79769e+308 0.441638 1 no P181 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 419.379 864.235 1.04317 -2.20185 0.0276761 0.0968958 no P182 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 410.895 143.712 -1.51559 1.92005 0.0548516 0.168123 no P183 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts OK 1337.23 13482.1 3.33373 -6.93367 4.1005e-12 1.6492e-10 yes P184 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 5.58516 4.89393 -0.190605 0.000597733 0.999523 1 no P185 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P186 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts OK 74.0847 483.083 2.70502 -0.823133 0.410433 0.711678 no P187 XLOC_000090 CORT chr1:10490158-10512208 iPS Fibroblasts OK 33.6985 12.1268 -1.47448 0.209345 0.834179 0.999997 no P188 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 172.607 526.06 1.60774 -2.3914 0.0167842 0.0660554 no P189 XLOC_000090 Cort chr1:10490158-10512208 iPS Fibroblasts NOTEST 5.24611 3.73278 -0.490996 0.0197763 0.984222 1 no P19 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS Fibroblasts OK 223.432 1068.96 2.25829 -4.69611 2.65164e-06 3.61368e-05 yes P190 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 67.0275 99.6012 0.57141 -0.354168 0.723213 0.971946 no P191 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 6.3006 21.9227 1.79887 -0.252094 0.800969 0.999997 no P192 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts OK 173.496 1041.13 2.58517 -4.65136 3.29748e-06 4.35004e-05 yes P193 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts OK 0 44.4442 1.79769e+308 1.79769e+308 0.230648 0.503094 no P194 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P195 XLOC_000091 Pex14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 18.0364 3.68586 -2.29084 0.0470281 0.962491 1 no P196 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts OK 1888.95 2744.34 0.538874 -1.44282 0.149072 0.371238 no P197 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts OK 30.0352 0 -1.79769e+308 -1.79769e+308 0.211276 0.467688 no P198 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts OK 25.3243 10.571 -1.26041 0.228828 0.819003 0.999997 no P199 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts OK 358.008 332.294 -0.10753 0.227893 0.81973 0.999997 no P2 XLOC_000002 OR4F5 chr1:69090-70008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P20 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 0 12.2197 1.79769e+308 1.79769e+308 0.24525 0.525519 no P200 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 14.6751 0.546235 -4.74771 3.44418 0.000572799 1 no P201 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 12.3118 7.55415e-05 -17.3143 0.00208675 0.998335 1 no P202 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 8.07306 1.79769e+308 1.79769e+308 0.374931 1 no P203 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 55.1609 193.294 1.80908 -1.62856 0.103406 0.283723 no P204 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0.00708472 0 -1.79769e+308 -1.79769e+308 0.497068 1 no P205 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 41.3995 66.4903 0.683529 -0.180489 0.856769 0.999997 no P206 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 74.4128 157.781 1.0843 -1.16162 0.245391 0.525519 no P207 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts OK 77.8716 363.317 2.22206 -3.49068 0.000481788 0.00338072 yes P208 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts OK 200.894 11.5677 -4.11826 4.62994 3.65767e-06 4.65714e-05 yes P209 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 75.7885 31.884 -1.24914 0.269581 0.787482 0.999997 no P21 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 9.60499 1.79769e+308 1.79769e+308 0.172317 1 no P210 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 0 41.1964 1.79769e+308 1.79769e+308 0.343024 0.643512 no P211 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 326.456 1331.71 2.02832 -2.40475 0.0161834 0.0643046 no P212 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 107.513 117.552 0.128785 -0.0498548 0.960238 0.999997 no P213 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 238.184 389.478 0.709464 -0.675104 0.499609 0.798889 no P214 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 1.75837 8.96806 2.35056 -0.118497 0.905674 1 no P215 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P216 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 11.3029 1.79769e+308 1.79769e+308 0.473198 1 no P217 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 4.86566 2.44992 -0.989904 0.00623635 0.995024 1 no P218 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P219 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 22.1488 0 -1.79769e+308 -1.79769e+308 0.290424 1 no P22 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 8.76465 34.8954 1.99327 -2.16303 0.030539 0.105426 no P220 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 108.07 514.96 2.2525 -4.52731 5.97379e-06 1 no P221 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0.0423122 0 -1.79769e+308 -1.79769e+308 0.473118 1 no P222 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts OK 14.401 40.6369 1.49663 -0.222257 0.824114 0.999997 no P223 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts OK 16.0046 116.452 2.86317 -0.214412 0.830226 0.999997 no P224 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts OK 849.538 10325.2 3.60335 -6.728 1.72007e-11 6.03488e-10 yes P225 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts OK 647.078 2871.51 2.1498 -5.10134 3.3726e-07 5.73341e-06 yes P226 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts OK 504.143 575.01 0.189755 -0.366506 0.713987 0.966638 no P227 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 6.44015 4.00161 -0.686515 0.102872 0.918064 1 no P228 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts OK 178.549 4.49588 -5.31158 4.33892 1.43182e-05 0.00016662 yes P229 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 19.3321 0.000474981 -15.3128 0.0148937 0.988117 1 no P23 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 6.75717 1.79769e+308 1.79769e+308 0.220782 1 no P230 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P231 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts OK 0.000432929 110.504 17.9615 -0.00756951 0.99396 0.999997 no P232 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts OK 0 1285.44 1.79769e+308 1.79769e+308 5.48538e-06 6.70028e-05 yes P233 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts OK 39.9995 0 -1.79769e+308 -1.79769e+308 0.188331 0.431108 no P234 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts NOTEST 12.8407 0 -1.79769e+308 -1.79769e+308 0.162096 1 no P235 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 2.38321 1.79769e+308 1.79769e+308 0.485245 1 no P236 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 315.192 191.792 -0.716688 1.13339 0.257051 0.542889 no P237 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 19.4784 94.7776 2.28267 -1.3543 0.175642 0.412748 no P238 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts NOTEST 0.911079 0 -1.79769e+308 -1.79769e+308 0.23502 1 no P239 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts NOTEST 8.82724 0 -1.79769e+308 -1.79769e+308 0.161692 1 no P24 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 253.688 694.672 1.45327 -0.855802 0.392107 0.697502 no P240 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts OK 47.604 0 -1.79769e+308 -1.79769e+308 0.00203352 0.0111378 yes P241 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts NOTEST 5.40803e-05 0 -1.79769e+308 -1.79769e+308 0.499993 1 no P242 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts NOTEST 1.78172 0 -1.79769e+308 -1.79769e+308 0.300882 1 no P243 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts NOTEST 3.60576 0 -1.79769e+308 -1.79769e+308 0.0603368 1 no P244 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no P245 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P246 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P247 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P248 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no P249 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no P25 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 21.1644 15.8664 -0.415662 0.0151036 0.98795 0.999997 no P250 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P251 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P252 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no P253 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P254 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P255 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts OK 695.717 40.2891 -4.11004 3.86513 0.000111028 0.000989652 yes P256 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts OK 602.018 70.7232 -3.08955 4.2368 2.26731e-05 0.000247602 yes P257 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P258 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P259 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 14.792 14.8538 0.0060104 -0.00313125 0.997502 0.999997 no P26 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 81.6371 160.99 0.979678 -0.200589 0.84102 0.999997 no P260 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 47.3072 0 -1.79769e+308 -1.79769e+308 0.0199638 0.0749892 no P261 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 0 27.8928 1.79769e+308 1.79769e+308 0.277099 0.57332 no P262 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 4.006 43.9125 3.4544 -0.162823 0.870658 0.999997 no P263 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 173.834 358.942 1.04605 -2.0786 0.0376544 0.125999 no P264 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 7.67766 10.0324 0.385926 -0.115068 0.908391 1 no P265 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 1.99898 29.388 3.87789 -0.5242 0.60014 0.899664 no P266 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 6.7035 1.79769e+308 1.79769e+308 0.332558 1 no P267 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 51.7288 3.19938 -4.0151 0.322426 0.74713 0.980902 no P268 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 0 208.608 1.79769e+308 1.79769e+308 0.0620669 0.187109 no P269 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 5.70387 219.237 5.26441 -2.05457 0.039921 0.132454 no P27 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts OK 140.404 781.158 2.47603 -4.62916 3.67149e-06 4.65714e-05 yes P270 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 0 65.7759 1.79769e+308 1.79769e+308 0.136154 0.349777 no P271 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 145.058 648.261 2.15994 -2.97732 0.00290784 0.0151741 yes P272 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P273 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P274 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 2.21856 0.862567 -1.36291 0.494457 0.620983 1 no P275 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 3.59181 2.29329 -0.647296 0.50928 0.610556 1 no P276 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0.572031 1.79769e+308 1.79769e+308 0.365615 1 no P277 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts OK 330.754 2197 2.7317 -5.82153 5.83102e-09 1.31717e-07 yes P278 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts NOTEST 3.36755e-05 0 -1.79769e+308 -1.79769e+308 0.499996 1 no P279 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts NOTEST 2.23634 5.61806 1.32893 -0.447969 0.654175 1 no P28 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts NOTEST 6.25639 4.31837 -0.534842 0.552796 0.580403 1 no P280 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P281 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P282 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 108.544 18.3447 -2.56484 0.623671 0.532844 0.832375 no P283 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 264.402 279.288 0.0790189 -0.155739 0.876239 0.999997 no P284 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 92.0125 78.8225 -0.223223 0.226356 0.820925 0.999997 no P285 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P286 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts OK 45.7332 0.922843 -5.63101 0.511007 0.609346 0.907689 no P287 XLOC_000137 RSC1A1 chr1:15944069-15988216 iPS Fibroblasts OK 534.708 376.086 -0.507689 0.801185 0.423024 0.726955 no P288 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts OK 439.099 310.347 -0.500666 0.688084 0.4914 0.790555 no P2881 XLOC_001221 OR4F16 chr1:621097-622034 iPS Fibroblasts NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P2882 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 176.913 41.5721 -2.08936 2.34941 0.0188032 0.0717445 no P2883 XLOC_001228 - chr1:761586-762902 iPS Fibroblasts OK 29.1742 39.9678 0.454142 -0.567774 0.570188 0.869788 no P2884 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 43.7364 72.8474 0.736042 -0.0822844 0.934421 0.999997 no P2885 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 328.516 646.349 0.976348 -1.30767 0.190985 0.433795 no P2886 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 256.209 1445.11 2.49578 -3.49404 0.000475771 0.00335276 yes P2887 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 36.029 55.7714 0.630367 -0.108681 0.913455 0.999997 no P2888 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts NOTEST 0 2.14049 1.79769e+308 1.79769e+308 0.233217 1 no P2889 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts OK 54.1565 29.4876 -0.877029 0.827243 0.408099 0.710127 no P289 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts OK 363.264 2346.33 2.69132 -6.1413 8.18468e-10 2.17686e-08 yes P2890 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts NOTEST 0 4.13955 1.79769e+308 1.79769e+308 0.350783 1 no P2891 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 18.8091 19.7743 0.0721984 -0.0396618 0.968363 0.999997 no P2892 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 50.4508 80.2251 0.669177 -0.488294 0.625342 0.915886 no P2893 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 16.1923 0 -1.79769e+308 -1.79769e+308 0.127864 1 no P2894 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 0.00198038 53.0677 14.7098 -0.0130554 0.989584 0.999997 no P2895 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 9.95714 22.7448 1.19173 -0.2866 0.774418 0.993602 no P2896 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts NOTEST 0.346272 0 -1.79769e+308 -1.79769e+308 0.315006 1 no P2897 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts OK 1.73622 14.2685 3.03882 -1.42171 0.15511 0.38062 no P2898 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0.00252879 0.00130815 -0.95092 0.000515119 0.999589 1 no P2899 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P29 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 53.2662 319.473 2.5844 -1.09334 0.274245 0.570277 no P290 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts NOTEST 6.39779 9.3373 0.545433 -0.543143 0.587032 1 no P2900 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 2.09869 0 -1.79769e+308 -1.79769e+308 0.293864 1 no P2901 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2902 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts NOTEST 1.29516 5.89401 2.18612 -0.701912 0.482734 1 no P2903 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 39.6628 539.303 3.76524 -1.38865 0.164938 0.39578 no P2904 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2905 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 32.4396 114.07 1.81409 -0.0863577 0.931182 0.999997 no P2906 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 829.134 8370.57 3.33565 -6.96476 3.28981e-12 1.35623e-10 yes P2907 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts OK 17.131 75.8216 2.146 -2.50106 0.0123824 0.0525701 no P2908 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 10.1146 95.4488 3.23829 -0.710164 0.477602 0.776693 no P2909 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 25.4338 160.966 2.66194 -0.955045 0.339555 0.64294 no P291 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 11.5611 0 -1.79769e+308 -1.79769e+308 0.00828204 1 no P2910 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 440.007 1704.75 1.95396 -3.79584 0.000147143 0.00125072 yes P2911 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 16.9893 27.9153 0.716428 -0.129263 0.89715 0.999997 no P2912 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts NOTEST 5.41455 2.68872 -1.00992 0.0152138 0.987862 1 no P2913 XLOC_001241 - chr1:1189293-1209234 iPS Fibroblasts OK 17.2606 20.3727 0.239156 -0.0846348 0.932552 0.999997 no P2914 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 93.257 810.457 3.11945 -3.19403 0.00140303 0.00826282 yes P2915 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 9.37264 101.369 3.43502 -0.620169 0.535146 0.832506 no P2916 XLOC_001242 - chr1:1227763-1260046 iPS Fibroblasts OK 26.1554 131.616 2.33116 -0.550923 0.581687 0.879195 no P2917 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 25.8307 86.9123 1.75048 -0.820189 0.412108 0.71383 no P2918 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2919 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 74.8279 14.441 -2.37341 0.104376 0.916871 0.999997 no P292 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 256.047 333.297 0.380402 -0.302342 0.762391 0.984453 no P2920 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2921 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 3.63351 1.79769e+308 1.79769e+308 0.496427 1 no P2922 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 109.796 407.64 1.89247 -0.707177 0.479456 0.777408 no P2923 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 22.9173 74.3645 1.69817 -0.255255 0.798526 0.999997 no P2924 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 11.6979 23.1589 0.98532 -0.0659454 0.947421 0.999997 no P2925 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 0 82.7322 1.79769e+308 1.79769e+308 0.369875 0.670983 no P2926 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 590.361 2355.04 1.99608 -3.08333 0.00204701 0.0111403 yes P2927 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 15.5849 16.3417 0.0684059 -0.00349088 0.997215 0.999997 no P2928 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 28.1613 3.66246 -2.94283 0.0214227 0.982908 0.999997 no P2929 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 4.09686 7.63052 0.897263 -0.0101301 0.991918 1 no P293 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 55.3931 11.5775 -2.25838 0.0556055 0.955656 0.999997 no P2930 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 30.2667 23.7193 -0.351671 0.119057 0.90523 0.999997 no P2931 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 173.57 1267.03 2.86786 -4.88324 1.04359e-06 1.60829e-05 yes P2932 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 63.7322 252.541 1.98642 -1.01255 0.311277 0.61658 no P2933 XLOC_001244 DVL1L1 chr1:1270658-1284492 iPS Fibroblasts OK 8.10625 49.6575 2.6149 -0.311764 0.75522 0.983415 no P2934 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 101.118 2934.02 4.85876 -3.33592 0.000850168 0.00535086 yes P2935 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 2.23252 18.6477 3.06225 -0.0420455 0.966462 0.999997 no P2936 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 721.263 8407.76 3.54312 -4.7796 1.75645e-06 1 no P2937 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 6.14109 95.5511 3.95971 -0.167997 0.866585 0.999997 no P2938 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 248.639 2864.03 3.52592 -1.99852 0.0456602 0.145355 no P2939 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 2557.58 7034.3 1.45963 -2.99354 0.00275761 0.0144818 yes P294 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 583.762 2099.12 1.84633 -3.76579 0.000166024 0.00138269 yes P2940 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 84.4595 97.6848 0.209875 -0.105166 0.916244 0.999997 no P2941 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 17.0885 18.1877 0.0899369 -0.0121093 0.990338 0.999997 no P2942 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 121.14 154.351 0.349537 -0.223893 0.822841 0.999997 no P2943 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 348.681 674.159 0.951184 -1.81513 0.0695036 0.203935 no P2944 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 172.404 322.484 0.903435 -0.710685 0.477279 0.776693 no P2945 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts OK 108.19 37.8673 -1.51454 0.150867 0.88008 0.999997 no P2946 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts OK 3025.74 8706.81 1.52485 -3.31303 0.0009229 0.00572129 yes P2947 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts OK 6.61991 15.6317 1.2396 -0.496243 0.619723 0.913247 no P2948 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts NOTEST 0.00430007 0.00204697 -1.07087 0.00120516 0.999038 1 no P2949 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts OK 31.9981 233.834 2.86942 -3.74518 0.000180267 0.00147158 yes P295 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 145.636 293.864 1.01278 -1.91218 0.0558529 0.170376 no P2950 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts NOTEST 17.0327 4.14556 -2.03867 0.0181171 0.985545 1 no P2951 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts OK 407.325 430.732 0.0806121 -0.0822887 0.934417 0.999997 no P2952 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts OK 1955.08 6236.3 1.67347 -3.6634 0.00024889 0.00192685 yes P2953 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 22.682 84.2667 1.89341 -0.172819 0.862794 0.999997 no P2954 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 10.5985 113.359 3.41896 -0.360114 0.718762 0.97039 no P2955 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 44.5894 1043.7 4.54886 -2.37866 0.0173759 0.0675202 no P2956 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 10.007 293.354 4.87356 -0.773811 0.439043 0.738297 no P2957 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 0 84.1064 1.79769e+308 1.79769e+308 0.427221 0.729272 no P2958 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 8.10282 114.365 3.81907 -0.149635 0.881053 0.999997 no P2959 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0.128652 3.69003 4.84208 -0.00891762 0.992885 1 no P296 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 40.228 168.12 2.06322 -2.47059 0.0134892 0.0563131 no P2960 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 7.69268 1.79769e+308 1.79769e+308 0.49711 1 no P2961 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 2.85432 91.7595 5.00664 -0.243239 0.80782 0.999997 no P2962 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 32.4975 20.3251 -0.677061 0.00578786 0.995382 0.999997 no P2963 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2964 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 6.57877 1.79769e+308 1.79769e+308 0.493408 1 no P2965 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2966 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 0 186.844 1.79769e+308 1.79769e+308 0.328653 0.632198 no P2967 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 9.33823 179.943 4.26825 -0.407798 0.683422 0.955054 no P2968 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 33.8277 286.25 3.081 -0.800519 0.42341 0.726955 no P2969 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 4.69427 19.8478 2.08001 -0.0455343 0.963681 0.999997 no P297 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2970 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 10.4083 0 -1.79769e+308 -1.79769e+308 0.408108 1 no P2971 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2972 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 23.7584 182.067 2.93796 -0.814452 0.415386 0.717248 no P2973 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2974 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 96.0585 431.974 2.16896 -0.832357 0.405208 0.708935 no P2975 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 93.1692 113.042 0.278934 -0.0529189 0.957797 0.999997 no P2976 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 57.9127 276.724 2.2565 -1.53229 0.125451 0.328884 no P2977 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 21.1432 25.3689 0.262864 -0.0120889 0.990355 0.999997 no P2978 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 48.2599 362.567 2.90935 -0.729277 0.465832 0.769384 no P2979 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 102.677 499.17 2.28142 -2.35145 0.0187002 0.0715468 no P298 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2980 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 19.9963 8.02851 -1.31653 0.0181367 0.98553 1 no P2981 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 57.4086 43.7417 -0.392256 0.0819804 0.934662 0.999997 no P2982 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 46.8111 2.79122 -4.06788 0.143026 0.88627 0.999997 no P2983 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 10.1742 1.85523 -2.45525 0.0404214 0.967757 1 no P2984 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 369.504 1204.38 1.70463 -3.72322 0.000196697 0.00158221 yes P2985 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts OK 4274.57 16698 1.96582 -4.12892 3.64475e-05 0.000385269 yes P2986 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts NOTEST 13.2928 10.8403 -0.294245 0.00132502 0.998943 1 no P2987 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 23.4913 23.4115 -0.00490924 0.00281086 0.997757 0.999997 no P2988 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 78.6765 0 -1.79769e+308 -1.79769e+308 0.00735151 0.033488 yes P2989 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P299 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P2990 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.645169 0 -1.79769e+308 -1.79769e+308 0.300876 1 no P2991 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.437707 0 -1.79769e+308 -1.79769e+308 0.332442 1 no P2992 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.583424 0 -1.79769e+308 -1.79769e+308 0.219947 1 no P2993 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts OK 13.1667 27.1259 1.04278 -0.126228 0.899551 0.999997 no P2994 XLOC_001263 - chr1:1981908-2139172 iPS Fibroblasts OK 6.98486 78.7015 3.49409 -0.548475 0.583366 0.880119 no P2995 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts OK 377.586 2591.54 2.77893 -3.16998 0.00152447 0.0088516 yes P2996 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 7.56119 19.0177 1.33066 -0.394483 0.693224 0.961419 no P2997 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 40.4484 64.133 0.664984 -0.436761 0.662285 0.944729 no P2998 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts NOTEST 1.30462 0 -1.79769e+308 -1.79769e+308 0.368444 1 no P2999 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 5.67183 19.3469 1.77022 -0.404889 0.685559 0.957228 no P3 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 265.93 34.2977 -2.95486 3.3377 0.000844762 0.00533721 yes P30 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 103.752 185.591 0.838985 -0.391215 0.695638 0.962038 no P300 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3000 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts OK 0 23.7899 1.79769e+308 1.79769e+308 0.473642 0.774837 no P3001 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts OK 290.341 893.546 1.6218 -1.39291 0.163648 0.393951 no P3002 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts OK 174.785 500.991 1.5192 -2.92007 0.00349955 0.0176476 yes P3003 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3004 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts NOTEST 6.35744 0 -1.79769e+308 -1.79769e+308 0.0423949 1 no P3005 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0.931281 3.38316 1.86108 -0.0777597 0.938019 1 no P3006 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no P3007 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 69.8392 92.849 0.410849 -0.552337 0.580718 1 no P3008 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts OK 43.7292 64.5702 0.562274 -0.623806 0.532755 0.832375 no P3009 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 179.578 402.167 1.16318 -1.61871 0.105509 0.288531 no P301 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 2.87744 0.308418 -3.22183 0.15158 0.879518 1 no P3010 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 62.1764 99.5061 0.678419 -0.444767 0.656488 0.940529 no P3011 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 23.0108 18.6731 -0.30135 0.219913 0.825939 0.999997 no P3012 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts OK 201.581 227.555 0.174861 -0.373366 0.708876 0.966638 no P3013 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts OK 867.894 1410.28 0.700388 -1.71311 0.0866925 0.246051 no P3014 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 111.609 177.709 0.671069 -0.486136 0.626871 0.915886 no P3015 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 15.12 85.1871 2.49418 -1.68931 0.0911601 0.254785 no P3016 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts OK 473.292 1178.32 1.31593 -2.66537 0.00769042 0.0348393 yes P3017 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 12.3891 8.76607 -0.499075 0.249038 0.803332 1 no P3018 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts OK 38.0315 98.804 1.37738 -1.96448 0.0494749 0.154223 no P3019 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 6.8891 0.611774 -3.49325 1.46963 0.141662 1 no P302 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 1.5524 0 -1.79769e+308 -1.79769e+308 0.44066 1 no P3020 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 0 2.58654 1.79769e+308 1.79769e+308 0.0700196 1 no P3021 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts OK 2222.07 7509.61 1.75684 -3.8057 0.000141403 0.00121445 yes P3022 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts OK 209.378 2365.52 3.49798 -2.79239 0.00523204 0.0246504 yes P3023 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts OK 1235.93 2319.74 0.908368 -2.18637 0.0287882 0.100151 no P3024 XLOC_001283 - chr1:6266188-6296044 iPS Fibroblasts OK 243.59 288.283 0.243029 -0.201212 0.840533 0.999997 no P3025 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts OK 37.8293 268.364 2.82662 -2.76946 0.00561494 0.0263041 yes P3026 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts OK 79.9572 498.6 2.64058 -3.88265 0.000103322 0.000931032 yes P3027 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 134.974 70.6091 0 0 1 1 no P3028 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 0 39.0287 0 0 1 1 no P3029 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 462.887 732.481 0 0 1 1 no P303 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 5.98972 0 -1.79769e+308 -1.79769e+308 0.39699 1 no P3030 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 126.845 110.585 0 0 1 1 no P3031 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 239.832 2679.84 0 0 1 1 no P3032 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 5.92301 1.41752 -2.06296 2.01896 0.0434917 1 no P3033 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 0 0.48661 1.79769e+308 1.79769e+308 0.338266 1 no P3034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 0.00544137 18.3016 11.7157 -0.0837056 0.93329 0.999997 no P3036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3037 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 3.95345 1.79769e+308 1.79769e+308 0.308371 1 no P3038 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 14.4826 0 -1.79769e+308 -1.79769e+308 0.123134 1 no P3039 XLOC_001287 - chr1:6521220-6580069 iPS Fibroblasts OK 30.5163 12.5671 -1.27992 0.383901 0.701052 0.964166 no P304 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 12.6409 1.81089 -2.80332 0.353537 0.723686 1 no P3040 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 22.6201 11.3936 -0.989383 0.147664 0.882608 1 no P3041 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3042 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 6.84793 1.79769e+308 1.79769e+308 0.434436 1 no P3043 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3044 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3045 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3046 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 23.1541 5.81123 -1.99435 0.307084 0.758779 1 no P3047 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 14.2602 0 -1.79769e+308 -1.79769e+308 0.17142 1 no P3048 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 2.06233 2.5797 0.32293 -0.0411122 0.967206 1 no P3049 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 12.7468 1.74109 -2.87207 0.301357 0.763142 1 no P305 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 407.437 1857.43 2.18866 -2.7506 0.00594866 0.02771 yes P3050 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 43.3554 34.9295 -0.311769 0.30545 0.760023 0.983735 no P3051 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts OK 503.823 361.435 -0.47918 1.00025 0.317189 0.621933 no P3052 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 0 378.033 1.79769e+308 1.79769e+308 0.0627513 0.188826 no P3053 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 109.476 77.2985 -0.5021 0.468422 0.639483 0.923386 no P3054 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 134.239 601.611 2.16403 -2.03687 0.0416632 0.136586 no P3055 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts OK 727.027 1673.01 1.20236 -2.78749 0.00531181 0.0249549 yes P3056 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts OK 11.865 29.7673 1.32701 -0.226486 0.820823 0.999997 no P3057 XLOC_001290 - chr1:6684924-6761966 iPS Fibroblasts OK 4.91606 28.6155 2.54122 -0.22929 0.818643 0.999997 no P3058 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3059 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0.0400905 0 -1.79769e+308 -1.79769e+308 0.496829 1 no P306 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 422.625 1815.92 2.10325 -2.31021 0.0208765 0.0770142 no P3060 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 2.40953 0 -1.79769e+308 -1.79769e+308 0.449621 1 no P3061 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3062 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts NOTEST 0 1.38187 1.79769e+308 1.79769e+308 0.0774008 1 no P3063 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 137.346 71.1003 -0.949889 0.287302 0.773881 0.993602 no P3064 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 641.313 2240.53 1.80474 -4.1258 3.69455e-05 0.000387574 yes P3065 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 1.40725 1692.19 10.2318 -0.605892 0.544586 0.843214 no P3066 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 0 47.6257 1.79769e+308 1.79769e+308 0.43296 0.734518 no P3067 XLOC_001294 - chr1:8412465-8877699 iPS Fibroblasts OK 85.8783 6.13498 -3.80716 0.0566625 0.954814 0.999997 no P3068 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 186.982 278.541 0.574986 -0.315866 0.752104 0.983415 no P3069 XLOC_001295 - chr1:8412465-8877699 iPS Fibroblasts NOTEST 20.7508 0 -1.79769e+308 -1.79769e+308 0.365376 1 no P307 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 351.835 1504.54 2.09635 -2.3117 0.0207945 0.0770142 no P3070 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 10.0879 0 -1.79769e+308 -1.79769e+308 0.485793 1 no P3071 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 19439.6 33570.6 0.788198 -1.7791 0.0752231 0.218385 no P3072 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 0 12912.6 1.79769e+308 1.79769e+308 0.0175203 0.0676604 no P3073 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3074 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 9.70153 0 -1.79769e+308 -1.79769e+308 0.484244 1 no P3075 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 2186.7 24138 3.46448 -4.67229 2.97853e-06 3.99317e-05 yes P3076 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 0 679.817 1.79769e+308 1.79769e+308 0.409236 0.711095 no P3077 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 444.441 181.074 -1.29541 0.0760813 0.939354 0.999997 no P3078 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts NOTEST 0 0.725244 1.79769e+308 1.79769e+308 0.180502 1 no P3079 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P308 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 41.0821 133.313 1.69824 -0.194736 0.8456 0.999997 no P3080 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3081 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3082 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 2.34161 4.17775 0.835229 -0.0307 0.975509 1 no P3083 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 7.16648 1.79769e+308 1.79769e+308 0.382366 1 no P3084 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts OK 3.56861 112.742 4.98152 -4.02042 5.80941e-05 0.000573636 yes P3085 XLOC_001299 - chr1:9164475-9189356 iPS Fibroblasts NOTEST 9.67107 1.26783 -2.93131 0.910899 0.362349 1 no P3086 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts NOTEST 1.60049 1.42116 -0.171454 0.0540506 0.956895 1 no P3087 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts OK 9.05298 24.4065 1.4308 -0.669934 0.5029 0.80279 no P3088 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts OK 16.7212 72.7269 2.12081 -1.5239 0.127533 0.33223 no P3089 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts OK 95.9263 69.3907 -0.467184 0.755747 0.449801 0.752253 no P309 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 272.536 3410.49 3.64546 -6.02531 1.68784e-09 4.21703e-08 yes P3090 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3091 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 340.016 1606.44 2.24019 -3.17472 0.00149981 0.00873919 yes P3092 XLOC_001303 - chr1:9711789-9884550 iPS Fibroblasts OK 3.82816 695.497 7.50525 -0.286002 0.774877 0.993602 no P3093 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 134.509 26.3156 -2.35372 0.150575 0.880311 0.999997 no P3094 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 0 2515.79 1.79769e+308 1.79769e+308 0.0020398 0.0111378 yes P3095 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts OK 479.396 509.797 0.0887044 -0.170607 0.864533 0.999997 no P3096 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 0 5.13452 1.79769e+308 1.79769e+308 0.473347 1 no P3097 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts OK 307.377 1009.9 1.71614 -3.09095 0.0019952 0.0110405 yes P3098 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 14.1134 7.08002 -0.995239 0.0690022 0.944988 1 no P3099 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts OK 298.378 316.625 0.0856349 -0.0931565 0.925779 0.999997 no P31 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 7.20193 0 -1.79769e+308 -1.79769e+308 0.163163 1 no P310 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 302.124 0 -1.79769e+308 -1.79769e+308 0.00139068 0.00821949 yes P3100 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts OK 485.4 848.024 0.804932 -1.13123 0.257958 0.543955 no P3101 XLOC_001307 - chr1:10696667-10856707 iPS Fibroblasts NOTEST 2.07597 0 -1.79769e+308 -1.79769e+308 0.393422 1 no P3102 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 8.95125 6.07219 -0.559873 0.391727 0.69526 1 no P3103 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 1.21532 1.6466 0.438153 -0.0605317 0.951732 1 no P3104 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 8.71581 0.352429 -4.62823 1.35562 0.175222 1 no P3105 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 1.66784 0.00205508 -9.66457 0.0248422 0.980181 1 no P3106 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 0 0.331458 1.79769e+308 1.79769e+308 0.277181 1 no P3107 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 0.000832712 0 -1.79769e+308 -1.79769e+308 0.499705 1 no P3108 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts OK 68.298 15.0124 -2.18569 2.8138 0.00489594 0.0234692 yes P3109 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P311 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 0 100.612 1.79769e+308 1.79769e+308 0.276283 0.572824 no P3110 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3111 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 6.76699 0 -1.79769e+308 -1.79769e+308 0.186969 1 no P3112 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 1002.98 7820.85 2.96303 -5.16451 2.41072e-07 4.22902e-06 yes P3113 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 1171.02 3003.63 1.35894 -1.46892 0.141855 0.35876 no P3114 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts NOTEST 0 7.79258 1.79769e+308 1.79769e+308 0.461701 1 no P3115 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts OK 90.8453 33.2215 -1.4513 0.418606 0.675504 0.950673 no P3116 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts OK 1339.2 1601.03 0.25762 -0.653821 0.513227 0.815329 no P3117 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts OK 578.796 636.873 0.137951 -0.350853 0.725699 0.9737 no P3118 XLOC_001312 - chr1:11166588-11322608 iPS Fibroblasts OK 59.0429 170.948 1.53372 -1.03527 0.300544 0.603814 no P3119 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts OK 302.813 72.9584 -2.05328 1.60748 0.107949 0.291816 no P312 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts OK 15.9225 49.7705 1.64423 -0.719566 0.471792 0.772715 no P3120 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3121 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts OK 4485.74 2368.21 -0.921547 2.41152 0.015886 0.0634285 no P3122 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 12.2816 263.856 4.42518 -3.37199 0.000746263 0.00482583 yes P3123 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 98.8766 277.975 1.49125 -2.48281 0.0130349 0.0548331 no P3124 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts OK 3.4039 18.088 2.40977 -0.308338 0.757825 0.983415 no P3125 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts NOTEST 770.486 0 -1.79769e+308 -1.79769e+308 0.000683496 1 no P3126 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts OK 136.358 113.009 -0.270955 0.114022 0.90922 0.999997 no P3127 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts OK 537.636 1330.79 1.30758 -2.64697 0.00812157 0.0364917 yes P3128 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 631.203 457.869 -0.463169 0.779474 0.435701 0.735867 no P3129 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 29.3372 1.34044 -4.45195 0.0357642 0.97147 0.999997 no P313 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts NOTEST 2.30684 0 -1.79769e+308 -1.79769e+308 0.485306 1 no P3130 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 664.349 292.677 -1.18263 1.47016 0.141518 0.358469 no P3131 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 34.783 0 -1.79769e+308 -1.79769e+308 0.314212 0.618604 no P3132 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3133 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts OK 162.796 1951.16 3.58319 -6.22559 4.79736e-10 1.304e-08 yes P3134 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no P3135 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3136 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.000123029 0 -1.79769e+308 -1.79769e+308 0.499966 1 no P3137 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.337687 0 -1.79769e+308 -1.79769e+308 0.414194 1 no P3138 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.334536 0 -1.79769e+308 -1.79769e+308 0.414227 1 no P3139 XLOC_001325 - chr1:13182960-13183967 iPS Fibroblasts OK 22.2793 207.399 3.21863 -4.25455 2.09472e-05 0.00023498 yes P314 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 47.5917 3.8214 -3.63854 0.338375 0.735081 0.978363 no P3140 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3141 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3142 XLOC_001328 PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts NOTEST 0.200361 0 -1.79769e+308 -1.79769e+308 0.436402 1 no P3143 XLOC_001328 PRAMEF13 chr1:13447413-13452656 iPS Fibroblasts NOTEST 0.000572928 0 -1.79769e+308 -1.79769e+308 0.499811 1 no P3144 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3145 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P3146 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no P3147 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3148 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts NOTEST 6.96034 0 -1.79769e+308 -1.79769e+308 0.0128373 1 no P3149 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 0 118.428 1.79769e+308 1.79769e+308 0.0208665 0.0770142 no P315 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 27.4034 98.6818 1.84843 -1.99736 0.0457856 0.145473 no P3150 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 145.227 55.404 -1.39025 0.982531 0.325838 0.62997 no P3151 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 75.4615 25.7553 -1.55087 1.34744 0.177839 0.415378 no P3152 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 173.37 80.6384 -1.10431 1.00942 0.312772 0.616939 no P3153 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 8.22122 1.79769e+308 1.79769e+308 0.372819 1 no P3154 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts OK 122.09 43.2083 -1.49857 0.836515 0.402865 0.705977 no P3155 XLOC_001338 - chr1:16133656-16134194 iPS Fibroblasts OK 7916.63 21049.2 1.41081 -3.46206 0.000536064 0.00366792 yes P3156 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 15.5862 2.23494 -2.80197 0.260092 0.794793 1 no P3157 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 106.181 560.414 2.39997 -3.78818 0.000151755 0.00128088 yes P3158 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 5.22855 1.79769e+308 1.79769e+308 0.447966 1 no P3159 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 35.4246 48.555 0.45487 -0.264338 0.791519 0.999997 no P316 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 65.6699 17.1632 -1.93591 1.03814 0.299204 0.603814 no P3160 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3161 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3162 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 10.1074 9.63291 -0.0693738 0.00850889 0.993211 1 no P3163 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 0.0412124 13.5911 8.36537 -0.168209 0.866419 0.999997 no P3164 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 11.9384 26.7081 1.16167 -0.176522 0.859884 0.999997 no P3165 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 12.5495 16.7923 0.420171 -0.111119 0.911522 0.999997 no P3166 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 8.04701 26.6845 1.72948 -0.396402 0.691809 0.961072 no P3167 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 100.427 235.204 1.22777 -1.43136 0.152326 0.376025 no P3168 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 71.8733 397.66 2.46801 -2.27742 0.0227612 0.0828549 no P3169 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 0 60.3352 1.79769e+308 1.79769e+308 0.252071 0.534962 no P317 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3170 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts OK 6.09452 38.8477 2.67224 -0.323259 0.746499 0.980902 no P3171 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts NOTEST 7.54529 7.5659 0.0039345 -0.000115232 0.999908 1 no P3172 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts NOTEST 22.2582 0 -1.79769e+308 -1.79769e+308 0.383855 1 no P3173 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts OK 234.901 923.073 1.97439 -4.11694 3.83937e-05 0.000393237 yes P3174 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 17.0126 132.515 2.96148 -1.64755 0.0994451 0.274222 no P3175 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 0 38.3291 1.79769e+308 1.79769e+308 0.209842 0.465719 no P3176 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 156.261 8.10745 -4.26857 2.04693 0.0406646 0.134381 no P3177 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts OK 28.2148 182.341 2.69211 -3.90462 9.4375e-05 0.000859803 yes P3178 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 22.2988 15.5838 -0.516918 0.12646 0.899368 0.999997 no P3179 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 292.804 533.075 0.864402 -1.69108 0.0908206 0.254267 no P318 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 7.45961 6.06956e-06 -20.2291 0.000165328 0.999868 1 no P3180 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 11.178 30.8971 1.4668 -0.347568 0.728165 0.974432 no P3181 XLOC_001347 - chr1:16576559-16678948 iPS Fibroblasts OK 27.075 0 -1.79769e+308 -1.79769e+308 0.157924 0.385803 no P3182 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 1.25463 0 -1.79769e+308 -1.79769e+308 0.44193 1 no P3183 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3184 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 0 33.8911 1.79769e+308 1.79769e+308 0.214876 0.474004 no P3185 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 0 551.679 1.79769e+308 1.79769e+308 0.0269954 0.0949155 no P3186 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 65.4571 232.03 1.82569 -0.890098 0.373413 0.675915 no P3187 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 2.67381 2.38008 -0.16789 0.0019933 0.99841 1 no P3188 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 153.181 592.825 1.95237 -3.11856 0.00181737 0.0101588 yes P3189 XLOC_001354 ESPNP chr1:17017712-17046652 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P319 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 2.7984 0 -1.79769e+308 -1.79769e+308 0.230408 1 no P3190 XLOC_001354 ESPN chr1:17017712-17046652 iPS Fibroblasts NOTEST 2.07327 0 -1.79769e+308 -1.79769e+308 0.134129 1 no P3191 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 1.90183 1.59851 -0.250659 0.0136945 0.989074 1 no P3192 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 14.2231 1.55467 -3.19355 0.207314 0.835764 1 no P3193 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 1631.49 1992.29 0.288239 -0.55271 0.580462 0.878148 no P3194 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 316.038 413.367 0.387327 -0.291627 0.770572 0.991164 no P3195 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 26.0242 0 -1.79769e+308 -1.79769e+308 0.257123 0.542889 no P3196 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 4.40168 24.341 2.46726 -0.369653 0.711641 0.966638 no P3197 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 0 46.6117 1.79769e+308 1.79769e+308 0.321011 0.624967 no P3198 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 124.905 177.11 0.503814 -0.624101 0.532562 0.832375 no P3199 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 125.906 205.856 0.709292 -0.949951 0.342137 0.643512 no P32 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts OK 5.8712 29.8843 2.34766 -0.369855 0.71149 0.966638 no P320 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 5.28057 0 -1.79769e+308 -1.79769e+308 0.17586 1 no P3200 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 66.6283 231.387 1.7961 -0.742034 0.458067 0.760995 no P3201 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts OK 1562.94 5372.43 1.78131 -4.16829 3.06896e-05 0.000328617 yes P3202 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts NOTEST 6.09039 0 -1.79769e+308 -1.79769e+308 0.263624 1 no P3203 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts OK 25.3396 1.76593e-05 -20.4525 0.000899178 0.999283 0.999997 no P3204 XLOC_001360 - chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0.887434 1.79769e+308 1.79769e+308 0.095774 1 no P3205 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 3342.9 1048.07 -1.67337 4.63458 3.57665e-06 1 no P3206 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no P3207 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 178.229 406.234 1.18858 -1.98998 0.0465927 0.147469 no P3208 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 85.8408 130.588 0.605284 -0.641601 0.521132 0.823129 no P3209 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts OK 102.06 303.773 1.57358 -3.15592 0.00159995 0.00918752 yes P321 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 0 0.513935 1.79769e+308 1.79769e+308 0.202031 1 no P3210 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 4.91166 243.59 5.6321 -0.323463 0.746345 0.980902 no P3211 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 28.2328 470.997 4.06027 -1.41628 0.156694 0.383432 no P3212 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 112.418 7.05837 -3.99339 0.139907 0.888733 0.999997 no P3213 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3214 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3215 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 38.8471 171.68 2.14385 -0.711689 0.476657 0.776693 no P3216 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 0 22.1323 1.79769e+308 1.79769e+308 0.468787 0.770717 no P3217 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 1.68163 294.701 7.45324 -0.0681441 0.945671 0.999997 no P3218 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 14.6135 229.039 3.97022 -0.144739 0.884917 0.999997 no P3219 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 623.312 666.218 0.0960407 -0.218497 0.827042 0.999997 no P322 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 8.59656 0.32407 -4.72938 2.78066 0.00542479 1 no P3220 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 39.3315 5.62521 -2.80571 0.0408876 0.967386 0.999997 no P3221 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 41.707 247.27 2.56773 -1.26108 0.20728 0.461897 no P3222 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 256.033 2042.6 2.996 -5.71891 1.0721e-08 2.3572e-07 yes P3223 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 0 57.4804 1.79769e+308 1.79769e+308 0.30057 0.603814 no P3224 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 11.7322 15.2695 0.38018 -0.0327198 0.973898 0.999997 no P3225 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 8.47305 10.5092 0.310695 -0.356588 0.7214 1 no P3226 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 0.000354505 0 -1.79769e+308 -1.79769e+308 0.499887 1 no P3227 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts OK 16.1619 15.2534 -0.0834673 0.0945577 0.924666 0.999997 no P3228 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts NOTEST 22.0575 3.31248 -2.73528 0.0232293 0.981467 1 no P3229 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts OK 341.159 3035.54 3.15344 -5.5553 2.77133e-08 5.64188e-07 yes P323 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts NOTEST 4.09774 0 -1.79769e+308 -1.79769e+308 0.0386699 1 no P3230 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts OK 0 179.738 1.79769e+308 1.79769e+308 0.393924 0.698475 no P3231 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 2361.48 19294.6 3.03043 -6.22473 4.82377e-10 1.304e-08 yes P3232 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 17.4929 86.3183 2.3029 -0.130683 0.896026 0.999997 no P3233 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 43.0618 70.755 0.716423 -0.0354422 0.971727 0.999997 no P3234 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 1302.83 0 -1.79769e+308 -1.79769e+308 8.13491e-05 0.000749411 yes P3235 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 6.20966 36.9795 2.57414 -0.570371 0.568426 0.869069 no P3236 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 16.1889 32.2829 0.995766 -0.340705 0.733325 0.977889 no P3237 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 6.08129 20.9118 1.78187 -0.142277 0.886861 0.999997 no P3238 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3239 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 2.72756 73.4655 4.75138 -0.610414 0.541587 0.839564 no P324 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3240 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 48.488 464.48 3.25992 -4.77692 1.78002e-06 2.59757e-05 yes P3241 XLOC_001374 RNF186 chr1:20140522-20141771 iPS Fibroblasts NOTEST 1.07721 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P3242 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3243 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts OK 134.324 12.952 -3.37447 3.16116 0.00157144 0.00906048 yes P3244 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3245 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3246 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts OK 171.705 7835.73 5.51206 -7.85065 4.21885e-15 2.67572e-13 yes P3247 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts OK 392.307 1509.04 1.94358 -4.25254 2.11358e-05 0.000235493 yes P3248 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts OK 4421.99 12703.4 1.52245 -3.69885 0.00021658 0.00170881 yes P3249 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts NOTEST 5.84642 0 -1.79769e+308 -1.79769e+308 0.477209 1 no P325 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3250 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts OK 30.3966 13.1454 -1.20935 0.0122497 0.990226 0.999997 no P3251 XLOC_001382 - chr1:20978259-20988037 iPS Fibroblasts NOTEST 5.18588 0 -1.79769e+308 -1.79769e+308 0.481145 1 no P3252 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 5.15833 0 -1.79769e+308 -1.79769e+308 0.310698 1 no P3253 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 53.8428 29.9178 -0.847751 0.789424 0.429864 0.731749 no P3254 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 0 11.7825 1.79769e+308 1.79769e+308 0.246188 0.526214 no P3255 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 4.98873 1.79769e+308 1.79769e+308 0.40849 1 no P3256 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 7.59828 82.6962 3.44407 -1.02281 0.306396 0.61094 no P3257 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 0 89.3077 1.79769e+308 1.79769e+308 0.0630672 0.189087 no P3258 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 17.3446 86.3601 2.31588 -1.78759 0.0738423 0.214755 no P3259 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 718.718 2161.72 1.58868 -2.08607 0.0369724 0.124423 no P326 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3260 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 487.058 1523.73 1.64544 -2.38681 0.0169952 0.0665679 no P3261 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 302.536 147.345 -1.0379 0.50504 0.613531 0.909052 no P3262 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 44.0552 89.2902 1.01919 -0.246332 0.805425 0.999997 no P3263 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 201.731 286.111 0.504142 -0.104316 0.916919 0.999997 no P3264 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 67.7047 234.83 1.79429 -0.761163 0.44656 0.748351 no P3265 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 99.134 49.7966 -0.993333 0.110693 0.91186 0.999997 no P3266 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 310.854 0 -1.79769e+308 -1.79769e+308 0.0196006 0.0739619 no P3267 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 155.005 310.62 1.00284 -0.98089 0.326647 0.62997 no P3268 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 85.7954 581.509 2.76083 -2.44457 0.0145027 0.0594898 no P3269 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 4.89492 48.898 3.32042 -0.363707 0.716077 0.968672 no P327 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 158.893 35.3353 -2.16888 1.24574 0.212861 0.47052 no P3270 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 494.463 640.112 0.372462 -0.374339 0.708152 0.966638 no P3271 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 16.2897 487.969 4.90476 -1.03572 0.300334 0.603814 no P3272 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3273 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3274 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 90.6691 986.479 3.4436 -2.43061 0.0150735 0.0609219 no P3275 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 0 127.783 1.79769e+308 1.79769e+308 0.384443 0.68707 no P3276 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 30.7121 87.2531 1.5064 -0.0820123 0.934637 0.999997 no P3277 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 67.8265 3871.51 5.8349 -6.42094 1.35436e-10 4.06062e-09 yes P3278 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 39.3564 1395.64 5.14819 -2.43204 0.0150139 0.0608939 no P3279 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 0 15.8926 1.79769e+308 1.79769e+308 0.486465 0.784913 no P328 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 28.6581 18.9462 -0.597038 0.247053 0.804867 0.999997 no P3280 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts OK 27.4868 2.12746 -3.69153 3.45464 0.000551018 0.00373921 yes P3281 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 14.88 0.00165223 -13.1367 0.0408286 0.967433 1 no P3282 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 10.5936 0 -1.79769e+308 -1.79769e+308 0.203811 1 no P3283 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 3.1394 0 -1.79769e+308 -1.79769e+308 0.325714 1 no P3284 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 215.746 194.761 -0.147629 0.0635172 0.949355 0.999997 no P3285 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 9.73763 0 -1.79769e+308 -1.79769e+308 0.347079 1 no P3286 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 40.7577 1.54293 -4.72333 0.0325374 0.974043 0.999997 no P3287 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 119.181 49.025 -1.28157 0.570022 0.568663 0.869069 no P3288 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 330.639 182.168 -0.859989 0.38542 0.699926 0.964166 no P3289 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 397.254 1051.93 1.4049 -2.85298 0.00433118 0.0211305 yes P329 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 57.9053 9.97606 -2.53715 0.492082 0.622661 0.915123 no P3290 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3291 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 31.0054 44.2579 0.513415 -0.199311 0.84202 0.999997 no P3292 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 101.632 3722.7 5.19493 -6.40741 1.48016e-10 4.35853e-09 yes P3293 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 15.8513 771.12 5.60429 -3.1199 0.00180915 0.0101588 yes P3294 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 8.87162 262.104 4.8848 -0.257172 0.797046 0.999997 no P3295 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 32.9146 0 -1.79769e+308 -1.79769e+308 0.395674 0.698573 no P3296 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 15.9522 0.00537242 -11.5359 0.13724 0.890841 1 no P3297 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 0.000222119 0.782392 11.7823 -0.00277907 0.997783 1 no P3298 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts NOTEST 3.40123 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P3299 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 56.1574 0 -1.79769e+308 -1.79769e+308 0.169084 0.404087 no P33 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts OK 222.846 444.091 0.994812 -1.84544 0.0649735 0.193396 no P330 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 0 381.592 1.79769e+308 1.79769e+308 0.000456313 0.00324336 yes P3300 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 804.448 885.771 0.138935 -0.347244 0.728408 0.974432 no P3301 XLOC_001396 HTR1D chr1:23518388-23521222 iPS Fibroblasts OK 223.865 0 -1.79769e+308 -1.79769e+308 6.06842e-05 0.00059212 yes P3302 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 174.016 0 -1.79769e+308 -1.79769e+308 0.053774 0.165435 no P3303 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 125.856 337.66 1.4238 -0.771008 0.440702 0.739286 no P3304 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 46.0789 95.6502 1.05366 -0.220708 0.82532 0.999997 no P3305 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 0.231084 0 -1.79769e+308 -1.79769e+308 0.475171 1 no P3306 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 871.304 1348.2 0.629788 -0.581645 0.560806 0.861052 no P3307 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 1672.29 2703.15 0.692816 -1.28753 0.197908 0.445834 no P3308 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 233.679 618.972 1.40534 -0.742424 0.457831 0.760995 no P3309 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 18.8159 0 -1.79769e+308 -1.79769e+308 0.43101 1 no P331 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 0 208.168 1.79769e+308 1.79769e+308 0.00509617 0.0241482 yes P3310 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts OK 60.989 386.766 2.66484 -3.64067 0.000271927 0.00206639 yes P3311 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 0 12.5792 1.79769e+308 1.79769e+308 0.466455 0.769384 no P3312 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 61.7872 147.495 1.25528 -0.628209 0.529867 0.831548 no P3313 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 0 75.1132 1.79769e+308 1.79769e+308 0.332048 0.635942 no P3314 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 72.9916 539.056 2.88463 -3.41524 0.000637264 0.00420339 yes P3315 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3316 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3317 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 181.965 591.657 1.7011 -3.08718 0.00202068 0.0111378 yes P3318 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3319 XLOC_001400 - chr1:23755055-23811057 iPS Fibroblasts OK 33.3151 61.9722 0.895443 -0.541534 0.58814 0.885701 no P332 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 5.30615 1.79769e+308 1.79769e+308 0.472061 1 no P3320 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 57.325 97.6727 0.768792 -0.486906 0.626325 0.915886 no P3321 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts OK 17.3678 59.0676 1.76595 -2.48715 0.0128773 0.0543085 no P3322 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts OK 290.313 325.332 0.164305 -0.153351 0.878121 0.999997 no P3323 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts OK 2233.71 1179.44 -0.921339 1.94336 0.0519728 0.160713 no P3324 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 4.49564 0 -1.79769e+308 -1.79769e+308 0.478102 1 no P3325 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 6.56657 4.63048 -0.503976 0.0211657 0.983114 1 no P3326 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 61.4119 155.802 1.34312 -0.817569 0.413603 0.715668 no P3327 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 34.8907 64.4525 0.885391 -0.35688 0.721182 0.970447 no P3328 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 17.4871 39.5664 1.17798 -0.362489 0.716987 0.969108 no P3329 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 184.266 498.222 1.435 -1.87217 0.0611828 0.184781 no P333 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts OK 12.7177 14.6487 0.203942 -0.0310917 0.975196 0.999997 no P3330 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 17.3205 39.9903 1.20717 -0.422974 0.672314 0.948371 no P3331 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 7.05744 5.84858 -0.271059 0.0104872 0.991633 1 no P3332 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 7.68224 0 -1.79769e+308 -1.79769e+308 0.320546 1 no P3333 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 184.728 1600.17 3.11475 -5.19576 2.03882e-07 3.65436e-06 yes P3334 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3335 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 0 114.728 1.79769e+308 1.79769e+308 0.199385 0.448549 no P3336 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts OK 207.2 140.427 -0.561204 0.900067 0.368084 0.668771 no P3337 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P3338 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts OK 177.784 1297.57 2.86761 -2.59373 0.00949397 0.0418598 yes P3339 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts OK 1054.92 1010.81 -0.0616163 0.119599 0.9048 0.999997 no P334 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 24.8197 0 -1.79769e+308 -1.79769e+308 0.140881 0.357405 no P3340 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 1.49896 0 -1.79769e+308 -1.79769e+308 0.204218 1 no P3341 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.798149 0 -1.79769e+308 -1.79769e+308 0.20295 1 no P3342 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.452065 0 -1.79769e+308 -1.79769e+308 0.306327 1 no P3343 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3344 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.347098 0 -1.79769e+308 -1.79769e+308 0.308557 1 no P3345 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 0.000273846 1.79769e+308 1.79769e+308 0.499753 1 no P3346 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P3347 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 3.57838 1.79769e+308 1.79769e+308 0.0328381 1 no P3348 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 6.64523 0 -1.79769e+308 -1.79769e+308 0.0070371 1 no P3349 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts OK 81.6347 0 -1.79769e+308 -1.79769e+308 0.00038214 0.00277599 yes P335 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 9.62232 6.95204 -0.468948 0.497417 0.618895 1 no P3350 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0.000702974 1.79769e+308 1.79769e+308 0.498969 1 no P3351 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 13.7311 0 -1.79769e+308 -1.79769e+308 0.43375 1 no P3352 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0.0365025 1.79769e+308 1.79769e+308 0.447072 1 no P3353 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 4.07053 0.0773653 -5.71739 0.921483 0.356798 1 no P3354 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 8.9548 15.7206 0.811925 -0.162795 0.87068 0.999997 no P3355 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 2.86176 13.0899 2.19347 -0.232413 0.816217 0.999997 no P3356 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 141.615 209.444 0.564598 -0.858054 0.390863 0.69604 no P3357 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 11.5429 57.9985 2.32901 -1.06707 0.285942 0.585737 no P3358 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P336 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts OK 58.273 0 -1.79769e+308 -1.79769e+308 0.00185698 0.0103103 yes P337 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts NOTEST 2.74185 0 -1.79769e+308 -1.79769e+308 0.4079 1 no P338 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts OK 104.809 0 -1.79769e+308 -1.79769e+308 0.000153023 0.00128088 yes P339 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts NOTEST 0 0.745204 1.79769e+308 1.79769e+308 0.105358 1 no P34 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts OK 12.4598 15.5201 0.316864 -0.390484 0.696179 0.962038 no P340 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 0.593912 0 -1.79769e+308 -1.79769e+308 0.15344 1 no P341 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 6.55753e-05 0 -1.79769e+308 -1.79769e+308 0.499977 1 no P342 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 5.07852e-05 0 -1.79769e+308 -1.79769e+308 0.499982 1 no P343 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts OK 773.162 1651.61 1.09504 -2.54218 0.0110164 0.0473074 yes P344 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 98.9774 406.656 2.03864 -2.55759 0.0105399 0.0456551 yes P345 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 6.84301 25.1112 1.87563 -0.340387 0.733565 0.977889 no P346 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 80.1847 156.014 0.960279 -0.839656 0.401101 0.70449 no P347 XLOC_000163 C1orf151 chr1:19923466-19984945 iPS Fibroblasts OK 246.288 1693.34 2.78146 -2.34735 0.0189074 0.0718395 no P348 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 3.52907 1.79769e+308 1.79769e+308 0.498836 1 no P349 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 0 8957.03 1.79769e+308 1.79769e+308 0.00211286 0.0114233 yes P35 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 35.8479 321.282 3.16388 -1.30931 0.190428 0.433125 no P350 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 463.905 1884.11 2.02198 -1.83292 0.0668147 0.198518 no P351 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 3.39355 0 -1.79769e+308 -1.79769e+308 0.0558829 1 no P352 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts OK 148.118 87.3998 -0.761045 1.44569 0.148264 0.369876 no P353 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts OK 0 147.21 1.79769e+308 1.79769e+308 0.00318923 0.0163324 yes P354 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 0.482643 0 -1.79769e+308 -1.79769e+308 0.31503 1 no P355 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P356 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 12.3177 0.492177 -4.64542 3.23168 0.00123066 1 no P357 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P358 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 1.30646 0.000774709 -10.7197 0.0212375 0.983056 1 no P359 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 3.74866e-05 0.572137 13.8977 -0.000633687 0.999494 1 no P36 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 77.2479 43.4345 -0.830655 0.448778 0.653591 0.938009 no P360 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 1.83014 0 -1.79769e+308 -1.79769e+308 0.0888144 1 no P361 XLOC_000170 FAM43B chr1:20878931-20881512 iPS Fibroblasts NOTEST 1.9757 1.55058 -0.349553 0.253507 0.799876 1 no P362 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts OK 223.547 232.113 0.0542521 -0.0783655 0.937537 0.999997 no P363 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 0 832.083 1.79769e+308 1.79769e+308 0.0365779 0.123348 no P364 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 640.208 2213.85 1.78994 -3.8392 0.000123435 0.00108847 yes P365 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 4.87776 34.3555 2.81625 -0.814494 0.415362 0.717248 no P366 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 0 15.9541 1.79769e+308 1.79769e+308 0.30867 0.613248 no P367 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 11.3784 50.1038 2.13862 -1.09785 0.272268 0.567599 no P368 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 68.9507 428.32 2.63505 -4.33602 1.45087e-05 0.000167306 yes P369 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts OK 877.819 64.4961 -3.76664 5.1039 3.32731e-07 5.71535e-06 yes P37 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 117.436 275.225 1.22874 -1.36979 0.170754 0.405942 no P370 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 14.1413 0 -1.79769e+308 -1.79769e+308 0.353934 1 no P371 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts OK 46.976 2.32536 -4.3364 0.417589 0.676248 0.950673 no P372 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 14.1212 0 -1.79769e+308 -1.79769e+308 0.370142 1 no P373 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts OK 10.8443 16.2682 0.585113 -0.00216545 0.998272 0.999997 no P374 XLOC_000178 CELA3B chr1:22303417-22339033 iPS Fibroblasts NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no P375 XLOC_000178 CELA3A chr1:22303417-22339033 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P376 XLOC_000178 - chr1:22303417-22339033 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P377 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 39.4183 55.0216 0.481134 -0.0360543 0.971239 0.999997 no P378 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 13.0529 70.2619 2.42838 -0.11925 0.905078 0.999997 no P379 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 583.18 668.209 0.196358 -0.108573 0.913541 0.999997 no P38 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 202.814 154.302 -0.394393 0.433885 0.664372 0.945902 no P380 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 2997.59 9098.98 1.6019 -3.5062 0.000454553 0.00324336 yes P381 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 11.3168 0 -1.79769e+308 -1.79769e+308 0.440365 1 no P382 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P383 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts NOTEST 5.796 7.15473 0.30384 -0.0853469 0.931986 1 no P384 XLOC_000181 - chr1:22778343-22857650 iPS Fibroblasts OK 41.9937 12.3722 -1.76307 0.306621 0.759132 0.983415 no P385 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts OK 83.12 210.854 1.34298 -2.57768 0.00994652 0.0435061 yes P386 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts NOTEST 2.71483 0 -1.79769e+308 -1.79769e+308 0.144438 1 no P387 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts OK 30.6745 0 -1.79769e+308 -1.79769e+308 0.00608258 0.028254 yes P388 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P389 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P39 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 100.608 1200.71 3.57707 -3.63335 0.000279761 0.00211617 yes P390 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P391 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts OK 0 79.1362 1.79769e+308 1.79769e+308 0.172687 0.40841 no P392 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts OK 0.0140869 73.628 12.3517 -0.192065 0.847692 0.999997 no P393 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 58.1996 794.32 3.77064 -6.39262 1.63069e-10 1 no P394 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P395 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts OK 2064.11 1754.94 -0.2341 0.56142 0.574511 0.873594 no P396 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts OK 556.677 597.396 0.101847 -0.130849 0.895895 0.999997 no P397 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts OK 6.87752 73.0221 3.40837 -0.284277 0.776198 0.994523 no P398 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts OK 8.91818 27.3759 1.61809 -0.615549 0.538192 0.835667 no P399 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 37247.7 56810.6 0.60901 -0.912252 0.361636 0.663335 no P4 XLOC_000006 OR4F16 chr1:367658-368595 iPS Fibroblasts NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no P40 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 470.224 819.961 0.802208 -1.27348 0.202849 0.455382 no P400 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 6878.03 57034.4 3.05177 -3.40828 0.000653738 0.00429488 yes P401 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 728.583 8804.01 3.595 -1.35066 0.176806 0.41355 no P402 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 227.08 86.3727 -1.39455 0.032494 0.974078 0.999997 no P403 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts OK 755.461 1232.52 0.706187 -1.80674 0.0708034 0.207012 no P404 XLOC_000194 - chr1:24104875-24114720 iPS Fibroblasts OK 42.6282 138.236 1.69725 -0.809573 0.418186 0.72082 no P405 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts OK 1031.1 1578.13 0.614039 -1.36 0.173831 0.409497 no P406 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 728.399 245.964 -1.56628 1.85221 0.0639955 0.191185 no P407 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 60.6827 0 -1.79769e+308 -1.79769e+308 0.178997 0.416313 no P408 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 151.125 801.526 2.40701 -2.3487 0.0188389 0.0717445 no P409 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 107.325 138.908 0.372137 -0.248664 0.803621 0.999997 no P41 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 31.4583 39.157 0.31583 -0.0834739 0.933475 0.999997 no P410 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts OK 2032.12 1795.17 -0.178866 0.476805 0.633501 0.921947 no P411 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 0.00176595 0.713246 8.65781 -0.0102322 0.991836 1 no P412 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 11.6632 0 -1.79769e+308 -1.79769e+308 0.0440615 1 no P413 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 9.34923 3.65658e-05 -17.964 0.000986009 0.999213 1 no P414 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts OK 0 60.0129 1.79769e+308 1.79769e+308 0.359802 0.661854 no P415 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts OK 102.299 181.782 0.829414 -0.356443 0.721509 0.970447 no P416 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 5.7743 2.27352 -1.34472 0.0068295 0.994551 1 no P417 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 340.07 1388.46 2.02958 -4.08439 4.41925e-05 1 no P418 XLOC_000199 - chr1:24742244-24799472 iPS Fibroblasts NOTEST 22.1357 7.66113 -1.53075 0.0515202 0.958911 1 no P419 XLOC_000200 - chr1:24829386-24862425 iPS Fibroblasts OK 15.7185 51.8532 1.72197 -0.327879 0.743003 0.978956 no P42 XLOC_000038 - chr1:1550883-1565984 iPS Fibroblasts NOTEST 20.1981 0 -1.79769e+308 -1.79769e+308 0.367618 1 no P420 XLOC_000200 - chr1:24829386-24862425 iPS Fibroblasts OK 0 46.3362 1.79769e+308 1.79769e+308 0.302015 0.604397 no P421 XLOC_000200 - chr1:24829386-24862425 iPS Fibroblasts NOTEST 10.6171 8.94425 -0.247357 0.0204523 0.983683 1 no P422 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 326.184 219.138 -0.573846 0.851455 0.394517 0.698573 no P423 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 20.7252 77.2898 1.89889 -0.603725 0.546026 0.843859 no P424 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts NOTEST 1.31366 0.128844 -3.34989 1.36696 0.171638 1 no P425 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 0.0198022 574.066 14.8233 -0.225562 0.821542 0.999997 no P426 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 41.7106 28.5028 -0.549309 0.090301 0.928048 0.999997 no P427 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 816.952 789.315 -0.0496498 0.0968883 0.922815 0.999997 no P428 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 347.64 164.784 -1.07702 0.485858 0.627068 0.915886 no P43 XLOC_000038 - chr1:1550883-1565984 iPS Fibroblasts OK 0.0361283 16.9683 8.87549 -0.248354 0.80386 0.999997 no P44 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 0 56.0751 1.79769e+308 1.79769e+308 0.131286 0.339861 no P45 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 4.60985 44.1025 3.25807 -1.11083 0.266643 0.558696 no P46 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 13.0332 17.092 0.391122 -0.137577 0.890575 0.999997 no P47 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P48 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P49 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 12.0776 30.3273 1.32828 -0.211428 0.832553 0.999997 no P5 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 52.9724 3.81714 -3.79467 0.0700385 0.944163 0.999997 no P50 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 0 45.3624 1.79769e+308 1.79769e+308 0.344684 0.644263 no P51 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 28.9547 66.3531 1.19637 -0.870536 0.384008 0.68707 no P52 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 9.17877 316.769 5.10899 -3.18271 0.00145902 0.00853163 yes P53 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts NOTEST 3.14247 6.12558 0.962948 -0.369472 0.711776 1 no P54 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 0.730004 6.24162 3.09594 -0.400296 0.688939 1 no P55 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts OK 0 13.8369 1.79769e+308 1.79769e+308 0.106259 0.288668 no P56 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 9.57879 0 -1.79769e+308 -1.79769e+308 0.0458444 1 no P57 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 19.4885 2.78903 -2.80478 0.00207132 0.998347 1 no P58 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts OK 0 90.7454 1.79769e+308 1.79769e+308 0.467191 0.769384 no P59 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts NOTEST 4.99201 11.254 1.17274 -0.821142 0.411566 1 no P6 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 48.0828 34.9169 -0.461596 0.071855 0.942717 0.999997 no P60 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 5.39767 1.08118 -2.31973 1.23799 0.215719 1 no P61 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 12.037 0.393202 -4.93606 2.5189 0.0117721 1 no P62 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P63 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 7.19324 0 -1.79769e+308 -1.79769e+308 0.428534 1 no P64 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 5.19072 0 -1.79769e+308 -1.79769e+308 0.469481 1 no P65 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 0 34.2875 1.79769e+308 1.79769e+308 0.311842 0.61658 no P66 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 94.566 45.4119 -1.05825 0.526393 0.598615 0.899013 no P67 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 199.815 0 -1.79769e+308 -1.79769e+308 0.00340279 0.0173185 yes P68 XLOC_000046 - chr1:1981908-2139172 iPS Fibroblasts OK 66.2174 100.493 0.601808 -0.400478 0.688805 0.957706 no P69 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts OK 246.057 1645.91 2.74182 -6.24327 4.28516e-10 1.19767e-08 yes P7 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 95.4282 0 -1.79769e+308 -1.79769e+308 0.357743 0.659864 no P70 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts OK 33.4962 143.247 2.09644 -0.721081 0.47086 0.772585 no P71 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts OK 800.086 3798.35 2.24715 -4.84783 1.24819e-06 1.88832e-05 yes P72 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P73 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0.593027 1.79769e+308 1.79769e+308 0.393566 1 no P74 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0.769693 1.79769e+308 1.79769e+308 0.320193 1 no P75 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 1.2132 0 -1.79769e+308 -1.79769e+308 0.274622 1 no P76 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 1.08359 1.27131 0.230486 -0.115529 0.908026 1 no P77 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 2.28814e-05 0 -1.79769e+308 -1.79769e+308 0.499982 1 no P78 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 2.02513 46.0527 4.5072 -1.95813 0.0502153 0.155942 no P79 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 4.50144 72.3071 4.00568 -1.17978 0.238087 0.515231 no P8 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 63.5773 138.131 1.11946 -1.35168 0.176477 0.413367 no P80 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 20.3741 650.706 4.99719 -4.14063 3.46353e-05 0.000368475 yes P81 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 21.3399 118.524 2.47355 -0.780042 0.435366 0.735867 no P82 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 222.585 616.77 1.47038 -1.95459 0.0506313 0.156938 no P83 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 48.0815 83.8728 0.802721 -0.409495 0.682176 0.954121 no P84 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P85 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 20.6279 21.4195 0.0543241 -0.0120819 0.99036 0.999997 no P86 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 147.391 561.382 1.92934 -2.21473 0.0267784 0.0945559 no P87 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 5.26014 1.79769e+308 1.79769e+308 0.467169 1 no P88 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P89 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P9 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 55.6229 48.7092 -0.191482 0.0905716 0.927833 0.999997 no P90 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.000730027 1.20838 10.6928 -0.019103 0.984759 1 no P91 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.00101879 7.0186 12.7501 -0.0317777 0.974649 1 no P92 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.586072 0 -1.79769e+308 -1.79769e+308 0.152132 1 no P93 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.000653284 0 -1.79769e+308 -1.79769e+308 0.49908 1 no P94 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.419018 0 -1.79769e+308 -1.79769e+308 0.231242 1 no P95 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts OK 135.254 2.38434 -5.82594 3.95142 7.76902e-05 0.000732064 yes P96 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no P97 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 8.08924 0 -1.79769e+308 -1.79769e+308 0.379198 1 no P98 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 23.0853 2.4012 -3.26514 1.26427 0.206132 1 no P99 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts OK 546.504 2676.03 2.29179 -5.18428 2.16846e-07 3.84493e-06 yes P1 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts NOTEST 0.347386 0 -1.79769e+308 -1.79769e+308 0.402261 1 no P10 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 180.118 60.5379 -1.57304 0.973461 0.330324 0.633377 no P100 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts OK 0 20.4274 1.79769e+308 1.79769e+308 0.439218 0.738297 no P101 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0.438492 1.79769e+308 1.79769e+308 0.352545 1 no P102 XLOC_000056 - chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.923281 0.0133356 -6.11341 0.0831379 0.933742 1 no P103 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P104 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P105 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 4.94475 0 -1.79769e+308 -1.79769e+308 0.0476228 1 no P106 XLOC_000056 - chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.585598 0 -1.79769e+308 -1.79769e+308 0.344411 1 no P107 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.0344885 0 -1.79769e+308 -1.79769e+308 0.463424 1 no P108 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts OK 63.3435 3.93866 -4.00742 4.24881 2.14913e-05 0.000237847 yes P109 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 5.31366 0 -1.79769e+308 -1.79769e+308 0.112078 1 no P11 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 0 30.5047 1.79769e+308 1.79769e+308 0.0475585 0.14995 no P110 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts NOTEST 2.99279 0.344217 -3.1201 1.59609 0.110469 1 no P111 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts OK 76.8718 58.9016 -0.38415 0.550115 0.582241 0.879226 no P112 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 4.80895 0 -1.79769e+308 -1.79769e+308 0.290423 1 no P113 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P114 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P115 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts OK 86.6597 101.804 0.23236 -0.429165 0.667803 0.946868 no P116 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P117 XLOC_000059 CAD chr1:3773844-3801992 hESC Fibroblasts OK 14.4431 4.99183 -1.53274 0.456673 0.647906 0.931179 no P118 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 8.65205 4.32215 -1.00129 0.242434 0.808444 1 no P119 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts OK 73.9584 1.26614 -5.86821 4.71838 2.37726e-06 3.29421e-05 yes P12 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 9.40489 22.8971 1.28368 -1.26539 0.205732 0.459691 no P120 XLOC_000064 - chr1:4847557-4852182 hESC Fibroblasts OK 18.1722 0.154615 -6.87691 3.65907 0.000253135 0.00194803 yes P121 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P122 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 95.0662 32.7443 -1.53769 1.32922 0.183774 0.425026 no P123 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 14.9138 1.91789 -2.95905 0.244121 0.807137 0.999997 no P124 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 21.0828 68.4146 1.69824 -2.02886 0.0424728 0.137599 no P125 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0.706557 0 -1.79769e+308 -1.79769e+308 0.345594 1 no P126 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 17.0218 10.1307 -0.748643 0.0103814 0.991717 0.999997 no P127 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 28.2454 35.0042 0.309513 -0.0471752 0.962374 0.999997 no P128 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 12.8983 4.63395 -1.47687 0.0936819 0.925362 0.999997 no P129 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts OK 1431.61 0 -1.79769e+308 -1.79769e+308 3.8204e-30 3.9374e-28 yes P13 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 13.3791 5.90797 -1.17924 0.27379 0.784246 0.998626 no P130 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 157.325 0 -1.79769e+308 -1.79769e+308 1.3715e-14 7.06749e-13 yes P131 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 20.3609 0.205083 -6.63345 2.68397 0.00727531 0.0332326 yes P132 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0.10991 8.05147e-05 -10.4148 0.000871698 0.999304 1 no P133 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0 1.29131 1.79769e+308 1.79769e+308 0.222308 1 no P134 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0.605201 0 -1.79769e+308 -1.79769e+308 0.172281 1 no P135 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0.536804 4.20431 2.9694 -0.86638 0.386282 1 no P136 XLOC_000071 - chr1:6640055-6649339 hESC Fibroblasts OK 85.1502 38.1578 -1.15803 0.935662 0.349447 0.650778 no P137 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts OK 241.107 214.473 -0.168879 0.307734 0.758285 0.983415 no P138 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts OK 660.096 769.313 0.220895 -0.682623 0.494845 0.794298 no P139 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 87.2395 129.652 0.571593 -0.200165 0.841351 0.999997 no P14 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts OK 987.18 3379.09 1.77525 -5.01809 5.21889e-07 8.60594e-06 yes P140 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 126.801 402.426 1.66615 -1.31321 0.189111 0.431108 no P141 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 19.5526 26.3763 0.431881 -0.0541185 0.956841 0.999997 no P142 XLOC_000074 - chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P143 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 1.97243 1.79769e+308 1.79769e+308 0.459719 1 no P144 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts OK 26.1246 0 -1.79769e+308 -1.79769e+308 7.13423e-06 8.52489e-05 yes P145 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 8.2803 3.72176 -1.1537 0.282169 0.777814 1 no P146 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts OK 502.334 7098.44 3.82078 -10.9673 0 0 yes P147 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 47.2457 0 -1.79769e+308 -1.79769e+308 2.18008e-07 1 no P148 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 0 17.4103 1.79769e+308 1.79769e+308 0.297441 0.601817 no P149 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 7.06457 82.6263 3.54793 -3.95944 7.51259e-05 0.000716085 yes P15 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts OK 1857.6 2553.38 0.458967 -1.27209 0.203343 0.455587 no P150 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 7.32764 29.553 2.01189 -0.471492 0.63729 0.92262 no P151 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 2.51904 7.31695 1.53837 -0.408281 0.683067 1 no P152 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 53.7103 221.632 2.04489 -4.33846 1.43481e-05 0.00016662 yes P153 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 27.1603 17.1487 -0.663401 0.0118376 0.990555 0.999997 no P154 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 35.935 301.624 3.06929 -0.474812 0.634921 0.921947 no P155 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 8370.4 21322.7 1.34902 -3.43236 0.000598347 0.00400616 yes P156 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 29.7198 142.738 2.26388 -4.11985 3.79118e-05 0.000390728 yes P157 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 9.9298 69.3396 2.80384 -2.24691 0.0246456 0.0885416 no P158 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P159 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P16 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts NOTEST 1.64828 0 -1.79769e+308 -1.79769e+308 0.0567344 1 no P160 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts OK 93.0165 1112.18 3.57976 -10.6305 0 0 yes P161 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts OK 86.131 876.41 3.347 -8.50949 0 0 yes P162 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts OK 21.5619 8.24063 -1.38766 0.253409 0.799953 0.999997 no P163 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts OK 207.722 258.098 0.313267 -0.583339 0.559665 0.860101 no P164 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts OK 171.51 257.242 0.58483 -1.32637 0.184718 0.42661 no P165 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts OK 230.871 73.4533 -1.65219 2.0622 0.0391888 0.130287 no P166 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 25.5368 21.2442 -0.265513 0.0146868 0.988282 0.999997 no P167 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 260.118 45.2674 -2.52262 0.296126 0.767134 0.987512 no P168 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 155.927 109.373 -0.511616 0.143442 0.885941 0.999997 no P169 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts OK 39.4422 319.369 3.01741 -7.86539 3.77476e-15 2.48983e-13 yes P17 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 6.97279 0 -1.79769e+308 -1.79769e+308 0.00246227 1 no P170 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts OK 229.575 19.7819 -3.53672 4.71889 2.3714e-06 3.29421e-05 yes P171 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts NOTEST 4.50396 0 -1.79769e+308 -1.79769e+308 0.228983 1 no P172 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts OK 10.3213 200.875 4.2826 -1.52984 0.126057 0.329425 no P173 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts OK 1102.07 1122.9 0.0270107 -0.0805157 0.935827 0.999997 no P174 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts OK 10.087 70.0715 2.79633 -0.330823 0.740778 0.978956 no P175 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts OK 20.3244 40.3364 0.988869 -0.504286 0.61406 0.909052 no P176 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P177 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 3.19143 0 -1.79769e+308 -1.79769e+308 0.188503 1 no P178 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P179 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 87.5644 29.2168 -1.58355 0.566267 0.571213 0.870545 no P18 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts OK 9.72413 0 -1.79769e+308 -1.79769e+308 0.000129882 0.00112724 yes P180 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 1.09608 5.57672 2.34706 -0.211056 0.832844 1 no P181 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 196.401 864.235 2.13762 -5.4424 5.25668e-08 1.0198e-06 yes P182 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 346.933 143.712 -1.27147 1.6952 0.0900375 0.252933 no P183 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts OK 6778.74 13482.1 0.991958 -2.46442 0.0137233 0.057002 no P184 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 2.2212 4.89393 1.13966 -0.00357404 0.997148 1 no P185 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P186 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts OK 402.424 483.083 0.263553 -0.0882514 0.929677 0.999997 no P187 XLOC_000090 CORT chr1:10490158-10512208 hESC Fibroblasts OK 27.3151 12.1268 -1.17149 0.17028 0.86479 0.999997 no P188 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 138.152 526.06 1.92897 -4.10601 4.02546e-05 0.000409752 yes P189 XLOC_000090 Cort chr1:10490158-10512208 hESC Fibroblasts OK 9.52176 3.73278 -1.35098 0.05825 0.95355 0.999997 no P19 XLOC_000026 B3GALT6 chr1:1167628-1170418 hESC Fibroblasts OK 276.214 1068.96 1.95235 -5.91507 3.3173e-09 7.92785e-08 yes P190 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 84.7865 99.6012 0.232329 -0.174717 0.861302 0.999997 no P191 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 0 21.9227 1.79769e+308 1.79769e+308 0.305287 0.609465 no P192 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts OK 598.647 1041.13 0.79837 -2.23395 0.0254863 0.0911646 no P193 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts OK 0 44.4442 1.79769e+308 1.79769e+308 0.230648 0.503094 no P194 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P195 XLOC_000091 Pex14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 7.51008 3.68586 -1.02683 0.0210874 0.983176 1 no P196 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts NOTEST 2365.52 2744.34 0.214303 -0.654613 0.512717 1 no P197 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts OK 35.6818 0 -1.79769e+308 -1.79769e+308 0.0268718 0.0946828 no P198 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0.912846 10.571 3.5336 -0.48214 0.629707 1 no P199 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts OK 307.383 332.294 0.112423 -0.306558 0.75918 0.983415 no P2 XLOC_000002 OR4F5 chr1:69090-70008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P20 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 30.4263 12.2197 -1.31611 0.621832 0.534052 0.832375 no P200 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts OK 61.7115 0.546235 -6.81987 5.58169 2.38187e-08 4.90962e-07 yes P201 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts NOTEST 0 7.55415e-05 1.79769e+308 1.79769e+308 0.499931 1 no P202 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts NOTEST 5.92521 8.07306 0.44625 -0.0732797 0.941584 1 no P203 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 149.919 193.294 0.366615 -0.554612 0.57916 0.87779 no P204 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 42.0022 0 -1.79769e+308 -1.79769e+308 0.0732063 0.213281 no P205 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 143.48 66.4903 -1.10963 0.441904 0.658558 0.94238 no P206 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 217.658 157.781 -0.464141 0.721271 0.470743 0.772585 no P207 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts OK 25.5712 363.317 3.82864 -8.06025 6.66134e-16 4.99298e-14 yes P208 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts OK 340.257 11.5677 -4.87845 6.10186 1.04843e-09 2.74423e-08 yes P209 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 48.0216 31.884 -0.590848 0.142863 0.886398 0.999997 no P21 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 2.57257 9.60499 1.90058 -0.938807 0.34783 1 no P210 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 9.26798 41.1964 2.15219 -0.489138 0.624744 0.915886 no P211 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 1078.57 1331.71 0.304155 -0.7062 0.480064 0.777628 no P212 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 212.87 117.552 -0.856671 0.410535 0.681414 0.954121 no P213 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 261.965 389.478 0.572168 -0.683188 0.494488 0.794298 no P214 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 2.17987 8.96806 2.04055 -0.106286 0.915355 1 no P215 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 2.18711 0 -1.79769e+308 -1.79769e+308 0.240981 1 no P216 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 7.96239 11.3029 0.50542 -0.0234305 0.981307 1 no P217 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 4.82023 2.44992 -0.976369 0.00623262 0.995027 1 no P218 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P219 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0.995584 0 -1.79769e+308 -1.79769e+308 0.375688 1 no P22 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 37.2973 34.8954 -0.0960364 0.123543 0.901677 0.999997 no P220 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts OK 325.683 514.96 0.660993 -1.99208 0.0463621 0.147021 no P221 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0.0955929 0 -1.79769e+308 -1.79769e+308 0.41022 1 no P222 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts OK 18.414 40.6369 1.14199 -0.22905 0.81883 0.999997 no P223 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts OK 1.78544 116.452 6.02731 -0.524709 0.599786 0.899664 no P224 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts OK 954.766 10325.2 3.43488 -7.71277 1.22125e-14 6.71278e-13 yes P225 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts OK 942.066 2871.51 1.60791 -4.64298 3.43412e-06 4.42412e-05 yes P226 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts OK 1223.51 575.01 -1.08937 2.79975 0.00511417 0.0241641 yes P227 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 0 4.00161 1.79769e+308 1.79769e+308 0.248371 1 no P228 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts OK 413.544 4.49588 -6.52329 5.60132 2.12726e-08 4.49726e-07 yes P229 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts OK 18.4204 0.000474981 -15.2431 0.014826 0.988171 0.999997 no P23 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 4.36667 6.75717 0.629885 -0.298748 0.765132 1 no P230 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 9.03791 0 -1.79769e+308 -1.79769e+308 0.124497 1 no P231 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts OK 5.69324 110.504 4.27871 -3.07036 0.00213802 0.0115215 yes P232 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts OK 28.1716 1285.44 5.51187 -14.2054 0 0 yes P233 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P234 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P235 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 4.58204 2.38321 -0.943087 0.0241683 0.980718 1 no P236 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 71.9285 191.792 1.41491 -2.32165 0.0202518 0.0755751 no P237 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 66.1936 94.7776 0.517853 -0.423606 0.671853 0.948371 no P238 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts NOTEST 1.34969 0 -1.79769e+308 -1.79769e+308 0.0786442 1 no P239 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 1.92876 0 -1.79769e+308 -1.79769e+308 0.0423899 1 no P24 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 666.825 694.672 0.059023 -0.04098 0.967312 0.999997 no P240 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 8.12602 0 -1.79769e+308 -1.79769e+308 2.89119e-07 1 no P241 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts NOTEST 0.592256 0 -1.79769e+308 -1.79769e+308 0.306735 1 no P242 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts NOTEST 0.698209 0 -1.79769e+308 -1.79769e+308 0.306735 1 no P243 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts NOTEST 0.853096 0 -1.79769e+308 -1.79769e+308 0.111514 1 no P244 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P245 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P246 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P247 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P248 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P249 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P25 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 14.7123 15.8664 0.108956 -0.003982 0.996823 0.999997 no P250 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P251 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P252 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P253 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts NOTEST 0.330232 0 -1.79769e+308 -1.79769e+308 0.240869 1 no P254 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P255 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts OK 816.633 40.2891 -4.34123 4.27331 1.92594e-05 0.000219026 yes P256 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts OK 879.809 70.7232 -3.63693 5.68362 1.3187e-08 2.86123e-07 yes P257 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P258 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 6.91549 0 -1.79769e+308 -1.79769e+308 0.25743 1 no P259 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 20.5972 14.8538 -0.471616 0.311708 0.755262 0.983415 no P26 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 108.47 160.99 0.569674 -0.121871 0.903001 0.999997 no P260 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 9.21056 0 -1.79769e+308 -1.79769e+308 0.002687 1 no P261 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 12.8679 27.8928 1.11612 -0.43767 0.661626 0.944607 no P262 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 0 43.9125 1.79769e+308 1.79769e+308 0.250176 0.532309 no P263 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 111.179 358.942 1.69087 -4.62447 3.75564e-06 4.72752e-05 yes P264 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 5.19027 10.0324 0.950785 -0.308976 0.75734 1 no P265 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 19.5662 29.388 0.586861 -0.332502 0.73951 0.978956 no P266 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 9.84787 6.7035 -0.554897 0.164697 0.869182 0.999997 no P267 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 45.0754 3.19938 -3.81647 0.306723 0.759054 0.983415 no P268 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 79.6627 208.608 1.38882 -1.44008 0.149845 0.37157 no P269 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 0 219.237 1.79769e+308 1.79769e+308 0.0420605 0.137351 no P27 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts OK 187.156 781.158 2.06137 -5.7929 6.91832e-09 1.54166e-07 yes P270 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 17.2845 65.7759 1.92808 -1.31278 0.189258 0.431108 no P271 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 215.094 648.261 1.59161 -3.40507 0.000661462 0.00432837 yes P272 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P273 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P274 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 1.79489 0.862567 -1.05719 0.402707 0.687164 1 no P275 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 6.18974 2.29329 -1.43246 1.29897 0.193955 1 no P276 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 0.429055 0.572031 0.414929 -0.0829553 0.933887 1 no P277 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts OK 468.604 2197 2.22909 -6.83631 8.12594e-12 3.11621e-10 yes P278 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P279 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts NOTEST 0 5.61806 1.79769e+308 1.79769e+308 0.0900461 1 no P28 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts NOTEST 2.57898 4.31837 0.743686 -0.805548 0.420503 1 no P280 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P281 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts NOTEST 1.27477 0 -1.79769e+308 -1.79769e+308 0.352721 1 no P282 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts OK 22.5422 18.3447 -0.297262 0.0733335 0.941541 0.999997 no P283 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts OK 106.224 279.288 1.39464 -3.44876 0.000563163 0.00380597 yes P284 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts NOTEST 24.4409 78.8225 1.68931 -1.96768 0.0491044 1 no P285 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P286 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts NOTEST 1.92594 0.922843 -1.06141 0.090458 0.927923 1 no P287 XLOC_000137 RSC1A1 chr1:15944069-15988216 hESC Fibroblasts OK 259.157 376.086 0.537237 -1.05298 0.292349 0.592968 no P288 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts OK 268.762 310.347 0.207554 -0.358859 0.719701 0.97039 no P2881 XLOC_001221 OR4F16 chr1:621097-622034 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2882 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 316.357 41.5721 -2.92787 4.12197 3.75646e-05 0.000389585 yes P2883 XLOC_001228 - chr1:761586-762902 hESC Fibroblasts OK 19.6665 39.9678 1.0231 -1.53129 0.125699 0.329011 no P2884 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 97.2158 72.8474 -0.416314 0.0505344 0.959697 0.999997 no P2885 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 547.174 646.349 0.240314 -0.383974 0.700998 0.964166 no P2886 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 1090.31 1445.11 0.406434 -0.800099 0.423653 0.726955 no P2887 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 100.448 55.7714 -0.848848 0.149951 0.880804 0.999997 no P2888 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts NOTEST 0.517867 2.14049 2.04729 -0.62116 0.534494 1 no P2889 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts OK 25.1834 29.4876 0.227636 -0.233649 0.815257 0.999997 no P289 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts OK 779.207 2346.33 1.59033 -4.91682 8.79633e-07 1.38144e-05 yes P2890 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts OK 12.2395 4.13955 -1.564 0.40981 0.681945 0.954121 no P2891 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 6.807 19.7743 1.53854 -0.88478 0.376275 0.680349 no P2892 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 91.6026 80.2251 -0.191334 0.160277 0.872663 0.999997 no P2893 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 14.7307 0 -1.79769e+308 -1.79769e+308 0.00359575 0.0179633 yes P2894 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 11.9017 53.0677 2.15667 -1.10424 0.269491 0.562786 no P2895 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 21.5806 22.7448 0.0758014 -0.0235876 0.981182 0.999997 no P2896 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts NOTEST 5.99833 0 -1.79769e+308 -1.79769e+308 5.83424e-06 1 no P2897 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 0 14.2685 1.79769e+308 1.79769e+308 0.0233543 0.0848265 no P2898 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 24.8393 0.00130815 -14.2128 0.0113078 0.990978 0.999997 no P2899 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P29 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts NOTEST 152.655 319.473 1.06541 -0.821583 0.411314 1 no P290 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts NOTEST 8.64356 9.3373 0.111381 -0.136942 0.891077 1 no P2900 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 10.3558 0 -1.79769e+308 -1.79769e+308 0.0150296 0.0608939 no P2901 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts NOTEST 1.21775 0 -1.79769e+308 -1.79769e+308 0.0797028 1 no P2902 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts NOTEST 0 5.89401 1.79769e+308 1.79769e+308 0.0457148 1 no P2903 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 17.9039 539.303 4.91275 -2.37584 0.0175091 0.0676604 no P2904 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2905 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 210.708 114.07 -0.885326 0.0437604 0.965095 0.999997 no P2906 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 1473.6 8370.57 2.50599 -6.78692 1.14553e-11 4.10647e-10 yes P2907 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts OK 41.9198 75.8216 0.854975 -1.29359 0.195806 0.441701 no P2908 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 21.3064 95.4488 2.16344 -1.05924 0.289493 0.588307 no P2909 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 55.9053 160.966 1.52569 -0.985429 0.324413 0.629362 no P291 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts OK 31.4534 0 -1.79769e+308 -1.79769e+308 1.02587e-11 3.84468e-10 yes P2910 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 621.812 1704.75 1.45501 -3.92254 8.7619e-05 0.000802687 yes P2911 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 15.5986 27.9153 0.839645 -0.166774 0.867548 0.999997 no P2912 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 2.68872 1.79769e+308 1.79769e+308 0.491248 1 no P2913 XLOC_001241 - chr1:1189293-1209234 hESC Fibroblasts OK 37.017 20.3727 -0.861555 0.348989 0.727098 0.974432 no P2914 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 181.357 810.457 2.1599 -3.18278 0.00145871 0.00853163 yes P2915 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 139.601 101.369 -0.461694 0.190777 0.8487 0.999997 no P2916 XLOC_001242 - chr1:1227763-1260046 hESC Fibroblasts OK 117.46 131.616 0.164166 -0.0511625 0.959196 0.999997 no P2917 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 113.499 86.9123 -0.385041 0.231308 0.817076 0.999997 no P2918 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2919 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 131.639 14.441 -3.18835 0.14041 0.888336 0.999997 no P292 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 85.4176 333.297 1.9642 -1.63546 0.101953 0.280201 no P2920 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2921 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 21.2906 3.63351 -2.55078 0.0158338 0.987367 0.999997 no P2922 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 428.913 407.64 -0.0733879 0.0367134 0.970714 0.999997 no P2923 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 99.7638 74.3645 -0.423902 0.0734539 0.941445 0.999997 no P2924 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 37.6829 23.1589 -0.702345 0.0500451 0.960086 0.999997 no P2925 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 45.4548 82.7322 0.864018 -0.195385 0.845091 0.999997 no P2926 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 1597.84 2355.04 0.559633 -1.07853 0.280797 0.578069 no P2927 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 41.6009 16.3417 -1.34806 0.0699245 0.944254 0.999997 no P2928 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 4.26182 3.66246 -0.218654 0.00159095 0.998731 1 no P2929 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 41.7594 7.63052 -2.45225 0.0302533 0.975865 0.999997 no P293 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 23.593 11.5775 -1.02703 0.0253242 0.979796 0.999997 no P2930 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 193.963 23.7193 -3.03165 1.07489 0.282422 0.579967 no P2931 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 674.206 1267.03 0.91019 -2.44157 0.0146234 0.0598362 no P2932 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 263.001 252.541 -0.058552 0.036739 0.970693 0.999997 no P2933 XLOC_001244 DVL1L1 chr1:1270658-1284492 hESC Fibroblasts OK 31.5522 49.6575 0.654271 -0.0842715 0.932841 0.999997 no P2934 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 0.00314546 2934.02 19.8312 -0.0832685 0.933638 0.999997 no P2935 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 18.5375 18.6477 0.00855196 -0.00014294 0.999886 0.999997 no P2936 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 67.479 8407.76 6.96114 -12.6982 0 0 yes P2937 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 11.8645 95.5511 3.00962 -0.188674 0.850348 0.999997 no P2938 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 55.4345 2864.03 5.69112 -5.8971 3.69951e-09 8.59223e-08 yes P2939 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 3660.17 7034.3 0.942496 -2.34628 0.0189619 0.0718809 no P294 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 850.47 2099.12 1.30345 -3.47578 0.000509362 0.00353463 yes P2940 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 112.752 97.6848 -0.206951 0.114192 0.909086 0.999997 no P2941 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 96.9882 18.1877 -2.41484 0.35166 0.725093 0.97368 no P2942 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 217.748 154.351 -0.496445 0.344049 0.730809 0.975793 no P2943 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 352.289 674.159 0.93633 -2.20399 0.0275247 0.0965708 no P2944 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 443.979 322.484 -0.461263 0.412727 0.679807 0.954044 no P2945 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts OK 88.7189 37.8673 -1.22829 0.123585 0.901644 0.999997 no P2946 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts OK 4267.92 8706.81 1.02861 -2.90714 0.00364755 0.0181169 yes P2947 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts OK 6.86284 15.6317 1.1876 -0.715645 0.47421 0.774998 no P2948 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts OK 49.1286 0.00204697 -14.5508 0.0230681 0.981596 0.999997 no P2949 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts OK 83.1162 233.834 1.49228 -2.91232 0.0035875 0.0179633 yes P295 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 241.251 293.864 0.284612 -0.622647 0.533517 0.832375 no P2950 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 11.4081 4.14556 -1.46042 0.0129999 0.989628 0.999997 no P2951 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 235.83 430.732 0.869044 -0.957175 0.338479 0.64294 no P2952 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 3166.29 6236.3 0.977897 -2.76821 0.00563649 0.0263302 yes P2953 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 146.455 84.2667 -0.797423 0.0796776 0.936494 0.999997 no P2954 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 162.241 113.359 -0.517241 0.0910142 0.927481 0.999997 no P2955 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 618 1043.7 0.75603 -0.829676 0.406722 0.709719 no P2956 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 204.998 293.354 0.517033 -0.314591 0.753073 0.983415 no P2957 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 0 84.1064 1.79769e+308 1.79769e+308 0.427221 0.729272 no P2958 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 24.8037 114.365 2.20501 -0.208056 0.835186 0.999997 no P2959 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 1.12006 3.69003 1.72006 -0.00260586 0.997921 1 no P296 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 140.357 168.12 0.260386 -0.417583 0.676252 0.950673 no P2960 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 21.7767 7.69268 -1.50123 0.00753701 0.993986 0.999997 no P2961 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 17.5163 91.7595 2.38916 -0.128746 0.897558 0.999997 no P2962 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 12.0452 20.3251 0.754804 -0.00652746 0.994792 0.999997 no P2963 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2964 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 22.1371 6.57877 -1.75058 0.0200491 0.984004 0.999997 no P2965 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2966 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 123.643 186.844 0.595654 -0.180823 0.856507 0.999997 no P2967 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 168.137 179.943 0.0979011 -0.0260476 0.979219 0.999997 no P2968 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 205.562 286.25 0.4777 -0.171403 0.863907 0.999997 no P2969 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 110.433 19.8478 -2.47611 0.0648849 0.948266 0.999997 no P297 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2970 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2971 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2972 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 109.837 182.067 0.729101 -0.266235 0.790058 0.999997 no P2973 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2974 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 274.135 431.974 0.656056 -0.303918 0.761191 0.984453 no P2975 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 127.494 113.042 -0.173575 0.033666 0.973143 0.999997 no P2976 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 222.366 276.724 0.315512 -0.265379 0.790717 0.999997 no P2977 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 37.3588 25.3689 -0.558391 0.0258941 0.979342 0.999997 no P2978 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 122.207 362.567 1.56892 -0.507466 0.611828 0.909052 no P2979 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 356.99 499.17 0.483648 -0.593437 0.552889 0.851273 no P298 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 2.91986 0 -1.79769e+308 -1.79769e+308 0.309484 1 no P2980 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 15.2497 8.02851 -0.925577 0.0127593 0.98982 0.999997 no P2981 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 210.14 43.7417 -2.26427 0.512149 0.608547 0.907689 no P2982 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 91.3616 2.79122 -5.03262 0.177031 0.859484 0.999997 no P2983 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 13.2843 1.85523 -2.84005 0.0468309 0.962648 0.999997 no P2984 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 843.106 1204.38 0.514506 -1.60839 0.10775 0.291756 no P2985 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts OK 4816.83 16698 1.79352 -3.98485 6.75234e-05 0.000647361 yes P2986 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts NOTEST 4.54411 10.8403 1.25433 -0.0056506 0.995491 1 no P2987 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 79.5862 23.4115 -1.7653 2.31352 0.0206939 0.0770142 no P2988 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 212.131 0 -1.79769e+308 -1.79769e+308 1.03345e-14 5.87642e-13 yes P2989 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts NOTEST 3.06699 0 -1.79769e+308 -1.79769e+308 0.0359621 1 no P299 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 9.02387 0 -1.79769e+308 -1.79769e+308 0.0125139 1 no P2990 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2991 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P2992 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0.932315 0 -1.79769e+308 -1.79769e+308 0.0219603 1 no P2993 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts OK 33.574 27.1259 -0.307674 0.0564177 0.955009 0.999997 no P2994 XLOC_001263 - chr1:1981908-2139172 hESC Fibroblasts OK 25.7926 78.7015 1.60943 -1.03773 0.299394 0.603814 no P2995 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts OK 1775.08 2591.54 0.545928 -1.22892 0.219103 0.481094 no P2996 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 6.7722 19.0177 1.48964 -0.511357 0.609101 0.907689 no P2997 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 34.0396 64.133 0.91385 -0.631826 0.5275 0.829922 no P2998 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts NOTEST 2.05545 0 -1.79769e+308 -1.79769e+308 0.40395 1 no P2999 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 66.6827 19.3469 -1.78521 0.795674 0.426222 0.729272 no P3 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 696.691 34.2977 -4.34434 5.92844 3.05833e-09 7.41646e-08 yes P30 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts OK 308.066 185.591 -0.73111 0.411722 0.680543 0.954121 no P300 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3000 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts OK 9.44927 23.7899 1.33208 -0.0608556 0.951474 0.999997 no P3001 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts OK 452.417 893.546 0.981889 -0.968985 0.332553 0.636171 no P3002 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts OK 361.252 500.991 0.47178 -1.29987 0.193646 0.438028 no P3003 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3004 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts NOTEST 2.94754 0 -1.79769e+308 -1.79769e+308 0.0305867 1 no P3005 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts OK 12.7571 3.38316 -1.91486 0.083474 0.933475 0.999997 no P3006 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no P3007 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 41.8309 92.849 1.15032 -2.02047 0.0433352 0.139298 no P3008 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 177.762 64.5702 -1.461 2.2504 0.0244238 0.0879363 no P3009 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 319.493 402.167 0.33201 -0.681345 0.495653 0.794298 no P301 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts OK 10.1766 0.308418 -5.04423 0.300035 0.764151 0.984453 no P3010 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 203.665 99.5061 -1.03334 0.870116 0.384237 0.68707 no P3011 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 74.6828 18.6731 -1.99981 1.75926 0.0785333 0.226401 no P3012 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts OK 422.204 227.555 -0.891723 2.49181 0.0127093 0.0537376 no P3013 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts OK 1345.43 1410.28 0.0679088 -0.214918 0.829831 0.999997 no P3014 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 52.3176 177.709 1.76415 -1.48573 0.137352 0.351772 no P3015 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 29.6392 85.1871 1.52313 -1.96714 0.0491672 0.153555 no P3016 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts OK 538.523 1178.32 1.12965 -3.22964 0.00123946 0.00743224 yes P3017 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 32.7056 8.76607 -1.89953 1.12749 0.259536 0.545886 no P3018 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 140.655 98.804 -0.509521 1.11568 0.26456 0.555036 no P3019 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts OK 13.8631 0.611774 -4.50211 1.97438 0.0483381 0.151539 no P302 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 5.14419 0 -1.79769e+308 -1.79769e+308 0.207583 1 no P3020 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts NOTEST 3.24653 2.58654 -0.327873 0.275149 0.783202 1 no P3021 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts OK 4302.07 7509.61 0.803709 -1.9798 0.047726 0.150191 no P3022 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts OK 72.9481 2365.52 5.01914 -3.29646 0.000979105 0.00602442 yes P3023 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts OK 1196.78 2319.74 0.954813 -2.64773 0.00810351 0.0364917 yes P3024 XLOC_001283 - chr1:6266188-6296044 hESC Fibroblasts OK 137.374 288.283 1.06937 -0.94846 0.342895 0.643512 no P3025 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts OK 97.14 268.364 1.46605 -2.32155 0.0202573 0.0755751 no P3026 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts OK 174.868 498.6 1.51161 -3.36101 0.000776578 0.00497527 yes P3027 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 731.817 70.6091 0 0 1 1 no P3028 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 0 39.0287 0 0 1 1 no P3029 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1047.97 732.481 0 0 1 1 no P303 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 4.34296 0 -1.79769e+308 -1.79769e+308 0.0840222 1 no P3030 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 93.6803 110.585 0 0 1 1 no P3031 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1356.8 2679.84 0 0 1 1 no P3032 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 6.44393 1.41752 -2.18458 2.40309 0.016257 1 no P3033 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 2.2157 0.48661 -2.18692 0.607064 0.543809 1 no P3034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 51.9914 18.3016 -1.50631 1.47588 0.139975 0.355652 no P3036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 9.71361 0 -1.79769e+308 -1.79769e+308 0.151372 0.374231 no P3037 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 6.79791 3.95345 -0.781978 0.25367 0.799751 1 no P3038 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3039 XLOC_001287 - chr1:6521220-6580069 hESC Fibroblasts OK 77.8501 12.5671 -2.63104 0.915797 0.359774 0.661854 no P304 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts OK 52.0827 1.81089 -4.84603 0.655272 0.512293 0.81463 no P3040 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 112.149 11.3936 -3.29913 0.557768 0.577003 0.87573 no P3041 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3042 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0.707673 6.84793 3.27451 -0.307037 0.758815 1 no P3043 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3044 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 10.7434 0 -1.79769e+308 -1.79769e+308 0.18792 0.431108 no P3045 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3046 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 166.161 5.81123 -4.83759 0.787948 0.430727 0.732236 no P3047 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 62.1096 0 -1.79769e+308 -1.79769e+308 7.13666e-07 1.14256e-05 yes P3048 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 38.9511 2.5797 -3.91639 0.954185 0.33999 0.642939 no P3049 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 35.8901 1.74109 -4.36552 0.469065 0.639023 0.923386 no P305 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 532.647 1857.43 1.80206 -2.59885 0.00935372 0.041352 yes P3050 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 121.824 34.9295 -1.80229 2.44872 0.0143364 0.0591017 no P3051 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts OK 189.708 361.435 0.929955 -2.39855 0.01646 0.0649389 no P3052 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 154.599 378.033 1.28998 -1.34626 0.178217 0.415672 no P3053 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 62.094 77.2985 0.315986 -0.329081 0.742094 0.978956 no P3054 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 151.442 601.611 1.99006 -2.62421 0.00868508 0.0388122 yes P3055 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts OK 1331.6 1673.01 0.329287 -0.958209 0.337958 0.642782 no P3056 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts OK 28.6342 29.7673 0.0559891 -0.0123245 0.990167 0.999997 no P3057 XLOC_001290 - chr1:6684924-6761966 hESC Fibroblasts OK 12.0359 28.6155 1.24946 -0.26543 0.790678 0.999997 no P3058 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3059 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P306 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 574.155 1815.92 1.66119 -2.13321 0.0329076 0.112349 no P3060 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0.950535 0 -1.79769e+308 -1.79769e+308 0.387454 1 no P3061 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3062 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts NOTEST 0.267901 1.38187 2.36684 -1.03459 0.30086 1 no P3063 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 21.342 71.1003 1.73616 -0.530948 0.595455 0.895082 no P3064 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 442.172 2240.53 2.34116 -6.97387 3.08353e-12 1.30378e-10 yes P3065 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 320.719 1692.19 2.39951 -5.93358 2.96391e-09 7.29475e-08 yes P3066 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 0 47.6257 1.79769e+308 1.79769e+308 0.43296 0.734518 no P3067 XLOC_001294 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 3.82252 6.13498 0.682535 -0.0101436 0.991907 1 no P3068 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 662.61 278.541 -1.25027 0.69688 0.485878 0.784734 no P3069 XLOC_001295 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P307 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 256.538 1504.54 2.55208 -3.35665 0.00078893 0.00502296 yes P3070 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 8.52523 0 -1.79769e+308 -1.79769e+308 0.468181 1 no P3071 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 29778.1 33570.6 0.172948 -0.401506 0.688047 0.95746 no P3072 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 8898.81 12912.6 0.537098 -0.747692 0.454646 0.758379 no P3073 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 54.1427 0 -1.79769e+308 -1.79769e+308 0.366732 0.668771 no P3074 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 3.84797 0 -1.79769e+308 -1.79769e+308 0.485216 1 no P3075 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 12561.6 24138 0.942283 -1.61323 0.106695 0.289376 no P3076 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 914.141 679.817 -0.427269 0.0661448 0.947263 0.999997 no P3077 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 211.161 181.074 -0.221768 0.0130283 0.989605 0.999997 no P3078 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts NOTEST 0.358204 0.725244 1.01768 -0.395685 0.692337 1 no P3079 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P308 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 0 133.313 1.79769e+308 1.79769e+308 0.429997 0.731749 no P3080 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 2.90964 0 -1.79769e+308 -1.79769e+308 0.0125747 1 no P3081 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3082 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 4.17775 1.79769e+308 1.79769e+308 0.478797 1 no P3083 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0.000167835 7.16648 15.3819 -0.00350708 0.997202 1 no P3084 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts OK 0 112.742 1.79769e+308 1.79769e+308 0.0292775 0.101639 no P3085 XLOC_001299 - chr1:9164475-9189356 hESC Fibroblasts NOTEST 5.09214 1.26783 -2.00591 0.639329 0.522609 1 no P3086 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts NOTEST 1.55989 1.42116 -0.134378 0.0491659 0.960787 1 no P3087 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts OK 5.68802 24.4065 2.10127 -1.32163 0.18629 0.42904 no P3088 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts OK 50.5863 72.7269 0.523742 -0.698717 0.484729 0.783645 no P3089 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts OK 212.722 69.3907 -1.61616 3.35287 0.00079978 0.00507245 yes P309 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 519.227 3410.49 2.71554 -7.95824 1.77636e-15 1.22051e-13 yes P3090 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0.589835 0 -1.79769e+308 -1.79769e+308 0.430197 1 no P3091 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 1063.01 1606.44 0.595713 -0.956392 0.338874 0.64294 no P3092 XLOC_001303 - chr1:9711789-9884550 hESC Fibroblasts OK 145.676 695.497 2.25528 -0.858203 0.39078 0.69604 no P3093 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 521.539 26.3156 -4.30879 0.275837 0.782674 0.998166 no P3094 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 0 2515.79 1.79769e+308 1.79769e+308 0.0020398 0.0111378 yes P3095 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts OK 655.696 509.797 -0.363105 0.953415 0.34038 0.64294 no P3096 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 0 5.13452 1.79769e+308 1.79769e+308 0.473347 1 no P3097 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts OK 194.222 1009.9 2.37843 -6.2895 3.18499e-10 9.05527e-09 yes P3098 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 3.50582 7.08002 1.014 -0.0712022 0.943237 1 no P3099 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts OK 268.726 316.625 0.236642 -0.27655 0.782126 0.998166 no P31 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts OK 59.0363 0 -1.79769e+308 -1.79769e+308 5.12217e-06 6.30333e-05 yes P310 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3100 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts OK 857.687 848.024 -0.0163463 0.0276474 0.977943 0.999997 no P3101 XLOC_001307 - chr1:10696667-10856707 hESC Fibroblasts NOTEST 1.40186 0 -1.79769e+308 -1.79769e+308 0.26695 1 no P3102 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 49.2697 6.07219 -3.02041 3.3287 0.000872536 0.00545005 yes P3103 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 37.729 1.6466 -4.51811 2.424 0.0153504 0.0617387 no P3104 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 21.1364 0.352429 -5.90625 1.75786 0.0787721 0.226693 no P3105 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 0 0.00205508 1.79769e+308 1.79769e+308 0.498521 1 no P3106 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 0.000964262 0.331458 8.42519 -0.0124787 0.990044 1 no P3107 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 4.32713 0 -1.79769e+308 -1.79769e+308 0.000938408 1 no P3108 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts OK 45.371 15.0124 -1.59562 2.48032 0.0131266 0.0550781 no P3109 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P311 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 16.6368 100.612 2.59634 -1.0061 0.314367 0.618604 no P3110 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 1.00455 0 -1.79769e+308 -1.79769e+308 0.342184 1 no P3111 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts OK 11.1666 0 -1.79769e+308 -1.79769e+308 0.000253989 0.00194803 yes P3112 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts OK 4481.12 7820.85 0.803466 -2.15713 0.0309952 0.10626 no P3113 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 432.981 3003.63 2.79433 -3.12328 0.00178846 1 no P3114 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts NOTEST 4.49163 7.79258 0.794862 -0.0524712 0.958153 1 no P3115 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts OK 67.2406 33.2215 -1.01722 0.307072 0.758789 0.983415 no P3116 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts OK 1276.69 1601.03 0.32659 -1.0141 0.310537 0.616216 no P3117 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts OK 892.477 636.873 -0.48681 1.45906 0.144548 0.3628 no P3118 XLOC_001312 - chr1:11166588-11322608 hESC Fibroblasts OK 135.175 170.948 0.338728 -0.316107 0.751921 0.983415 no P3119 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts OK 1488.36 72.9584 -4.3505 3.70758 0.000209249 0.001675 yes P312 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts OK 62.5679 49.7705 -0.330131 0.274991 0.783323 0.998222 no P3120 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 7.02688 0 -1.79769e+308 -1.79769e+308 0.357358 1 no P3121 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts OK 6757.57 2368.21 -1.51271 4.77367 1.809e-06 2.6167e-05 yes P3122 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 64.418 263.856 2.03421 -3.74537 0.000180125 1 no P3123 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts OK 93.2442 277.975 1.57587 -3.25743 0.00112424 0.00684087 yes P3124 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts OK 10.2838 18.088 0.814661 -0.159931 0.872936 0.999997 no P3125 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 7.22153 0 -1.79769e+308 -1.79769e+308 0.0228854 1 no P3126 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts OK 97.0102 113.009 0.220233 -0.0969657 0.922754 0.999997 no P3127 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts OK 657.437 1330.79 1.01736 -2.81118 0.00493606 0.023593 yes P3128 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 302.602 457.869 0.597516 -1.26964 0.204213 0.456917 no P3129 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 28.066 1.34044 -4.38804 0.0352654 0.971868 0.999997 no P313 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts NOTEST 4.93427 0 -1.79769e+308 -1.79769e+308 0.334821 1 no P3130 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 334.324 292.677 -0.191934 0.275888 0.782634 0.998166 no P3131 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 10.8508 0 -1.79769e+308 -1.79769e+308 0.165124 0.39578 no P3132 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3133 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts OK 2184.6 1951.16 -0.163037 0.462258 0.643896 0.927769 no P3134 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3135 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3136 XLOC_001324 PRAMEF5 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3137 XLOC_001324 PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3138 XLOC_001324 PRAMEF5 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3139 XLOC_001325 - chr1:13182960-13183967 hESC Fibroblasts OK 275.825 207.399 -0.411345 0.794459 0.426928 0.729272 no P314 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 30.5389 3.8214 -2.99847 0.278725 0.780456 0.997653 no P3140 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3141 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3142 XLOC_001328 PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3143 XLOC_001328 PRAMEF13 chr1:13447413-13452656 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3144 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3145 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3146 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3147 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3148 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts NOTEST 8.16584 0 -1.79769e+308 -1.79769e+308 5.37334e-05 1 no P3149 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 197.024 118.428 -0.734362 0.997412 0.318565 0.623094 no P315 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 428.259 98.6818 -2.11763 4.19792 2.69379e-05 0.000292241 yes P3150 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 132.595 55.404 -1.25896 1.03389 0.301189 0.603814 no P3151 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 32.8483 25.7553 -0.350951 0.33421 0.738221 0.978956 no P3152 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 51.7979 80.6384 0.638575 -0.646498 0.517957 0.820398 no P3153 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 17.767 8.22122 -1.11178 0.244213 0.807066 0.999997 no P3154 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts OK 115.866 43.2083 -1.42308 0.890662 0.373111 0.675915 no P3155 XLOC_001338 - chr1:16133656-16134194 hESC Fibroblasts OK 16097 21049.2 0.386973 -1.17641 0.239429 0.517456 no P3156 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 20.1751 2.23494 -3.17427 0.301325 0.763166 0.984453 no P3157 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 259.204 560.414 1.11241 -2.96273 0.00304921 0.0157622 yes P3158 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 6.42816 5.22855 -0.297994 0.0268404 0.978587 1 no P3159 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 24.9031 48.555 0.963295 -0.664337 0.506475 0.806934 no P316 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 100.239 17.1632 -2.54605 1.39725 0.162339 0.392778 no P3160 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 6.98597 0 -1.79769e+308 -1.79769e+308 0.0872004 1 no P3161 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3162 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 7.07875 9.63291 0.444477 -0.0573822 0.954241 1 no P3163 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 2.7664 13.5911 2.29658 -0.391753 0.695241 0.962038 no P3164 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 8.33768 26.7081 1.67956 -0.336691 0.73635 0.978363 no P3165 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 0 16.7923 1.79769e+308 1.79769e+308 0.318334 0.623094 no P3166 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 0 26.6845 1.79769e+308 1.79769e+308 0.277781 0.574012 no P3167 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 3.62862 235.204 6.01834 -5.42991 5.63836e-08 1.08112e-06 yes P3168 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 3.46957 397.66 6.84064 -5.90824 3.45785e-09 8.1457e-08 yes P3169 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 0 60.3352 1.79769e+308 1.79769e+308 0.252071 0.534962 no P317 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3170 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts OK 21.4939 38.8477 0.853903 -0.372944 0.70919 0.966638 no P3171 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts NOTEST 4.46492 7.5659 0.760877 -0.0252848 0.979828 1 no P3172 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts NOTEST 2.16378 0 -1.79769e+308 -1.79769e+308 0.422369 1 no P3173 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts OK 573.472 923.073 0.686721 -2.03205 0.0421485 0.137351 no P3174 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 324.019 132.515 -1.28992 2.16192 0.030624 0.105426 no P3175 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 0 38.3291 1.79769e+308 1.79769e+308 0.209842 0.465719 no P3176 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 678.385 8.10745 -6.38671 3.11931 0.00181275 0.0101588 yes P3177 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts OK 53.4824 182.341 1.7695 -3.52638 0.000421284 0.00303361 yes P3178 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 2.24339 15.5838 2.7963 -0.645033 0.518906 0.820398 no P3179 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 256.568 533.075 1.055 -2.88559 0.00390683 0.0192885 yes P318 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 6.34529e-05 6.06956e-06 -3.38602 2.75938e-05 0.999978 1 no P3180 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 8.45144 30.8971 1.8702 -0.603985 0.545854 0.843859 no P3181 XLOC_001347 - chr1:16576559-16678948 hESC Fibroblasts NOTEST 0.999115 0 -1.79769e+308 -1.79769e+308 0.247955 1 no P3182 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3183 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3184 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 76.9358 33.8911 -1.18275 0.619138 0.535826 0.832777 no P3185 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 120.904 551.679 2.18996 -2.52271 0.0116455 0.04975 yes P3186 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 27.9922 232.03 3.05122 -2.09837 0.0358725 0.121466 no P3187 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 2.13127 2.38008 0.159297 -0.00202641 0.998383 1 no P3188 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 109.231 592.825 2.44022 -5.49341 3.94255e-08 7.83285e-07 yes P3189 XLOC_001354 ESPNP chr1:17017712-17046652 hESC Fibroblasts NOTEST 3.47275 0 -1.79769e+308 -1.79769e+308 0.0482484 1 no P319 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 1.50479 0 -1.79769e+308 -1.79769e+308 0.0372925 1 no P3190 XLOC_001354 ESPN chr1:17017712-17046652 hESC Fibroblasts OK 11.1097 0 -1.79769e+308 -1.79769e+308 2.90933e-06 3.93237e-05 yes P3191 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts NOTEST 3.25841 1.59851 -1.02744 0.0736512 0.941288 1 no P3192 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts OK 38.162 1.55467 -4.61745 0.301429 0.763087 0.984453 no P3193 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 4040.61 1992.29 -1.02014 2.38741 0.0169677 0.0665679 no P3194 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 825.956 413.367 -0.998641 0.883701 0.376858 0.680655 no P3195 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 18.4495 0 -1.79769e+308 -1.79769e+308 0.137594 0.351772 no P3196 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 12.3556 24.341 0.978227 -0.205997 0.836793 0.999997 no P3197 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 22.7704 46.6117 1.03353 -0.289576 0.772141 0.992409 no P3198 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 537.876 177.11 -1.60263 2.86861 0.00412275 0.0202334 yes P3199 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 472.669 205.856 -1.1992 2.13044 0.0331352 0.112892 no P32 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts OK 58.9274 29.8843 -0.979553 0.501649 0.615915 0.910589 no P320 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 0.286309 0 -1.79769e+308 -1.79769e+308 0.333484 1 no P3200 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 366.46 231.387 -0.66335 0.678151 0.497676 0.796765 no P3201 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts OK 1548.47 5372.43 1.79473 -5.61323 1.98579e-08 4.25269e-07 yes P3202 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts NOTEST 3.49549 0 -1.79769e+308 -1.79769e+308 0.219199 1 no P3203 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts OK 62.6093 1.76593e-05 -21.7575 0.00095655 0.999237 0.999997 no P3204 XLOC_001360 - chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0.887434 1.79769e+308 1.79769e+308 0.095774 1 no P3205 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts OK 5456.99 1048.07 -2.38038 7.49464 6.63913e-14 3.31755e-12 yes P3206 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3207 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 434.186 406.234 -0.0960002 0.241311 0.809314 0.999997 no P3208 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 218.303 130.588 -0.741314 1.047 0.295098 0.597808 no P3209 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts OK 89.541 303.773 1.76237 -4.98216 6.28781e-07 1.01653e-05 yes P321 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 2.33196 0.513935 -2.18188 1.11817 0.263496 1 no P3210 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 426.519 243.59 -0.808154 0.389931 0.696588 0.962038 no P3211 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 557.747 470.997 -0.243893 0.19825 0.84285 0.999997 no P3212 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 4.71016 7.05837 0.583558 -0.0203922 0.98373 1 no P3213 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3214 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 167.676 0 -1.79769e+308 -1.79769e+308 0.0104565 0.0454956 yes P3215 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 192.593 171.68 -0.165827 0.0762327 0.939234 0.999997 no P3216 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 22.9292 22.1323 -0.0510316 0.00276094 0.997797 0.999997 no P3217 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 92.8871 294.701 1.6657 -0.854576 0.392786 0.697957 no P3218 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 50.0495 229.039 2.19416 -0.336772 0.736289 0.978363 no P3219 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 765.815 666.218 -0.201002 0.495133 0.620506 0.913584 no P322 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts NOTEST 12.671 0.32407 -5.28908 3.31366 0.000920822 1 no P3220 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 5.33048 5.62521 0.0776413 -0.00113021 0.999098 1 no P3221 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 112.439 247.27 1.13694 -0.681647 0.495462 0.794298 no P3222 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 452.421 2042.6 2.17467 -5.58713 2.3085e-08 4.81863e-07 yes P3223 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 27.296 57.4804 1.07438 -0.368103 0.712796 0.966638 no P3224 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 3.92853 15.2695 1.95859 -0.178634 0.858225 0.999997 no P3225 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts OK 11.7019 10.5092 -0.155089 0.218303 0.827193 0.999997 no P3226 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3227 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts OK 17.2325 15.2534 -0.176005 0.235969 0.813457 0.999997 no P3228 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts NOTEST 2.29939 3.31248 0.526662 -0.0044676 0.996435 1 no P3229 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts OK 693.277 3035.54 2.13045 -5.22776 1.71577e-07 3.10913e-06 yes P323 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts NOTEST 3.11869 0 -1.79769e+308 -1.79769e+308 0.0140302 1 no P3230 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts OK 0 179.738 1.79769e+308 1.79769e+308 0.393924 0.698475 no P3231 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 5169.04 19294.6 1.90023 -4.86533 1.14265e-06 1.74466e-05 yes P3232 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 8.25067 86.3183 3.38708 -0.201058 0.840653 0.999997 no P3233 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 69.4828 70.755 0.0261749 -0.00130635 0.998958 0.999997 no P3234 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3235 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 36.9795 1.79769e+308 1.79769e+308 0.343647 0.643947 no P3236 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 9.20491 32.2829 1.8103 -0.727787 0.466744 0.769384 no P3237 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 20.9118 1.79769e+308 1.79769e+308 0.418961 0.721156 no P3238 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 1.29633 0 -1.79769e+308 -1.79769e+308 0.337923 1 no P3239 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 73.4655 1.79769e+308 1.79769e+308 0.0896063 0.252151 no P324 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts NOTEST 1.38095 0 -1.79769e+308 -1.79769e+308 0.181472 1 no P3240 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 56.5465 464.48 3.03811 -7.27405 3.48832e-13 1.55466e-11 yes P3241 XLOC_001374 RNF186 chr1:20140522-20141771 hESC Fibroblasts NOTEST 0.423276 0 -1.79769e+308 -1.79769e+308 0.240869 1 no P3242 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3243 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts OK 35.1082 12.952 -1.43863 1.65431 0.0980649 0.271324 no P3244 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3245 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3246 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts OK 124.278 7835.73 5.97843 -13.8149 0 0 yes P3247 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts OK 351.837 1509.04 2.10065 -6.42614 1.30882e-10 3.99676e-09 yes P3248 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts OK 4971.96 12703.4 1.35333 -3.62662 0.000287153 0.00216217 yes P3249 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P325 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts NOTEST 0.21117 0 -1.79769e+308 -1.79769e+308 0.240869 1 no P3250 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts OK 19.3729 13.1454 -0.559486 0.00567096 0.995475 0.999997 no P3251 XLOC_001382 - chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3252 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 48.9997 0 -1.79769e+308 -1.79769e+308 7.17472e-08 1 no P3253 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 102.304 29.9178 -1.77378 1.82215 0.0684327 1 no P3254 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 5.90044 11.7825 0.997751 -0.402083 0.687623 0.95746 no P3255 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 3.5495 4.98873 0.491059 -0.064287 0.948742 1 no P3256 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 11.229 82.6962 2.8806 -1.77325 0.0761872 0.220643 no P3257 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 16.4694 89.3077 2.439 -2.2132 0.0268838 1 no P3258 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 129.453 86.3601 -0.583993 0.646717 0.517815 1 no P3259 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 520.882 2161.72 2.05315 -3.16366 0.00155801 0.00901459 yes P326 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 5.26 0 -1.79769e+308 -1.79769e+308 0.184349 1 no P3260 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 240.884 1523.73 2.6612 -4.64363 3.42335e-06 4.42412e-05 yes P3261 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 107.411 147.345 0.456065 -0.225706 0.82143 0.999997 no P3262 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 56.1343 89.2902 0.66962 -0.183781 0.854185 0.999997 no P3263 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 108.229 286.111 1.40249 -0.307009 0.758836 0.983415 no P3264 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 19.1563 234.83 3.61572 -1.8954 0.0580393 0.175932 no P3265 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 39.0388 49.7966 0.351137 -0.0394027 0.968569 0.999997 no P3266 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3267 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 149.423 310.62 1.05575 -1.18154 0.237389 0.515072 no P3268 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 265.087 581.509 1.13333 -1.46238 0.143636 0.36106 no P3269 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 0 48.898 1.79769e+308 1.79769e+308 0.342931 0.643512 no P327 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 479.078 35.3353 -3.76108 2.22709 0.0259415 0.0925919 no P3270 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 247.208 640.112 1.3726 -1.42732 0.153487 0.377761 no P3271 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 6.37526 487.969 6.25816 -3.64198 0.00027055 0.00206545 yes P3272 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3273 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3274 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 28.0163 986.479 5.13795 -3.77317 0.000161186 1 no P3275 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 5.98009 127.783 4.41738 -0.876867 0.380559 0.68509 no P3276 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 14.4148 87.2531 2.59766 -0.141923 0.887141 0.999997 no P3277 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 419.192 3871.51 3.20721 -4.8217 1.42337e-06 2.11453e-05 yes P3278 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 95.1492 1395.64 3.8746 -2.06417 0.0390012 0.129925 no P3279 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 4.34987 15.8926 1.86931 -0.0439447 0.964949 0.999997 no P328 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 64.0925 18.9462 -1.75825 0.826981 0.408248 0.710127 no P3280 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 67.9603 2.12746 -4.99749 5.88103 4.07718e-09 9.33788e-08 yes P3281 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 64.0794 0.00165223 -15.2432 0.0473758 0.962214 1 no P3282 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 23.1783 0 -1.79769e+308 -1.79769e+308 0.000624781 0.00415429 yes P3283 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 23.4017 0 -1.79769e+308 -1.79769e+308 0.0365495 0.123348 no P3284 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 175.948 194.761 0.146552 -0.0653015 0.947934 0.999997 no P3285 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 1.61711 0 -1.79769e+308 -1.79769e+308 0.410798 1 no P3286 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 4.47726 1.54293 -1.53694 0.010587 0.991553 1 no P3287 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 49.6025 49.025 -0.0168938 0.00784538 0.99374 0.999997 no P3288 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 44.7452 182.168 2.02546 -0.903205 0.366417 0.668771 no P3289 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 512.56 1051.93 1.03724 -2.8573 0.00427263 0.0209067 yes P329 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 55.941 9.97606 -2.48736 0.487379 0.62599 0.915886 no P3290 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3291 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 26.2055 44.2579 0.756064 -0.366683 0.713855 0.966638 no P3292 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 741.639 3722.7 2.32756 -3.12474 0.00177963 0.01005 yes P3293 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 124.328 771.12 2.6328 -1.7182 0.0857603 0.243826 no P3294 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 185.017 262.104 0.502481 -0.0269747 0.97848 0.999997 no P3295 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3296 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts OK 73.6692 0.00537242 -13.7432 0.163502 0.870123 0.999997 no P3297 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts NOTEST 0 0.782392 1.79769e+308 1.79769e+308 0.106931 1 no P3298 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts NOTEST 1.30651 0 -1.79769e+308 -1.79769e+308 0.240869 1 no P3299 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts NOTEST 3.29156 0 -1.79769e+308 -1.79769e+308 0.226695 1 no P33 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts OK 469.362 444.091 -0.079845 0.202495 0.83953 0.999997 no P330 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 0 381.592 1.79769e+308 1.79769e+308 0.000456313 0.00324336 yes P3300 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts OK 432.503 885.771 1.03422 -2.93303 0.00335667 0.0171367 yes P3301 XLOC_001396 HTR1D chr1:23518388-23521222 hESC Fibroblasts OK 138.505 0 -1.79769e+308 -1.79769e+308 1.57272e-23 1.44078e-21 yes P3302 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 2.65635 0 -1.79769e+308 -1.79769e+308 0.419546 1 no P3303 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 198.346 337.66 0.767552 -0.506655 0.612397 0.909052 no P3304 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 90.6925 95.6502 0.0767851 -0.0176817 0.985893 0.999997 no P3305 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 3.70001 0 -1.79769e+308 -1.79769e+308 0.371514 1 no P3306 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 1176.83 1348.2 0.196131 -0.191581 0.84807 0.999997 no P3307 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 1344.32 2703.15 1.00776 -2.03931 0.0414187 0.136423 no P3308 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 200.546 618.972 1.62594 -0.881537 0.378027 0.68202 no P3309 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 3.27082 0 -1.79769e+308 -1.79769e+308 0.438713 1 no P331 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 0 208.168 1.79769e+308 1.79769e+308 0.00509617 0.0241482 yes P3310 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts OK 18.4192 386.766 4.39217 -10.3872 0 0 yes P3311 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 0 12.5792 1.79769e+308 1.79769e+308 0.466455 0.769384 no P3312 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 0 147.495 1.79769e+308 1.79769e+308 0.158876 0.387554 no P3313 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 4.90057 75.1132 3.93805 -1.10557 0.268912 0.562736 no P3314 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 1.36049 539.056 8.63017 -6.71755 1.84808e-11 6.27901e-10 yes P3315 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 5.93528 0 -1.79769e+308 -1.79769e+308 0.435254 1 no P3316 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 24.2074 0 -1.79769e+308 -1.79769e+308 0.0805175 0.230509 no P3317 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 557.63 591.657 0.0854519 -0.227671 0.819902 0.999997 no P3318 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3319 XLOC_001400 - chr1:23755055-23811057 hESC Fibroblasts OK 59.9998 61.9722 0.0466629 -0.0378668 0.969794 0.999997 no P332 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 2.78634 5.30615 0.929294 -0.0441671 0.964771 1 no P3320 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 22.8075 97.6727 2.09845 -1.48348 0.137946 0.352126 no P3321 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts OK 95.4288 59.0676 -0.692058 1.38803 0.165129 0.39578 no P3322 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts OK 130.941 325.332 1.31299 -1.59588 0.110515 0.296807 no P3323 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts OK 3052.85 1179.44 -1.37205 3.45896 0.000542271 0.00369506 yes P3324 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 5.43458 0 -1.79769e+308 -1.79769e+308 0.292274 1 no P3325 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 9.86629 4.63048 -1.09135 0.0482376 0.961527 0.999997 no P3326 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 43.8262 155.802 1.82985 -1.39777 0.162183 0.392778 no P3327 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 51.369 64.4525 0.327337 -0.15706 0.875197 0.999997 no P3328 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 17.3703 39.5664 1.18766 -0.515162 0.60644 0.907388 no P3329 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 440.531 498.222 0.177545 -0.327526 0.74327 0.978956 no P333 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts OK 44.6171 14.6487 -1.60682 0.27939 0.779946 0.997653 no P3330 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 7.27536 39.9903 2.45856 -1.03353 0.301358 0.603814 no P3331 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 9.6936 5.84858 -0.728947 0.0287653 0.977052 0.999997 no P3332 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 12.5886 0 -1.79769e+308 -1.79769e+308 0.0210085 0.0773283 no P3333 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 286.755 1600.17 2.48033 -6.79361 1.09359e-11 4.00741e-10 yes P3334 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3335 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 42.7613 114.728 1.42384 -0.798329 0.42468 0.727959 no P3336 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts OK 122.432 140.427 0.197841 -0.390637 0.696065 0.962038 no P3337 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3338 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts OK 533.444 1297.57 1.2824 -2.47268 0.0134105 0.0561267 no P3339 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts OK 767.195 1010.81 0.397849 -0.899756 0.36825 0.668771 no P334 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 25.6249 0 -1.79769e+308 -1.79769e+308 0.00259312 0.013679 yes P3340 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3341 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0.363637 0 -1.79769e+308 -1.79769e+308 0.186004 1 no P3342 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 1.77127 0 -1.79769e+308 -1.79769e+308 0.0132666 1 no P3343 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 1.19576 0 -1.79769e+308 -1.79769e+308 0.127659 1 no P3344 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0.607421 0 -1.79769e+308 -1.79769e+308 0.0776478 1 no P3345 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 5.55488 0.000273846 -14.3081 0.00613477 0.995105 1 no P3346 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P3347 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 0 3.57838 1.79769e+308 1.79769e+308 0.0328381 1 no P3348 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 1.45433 0 -1.79769e+308 -1.79769e+308 0.107539 1 no P3349 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 44.0625 0 -1.79769e+308 -1.79769e+308 1.69034e-10 4.89011e-09 yes P335 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts OK 17.1125 6.95204 -1.29954 1.74086 0.0817088 0.233514 no P3350 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts NOTEST 0 0.000702974 1.79769e+308 1.79769e+308 0.498969 1 no P3351 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 125.353 0 -1.79769e+308 -1.79769e+308 0.000117086 0.00103804 yes P3352 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 12.9816 0.0365025 -8.47426 0.780855 0.434888 0.735867 no P3353 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 24.4887 0.0773653 -8.30622 1.61767 0.105734 0.288668 no P3354 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 2.3477 15.7206 2.74334 -0.71943 0.471876 0.772715 no P3355 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 10.1778 13.0899 0.363025 -0.159989 0.87289 0.999997 no P3356 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 132.318 209.444 0.662561 -1.31271 0.189279 0.431108 no P3357 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 7.16763 57.9985 3.01645 -2.31194 0.020781 0.0770142 no P3358 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P336 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts OK 398.742 0 -1.79769e+308 -1.79769e+308 7.73853e-22 6.71623e-20 yes P337 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts NOTEST 3.24727 0 -1.79769e+308 -1.79769e+308 0.455712 1 no P338 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts OK 209.176 0 -1.79769e+308 -1.79769e+308 1.57475e-32 1.73118e-30 yes P339 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts NOTEST 8.37135 0.745204 -3.48975 2.01068 0.0443595 1 no P34 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts OK 69.2663 15.5201 -2.15801 3.56653 0.000361735 0.00263939 yes P340 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 0.969259 0 -1.79769e+308 -1.79769e+308 0.0110943 1 no P341 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P342 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 7.1892e-05 0 -1.79769e+308 -1.79769e+308 0.499937 1 no P343 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts OK 961.74 1651.61 0.780159 -2.37831 0.0173923 0.0675202 no P344 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 246.16 406.656 0.724212 -1.51613 0.129488 0.335732 no P345 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 0.0310775 25.1112 9.65824 -0.32266 0.746953 0.980902 no P346 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 78.4626 156.014 0.991599 -1.05913 0.28954 0.588307 no P347 XLOC_000163 C1orf151 chr1:19923466-19984945 hESC Fibroblasts OK 618.381 1693.34 1.45331 -1.35329 0.175962 0.412748 no P348 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 1.64141 3.52907 1.10436 -0.00223238 0.998219 1 no P349 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 162.125 8957.03 5.78784 -10.1089 0 0 yes P35 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 321.282 321.282 -2.94691e-06 3.41128e-06 0.999997 0.999997 no P350 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 16.9244 1884.11 6.79864 -4.7867 1.69545e-06 2.49625e-05 yes P351 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts OK 22.3161 0 -1.79769e+308 -1.79769e+308 2.82075e-11 9.12042e-10 yes P352 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts OK 157.667 87.3998 -0.851179 2.02602 0.0427627 0.138266 no P353 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts OK 0.847143 147.21 7.44105 -5.14402 2.68921e-07 4.66791e-06 yes P354 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P355 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts NOTEST 0.361045 0 -1.79769e+308 -1.79769e+308 0.159889 1 no P356 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts OK 17.9074 0.492177 -5.18523 3.87498 0.000106632 0.00095563 yes P357 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P358 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 6.27626 0.000774709 -12.984 0.0257234 0.979478 1 no P359 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0.572137 1.79769e+308 1.79769e+308 0.114546 1 no P36 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 111.183 43.4345 -1.35603 0.849522 0.395591 0.698573 no P360 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts OK 11.844 0 -1.79769e+308 -1.79769e+308 3.79697e-07 6.38899e-06 yes P361 XLOC_000170 FAM43B chr1:20878931-20881512 hESC Fibroblasts OK 40.5541 1.55058 -4.70896 5.03446 4.79204e-07 7.98189e-06 yes P362 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts OK 133.245 232.113 0.800745 -1.49151 0.135826 0.349777 no P363 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 114.96 832.083 2.8556 -3.29087 0.000998788 0.00612268 yes P364 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 326.979 2213.85 2.75929 -7.37461 1.64757e-13 7.76241e-12 yes P365 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts NOTEST 17.0989 34.3555 1.00664 -0.499019 0.617766 1 no P366 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 1.81796 15.9541 3.13353 -0.982008 0.326096 0.62997 no P367 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 3.12392 50.1038 4.00349 -2.43896 0.0147297 0.0601221 no P368 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 37.3701 428.32 3.51873 -7.96305 1.77636e-15 1.22051e-13 yes P369 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 4753.79 64.4961 -6.20372 9.04021 0 0 yes P37 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 409.377 275.225 -0.572818 1.01836 0.308509 0.613248 no P370 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 40.1523 0 -1.79769e+308 -1.79769e+308 0.124082 0.326855 no P371 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 130.881 2.32536 -5.81466 0.572198 0.567188 0.869069 no P372 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 120.584 0 -1.79769e+308 -1.79769e+308 0.00451612 0.0218389 yes P373 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts OK 22.0415 16.2682 -0.438171 0.00162169 0.998706 0.999997 no P374 XLOC_000178 CELA3B chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P375 XLOC_000178 CELA3A chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P376 XLOC_000178 - chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P377 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 8.77177 55.0216 2.64906 -0.200338 0.841216 0.999997 no P378 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 9.59677 70.2619 2.87212 -0.172269 0.863226 0.999997 no P379 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 83.254 668.209 3.00471 -1.87498 0.0607961 0.18395 no P38 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 138.44 154.302 0.156495 -0.183382 0.854498 0.999997 no P380 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 1520.88 9098.98 2.5808 -6.83982 7.92899e-12 3.11307e-10 yes P381 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 3.95557 0 -1.79769e+308 -1.79769e+308 0.298891 1 no P382 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P383 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts OK 76.4937 7.15473 -3.41837 1.4773 0.139596 0.355238 no P384 XLOC_000181 - chr1:22778343-22857650 hESC Fibroblasts OK 23.69 12.3722 -0.937171 0.165335 0.86868 0.999997 no P385 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 121.688 210.854 0.793062 -2.17516 0.0296178 1 no P386 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts OK 16.9383 0 -1.79769e+308 -1.79769e+308 1.00724e-07 1.84549e-06 yes P387 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts OK 69.3632 0 -1.79769e+308 -1.79769e+308 1.29473e-10 3.99676e-09 yes P388 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P389 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P39 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 542.034 1200.71 1.14743 -2.4716 0.0134509 1 no P390 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P391 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 37.3058 79.1362 1.08494 -0.69215 0.488843 1 no P392 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 80.4755 73.628 -0.128295 0.06344 0.949416 1 no P393 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 183.879 794.32 2.11096 -4.77291 1.81587e-06 1 no P394 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P395 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts OK 3123.43 1754.94 -0.83171 2.29248 0.0218782 0.0798169 no P396 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts OK 911.067 597.396 -0.608869 0.975473 0.329326 0.632198 no P397 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts OK 2.53326 73.0221 4.84926 -1.68463 0.0920605 0.256866 no P398 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts OK 4.45377 27.3759 2.61981 -1.45422 0.145886 0.365602 no P399 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 66407.9 56810.6 -0.225194 0.346736 0.728789 0.974432 no P4 XLOC_000006 OR4F16 chr1:367658-368595 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P40 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 790.187 819.961 0.0533603 -0.103776 0.917347 1 no P400 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 6624.43 57034.4 3.10596 -3.74942 0.000177241 0.00145408 yes P401 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 1583.34 8804.01 2.47519 -1.07554 0.282132 0.579967 no P402 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 191.396 86.3727 -1.14791 0.0267524 0.978657 0.999997 no P403 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts OK 523.425 1232.52 1.23556 -3.83604 0.000125032 0.00109669 yes P404 XLOC_000194 - chr1:24104875-24114720 hESC Fibroblasts OK 57.722 138.236 1.25994 -0.944357 0.344987 0.644263 no P405 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts OK 1150.34 1578.13 0.456163 -1.32347 0.18568 0.428232 no P406 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 738.535 245.964 -1.58622 2.03902 0.041448 0.136423 no P407 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P408 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 1591.41 801.526 -0.989489 2.22078 0.0263661 0.0935003 no P409 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 366.517 138.908 -1.39975 1.25793 0.208416 0.463802 no P41 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts OK 54.4924 39.157 -0.476786 0.141762 0.887268 0.999997 no P410 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts OK 1015.28 1795.17 0.822244 -2.59154 0.00955471 0.0420152 yes P411 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0 0.713246 1.79769e+308 1.79769e+308 0.156094 1 no P412 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts OK 24.5694 0 -1.79769e+308 -1.79769e+308 1.33233e-14 7.06749e-13 yes P413 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0.00104564 3.65658e-05 -4.83775 0.000265429 0.999788 1 no P414 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 4.01002 60.0129 3.90359 -0.948759 0.342743 0.643512 no P415 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 55.217 181.782 1.71903 -0.831616 0.405626 0.708935 no P416 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts NOTEST 0.568882 2.27352 1.99873 -0.0101833 0.991875 1 no P417 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 80.6785 1388.46 4.10515 -10.084 0 0 yes P418 XLOC_000199 - chr1:24742244-24799472 hESC Fibroblasts NOTEST 5.64277 7.66113 0.441153 -0.0148822 0.988126 1 no P419 XLOC_000200 - chr1:24829386-24862425 hESC Fibroblasts OK 11.8633 51.8532 2.12792 -0.560992 0.574803 0.873594 no P42 XLOC_000038 - chr1:1550883-1565984 hESC Fibroblasts OK 217.26 0 -1.79769e+308 -1.79769e+308 0.0174021 0.0675202 no P420 XLOC_000200 - chr1:24829386-24862425 hESC Fibroblasts OK 4.24998 46.3362 3.44661 -1.01887 0.308265 0.613248 no P421 XLOC_000200 - chr1:24829386-24862425 hESC Fibroblasts NOTEST 2.64685 8.94425 1.75668 -0.174617 0.861381 1 no P422 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 113.081 219.138 0.954477 -1.69115 0.0908078 0.254267 no P423 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 0 77.2898 1.79769e+308 1.79769e+308 0.243741 0.524711 no P424 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts NOTEST 2.35713 0.128844 -4.19333 1.83747 0.0661412 1 no P425 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 0 574.066 1.79769e+308 1.79769e+308 0.00172002 0.00974678 yes P426 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 47.1916 28.5028 -0.727426 0.120902 0.903768 0.999997 no P427 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 805.739 789.315 -0.0297118 0.0660008 0.947377 0.999997 no P428 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 876.963 164.784 -2.41194 1.11813 0.263512 0.553543 no P43 XLOC_000038 - chr1:1550883-1565984 hESC Fibroblasts OK 26.2154 16.9683 -0.627575 0.220163 0.825745 0.999997 no P44 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 3.88743 56.0751 3.85047 -2.07677 0.0378229 0.126255 no P45 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 37.6352 44.1025 0.228778 -0.14303 0.886266 0.999997 no P46 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 0.00352987 17.092 12.2414 -0.0977963 0.922094 0.999997 no P47 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P48 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 4.48044 0 -1.79769e+308 -1.79769e+308 0.24101 1 no P49 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 0 30.3273 1.79769e+308 1.79769e+308 0.405843 0.708935 no P5 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 1.74761 3.81714 1.12711 -0.0206055 0.98356 1 no P50 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 100.348 45.3624 -1.14544 0.316453 0.751659 0.983415 no P51 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 100.346 66.3531 -0.596751 0.504202 0.61412 0.909052 no P52 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 86.1128 316.769 1.87913 -3.37365 0.000741784 0.00481575 yes P53 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts OK 33.88 6.12558 -2.46752 1.55482 0.11999 0.316581 no P54 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 9.67624 6.24162 -0.632526 0.19623 0.84443 0.999997 no P55 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 0 13.8369 1.79769e+308 1.79769e+308 0.106259 0.288668 no P56 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 23.6518 0 -1.79769e+308 -1.79769e+308 0.000240873 0.00187358 yes P57 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 18.0861 2.78903 -2.69705 0.00199175 0.998411 0.999997 no P58 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 73.9259 90.7454 0.295744 -0.016833 0.98657 0.999997 no P59 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts NOTEST 3.15678 11.254 1.83391 -1.49266 0.135527 1 no P6 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts OK 4.50533 34.9169 2.95422 -0.426077 0.670052 0.946949 no P60 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts OK 26.9908 1.08118 -4.64179 2.89373 0.003807 0.0188521 yes P61 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts OK 41.7053 0.393202 -6.72881 3.58001 0.000343586 0.00252934 yes P62 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P63 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 17.4198 0 -1.79769e+308 -1.79769e+308 0.133938 0.346181 no P64 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 3.07856 0 -1.79769e+308 -1.79769e+308 0.426846 1 no P65 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 0 34.2875 1.79769e+308 1.79769e+308 0.311842 0.61658 no P66 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 60.5588 45.4119 -0.415268 0.213371 0.831038 0.999997 no P67 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 833.609 0 -1.79769e+308 -1.79769e+308 3.60688e-28 3.49868e-26 yes P68 XLOC_000046 - chr1:1981908-2139172 hESC Fibroblasts OK 109.688 100.493 -0.126319 0.106377 0.915283 0.999997 no P69 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts OK 740.008 1645.91 1.15327 -3.57845 0.000345636 0.00253312 yes P7 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P70 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts OK 30.1072 143.247 2.25033 -0.995911 0.319293 0.623094 no P71 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts OK 772.363 3798.35 2.29802 -6.08292 1.18015e-09 2.99395e-08 yes P72 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P73 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 6.36609e-05 0.593027 13.1854 -0.00234077 0.998132 1 no P74 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 1.11603 0.769693 -0.536018 0.167195 0.867217 1 no P75 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P76 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 1.19958 1.27131 0.0837773 -0.047765 0.961904 1 no P77 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P78 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 0.4903 46.0527 6.55348 -4.10092 4.11513e-05 0.00041631 yes P79 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 3.17316 72.3071 4.51014 -2.54391 0.0109619 0.0471961 yes P8 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 180.736 138.131 -0.387843 0.65007 0.515647 0.818385 no P80 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 0 650.706 1.79769e+308 1.79769e+308 0.000218799 0.00171809 yes P81 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 0.103287 118.524 10.1643 -0.439385 0.660383 0.943649 no P82 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 431.86 616.77 0.514169 -1.08079 0.279791 0.577179 no P83 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 46.1049 83.8728 0.863283 -0.552957 0.580293 0.878148 no P84 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P85 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 15.5461 21.4195 0.462373 -0.108914 0.913271 0.999997 no P86 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 327.266 561.382 0.778519 -1.55496 0.119955 0.316581 no P87 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 36.9813 5.26014 -2.81363 0.1606 0.872409 0.999997 no P88 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P89 XLOC_000052 ACTRT2 chr1:2938045-2939465 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P9 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 151.63 48.7092 -1.63829 0.903481 0.366271 0.668771 no P90 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0 1.20838 1.79769e+308 1.79769e+308 0.348531 1 no P91 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0 7.0186 1.79769e+308 1.79769e+308 0.0148547 1 no P92 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 4.52426 0 -1.79769e+308 -1.79769e+308 1.83109e-06 1 no P93 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no P94 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0.770522 0 -1.79769e+308 -1.79769e+308 0.153883 1 no P95 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 229.313 2.38434 -6.58758 4.64732 3.36281e-06 4.40101e-05 yes P96 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 5.86138 0 -1.79769e+308 -1.79769e+308 0.177621 1 no P97 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 11.6052 0 -1.79769e+308 -1.79769e+308 0.0890786 0.251525 no P98 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 120.614 2.4012 -5.65049 3.03509 0.00240464 0.0127911 yes P99 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts OK 498.776 2676.03 2.42363 -7.46346 8.43769e-14 4.09228e-12 yes cummeRbund/inst/extdata/chr1_snippet.gtf0000644000175200017520001171677314516004263021435 0ustar00biocbuildbiocbuildchr1 nearCoding exon 11874 12227 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000003"; exon_number "1"; oId "uc010nxr.1"; nearest_ref "uc010nxr.1"; class_code "="; tss_id "TSS1"; chr1 nearCoding exon 12646 12697 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000003"; exon_number "2"; oId "uc010nxr.1"; nearest_ref "uc010nxr.1"; class_code "="; tss_id "TSS1"; chr1 nearCoding exon 13221 14409 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000003"; exon_number "3"; oId "uc010nxr.1"; nearest_ref "uc010nxr.1"; class_code "="; tss_id "TSS1"; chr1 coding exon 11874 12227 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000002"; exon_number "1"; oId "uc010nxq.1"; nearest_ref "uc010nxq.1"; class_code "="; tss_id "TSS1"; p_id "P1"; chr1 coding exon 12595 12721 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000002"; exon_number "2"; oId "uc010nxq.1"; nearest_ref "uc010nxq.1"; class_code "="; tss_id "TSS1"; p_id "P1"; chr1 coding exon 13403 14409 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000002"; exon_number "3"; oId "uc010nxq.1"; nearest_ref "uc010nxq.1"; class_code "="; tss_id "TSS1"; p_id "P1"; chr1 nearCoding exon 11874 12227 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000001"; exon_number "1"; oId "uc001aaa.3"; nearest_ref "uc001aaa.3"; class_code "="; tss_id "TSS1"; chr1 nearCoding exon 12613 12721 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000001"; exon_number "2"; oId "uc001aaa.3"; nearest_ref "uc001aaa.3"; class_code "="; tss_id "TSS1"; chr1 nearCoding exon 13221 14409 . + . gene_id "XLOC_000001"; transcript_id "TCONS_00000001"; exon_number "3"; oId "uc001aaa.3"; nearest_ref "uc001aaa.3"; class_code "="; tss_id "TSS1"; chr1 coding exon 69091 70008 . + . gene_id "XLOC_000002"; transcript_id "TCONS_00000004"; exon_number "1"; gene_name "OR4F5"; oId "uc001aal.1"; nearest_ref "uc001aal.1"; class_code "="; p_id "P2"; chr1 noncoding exon 321084 321114 . + . gene_id "XLOC_000003"; transcript_id "TCONS_00000005"; exon_number "1"; oId "uc001aaq.1"; nearest_ref "uc001aaq.1"; class_code "="; chr1 noncoding exon 321146 321223 . + . gene_id "XLOC_000004"; transcript_id "TCONS_00000006"; exon_number "1"; oId "uc001aar.1"; nearest_ref "uc001aar.1"; class_code "="; chr1 coding exon 322037 322228 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000007"; exon_number "1"; oId "uc009vjk.2"; nearest_ref "uc009vjk.2"; class_code "="; tss_id "TSS2"; p_id "P3"; chr1 coding exon 324288 324345 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000007"; exon_number "2"; oId "uc009vjk.2"; nearest_ref "uc009vjk.2"; class_code "="; tss_id "TSS2"; p_id "P3"; chr1 coding exon 324439 326938 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000007"; exon_number "3"; oId "uc009vjk.2"; nearest_ref "uc009vjk.2"; class_code "="; tss_id "TSS2"; p_id "P3"; chr1 nearCoding exon 323892 324060 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000009"; exon_number "1"; oId "uc001aav.3"; nearest_ref "uc001aav.3"; class_code "="; tss_id "TSS3"; chr1 nearCoding exon 324288 324345 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000009"; exon_number "2"; oId "uc001aav.3"; nearest_ref "uc001aav.3"; class_code "="; tss_id "TSS3"; chr1 nearCoding exon 324439 326938 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000009"; exon_number "3"; oId "uc001aav.3"; nearest_ref "uc001aav.3"; class_code "="; tss_id "TSS3"; chr1 nearCoding exon 327036 328580 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000009"; exon_number "4"; oId "uc001aav.3"; nearest_ref "uc001aav.3"; class_code "="; tss_id "TSS3"; chr1 coding exon 323892 324060 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000008"; exon_number "1"; oId "uc001aau.2"; nearest_ref "uc001aau.2"; class_code "="; tss_id "TSS3"; p_id "P3"; chr1 coding exon 324288 324345 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000008"; exon_number "2"; oId "uc001aau.2"; nearest_ref "uc001aau.2"; class_code "="; tss_id "TSS3"; p_id "P3"; chr1 coding exon 324439 328580 . + . gene_id "XLOC_000005"; transcript_id "TCONS_00000008"; exon_number "3"; oId "uc001aau.2"; nearest_ref "uc001aau.2"; class_code "="; tss_id "TSS3"; p_id "P3"; chr1 coding exon 367659 368595 . + . gene_id "XLOC_000006"; transcript_id "TCONS_00000010"; exon_number "1"; gene_name "OR4F16"; oId "uc010nxu.1"; nearest_ref "uc010nxu.1"; class_code "="; p_id "P4"; chr1 noncoding exon 420206 420296 . + . gene_id "XLOC_000007"; transcript_id "TCONS_00000011"; exon_number "1"; oId "uc001aax.1"; nearest_ref "uc001aax.1"; class_code "="; tss_id "TSS4"; chr1 noncoding exon 420992 421258 . + . gene_id "XLOC_000007"; transcript_id "TCONS_00000011"; exon_number "2"; oId "uc001aax.1"; nearest_ref "uc001aax.1"; class_code "="; tss_id "TSS4"; chr1 noncoding exon 421396 421839 . + . gene_id "XLOC_000007"; transcript_id "TCONS_00000011"; exon_number "3"; oId "uc001aax.1"; nearest_ref "uc001aax.1"; class_code "="; tss_id "TSS4"; chr1 noncoding exon 566462 568045 . + . gene_id "XLOC_000008"; transcript_id "TCONS_00000012"; exon_number "1"; oId "uc001aaz.2"; nearest_ref "uc001aaz.2"; class_code "="; chr1 noncoding exon 568149 568842 . + . gene_id "XLOC_000009"; transcript_id "TCONS_00000013"; exon_number "1"; oId "uc001aba.1"; nearest_ref "uc001aba.1"; class_code "="; chr1 noncoding exon 568844 568912 . + . gene_id "XLOC_000010"; transcript_id "TCONS_00000014"; exon_number "1"; oId "uc001abb.2"; nearest_ref "uc001abb.2"; class_code "="; chr1 noncoding exon 569327 570349 . + . gene_id "XLOC_000011"; transcript_id "TCONS_00000015"; exon_number "1"; oId "uc001abc.2"; nearest_ref "uc001abc.2"; class_code "="; chr1 noncoding exon 763064 763155 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000016"; exon_number "1"; oId "uc009vjn.1"; nearest_ref "uc009vjn.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 764383 764484 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000016"; exon_number "2"; oId "uc009vjn.1"; nearest_ref "uc009vjn.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 787307 787490 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000016"; exon_number "3"; oId "uc009vjn.1"; nearest_ref "uc009vjn.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788771 788902 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000016"; exon_number "4"; oId "uc009vjn.1"; nearest_ref "uc009vjn.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 763064 763155 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000019"; exon_number "1"; oId "uc009vjo.1"; nearest_ref "uc009vjo.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 764383 764484 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000019"; exon_number "2"; oId "uc009vjo.1"; nearest_ref "uc009vjo.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788051 788146 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000019"; exon_number "3"; oId "uc009vjo.1"; nearest_ref "uc009vjo.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788771 788997 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000019"; exon_number "4"; oId "uc009vjo.1"; nearest_ref "uc009vjo.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 763064 763155 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000018"; exon_number "1"; oId "uc001abq.1"; nearest_ref "uc001abq.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 764383 764484 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000018"; exon_number "2"; oId "uc001abq.1"; nearest_ref "uc001abq.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 787307 787490 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000018"; exon_number "3"; oId "uc001abq.1"; nearest_ref "uc001abq.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788051 788146 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000018"; exon_number "4"; oId "uc001abq.1"; nearest_ref "uc001abq.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788771 788997 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000018"; exon_number "5"; oId "uc001abq.1"; nearest_ref "uc001abq.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 763064 763155 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000017"; exon_number "1"; oId "uc001abp.1"; nearest_ref "uc001abp.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 764383 764484 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000017"; exon_number "2"; oId "uc001abp.1"; nearest_ref "uc001abp.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 783034 783186 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000017"; exon_number "3"; oId "uc001abp.1"; nearest_ref "uc001abp.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 787307 787490 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000017"; exon_number "4"; oId "uc001abp.1"; nearest_ref "uc001abp.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788051 788146 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000017"; exon_number "5"; oId "uc001abp.1"; nearest_ref "uc001abp.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788771 788997 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000017"; exon_number "6"; oId "uc001abp.1"; nearest_ref "uc001abp.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 763064 763155 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "1"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 764383 764484 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "2"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 783034 783186 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "3"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 787307 787490 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "4"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788051 788146 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "5"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788771 788902 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "6"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 788957 789740 . + . gene_id "XLOC_000012"; transcript_id "TCONS_00000020"; exon_number "7"; oId "uc001abr.1"; nearest_ref "uc001abr.1"; class_code "="; tss_id "TSS5"; chr1 noncoding exon 791898 794579 . + . gene_id "XLOC_000013"; transcript_id "TCONS_00000021"; exon_number "1"; oId "uc001abs.2"; nearest_ref "uc001abs.2"; class_code "="; chr1 noncoding exon 846815 846853 . + . gene_id "XLOC_000014"; transcript_id "TCONS_00000022"; exon_number "1"; oId "uc001abu.1"; nearest_ref "uc001abu.1"; class_code "="; tss_id "TSS6"; chr1 noncoding exon 847325 850328 . + . gene_id "XLOC_000014"; transcript_id "TCONS_00000022"; exon_number "2"; oId "uc001abu.1"; nearest_ref "uc001abu.1"; class_code "="; tss_id "TSS6"; chr1 coding exon 860530 860569 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000023"; exon_number "1"; gene_name "SAMD11"; oId "uc001abv.1"; nearest_ref "uc001abv.1"; class_code "="; tss_id "TSS7"; p_id "P7"; chr1 coding exon 861302 861393 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000023"; exon_number "2"; gene_name "SAMD11"; oId "uc001abv.1"; nearest_ref "uc001abv.1"; class_code "="; tss_id "TSS7"; p_id "P7"; chr1 coding exon 865535 865716 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000023"; exon_number "3"; gene_name "SAMD11"; oId "uc001abv.1"; nearest_ref "uc001abv.1"; class_code "="; tss_id "TSS7"; p_id "P7"; chr1 coding exon 866419 866469 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000023"; exon_number "4"; gene_name "SAMD11"; oId "uc001abv.1"; nearest_ref "uc001abv.1"; class_code "="; tss_id "TSS7"; p_id "P7"; chr1 coding exon 871152 871276 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000023"; exon_number "5"; gene_name "SAMD11"; oId "uc001abv.1"; nearest_ref "uc001abv.1"; class_code "="; tss_id "TSS7"; p_id "P7"; chr1 coding exon 861121 861180 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "1"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 861302 861393 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "2"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 865535 865716 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "3"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 866419 866469 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "4"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 871152 871276 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "5"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 874420 874509 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "6"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 874655 874840 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "7"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 876524 876686 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "8"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 877516 877631 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "9"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 877790 877868 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "10"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 877939 878438 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "11"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 878633 878757 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "12"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 879078 879188 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "13"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 879288 879961 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000024"; exon_number "14"; gene_name "SAMD11"; oId "uc001abw.1"; nearest_ref "uc001abw.1"; class_code "="; tss_id "TSS8"; p_id "P5"; chr1 coding exon 871152 871276 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "1"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 874420 874509 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "2"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 874655 874792 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "3"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 876524 876686 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "4"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 877516 877631 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "5"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 877790 877868 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "6"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 877939 878438 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "7"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 878633 878757 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "8"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 879078 879188 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "9"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 879288 879961 . + . gene_id "XLOC_000015"; transcript_id "TCONS_00000025"; exon_number "10"; gene_name "SAMD11"; oId "uc001abx.1"; nearest_ref "uc001abx.1"; class_code "="; tss_id "TSS9"; p_id "P6"; chr1 coding exon 895967 896180 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "1"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 896673 896932 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "2"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 897009 897130 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "3"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 897206 897427 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "4"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 897735 897851 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "5"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 898084 898297 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "6"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 898489 898633 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "7"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 898717 898884 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "8"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 899300 899388 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "9"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 899487 899560 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "10"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 899729 899910 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "11"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 900343 901095 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000026"; exon_number "12"; gene_name "KLHL17"; oId "uc001aca.1"; nearest_ref "uc001aca.1"; class_code "="; tss_id "TSS10"; p_id "P8"; chr1 coding exon 896829 897130 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000027"; exon_number "1"; gene_name "KLHL17"; oId "uc001acb.1"; nearest_ref "uc001acb.1"; class_code "="; tss_id "TSS11"; p_id "P9"; chr1 coding exon 897206 897858 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000027"; exon_number "2"; gene_name "KLHL17"; oId "uc001acb.1"; nearest_ref "uc001acb.1"; class_code "="; tss_id "TSS11"; p_id "P9"; chr1 nearCoding exon 897461 897851 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "1"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 898084 898297 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "2"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 898489 898633 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "3"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 898717 898884 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "4"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 899300 899388 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "5"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 899487 899547 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "6"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 899729 899910 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "7"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 nearCoding exon 900343 901095 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000028"; exon_number "8"; gene_name "KLHL17"; oId "uc001acc.1"; nearest_ref "uc001acc.1"; class_code "="; tss_id "TSS12"; chr1 coding exon 897735 897851 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000029"; exon_number "1"; gene_name "KLHL17"; oId "uc010nyb.1"; nearest_ref "uc010nyb.1"; class_code "="; tss_id "TSS13"; p_id "P10"; chr1 coding exon 898084 898297 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000029"; exon_number "2"; gene_name "KLHL17"; oId "uc010nyb.1"; nearest_ref "uc010nyb.1"; class_code "="; tss_id "TSS13"; p_id "P10"; chr1 coding exon 898412 899229 . + . gene_id "XLOC_000016"; transcript_id "TCONS_00000029"; exon_number "3"; gene_name "KLHL17"; oId "uc010nyb.1"; nearest_ref "uc010nyb.1"; class_code "="; tss_id "TSS13"; p_id "P10"; chr1 coding exon 901877 901994 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "1"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 902084 902183 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "2"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 905657 905803 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "3"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 905901 905981 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "4"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 906066 906138 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "5"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 906259 906386 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "6"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 906457 906588 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "7"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 906704 906784 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "8"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 907455 907530 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "9"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 907668 907804 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "10"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 908241 908390 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "11"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 908880 909020 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "12"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 909213 909431 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "13"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 909696 909744 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "14"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 909822 910482 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000032"; exon_number "15"; gene_name "PLEKHN1"; oId "uc001acf.2"; nearest_ref "uc001acf.2"; class_code "="; tss_id "TSS14"; p_id "P11"; chr1 coding exon 901877 901994 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "1"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 902084 902183 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "2"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 905657 905803 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "3"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 905901 905981 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "4"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 906066 906386 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "5"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 906457 906588 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "6"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 906704 906784 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "7"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 907455 907530 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "8"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 907668 907804 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "9"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 908241 908390 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "10"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 908566 908706 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "11"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 908880 909020 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "12"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 909213 909431 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "13"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 909696 909744 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "14"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 909822 910482 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000031"; exon_number "15"; gene_name "PLEKHN1"; oId "uc001ace.2"; nearest_ref "uc001ace.2"; class_code "="; tss_id "TSS14"; p_id "P12"; chr1 coding exon 901877 901994 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "1"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 902084 902183 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "2"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 905657 905803 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "3"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 905901 905981 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "4"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 906066 906138 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "5"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 906259 906386 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "6"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 906493 906588 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "7"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 906704 906784 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "8"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 907455 907530 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "9"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 907668 907804 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "10"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 908241 908390 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "11"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 908566 908706 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "12"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 908880 909020 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "13"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 909213 909431 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "14"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 909696 909744 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "15"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 909822 910482 . + . gene_id "XLOC_000017"; transcript_id "TCONS_00000030"; exon_number "16"; gene_name "PLEKHN1"; oId "uc001acd.2"; nearest_ref "uc001acd.2"; class_code "="; tss_id "TSS14"; p_id "P13"; chr1 coding exon 948847 948956 . + . gene_id "XLOC_000018"; transcript_id "TCONS_00000033"; exon_number "1"; gene_name "ISG15"; oId "uc001acj.3"; nearest_ref "uc001acj.3"; class_code "="; tss_id "TSS15"; p_id "P14"; chr1 coding exon 949364 949915 . + . gene_id "XLOC_000018"; transcript_id "TCONS_00000033"; exon_number "2"; gene_name "ISG15"; oId "uc001acj.3"; nearest_ref "uc001acj.3"; class_code "="; tss_id "TSS15"; p_id "P14"; chr1 coding exon 955503 955753 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "1"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 957581 957842 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "2"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 970657 970704 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "3"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 976045 976260 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "4"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 976553 976777 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "5"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 976858 977082 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "6"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 977336 977542 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "7"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 978619 978837 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "8"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 978918 979112 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "9"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 979203 979403 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "10"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 979489 979637 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "11"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 979714 979819 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "12"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 980541 980657 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "13"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 980739 980903 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "14"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 981113 981256 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "15"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 981344 981468 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "16"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 981540 981645 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "17"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 981777 982115 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "18"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 982200 982337 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "19"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 982707 982834 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "20"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 982953 983067 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "21"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 983156 983275 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "22"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 983392 983745 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "23"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 984247 984439 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "24"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 984616 984831 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "25"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 984946 985175 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "26"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 985283 985417 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "27"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 985613 985709 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "28"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 985807 985971 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "29"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 986106 986217 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "30"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 986633 986749 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "31"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 986833 987025 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "32"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 987108 987195 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "33"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 989133 989357 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "34"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 989828 989931 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "35"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 coding exon 990204 991492 . + . gene_id "XLOC_000019"; transcript_id "TCONS_00000034"; exon_number "36"; gene_name "AGRN"; oId "uc001ack.1"; nearest_ref "uc001ack.1"; class_code "="; tss_id "TSS16"; p_id "P15"; chr1 noncoding exon 995083 995162 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000035"; exon_number "1"; oId "uc009vjs.1"; nearest_ref "uc009vjs.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 995657 995773 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000035"; exon_number "2"; oId "uc009vjs.1"; nearest_ref "uc009vjs.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 995919 996088 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000035"; exon_number "3"; oId "uc009vjs.1"; nearest_ref "uc009vjs.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 996400 996497 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000035"; exon_number "4"; oId "uc009vjs.1"; nearest_ref "uc009vjs.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 997229 997436 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000035"; exon_number "5"; oId "uc009vjs.1"; nearest_ref "uc009vjs.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 995117 995226 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000036"; exon_number "1"; oId "uc001acl.1"; nearest_ref "uc001acl.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 995660 995773 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000036"; exon_number "2"; oId "uc001acl.1"; nearest_ref "uc001acl.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 998459 998581 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000036"; exon_number "3"; oId "uc001acl.1"; nearest_ref "uc001acl.1"; class_code "="; tss_id "TSS17"; chr1 noncoding exon 1001210 1001833 . + . gene_id "XLOC_000020"; transcript_id "TCONS_00000036"; exon_number "4"; oId "uc001acl.1"; nearest_ref "uc001acl.1"; class_code "="; tss_id "TSS17"; chr1 coding exon 1072397 1072490 . + . gene_id "XLOC_000021"; transcript_id "TCONS_00000037"; exon_number "1"; oId "uc001acv.2"; nearest_ref "uc001acv.2"; class_code "="; tss_id "TSS18"; p_id "P16"; chr1 coding exon 1076205 1076412 . + . gene_id "XLOC_000021"; transcript_id "TCONS_00000037"; exon_number "2"; oId "uc001acv.2"; nearest_ref "uc001acv.2"; class_code "="; tss_id "TSS18"; p_id "P16"; chr1 coding exon 1078119 1079432 . + . gene_id "XLOC_000021"; transcript_id "TCONS_00000037"; exon_number "3"; oId "uc001acv.2"; nearest_ref "uc001acv.2"; class_code "="; tss_id "TSS18"; p_id "P16"; chr1 noncoding exon 1102484 1102578 . + . gene_id "XLOC_000022"; transcript_id "TCONS_00000038"; exon_number "1"; oId "uc001acw.2"; nearest_ref "uc001acw.2"; class_code "="; chr1 noncoding exon 1103243 1103332 . + . gene_id "XLOC_000023"; transcript_id "TCONS_00000039"; exon_number "1"; oId "uc010nye.1"; nearest_ref "uc010nye.1"; class_code "="; chr1 noncoding exon 1104385 1104467 . + . gene_id "XLOC_000024"; transcript_id "TCONS_00000040"; exon_number "1"; oId "uc010nyf.1"; nearest_ref "uc010nyf.1"; class_code "="; chr1 coding exon 1109286 1109306 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "1"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1109646 1109701 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "2"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1109804 1109869 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "3"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1114569 1114713 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "4"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115037 1115117 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "5"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115414 1115720 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "6"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115863 1115981 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "7"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1116111 1116240 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "8"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1117121 1117195 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "9"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1117741 1117826 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "10"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1118256 1118427 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "11"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1119300 1119471 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "12"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1120349 1120489 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "13"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1131980 1132096 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "14"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1132473 1132566 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "15"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1132818 1133313 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000042"; exon_number "16"; gene_name "TTLL10"; oId "uc010nyg.1"; nearest_ref "uc010nyg.1"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1109286 1109306 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "1"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1109665 1109701 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "2"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1109804 1109869 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "3"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1114569 1114713 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "4"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115037 1115117 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "5"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115414 1115720 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "6"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115863 1115981 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "7"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1116111 1116240 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "8"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1117121 1117195 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "9"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1117741 1117826 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "10"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1118256 1118427 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "11"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1119300 1119471 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "12"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1120349 1120489 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "13"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1131980 1132096 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "14"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1132473 1132566 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "15"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1132818 1133313 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000041"; exon_number "16"; gene_name "TTLL10"; oId "uc001acy.2"; nearest_ref "uc001acy.2"; class_code "="; tss_id "TSS19"; p_id "P18"; chr1 coding exon 1115077 1115233 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "1"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1115414 1115720 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "2"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1115863 1115981 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "3"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1116111 1116240 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "4"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1117121 1117195 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "5"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1117741 1117826 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "6"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1118256 1118427 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "7"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1119300 1119471 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "8"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1120349 1121241 . + . gene_id "XLOC_000025"; transcript_id "TCONS_00000043"; exon_number "9"; gene_name "TTLL10"; oId "uc001acz.1"; nearest_ref "uc001acz.1"; class_code "="; tss_id "TSS20"; p_id "P17"; chr1 coding exon 1167629 1170418 . + . gene_id "XLOC_000026"; transcript_id "TCONS_00000044"; exon_number "1"; gene_name "B3GALT6"; oId "uc001adk.2"; nearest_ref "uc001adk.2"; class_code "="; p_id "P19"; chr1 coding exon 1215816 1216046 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "1"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1216606 1216677 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "2"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1216791 1216990 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "3"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1217622 1217695 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "4"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1219358 1219470 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "5"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1221306 1221658 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "6"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1222148 1222355 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "7"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1222489 1222679 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "8"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1222888 1222976 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "9"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1223053 1223216 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "10"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1223319 1223417 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "11"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1225651 1225768 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "12"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1225857 1225935 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "13"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1226017 1226074 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "14"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1226275 1226333 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "15"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1226445 1226520 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "16"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1226634 1227409 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000046"; exon_number "17"; gene_name "SCNN1D"; oId "uc001adu.1"; nearest_ref "uc001adu.1"; class_code "="; tss_id "TSS21"; p_id "P22"; chr1 coding exon 1215816 1216046 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "1"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1216606 1216677 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "2"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1216791 1216990 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "3"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1217622 1217695 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "4"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1219358 1219470 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "5"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1220951 1221044 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "6"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1221306 1221658 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "7"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1222148 1222355 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "8"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1222489 1222679 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "9"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1222888 1222976 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "10"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1223053 1223216 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "11"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1223319 1223417 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "12"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1225651 1225768 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "13"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1225857 1225935 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "14"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1226017 1226074 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "15"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1226275 1226333 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "16"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1226445 1226520 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "17"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1226634 1227409 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000045"; exon_number "18"; gene_name "SCNN1D"; oId "uc001adt.1"; nearest_ref "uc001adt.1"; class_code "="; tss_id "TSS21"; p_id "P21"; chr1 coding exon 1217489 1217695 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "1"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1219358 1219470 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "2"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1220951 1221044 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "3"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1221306 1221658 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "4"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1222148 1222355 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "5"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1222489 1222679 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "6"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1222888 1222976 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "7"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1223053 1223216 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "8"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1223319 1223417 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "9"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1225651 1225768 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "10"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1225857 1225935 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "11"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1226017 1226074 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "12"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1226275 1226333 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "13"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1226445 1226520 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "14"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1226634 1227409 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000048"; exon_number "15"; gene_name "SCNN1D"; oId "uc001adw.2"; nearest_ref "uc001adw.2"; class_code "="; tss_id "TSS22"; p_id "P23"; chr1 coding exon 1217489 1217695 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "1"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1219358 1219470 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "2"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1221306 1221658 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "3"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1222148 1222355 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "4"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1222489 1222679 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "5"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1222888 1222976 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "6"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1223053 1223216 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "7"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1223319 1223417 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "8"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1225651 1225768 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "9"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1225857 1225935 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "10"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1226017 1226074 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "11"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1226275 1226333 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "12"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1226445 1226520 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "13"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1226634 1227409 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000047"; exon_number "14"; gene_name "SCNN1D"; oId "uc001adv.2"; nearest_ref "uc001adv.2"; class_code "="; tss_id "TSS22"; p_id "P22"; chr1 coding exon 1217537 1217567 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "1"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1217656 1217695 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "2"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1219358 1219470 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "3"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1221306 1221658 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "4"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1222148 1222355 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "5"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1222489 1222679 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "6"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1222888 1223216 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "7"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1223319 1223417 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "8"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1225651 1225768 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "9"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1225857 1225935 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "10"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1226017 1226074 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "11"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1226275 1226333 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "12"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1226445 1226520 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "13"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1226634 1227409 . + . gene_id "XLOC_000027"; transcript_id "TCONS_00000049"; exon_number "14"; gene_name "SCNN1D"; oId "uc001adx.2"; nearest_ref "uc001adx.2"; class_code "="; tss_id "TSS22"; p_id "P20"; chr1 coding exon 1243994 1244100 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "1"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1244466 1244653 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "2"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1244834 1244983 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "3"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1245061 1245231 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "4"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1246014 1246068 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "5"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1246289 1246451 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "6"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1246710 1247056 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000051"; exon_number "7"; gene_name "PUSL1"; oId "uc010nyi.1"; nearest_ref "uc010nyi.1"; class_code "="; tss_id "TSS23"; p_id "P26"; chr1 coding exon 1243994 1244100 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "1"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1244295 1244352 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "2"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1244466 1244653 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "3"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1244834 1244983 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "4"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1245061 1245231 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "5"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1246014 1246068 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "6"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1246289 1246451 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "7"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1246710 1247056 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000050"; exon_number "8"; gene_name "PUSL1"; oId "uc001aed.2"; nearest_ref "uc001aed.2"; class_code "="; tss_id "TSS23"; p_id "P24"; chr1 coding exon 1244466 1244653 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000052"; exon_number "1"; gene_name "PUSL1"; oId "uc009vjx.2"; nearest_ref "uc009vjx.2"; class_code "="; tss_id "TSS24"; p_id "P25"; chr1 coding exon 1244834 1245194 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000052"; exon_number "2"; gene_name "PUSL1"; oId "uc009vjx.2"; nearest_ref "uc009vjx.2"; class_code "="; tss_id "TSS24"; p_id "P25"; chr1 coding exon 1245416 1246451 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000052"; exon_number "3"; gene_name "PUSL1"; oId "uc009vjx.2"; nearest_ref "uc009vjx.2"; class_code "="; tss_id "TSS24"; p_id "P25"; chr1 coding exon 1246710 1247056 . + . gene_id "XLOC_000028"; transcript_id "TCONS_00000052"; exon_number "4"; gene_name "PUSL1"; oId "uc009vjx.2"; nearest_ref "uc009vjx.2"; class_code "="; tss_id "TSS24"; p_id "P25"; chr1 coding exon 1260143 1260482 . + . gene_id "XLOC_000029"; transcript_id "TCONS_00000053"; exon_number "1"; gene_name "GLTPD1"; oId "uc001aeo.2"; nearest_ref "uc001aeo.2"; class_code "="; tss_id "TSS25"; p_id "P27"; chr1 coding exon 1262216 1262412 . + . gene_id "XLOC_000029"; transcript_id "TCONS_00000053"; exon_number "2"; gene_name "GLTPD1"; oId "uc001aeo.2"; nearest_ref "uc001aeo.2"; class_code "="; tss_id "TSS25"; p_id "P27"; chr1 coding exon 1262621 1264275 . + . gene_id "XLOC_000029"; transcript_id "TCONS_00000053"; exon_number "3"; gene_name "GLTPD1"; oId "uc001aeo.2"; nearest_ref "uc001aeo.2"; class_code "="; tss_id "TSS25"; p_id "P27"; chr1 coding exon 1266726 1266916 . + . gene_id "XLOC_000030"; transcript_id "TCONS_00000054"; exon_number "1"; gene_name "TAS1R3"; oId "uc010nyk.1"; nearest_ref "uc010nyk.1"; class_code "="; tss_id "TSS26"; p_id "P28"; chr1 coding exon 1267018 1267318 . + . gene_id "XLOC_000030"; transcript_id "TCONS_00000054"; exon_number "2"; gene_name "TAS1R3"; oId "uc010nyk.1"; nearest_ref "uc010nyk.1"; class_code "="; tss_id "TSS26"; p_id "P28"; chr1 coding exon 1267404 1268186 . + . gene_id "XLOC_000030"; transcript_id "TCONS_00000054"; exon_number "3"; gene_name "TAS1R3"; oId "uc010nyk.1"; nearest_ref "uc010nyk.1"; class_code "="; tss_id "TSS26"; p_id "P28"; chr1 coding exon 1268301 1268504 . + . gene_id "XLOC_000030"; transcript_id "TCONS_00000054"; exon_number "4"; gene_name "TAS1R3"; oId "uc010nyk.1"; nearest_ref "uc010nyk.1"; class_code "="; tss_id "TSS26"; p_id "P28"; chr1 coding exon 1268639 1268759 . + . gene_id "XLOC_000030"; transcript_id "TCONS_00000054"; exon_number "5"; gene_name "TAS1R3"; oId "uc010nyk.1"; nearest_ref "uc010nyk.1"; class_code "="; tss_id "TSS26"; p_id "P28"; chr1 coding exon 1268886 1269843 . + . gene_id "XLOC_000030"; transcript_id "TCONS_00000054"; exon_number "6"; gene_name "TAS1R3"; oId "uc010nyk.1"; nearest_ref "uc010nyk.1"; class_code "="; tss_id "TSS26"; p_id "P28"; chr1 coding exon 1334910 1335069 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000055"; exon_number "1"; oId "uc001afm.2"; nearest_ref "uc001afm.2"; class_code "="; tss_id "TSS27"; p_id "P29"; chr1 coding exon 1335538 1335683 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000055"; exon_number "2"; oId "uc001afm.2"; nearest_ref "uc001afm.2"; class_code "="; tss_id "TSS27"; p_id "P29"; chr1 coding exon 1335985 1337425 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000055"; exon_number "3"; oId "uc001afm.2"; nearest_ref "uc001afm.2"; class_code "="; tss_id "TSS27"; p_id "P29"; chr1 nearCoding exon 1334910 1335069 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000056"; exon_number "1"; oId "uc001afn.1"; nearest_ref "uc001afn.1"; class_code "="; tss_id "TSS27"; chr1 nearCoding exon 1335538 1335683 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000056"; exon_number "2"; oId "uc001afn.1"; nearest_ref "uc001afn.1"; class_code "="; tss_id "TSS27"; chr1 nearCoding exon 1335985 1336650 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000056"; exon_number "3"; oId "uc001afn.1"; nearest_ref "uc001afn.1"; class_code "="; tss_id "TSS27"; chr1 nearCoding exon 1337454 1338075 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000056"; exon_number "4"; oId "uc001afn.1"; nearest_ref "uc001afn.1"; class_code "="; tss_id "TSS27"; chr1 coding exon 1334912 1335065 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000057"; exon_number "1"; oId "uc009vkd.2"; nearest_ref "uc009vkc.1"; class_code "="; tss_id "TSS27"; p_id "P30"; chr1 coding exon 1335538 1335683 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000057"; exon_number "2"; oId "uc009vkd.2"; nearest_ref "uc009vkc.1"; class_code "="; tss_id "TSS27"; p_id "P30"; chr1 coding exon 1335985 1337425 . + . gene_id "XLOC_000031"; transcript_id "TCONS_00000057"; exon_number "3"; oId "uc009vkd.2"; nearest_ref "uc009vkc.1"; class_code "="; tss_id "TSS27"; p_id "P30"; chr1 coding exon 1361508 1361765 . + . gene_id "XLOC_000032"; transcript_id "TCONS_00000058"; exon_number "1"; oId "uc010nyp.1"; nearest_ref "uc010nyp.1"; class_code "="; tss_id "TSS28"; p_id "P31"; chr1 coding exon 1362934 1363166 . + . gene_id "XLOC_000032"; transcript_id "TCONS_00000058"; exon_number "2"; oId "uc010nyp.1"; nearest_ref "uc010nyp.1"; class_code "="; tss_id "TSS28"; p_id "P31"; chr1 coding exon 1370909 1371201 . + . gene_id "XLOC_000033"; transcript_id "TCONS_00000060"; exon_number "1"; gene_name "VWA1"; oId "uc001afs.2"; nearest_ref "uc001afs.2"; class_code "="; tss_id "TSS29"; p_id "P33"; chr1 coding exon 1372307 1372864 . + . gene_id "XLOC_000033"; transcript_id "TCONS_00000060"; exon_number "2"; gene_name "VWA1"; oId "uc001afs.2"; nearest_ref "uc001afs.2"; class_code "="; tss_id "TSS29"; p_id "P33"; chr1 coding exon 1374461 1376145 . + . gene_id "XLOC_000033"; transcript_id "TCONS_00000060"; exon_number "3"; gene_name "VWA1"; oId "uc001afs.2"; nearest_ref "uc001afs.2"; class_code "="; tss_id "TSS29"; p_id "P33"; chr1 coding exon 1370909 1371201 . + . gene_id "XLOC_000033"; transcript_id "TCONS_00000059"; exon_number "1"; gene_name "VWA1"; oId "uc001afr.2"; nearest_ref "uc001afr.2"; class_code "="; tss_id "TSS29"; p_id "P32"; chr1 coding exon 1372702 1372864 . + . gene_id "XLOC_000033"; transcript_id "TCONS_00000059"; exon_number "2"; gene_name "VWA1"; oId "uc001afr.2"; nearest_ref "uc001afr.2"; class_code "="; tss_id "TSS29"; p_id "P32"; chr1 coding exon 1374461 1376145 . + . gene_id "XLOC_000033"; transcript_id "TCONS_00000059"; exon_number "3"; gene_name "VWA1"; oId "uc001afr.2"; nearest_ref "uc001afr.2"; class_code "="; tss_id "TSS29"; p_id "P32"; chr1 coding exon 1385069 1386138 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "1"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1387426 1387502 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "2"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1387745 1387814 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "3"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1389725 1389880 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "4"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1390840 1390899 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "5"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1391171 1391296 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "6"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1391605 1391729 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "7"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1392509 1392560 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "8"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1394541 1394611 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "9"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1396130 1396297 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "10"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1397980 1398088 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "11"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1403764 1405538 . + . gene_id "XLOC_000034"; transcript_id "TCONS_00000061"; exon_number "12"; gene_name "ATAD3C"; oId "uc001aft.2"; nearest_ref "uc001aft.2"; class_code "="; tss_id "TSS30"; p_id "P34"; chr1 coding exon 1407164 1407469 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "1"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1412654 1412730 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "2"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1414024 1414125 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "3"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1414429 1414488 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "4"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1416247 1416316 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "5"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1417518 1417683 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "6"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1417925 1417994 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "7"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1420396 1420551 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "8"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1421162 1421218 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "9"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1421490 1421615 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "10"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1421924 1422048 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "11"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1423243 1423294 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "12"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1424584 1424654 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "13"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1425637 1425804 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "14"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1425943 1426051 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "15"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1430865 1431581 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000062"; exon_number "16"; gene_name "ATAD3B"; oId "uc001afv.2"; nearest_ref "uc001afv.2"; class_code "="; tss_id "TSS31"; p_id "P37"; chr1 coding exon 1413406 1414125 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000063"; exon_number "1"; gene_name "ATAD3B"; oId "uc001afw.2"; nearest_ref "uc001afw.2"; class_code "="; tss_id "TSS32"; p_id "P36"; chr1 coding exon 1414429 1414488 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000063"; exon_number "2"; gene_name "ATAD3B"; oId "uc001afw.2"; nearest_ref "uc001afw.2"; class_code "="; tss_id "TSS32"; p_id "P36"; chr1 coding exon 1416247 1416316 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000063"; exon_number "3"; gene_name "ATAD3B"; oId "uc001afw.2"; nearest_ref "uc001afw.2"; class_code "="; tss_id "TSS32"; p_id "P36"; chr1 coding exon 1417518 1417683 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000063"; exon_number "4"; gene_name "ATAD3B"; oId "uc001afw.2"; nearest_ref "uc001afw.2"; class_code "="; tss_id "TSS32"; p_id "P36"; chr1 coding exon 1417925 1418847 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000063"; exon_number "5"; gene_name "ATAD3B"; oId "uc001afw.2"; nearest_ref "uc001afw.2"; class_code "="; tss_id "TSS32"; p_id "P36"; chr1 coding exon 1413406 1414125 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "1"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1414429 1414488 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "2"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1416247 1416316 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "3"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1417518 1417683 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "4"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1417925 1417994 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "5"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1420396 1420551 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "6"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1421162 1421218 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "7"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1421490 1421615 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "8"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1421924 1422048 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "9"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1423243 1423294 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "10"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1424584 1424654 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "11"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1425637 1425804 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "12"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1425943 1426051 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "13"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1430865 1431581 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000064"; exon_number "14"; gene_name "ATAD3B"; oId "uc001afx.2"; nearest_ref "uc001afx.2"; class_code "="; tss_id "TSS32"; p_id "P38"; chr1 coding exon 1425461 1425804 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000065"; exon_number "1"; gene_name "ATAD3B"; oId "uc001afy.2"; nearest_ref "uc001afy.2"; class_code "="; tss_id "TSS33"; p_id "P35"; chr1 coding exon 1425943 1426051 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000065"; exon_number "2"; gene_name "ATAD3B"; oId "uc001afy.2"; nearest_ref "uc001afy.2"; class_code "="; tss_id "TSS33"; p_id "P35"; chr1 coding exon 1430865 1431581 . + . gene_id "XLOC_000035"; transcript_id "TCONS_00000065"; exon_number "3"; gene_name "ATAD3B"; oId "uc001afy.2"; nearest_ref "uc001afy.2"; class_code "="; tss_id "TSS33"; p_id "P35"; chr1 coding exon 1447555 1447853 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "1"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1451392 1451468 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "2"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1452691 1452792 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "3"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1453096 1453155 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "4"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1454301 1454370 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "5"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1455521 1455686 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "6"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1455928 1455997 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "7"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1458124 1458279 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "8"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1458891 1458947 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "9"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1459219 1459344 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "10"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1459653 1459777 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "11"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1460620 1460671 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "12"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1461841 1461911 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "13"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1463075 1463242 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "14"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1464603 1464711 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "15"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1469306 1470064 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000067"; exon_number "16"; gene_name "ATAD3A"; oId "uc001aga.1"; nearest_ref "uc001aga.1"; class_code "="; tss_id "TSS34"; p_id "P40"; chr1 coding exon 1447555 1447853 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "1"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1451392 1451468 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "2"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1452547 1452792 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "3"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1453096 1453155 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "4"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1454301 1454370 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "5"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1455521 1455686 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "6"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1455928 1455997 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "7"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1458124 1458279 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "8"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1458891 1458947 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "9"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1459219 1459344 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "10"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1459653 1459777 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "11"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1460620 1460671 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "12"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1461841 1461911 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "13"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1463075 1463242 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "14"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1464603 1464711 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "15"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1469306 1470064 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000066"; exon_number "16"; gene_name "ATAD3A"; oId "uc001afz.1"; nearest_ref "uc001afz.1"; class_code "="; tss_id "TSS34"; p_id "P41"; chr1 coding exon 1447910 1448070 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "1"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1451392 1451468 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "2"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1452691 1452792 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "3"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1453096 1453155 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "4"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1454301 1454370 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "5"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1455521 1455686 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "6"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1455928 1455997 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "7"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1458124 1458279 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "8"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1458891 1458947 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "9"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1459219 1459344 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "10"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1459653 1459777 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "11"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1460620 1460671 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "12"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1461841 1461911 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "13"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1463075 1463242 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "14"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1464603 1464711 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "15"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 coding exon 1469306 1470064 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000068"; exon_number "16"; gene_name "ATAD3A"; oId "uc001agb.1"; nearest_ref "uc001agb.1"; class_code "="; tss_id "TSS35"; p_id "P39"; chr1 nearCoding exon 1467449 1470064 . + . gene_id "XLOC_000036"; transcript_id "TCONS_00000069"; exon_number "1"; oId "uc001agc.1"; nearest_ref "uc001agc.1"; class_code "="; chr1 noncoding exon 1535819 1536086 . + . gene_id "XLOC_000037"; transcript_id "TCONS_00000070"; exon_number "1"; oId "uc001agf.1"; nearest_ref "uc001agf.1"; class_code "="; tss_id "TSS36"; chr1 noncoding exon 1542253 1542862 . + . gene_id "XLOC_000037"; transcript_id "TCONS_00000070"; exon_number "2"; oId "uc001agf.1"; nearest_ref "uc001agf.1"; class_code "="; tss_id "TSS36"; chr1 noncoding exon 1542997 1543166 . + . gene_id "XLOC_000037"; transcript_id "TCONS_00000070"; exon_number "3"; oId "uc001agf.1"; nearest_ref "uc001agf.1"; class_code "="; tss_id "TSS36"; chr1 coding exon 1550884 1551013 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "1"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "2"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1558769 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "3"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "4"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "5"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "6"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "7"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1560938 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "8"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "9"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "10"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "11"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "12"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "13"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "14"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "15"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "16"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "17"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "18"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "19"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000073"; exon_number "20"; gene_name "MIB2"; oId "uc001agi.2"; nearest_ref "uc001agi.2"; class_code "="; tss_id "TSS37"; p_id "P48"; chr1 coding exon 1550884 1551013 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "1"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "2"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1558769 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "3"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "4"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "5"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "6"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "7"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "8"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "9"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "10"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "11"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "12"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "13"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "14"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "15"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "16"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "17"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "18"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000075"; exon_number "19"; gene_name "MIB2"; oId "uc001agk.2"; nearest_ref "uc001agk.2"; class_code "="; tss_id "TSS37"; p_id "P47"; chr1 coding exon 1550884 1551013 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "1"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "2"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1558769 1558862 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "3"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "4"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "5"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "6"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "7"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "8"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "9"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "10"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "11"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "12"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "13"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "14"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "15"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "16"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "17"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "18"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "19"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000074"; exon_number "20"; gene_name "MIB2"; oId "uc001agj.2"; nearest_ref "uc001agj.2"; class_code "="; tss_id "TSS37"; p_id "P51"; chr1 coding exon 1550884 1551013 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "1"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "2"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1558811 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "3"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "4"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "5"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "6"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "7"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "8"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "9"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "10"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "11"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "12"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "13"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "14"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "15"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "16"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "17"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "18"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "19"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000072"; exon_number "20"; gene_name "MIB2"; oId "uc001agh.2"; nearest_ref "uc001agh.2"; class_code "="; tss_id "TSS37"; p_id "P52"; chr1 coding exon 1550884 1551013 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "1"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "2"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1558769 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "3"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "4"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "5"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "6"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "7"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "8"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "9"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "10"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "11"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "12"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "13"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "14"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "15"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "16"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "17"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "18"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "19"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000071"; exon_number "20"; gene_name "MIB2"; oId "uc001agg.2"; nearest_ref "uc001agg.2"; class_code "="; tss_id "TSS37"; p_id "P46"; chr1 coding exon 1551285 1551480 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "1"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "2"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1558769 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "3"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "4"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "5"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "6"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "7"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "8"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "9"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "10"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "11"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "12"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "13"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "14"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "15"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "16"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "17"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000076"; exon_number "18"; gene_name "MIB2"; oId "uc001agl.1"; nearest_ref "uc001agl.1"; class_code "="; tss_id "TSS38"; p_id "P45"; chr1 coding exon 1551285 1551480 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "1"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1551888 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "2"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1558811 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "3"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "4"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "5"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "6"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "7"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "8"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "9"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "10"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "11"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "12"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "13"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "14"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "15"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "16"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "17"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000077"; exon_number "18"; oId "uc001agm.2"; nearest_ref "uc001agm.2"; class_code "="; tss_id "TSS38"; p_id "P43"; chr1 coding exon 1551690 1551994 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "1"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1558769 1559079 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "2"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "3"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "4"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "5"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "6"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "7"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "8"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "9"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "10"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "11"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "12"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "13"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "14"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "15"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "16"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "17"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "18"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000078"; exon_number "19"; gene_name "MIB2"; oId "uc010nyq.1"; nearest_ref "uc010nyq.1"; class_code "="; tss_id "TSS39"; p_id "P44"; chr1 coding exon 1559154 1559325 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "1"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1560175 1560281 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "2"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "3"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "4"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1560926 1561033 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "5"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "6"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "7"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "8"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "9"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "10"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "11"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "12"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "13"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "14"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "15"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000079"; exon_number "16"; gene_name "MIB2"; oId "uc009vkh.2"; nearest_ref "uc009vkh.2"; class_code "="; tss_id "TSS40"; p_id "P50"; chr1 coding exon 1560371 1560565 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "1"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1560666 1560808 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "2"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1562030 1562134 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "3"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1562217 1562379 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "4"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1562454 1562587 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "5"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1562676 1562824 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "6"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1563053 1563209 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "7"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1563399 1563559 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "8"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1563653 1563779 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "9"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1563869 1564102 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "10"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1564513 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "11"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1564765 1564946 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "12"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "13"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000080"; exon_number "14"; gene_name "MIB2"; oId "uc001agn.2"; nearest_ref "uc001agn.2"; class_code "="; tss_id "TSS41"; p_id "P49"; chr1 coding exon 1564486 1564691 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000081"; exon_number "1"; oId "uc001ago.2"; nearest_ref "uc001ago.2"; class_code "="; tss_id "TSS42"; p_id "P42"; chr1 coding exon 1565019 1565084 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000081"; exon_number "2"; oId "uc001ago.2"; nearest_ref "uc001ago.2"; class_code "="; tss_id "TSS42"; p_id "P42"; chr1 coding exon 1565672 1565984 . + . gene_id "XLOC_000038"; transcript_id "TCONS_00000081"; exon_number "3"; oId "uc001ago.2"; nearest_ref "uc001ago.2"; class_code "="; tss_id "TSS42"; p_id "P42"; chr1 coding exon 1567560 1567753 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "1"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1568162 1568292 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "2"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1568360 1568734 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "3"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1569127 1569291 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "4"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1569368 1569478 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "5"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1569581 1569707 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "6"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1569827 1570029 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000083"; exon_number "7"; oId "uc001agq.2"; nearest_ref "uc001agq.2"; class_code "="; tss_id "TSS43"; p_id "P56"; chr1 coding exon 1567560 1567753 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "1"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1568162 1568292 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "2"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1568360 1568499 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "3"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1568567 1568734 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "4"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1569127 1569291 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "5"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1569368 1569478 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "6"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1569581 1569707 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "7"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1569827 1570029 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000082"; exon_number "8"; gene_name "MMP23B"; oId "uc001agp.2"; nearest_ref "uc001agp.2"; class_code "="; tss_id "TSS43"; p_id "P53"; chr1 coding exon 1568162 1568292 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000084"; exon_number "1"; oId "uc001agr.2"; nearest_ref "uc001agr.2"; class_code "="; tss_id "TSS44"; p_id "P55"; chr1 coding exon 1568567 1568734 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000084"; exon_number "2"; oId "uc001agr.2"; nearest_ref "uc001agr.2"; class_code "="; tss_id "TSS44"; p_id "P55"; chr1 coding exon 1569127 1569291 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000084"; exon_number "3"; oId "uc001agr.2"; nearest_ref "uc001agr.2"; class_code "="; tss_id "TSS44"; p_id "P55"; chr1 coding exon 1569368 1569478 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000084"; exon_number "4"; oId "uc001agr.2"; nearest_ref "uc001agr.2"; class_code "="; tss_id "TSS44"; p_id "P55"; chr1 coding exon 1569581 1569707 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000084"; exon_number "5"; oId "uc001agr.2"; nearest_ref "uc001agr.2"; class_code "="; tss_id "TSS44"; p_id "P55"; chr1 coding exon 1569827 1570029 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000084"; exon_number "6"; oId "uc001agr.2"; nearest_ref "uc001agr.2"; class_code "="; tss_id "TSS44"; p_id "P55"; chr1 coding exon 1568567 1568734 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000085"; exon_number "1"; oId "uc009vki.2"; nearest_ref "uc009vki.2"; class_code "="; tss_id "TSS45"; p_id "P54"; chr1 coding exon 1569127 1569478 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000085"; exon_number "2"; oId "uc009vki.2"; nearest_ref "uc009vki.2"; class_code "="; tss_id "TSS45"; p_id "P54"; chr1 coding exon 1569581 1569707 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000085"; exon_number "3"; oId "uc009vki.2"; nearest_ref "uc009vki.2"; class_code "="; tss_id "TSS45"; p_id "P54"; chr1 coding exon 1569827 1570029 . + . gene_id "XLOC_000039"; transcript_id "TCONS_00000085"; exon_number "4"; oId "uc009vki.2"; nearest_ref "uc009vki.2"; class_code "="; tss_id "TSS45"; p_id "P54"; chr1 coding exon 1631378 1631511 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000086"; exon_number "1"; oId "uc001ahi.1"; nearest_ref "uc001ahi.1"; class_code "="; tss_id "TSS46"; p_id "P58"; chr1 coding exon 1631786 1631953 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000086"; exon_number "2"; oId "uc001ahi.1"; nearest_ref "uc001ahi.1"; class_code "="; tss_id "TSS46"; p_id "P58"; chr1 coding exon 1632346 1632510 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000086"; exon_number "3"; oId "uc001ahi.1"; nearest_ref "uc001ahi.1"; class_code "="; tss_id "TSS46"; p_id "P58"; chr1 coding exon 1632587 1632697 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000086"; exon_number "4"; oId "uc001ahi.1"; nearest_ref "uc001ahi.1"; class_code "="; tss_id "TSS46"; p_id "P58"; chr1 coding exon 1632800 1632926 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000086"; exon_number "5"; oId "uc001ahi.1"; nearest_ref "uc001ahi.1"; class_code "="; tss_id "TSS46"; p_id "P58"; chr1 coding exon 1633047 1633247 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000086"; exon_number "6"; oId "uc001ahi.1"; nearest_ref "uc001ahi.1"; class_code "="; tss_id "TSS46"; p_id "P58"; chr1 coding exon 1631786 1631953 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000087"; exon_number "1"; oId "uc009vko.1"; nearest_ref "uc009vko.1"; class_code "="; tss_id "TSS47"; p_id "P57"; chr1 coding exon 1632346 1632697 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000087"; exon_number "2"; oId "uc009vko.1"; nearest_ref "uc009vko.1"; class_code "="; tss_id "TSS47"; p_id "P57"; chr1 coding exon 1632800 1632926 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000087"; exon_number "3"; oId "uc009vko.1"; nearest_ref "uc009vko.1"; class_code "="; tss_id "TSS47"; p_id "P57"; chr1 coding exon 1633047 1633247 . + . gene_id "XLOC_000040"; transcript_id "TCONS_00000087"; exon_number "4"; oId "uc009vko.1"; nearest_ref "uc009vko.1"; class_code "="; tss_id "TSS47"; p_id "P57"; chr1 noncoding exon 1656054 1656202 . + . gene_id "XLOC_000041"; transcript_id "TCONS_00000088"; exon_number "1"; oId "uc001ahx.1"; nearest_ref "uc001ahx.1"; class_code "="; tss_id "TSS48"; chr1 noncoding exon 1661685 1663343 . + . gene_id "XLOC_000041"; transcript_id "TCONS_00000088"; exon_number "2"; oId "uc001ahx.1"; nearest_ref "uc001ahx.1"; class_code "="; tss_id "TSS48"; chr1 coding exon 1822910 1823290 . + . gene_id "XLOC_000042"; transcript_id "TCONS_00000089"; exon_number "1"; oId "uc001aig.1"; nearest_ref "uc001aig.1"; class_code "="; tss_id "TSS49"; p_id "P59"; chr1 coding exon 1823573 1824112 . + . gene_id "XLOC_000042"; transcript_id "TCONS_00000089"; exon_number "2"; oId "uc001aig.1"; nearest_ref "uc001aig.1"; class_code "="; tss_id "TSS49"; p_id "P59"; chr1 coding exon 1846266 1846746 . + . gene_id "XLOC_000043"; transcript_id "TCONS_00000090"; exon_number "1"; gene_name "CALML6"; oId "uc001aih.1"; nearest_ref "uc001aih.1"; class_code "="; tss_id "TSS50"; p_id "P60"; chr1 coding exon 1847124 1847174 . + . gene_id "XLOC_000043"; transcript_id "TCONS_00000090"; exon_number "2"; gene_name "CALML6"; oId "uc001aih.1"; nearest_ref "uc001aih.1"; class_code "="; tss_id "TSS50"; p_id "P60"; chr1 coding exon 1847880 1848054 . + . gene_id "XLOC_000043"; transcript_id "TCONS_00000090"; exon_number "3"; gene_name "CALML6"; oId "uc001aih.1"; nearest_ref "uc001aih.1"; class_code "="; tss_id "TSS50"; p_id "P60"; chr1 coding exon 1848191 1848335 . + . gene_id "XLOC_000043"; transcript_id "TCONS_00000090"; exon_number "4"; gene_name "CALML6"; oId "uc001aih.1"; nearest_ref "uc001aih.1"; class_code "="; tss_id "TSS50"; p_id "P60"; chr1 coding exon 1848413 1848513 . + . gene_id "XLOC_000043"; transcript_id "TCONS_00000090"; exon_number "5"; gene_name "CALML6"; oId "uc001aih.1"; nearest_ref "uc001aih.1"; class_code "="; tss_id "TSS50"; p_id "P60"; chr1 coding exon 1848586 1848733 . + . gene_id "XLOC_000043"; transcript_id "TCONS_00000090"; exon_number "6"; gene_name "CALML6"; oId "uc001aih.1"; nearest_ref "uc001aih.1"; class_code "="; tss_id "TSS50"; p_id "P60"; chr1 coding exon 1950768 1950930 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "1"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1956381 1956493 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "2"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1956773 1956840 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "3"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1956957 1957177 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "4"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1959016 1959098 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "5"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1959594 1959731 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "6"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1960550 1960705 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "7"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1960990 1961201 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "8"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1961422 1962192 . + . gene_id "XLOC_000044"; transcript_id "TCONS_00000091"; exon_number "9"; gene_name "GABRD"; oId "uc001aip.2"; nearest_ref "uc001aip.2"; class_code "="; tss_id "TSS51"; p_id "P61"; chr1 coding exon 1981909 1982140 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "1"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 1986880 1987001 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "2"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 1987923 1988012 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "3"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 1990980 1991030 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "4"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2066701 2066786 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "5"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2075649 2075780 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "6"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "7"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "8"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "9"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2087434 2087531 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "10"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2100957 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "11"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "12"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "13"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "14"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "15"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "16"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "17"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000092"; exon_number "18"; gene_name "PRKCZ"; oId "uc001aiq.2"; nearest_ref "uc001aiq.2"; class_code "="; tss_id "TSS52"; p_id "P67"; chr1 coding exon 2005086 2005368 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "1"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2066701 2066786 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "2"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2075649 2075780 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "3"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "4"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "5"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "6"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2087434 2087531 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "7"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2100957 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "8"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "9"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "10"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "11"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "12"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "13"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "14"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000093"; exon_number "15"; gene_name "PRKCZ"; oId "uc001air.2"; nearest_ref "uc001air.2"; class_code "="; tss_id "TSS53"; p_id "P66"; chr1 coding exon 2005512 2005714 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "1"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2066701 2066786 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "2"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2075649 2075780 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "3"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "4"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "5"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "6"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2087434 2087531 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "7"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2100957 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "8"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "9"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "10"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "11"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "12"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "13"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "14"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000094"; exon_number "15"; gene_name "PRKCZ"; oId "uc010nyw.1"; nearest_ref "uc010nyw.1"; class_code "="; tss_id "TSS54"; p_id "P62"; chr1 coding exon 2036155 2036334 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "1"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2066701 2066786 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "2"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2075649 2075780 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "3"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "4"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "5"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "6"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2087434 2087531 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "7"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2100957 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "8"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "9"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "10"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "11"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "12"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "13"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "14"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000095"; exon_number "15"; gene_name "PRKCZ"; oId "uc001ais.2"; nearest_ref "uc001ais.2"; class_code "="; tss_id "TSS55"; p_id "P66"; chr1 coding exon 2075890 2076023 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "1"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "2"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "3"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "4"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2087434 2087531 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "5"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2100957 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "6"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "7"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "8"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "9"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "10"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "11"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "12"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000096"; exon_number "13"; gene_name "PRKCZ"; oId "uc009vla.2"; nearest_ref "uc009vla.2"; class_code "="; tss_id "TSS56"; p_id "P65"; chr1 coding exon 2076796 2076950 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000097"; exon_number "1"; gene_name "PRKCZ"; oId "uc009vlb.2"; nearest_ref "uc009vlb.2"; class_code "="; tss_id "TSS57"; p_id "P64"; chr1 coding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000097"; exon_number "2"; gene_name "PRKCZ"; oId "uc009vlb.2"; nearest_ref "uc009vlb.2"; class_code "="; tss_id "TSS57"; p_id "P64"; chr1 coding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000097"; exon_number "3"; gene_name "PRKCZ"; oId "uc009vlb.2"; nearest_ref "uc009vlb.2"; class_code "="; tss_id "TSS57"; p_id "P64"; chr1 coding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000097"; exon_number "4"; gene_name "PRKCZ"; oId "uc009vlb.2"; nearest_ref "uc009vlb.2"; class_code "="; tss_id "TSS57"; p_id "P64"; chr1 coding exon 2087434 2088166 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000097"; exon_number "5"; gene_name "PRKCZ"; oId "uc009vlb.2"; nearest_ref "uc009vlb.2"; class_code "="; tss_id "TSS57"; p_id "P64"; chr1 nearCoding exon 2076796 2076950 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "1"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2077466 2077547 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "2"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2080311 2080363 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "3"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2082229 2082417 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "4"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2087434 2087531 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "5"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2100957 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "6"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "7"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "8"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "9"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "10"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "11"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2113271 2113353 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "12"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "13"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 nearCoding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000098"; exon_number "14"; gene_name "PRKCZ"; oId "uc010nyx.1"; nearest_ref "uc010nyx.1"; class_code "="; tss_id "TSS57"; chr1 coding exon 2100287 2101043 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "1"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2103494 2103629 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "2"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2103740 2103827 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "3"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2105336 2105455 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "4"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2106193 2106272 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "5"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2106663 2106752 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "6"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2116022 2116137 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "7"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 coding exon 2116361 2116832 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000099"; exon_number "8"; gene_name "PRKCZ"; oId "uc001ait.2"; nearest_ref "uc001ait.2"; class_code "="; tss_id "TSS58"; p_id "P63"; chr1 antisense exon 2112575 2114663 . + . gene_id "XLOC_000045"; transcript_id "TCONS_00000100"; exon_number "1"; oId "uc001aiu.1"; nearest_ref "uc001aiu.1"; class_code "="; chr1 coding exon 2121237 2123179 . + . gene_id "XLOC_000046"; transcript_id "TCONS_00000101"; exon_number "1"; oId "uc001aiz.1"; nearest_ref "uc001aiz.1"; class_code "="; p_id "P68"; chr1 coding exon 2160134 2161174 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "1"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2234417 2234542 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "2"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2234724 2234839 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "3"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2235279 2235541 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "4"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2235732 2236024 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "5"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2237459 2237689 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "6"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2238016 2241651 . + . gene_id "XLOC_000047"; transcript_id "TCONS_00000102"; exon_number "7"; gene_name "SKI"; oId "uc001aja.3"; nearest_ref "uc001aja.3"; class_code "="; tss_id "TSS59"; p_id "P69"; chr1 coding exon 2323214 2323397 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "1"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2327223 2327310 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "2"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2328555 2328659 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "3"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2330854 2330953 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "4"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2332296 2332374 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "5"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2333536 2333781 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "6"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2334474 2336874 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000104"; exon_number "7"; gene_name "RER1"; oId "uc001ajf.1"; nearest_ref "uc001ajf.1"; class_code "="; tss_id "TSS60"; p_id "P70"; chr1 coding exon 2323214 2323397 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "1"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2327223 2327310 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "2"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2328555 2328659 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "3"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2330854 2330953 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "4"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2332296 2332374 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "5"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2333646 2333781 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "6"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2334474 2336874 . + . gene_id "XLOC_000048"; transcript_id "TCONS_00000103"; exon_number "7"; gene_name "RER1"; oId "uc001aje.1"; nearest_ref "uc001aje.1"; class_code "="; tss_id "TSS60"; p_id "P71"; chr1 coding exon 2407754 2408151 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "1"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2409915 2410061 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "2"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2411173 2411414 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "3"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2411623 2411751 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "4"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2415887 2416057 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "5"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2418346 2418439 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "6"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2418612 2418815 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "7"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2419037 2419157 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "8"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2420646 2420817 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "9"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2421199 2421306 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "10"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2422631 2422774 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "11"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2426295 2426387 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "12"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2426927 2427009 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "13"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2428046 2428143 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "14"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2428267 2428449 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "15"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2428941 2429048 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "16"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2429962 2430086 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "17"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2430183 2430267 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "18"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2430523 2430669 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "19"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2431080 2431159 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "20"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2433551 2433848 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "21"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2435361 2436964 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000105"; exon_number "22"; gene_name "PLCH2"; oId "uc001aji.1"; nearest_ref "uc001aji.1"; class_code "="; tss_id "TSS61"; p_id "P74"; chr1 coding exon 2411623 2411751 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "1"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2415887 2416057 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "2"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2418346 2418439 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "3"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2418612 2418815 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "4"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2419037 2419157 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "5"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2420646 2420817 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "6"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2421199 2421306 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "7"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2422631 2422774 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "8"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2426295 2426387 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "9"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2426927 2427009 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "10"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2428046 2428143 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "11"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2428267 2428449 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "12"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2428941 2429048 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "13"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2429962 2430086 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "14"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2430183 2430267 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "15"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2430523 2430669 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "16"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2431080 2431159 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "17"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2433551 2433848 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "18"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2435384 2436891 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000106"; exon_number "19"; gene_name "PLCH2"; oId "uc010nyz.1"; nearest_ref "uc010nyz.1"; class_code "="; tss_id "TSS62"; p_id "P72"; chr1 coding exon 2411623 2411751 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "1"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2415887 2416057 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "2"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2418346 2418439 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "3"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2418612 2418815 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "4"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2419037 2419157 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "5"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2420646 2420817 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "6"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2421199 2421306 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "7"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2422631 2422774 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "8"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2426295 2426387 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "9"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2426927 2427009 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "10"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2428046 2428143 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "11"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2428267 2428449 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "12"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2429962 2430086 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "13"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2430183 2430267 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "14"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2430523 2430669 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "15"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2431080 2431159 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "16"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2433551 2433848 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "17"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2435361 2436964 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000107"; exon_number "18"; gene_name "PLCH2"; oId "uc009vle.1"; nearest_ref "uc009vle.1"; class_code "="; tss_id "TSS62"; p_id "P73"; chr1 coding exon 2411623 2411751 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "1"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2415887 2416057 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "2"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2418346 2418439 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "3"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2418612 2418815 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "4"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2419037 2419157 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "5"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2420646 2420817 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "6"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2421199 2421306 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "7"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2422631 2422774 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "8"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2426295 2426387 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "9"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2426927 2427009 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "10"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2428046 2428143 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "11"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2428267 2428449 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "12"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2428941 2429048 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "13"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2429962 2430086 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "14"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2430183 2430267 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "15"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2430523 2430669 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "16"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2431080 2431159 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "17"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2433551 2434349 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "18"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2435056 2436965 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000108"; exon_number "19"; gene_name "PLCH2"; oId "uc001ajj.1"; nearest_ref "uc001ajj.1"; class_code "="; tss_id "TSS62"; p_id "P77"; chr1 coding exon 2411623 2411751 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "1"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2415887 2416057 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "2"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2418346 2418439 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "3"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2418612 2418815 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "4"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2419037 2419157 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "5"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2420646 2420817 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "6"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2421199 2421306 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "7"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2422631 2422774 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "8"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2426295 2426387 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "9"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2426927 2427009 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "10"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2428046 2428143 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "11"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2428267 2428449 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "12"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2428941 2429048 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "13"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2429962 2430086 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "14"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2430183 2430267 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "15"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2430523 2430669 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "16"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2431080 2431159 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "17"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2433551 2436969 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000109"; exon_number "18"; gene_name "PLCH2"; oId "uc001ajk.1"; nearest_ref "uc001ajk.1"; class_code "="; tss_id "TSS62"; p_id "P76"; chr1 coding exon 2430183 2430267 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000110"; exon_number "1"; gene_name "PLCH2"; oId "uc001ajl.1"; nearest_ref "uc001ajl.1"; class_code "="; tss_id "TSS63"; p_id "P75"; chr1 coding exon 2430523 2430669 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000110"; exon_number "2"; gene_name "PLCH2"; oId "uc001ajl.1"; nearest_ref "uc001ajl.1"; class_code "="; tss_id "TSS63"; p_id "P75"; chr1 coding exon 2431080 2431159 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000110"; exon_number "3"; gene_name "PLCH2"; oId "uc001ajl.1"; nearest_ref "uc001ajl.1"; class_code "="; tss_id "TSS63"; p_id "P75"; chr1 coding exon 2433551 2433848 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000110"; exon_number "4"; gene_name "PLCH2"; oId "uc001ajl.1"; nearest_ref "uc001ajl.1"; class_code "="; tss_id "TSS63"; p_id "P75"; chr1 coding exon 2435056 2435082 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000110"; exon_number "5"; gene_name "PLCH2"; oId "uc001ajl.1"; nearest_ref "uc001ajl.1"; class_code "="; tss_id "TSS63"; p_id "P75"; chr1 coding exon 2435361 2436964 . + . gene_id "XLOC_000049"; transcript_id "TCONS_00000110"; exon_number "6"; gene_name "PLCH2"; oId "uc001ajl.1"; nearest_ref "uc001ajl.1"; class_code "="; tss_id "TSS63"; p_id "P75"; chr1 coding exon 2487805 2488172 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000111"; exon_number "1"; gene_name "TNFRSF14"; oId "uc010nzc.1"; nearest_ref "uc010nzc.1"; class_code "="; tss_id "TSS64"; p_id "P81"; chr1 coding exon 2489165 2489273 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000111"; exon_number "2"; gene_name "TNFRSF14"; oId "uc010nzc.1"; nearest_ref "uc010nzc.1"; class_code "="; tss_id "TSS64"; p_id "P81"; chr1 coding exon 2489782 2489907 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000111"; exon_number "3"; gene_name "TNFRSF14"; oId "uc010nzc.1"; nearest_ref "uc010nzc.1"; class_code "="; tss_id "TSS64"; p_id "P81"; chr1 coding exon 2490320 2490438 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000111"; exon_number "4"; gene_name "TNFRSF14"; oId "uc010nzc.1"; nearest_ref "uc010nzc.1"; class_code "="; tss_id "TSS64"; p_id "P81"; chr1 coding exon 2487805 2488172 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000112"; exon_number "1"; gene_name "TNFRSF14"; oId "uc009vlf.1"; nearest_ref "uc009vlf.1"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2489165 2489273 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000112"; exon_number "2"; gene_name "TNFRSF14"; oId "uc009vlf.1"; nearest_ref "uc009vlf.1"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2489782 2489907 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000112"; exon_number "3"; gene_name "TNFRSF14"; oId "uc009vlf.1"; nearest_ref "uc009vlf.1"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2491262 2491417 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000112"; exon_number "4"; gene_name "TNFRSF14"; oId "uc009vlf.1"; nearest_ref "uc009vlf.1"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2492063 2492974 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000112"; exon_number "5"; gene_name "TNFRSF14"; oId "uc009vlf.1"; nearest_ref "uc009vlf.1"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2487805 2488172 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000113"; exon_number "1"; gene_name "TNFRSF14"; oId "uc001ajt.1"; nearest_ref "uc001ajt.1"; class_code "="; tss_id "TSS64"; p_id "P78"; chr1 coding exon 2489165 2489273 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000113"; exon_number "2"; gene_name "TNFRSF14"; oId "uc001ajt.1"; nearest_ref "uc001ajt.1"; class_code "="; tss_id "TSS64"; p_id "P78"; chr1 coding exon 2489782 2491417 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000113"; exon_number "3"; gene_name "TNFRSF14"; oId "uc001ajt.1"; nearest_ref "uc001ajt.1"; class_code "="; tss_id "TSS64"; p_id "P78"; chr1 coding exon 2492063 2492153 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000113"; exon_number "4"; gene_name "TNFRSF14"; oId "uc001ajt.1"; nearest_ref "uc001ajt.1"; class_code "="; tss_id "TSS64"; p_id "P78"; chr1 coding exon 2492933 2495188 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000113"; exon_number "5"; gene_name "TNFRSF14"; oId "uc001ajt.1"; nearest_ref "uc001ajt.1"; class_code "="; tss_id "TSS64"; p_id "P78"; chr1 coding exon 2487805 2488172 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "1"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2489165 2489273 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "2"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2489782 2489907 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "3"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2491262 2491417 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "4"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2492063 2492153 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "5"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2494304 2494335 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "6"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2494587 2495265 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000115"; exon_number "7"; gene_name "TNFRSF14"; oId "uc001ajs.2"; nearest_ref "uc001ajs.2"; class_code "="; tss_id "TSS64"; p_id "P79"; chr1 coding exon 2487805 2488172 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "1"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2489165 2489273 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "2"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2489782 2489907 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "3"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2491262 2491417 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "4"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2492063 2492153 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "5"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2493112 2493254 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "6"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2494304 2494335 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "7"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2494587 2495265 . + . gene_id "XLOC_000050"; transcript_id "TCONS_00000114"; exon_number "8"; gene_name "TNFRSF14"; oId "uc001ajr.2"; nearest_ref "uc001ajr.2"; class_code "="; tss_id "TSS64"; p_id "P80"; chr1 coding exon 2518249 2518387 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "1"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2518530 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "2"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "3"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2519829 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "4"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2519989 2520064 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "5"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2520393 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "6"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000118"; exon_number "7"; gene_name "C1orf93"; oId "uc001ajw.1"; nearest_ref "uc001ajw.1"; class_code "="; tss_id "TSS65"; p_id "P86"; chr1 coding exon 2518249 2518387 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000120"; exon_number "1"; gene_name "C1orf93"; oId "uc010nze.1"; nearest_ref "uc010nze.1"; class_code "="; tss_id "TSS65"; p_id "P85"; chr1 coding exon 2518530 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000120"; exon_number "2"; gene_name "C1orf93"; oId "uc010nze.1"; nearest_ref "uc010nze.1"; class_code "="; tss_id "TSS65"; p_id "P85"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000120"; exon_number "3"; gene_name "C1orf93"; oId "uc010nze.1"; nearest_ref "uc010nze.1"; class_code "="; tss_id "TSS65"; p_id "P85"; chr1 coding exon 2519829 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000120"; exon_number "4"; gene_name "C1orf93"; oId "uc010nze.1"; nearest_ref "uc010nze.1"; class_code "="; tss_id "TSS65"; p_id "P85"; chr1 coding exon 2520393 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000120"; exon_number "5"; gene_name "C1orf93"; oId "uc010nze.1"; nearest_ref "uc010nze.1"; class_code "="; tss_id "TSS65"; p_id "P85"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000120"; exon_number "6"; gene_name "C1orf93"; oId "uc010nze.1"; nearest_ref "uc010nze.1"; class_code "="; tss_id "TSS65"; p_id "P85"; chr1 coding exon 2518249 2518387 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000121"; exon_number "1"; gene_name "C1orf93"; oId "uc010nzf.1"; nearest_ref "uc010nzf.1"; class_code "="; tss_id "TSS65"; p_id "P84"; chr1 coding exon 2518530 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000121"; exon_number "2"; gene_name "C1orf93"; oId "uc010nzf.1"; nearest_ref "uc010nzf.1"; class_code "="; tss_id "TSS65"; p_id "P84"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000121"; exon_number "3"; gene_name "C1orf93"; oId "uc010nzf.1"; nearest_ref "uc010nzf.1"; class_code "="; tss_id "TSS65"; p_id "P84"; chr1 coding exon 2519829 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000121"; exon_number "4"; gene_name "C1orf93"; oId "uc010nzf.1"; nearest_ref "uc010nzf.1"; class_code "="; tss_id "TSS65"; p_id "P84"; chr1 coding exon 2520396 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000121"; exon_number "5"; gene_name "C1orf93"; oId "uc010nzf.1"; nearest_ref "uc010nzf.1"; class_code "="; tss_id "TSS65"; p_id "P84"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000121"; exon_number "6"; gene_name "C1orf93"; oId "uc010nzf.1"; nearest_ref "uc010nzf.1"; class_code "="; tss_id "TSS65"; p_id "P84"; chr1 coding exon 2518249 2518387 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "1"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2518530 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "2"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "3"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2519829 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "4"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2519969 2520064 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "5"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2520393 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "6"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000119"; exon_number "7"; gene_name "C1orf93"; oId "uc010nzd.1"; nearest_ref "uc010nzd.1"; class_code "="; tss_id "TSS65"; p_id "P88"; chr1 coding exon 2518249 2518387 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "1"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2518530 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "2"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "3"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2519775 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "4"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2519989 2520064 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "5"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2520361 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "6"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000117"; exon_number "7"; gene_name "C1orf93"; oId "uc001ajv.1"; nearest_ref "uc001ajv.1"; class_code "="; tss_id "TSS65"; p_id "P87"; chr1 coding exon 2518249 2518387 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "1"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2518530 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "2"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "3"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2519829 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "4"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2519989 2520064 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "5"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2520361 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "6"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000116"; exon_number "7"; gene_name "C1orf93"; oId "uc001aju.1"; nearest_ref "uc001aju.1"; class_code "="; tss_id "TSS65"; p_id "P82"; chr1 coding exon 2518517 2518734 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000122"; exon_number "1"; gene_name "C1orf93"; oId "uc001ajx.1"; nearest_ref "uc001ajx.1"; class_code "="; tss_id "TSS66"; p_id "P83"; chr1 coding exon 2519180 2519231 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000122"; exon_number "2"; gene_name "C1orf93"; oId "uc001ajx.1"; nearest_ref "uc001ajx.1"; class_code "="; tss_id "TSS66"; p_id "P83"; chr1 coding exon 2519829 2519892 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000122"; exon_number "3"; gene_name "C1orf93"; oId "uc001ajx.1"; nearest_ref "uc001ajx.1"; class_code "="; tss_id "TSS66"; p_id "P83"; chr1 coding exon 2519969 2520064 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000122"; exon_number "4"; gene_name "C1orf93"; oId "uc001ajx.1"; nearest_ref "uc001ajx.1"; class_code "="; tss_id "TSS66"; p_id "P83"; chr1 coding exon 2520393 2520479 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000122"; exon_number "5"; gene_name "C1orf93"; oId "uc001ajx.1"; nearest_ref "uc001ajx.1"; class_code "="; tss_id "TSS66"; p_id "P83"; chr1 coding exon 2520849 2522902 . + . gene_id "XLOC_000051"; transcript_id "TCONS_00000122"; exon_number "6"; gene_name "C1orf93"; oId "uc001ajx.1"; nearest_ref "uc001ajx.1"; class_code "="; tss_id "TSS66"; p_id "P83"; chr1 coding exon 2938046 2939465 . + . gene_id "XLOC_000052"; transcript_id "TCONS_00000123"; exon_number "1"; gene_name "ACTRT2"; oId "uc001ajz.2"; nearest_ref "uc001ajz.2"; class_code "="; p_id "P89"; chr1 coding exon 2985744 2985860 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "1"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3102689 3103038 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "2"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3160651 3160701 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "3"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3301716 3301850 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "4"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3313055 3313157 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "5"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3319355 3319562 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "6"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3321303 3321450 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "7"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3322059 3322212 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "8"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3327948 3329364 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "9"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3331124 3331211 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "10"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3334392 3334561 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "11"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3335231 3335308 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "12"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3342145 3342314 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "13"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3342615 3342789 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "14"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3347436 3347672 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "15"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3348530 3348704 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "16"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 3350298 3355183 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000126"; exon_number "17"; gene_name "PRDM16"; oId "uc001ake.2"; nearest_ref "uc001ake.2"; class_code "="; tss_id "TSS67"; p_id "P94"; chr1 coding exon 2985744 2985860 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "1"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3102689 3103038 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "2"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3160651 3160701 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "3"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3301716 3301854 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "4"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3313055 3313157 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "5"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3319355 3319562 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "6"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3321303 3321450 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "7"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3322059 3322212 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "8"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3327948 3329364 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "9"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3331127 3331211 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "10"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3334392 3334561 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "11"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3335231 3335308 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "12"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3342145 3342314 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "13"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3342615 3342789 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "14"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3347436 3347672 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "15"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3348530 3348704 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "16"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 3350241 3355183 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000128"; exon_number "17"; gene_name "PRDM16"; oId "uc009vlh.2"; nearest_ref "uc009vlh.2"; class_code "="; tss_id "TSS67"; p_id "P93"; chr1 coding exon 2985744 2985860 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "1"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3102689 3103038 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "2"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3160651 3160701 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "3"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3301716 3301850 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "4"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3313055 3313157 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "5"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3319355 3319562 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "6"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3321303 3321450 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "7"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3322059 3322212 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "8"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3327948 3329364 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "9"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3331124 3331211 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "10"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3334392 3334561 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "11"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3335231 3335308 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "12"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3342145 3342314 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "13"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3342615 3342789 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "14"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3347436 3347672 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "15"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3348530 3348704 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "16"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 3350241 3355183 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000127"; exon_number "17"; gene_name "PRDM16"; oId "uc001akf.2"; nearest_ref "uc001akf.2"; class_code "="; tss_id "TSS67"; p_id "P90"; chr1 coding exon 2985744 2985860 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "1"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3102689 3103038 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "2"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3160651 3160701 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "3"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3301716 3301850 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "4"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3313055 3313157 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "5"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3319355 3319562 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "6"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3321303 3321450 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "7"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3322059 3322212 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "8"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3327948 3329364 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "9"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3331127 3331211 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "10"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3334392 3334561 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "11"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3335231 3335308 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "12"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3342145 3342314 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "13"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3342615 3342789 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "14"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3347436 3347672 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "15"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3348530 3348704 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "16"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 3350241 3355183 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000125"; exon_number "17"; gene_name "PRDM16"; oId "uc001akd.2"; nearest_ref "uc001akd.2"; class_code "="; tss_id "TSS67"; p_id "P91"; chr1 coding exon 2985744 2985860 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "1"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3102689 3103038 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "2"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3160651 3160701 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "3"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3301716 3301850 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "4"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3313055 3313157 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "5"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3319355 3319562 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "6"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3321303 3321450 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "7"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3322059 3322212 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "8"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3327948 3329364 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "9"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3331127 3331211 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "10"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3334392 3334561 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "11"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3335231 3335308 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "12"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3342145 3342314 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "13"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3342615 3342789 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "14"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3347436 3347672 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "15"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3348530 3348704 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "16"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3350298 3355183 . + . gene_id "XLOC_000053"; transcript_id "TCONS_00000124"; exon_number "17"; gene_name "PRDM16"; oId "uc001akc.2"; nearest_ref "uc001akc.2"; class_code "="; tss_id "TSS67"; p_id "P92"; chr1 coding exon 3371147 3371375 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "1"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3379630 3380236 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "2"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3382712 3382757 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "3"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3383732 3383901 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "4"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3385444 3385500 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "5"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3385997 3386157 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "6"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3389642 3389794 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "7"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3389957 3390086 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "8"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3391272 3391346 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "9"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3392534 3392626 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "10"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3394439 3394590 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "11"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3394988 3395176 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "12"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3396081 3396154 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "13"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3396376 3396477 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "14"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3397012 3397675 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000129"; exon_number "15"; gene_name "ARHGEF16"; oId "uc001akg.3"; nearest_ref "uc001akg.3"; class_code "="; tss_id "TSS68"; p_id "P95"; chr1 coding exon 3382569 3382757 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "1"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3383732 3383901 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "2"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3385444 3385500 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "3"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3385997 3386157 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "4"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3389642 3389794 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "5"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3389957 3390086 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "6"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3391272 3391346 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "7"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3392534 3392626 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "8"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3394439 3394590 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "9"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3394988 3395176 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "10"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3396081 3396154 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "11"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3396376 3396477 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "12"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3397012 3397675 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000130"; exon_number "13"; gene_name "ARHGEF16"; oId "uc001aki.2"; nearest_ref "uc001aki.2"; class_code "="; tss_id "TSS69"; p_id "P98"; chr1 coding exon 3383535 3383901 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "1"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3385444 3385500 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "2"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3385997 3386157 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "3"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3389642 3389794 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "4"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3389957 3390086 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "5"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3391272 3391346 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "6"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3392534 3392626 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "7"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3394439 3394590 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "8"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3394988 3395176 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "9"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3396081 3396154 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "10"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3396376 3396477 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "11"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3397012 3397675 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000131"; exon_number "12"; gene_name "ARHGEF16"; oId "uc001akj.2"; nearest_ref "uc001akj.2"; class_code "="; tss_id "TSS70"; p_id "P98"; chr1 coding exon 3388171 3388355 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000132"; exon_number "1"; gene_name "ARHGEF16"; oId "uc009vli.1"; nearest_ref "uc009vli.1"; class_code "="; tss_id "TSS71"; p_id "P97"; chr1 coding exon 3389642 3389794 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000132"; exon_number "2"; gene_name "ARHGEF16"; oId "uc009vli.1"; nearest_ref "uc009vli.1"; class_code "="; tss_id "TSS71"; p_id "P97"; chr1 coding exon 3389957 3391021 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000132"; exon_number "3"; gene_name "ARHGEF16"; oId "uc009vli.1"; nearest_ref "uc009vli.1"; class_code "="; tss_id "TSS71"; p_id "P97"; chr1 coding exon 3388171 3388355 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "1"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3389642 3389794 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "2"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3389957 3390086 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "3"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3391272 3391346 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "4"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3392534 3392626 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "5"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3394439 3394590 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "6"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3394988 3395176 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "7"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3396081 3396154 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "8"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3396376 3396477 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "9"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3397012 3397675 . + . gene_id "XLOC_000054"; transcript_id "TCONS_00000133"; exon_number "10"; gene_name "ARHGEF16"; oId "uc010nzh.1"; nearest_ref "uc010nzh.1"; class_code "="; tss_id "TSS71"; p_id "P96"; chr1 coding exon 3541556 3541837 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000135"; exon_number "1"; gene_name "TPRG1L"; oId "uc009vlj.2"; nearest_ref "uc009vlj.2"; class_code "="; tss_id "TSS72"; p_id "P100"; chr1 coding exon 3541988 3542079 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000135"; exon_number "2"; gene_name "TPRG1L"; oId "uc009vlj.2"; nearest_ref "uc009vlj.2"; class_code "="; tss_id "TSS72"; p_id "P100"; chr1 coding exon 3544064 3544217 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000135"; exon_number "3"; gene_name "TPRG1L"; oId "uc009vlj.2"; nearest_ref "uc009vlj.2"; class_code "="; tss_id "TSS72"; p_id "P100"; chr1 coding exon 3544973 3546692 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000135"; exon_number "4"; gene_name "TPRG1L"; oId "uc009vlj.2"; nearest_ref "uc009vlj.2"; class_code "="; tss_id "TSS72"; p_id "P100"; chr1 coding exon 3541556 3541837 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000134"; exon_number "1"; gene_name "TPRG1L"; oId "uc001akm.2"; nearest_ref "uc001akm.2"; class_code "="; tss_id "TSS72"; p_id "P99"; chr1 coding exon 3541988 3542079 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000134"; exon_number "2"; gene_name "TPRG1L"; oId "uc001akm.2"; nearest_ref "uc001akm.2"; class_code "="; tss_id "TSS72"; p_id "P99"; chr1 coding exon 3542277 3542453 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000134"; exon_number "3"; gene_name "TPRG1L"; oId "uc001akm.2"; nearest_ref "uc001akm.2"; class_code "="; tss_id "TSS72"; p_id "P99"; chr1 coding exon 3544064 3544217 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000134"; exon_number "4"; gene_name "TPRG1L"; oId "uc001akm.2"; nearest_ref "uc001akm.2"; class_code "="; tss_id "TSS72"; p_id "P99"; chr1 coding exon 3544973 3546692 . + . gene_id "XLOC_000055"; transcript_id "TCONS_00000134"; exon_number "5"; gene_name "TPRG1L"; oId "uc001akm.2"; nearest_ref "uc001akm.2"; class_code "="; tss_id "TSS72"; p_id "P99"; chr1 coding exon 3569129 3569205 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "1"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3598897 3598994 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "2"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3599624 3599744 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "3"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "4"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "5"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "6"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "7"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "8"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "9"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "10"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3646564 3646615 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "11"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3649911 3650456 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000136"; exon_number "12"; gene_name "TP73"; oId "uc001akq.2"; nearest_ref "uc001akq.2"; class_code "="; tss_id "TSS73"; p_id "P101"; chr1 coding exon 3569129 3569205 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "1"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3598897 3598994 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "2"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3599624 3599744 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "3"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "4"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "5"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "6"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "7"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "8"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "9"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "10"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3646564 3646712 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "11"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3647491 3647629 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "12"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3648027 3648120 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "13"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3649311 3650467 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000137"; exon_number "14"; gene_name "TP73"; oId "uc001akp.2"; nearest_ref "uc001akp.2"; class_code "="; tss_id "TSS73"; p_id "P108"; chr1 coding exon 3607236 3607508 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "1"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "2"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "3"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "4"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "5"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "6"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "7"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3645891 3646314 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000138"; exon_number "8"; gene_name "TP73"; oId "uc010nzj.1"; nearest_ref "uc010nzj.1"; class_code "="; tss_id "TSS74"; p_id "P109"; chr1 coding exon 3607236 3607508 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "1"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "2"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "3"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "4"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "5"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "6"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "7"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "8"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3647491 3647629 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "9"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3648027 3648120 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "10"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3649311 3650467 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000141"; exon_number "11"; gene_name "TP73"; oId "uc009vlk.1"; nearest_ref "uc009vlk.1"; class_code "="; tss_id "TSS74"; p_id "P107"; chr1 coding exon 3607236 3607508 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "1"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "2"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "3"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "4"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "5"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "6"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "7"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "8"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3646564 3646712 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "9"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3647491 3647629 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "10"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3649311 3650467 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000140"; exon_number "11"; gene_name "TP73"; oId "uc001aks.2"; nearest_ref "uc001aks.2"; class_code "="; tss_id "TSS74"; p_id "P105"; chr1 coding exon 3607236 3607508 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "1"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "2"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "3"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "4"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "5"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "6"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "7"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "8"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3646564 3646712 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "9"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3647491 3647629 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "10"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3648027 3648120 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "11"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3649311 3650467 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000139"; exon_number "12"; gene_name "TP73"; oId "uc001akr.2"; nearest_ref "uc001akr.2"; class_code "="; tss_id "TSS74"; p_id "P104"; chr1 coding exon 3614610 3614715 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000142"; exon_number "1"; oId "uc009vll.2"; nearest_ref "uc009vll.2"; class_code "="; tss_id "TSS75"; p_id "P106"; chr1 coding exon 3624113 3625097 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000142"; exon_number "2"; oId "uc009vll.2"; nearest_ref "uc009vll.2"; class_code "="; tss_id "TSS75"; p_id "P106"; chr1 coding exon 3614610 3614715 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "1"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3624113 3624355 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "2"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3638585 3638771 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "3"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3639918 3640033 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "4"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3643679 3643788 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "5"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3644192 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "6"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "7"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "8"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3646564 3646712 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "9"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3647491 3647629 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "10"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3648027 3648120 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "11"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3649311 3650467 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000143"; exon_number "12"; gene_name "TP73"; oId "uc010nzk.1"; nearest_ref "uc010nzk.1"; class_code "="; tss_id "TSS75"; p_id "P103"; chr1 coding exon 3644042 3644334 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000144"; exon_number "1"; oId "uc010nzl.1"; nearest_ref "uc010nzl.1"; class_code "="; tss_id "TSS76"; p_id "P102"; chr1 coding exon 3644693 3644781 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000144"; exon_number "2"; oId "uc010nzl.1"; nearest_ref "uc010nzl.1"; class_code "="; tss_id "TSS76"; p_id "P102"; chr1 coding exon 3645891 3646012 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000144"; exon_number "3"; oId "uc010nzl.1"; nearest_ref "uc010nzl.1"; class_code "="; tss_id "TSS76"; p_id "P102"; chr1 coding exon 3647491 3647629 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000144"; exon_number "4"; oId "uc010nzl.1"; nearest_ref "uc010nzl.1"; class_code "="; tss_id "TSS76"; p_id "P102"; chr1 coding exon 3648027 3648120 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000144"; exon_number "5"; oId "uc010nzl.1"; nearest_ref "uc010nzl.1"; class_code "="; tss_id "TSS76"; p_id "P102"; chr1 coding exon 3649311 3650467 . + . gene_id "XLOC_000056"; transcript_id "TCONS_00000144"; exon_number "6"; oId "uc010nzl.1"; nearest_ref "uc010nzl.1"; class_code "="; tss_id "TSS76"; p_id "P102"; chr1 coding exon 3668965 3669363 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "1"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3670682 3670805 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "2"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3672021 3672131 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "3"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3673297 3673454 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "4"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3677845 3677994 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "5"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3679184 3679276 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "6"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3679672 3680038 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "7"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3680270 3680400 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "8"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3683099 3683176 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "9"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3683797 3684009 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "10"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3686347 3686451 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "11"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3687965 3688209 . + . gene_id "XLOC_000057"; transcript_id "TCONS_00000145"; exon_number "12"; gene_name "CCDC27"; oId "uc001akv.2"; nearest_ref "uc001akv.2"; class_code "="; tss_id "TSS77"; p_id "P110"; chr1 coding exon 3689352 3689405 . + . gene_id "XLOC_000058"; transcript_id "TCONS_00000146"; exon_number "1"; oId "uc001akw.3"; nearest_ref "uc001akw.3"; class_code "="; tss_id "TSS78"; p_id "P111"; chr1 coding exon 3689627 3689745 . + . gene_id "XLOC_000058"; transcript_id "TCONS_00000146"; exon_number "2"; oId "uc001akw.3"; nearest_ref "uc001akw.3"; class_code "="; tss_id "TSS78"; p_id "P111"; chr1 coding exon 3691863 3692047 . + . gene_id "XLOC_000058"; transcript_id "TCONS_00000146"; exon_number "3"; oId "uc001akw.3"; nearest_ref "uc001akw.3"; class_code "="; tss_id "TSS78"; p_id "P111"; chr1 coding exon 3692359 3692545 . + . gene_id "XLOC_000058"; transcript_id "TCONS_00000146"; exon_number "4"; oId "uc001akw.3"; nearest_ref "uc001akw.3"; class_code "="; tss_id "TSS78"; p_id "P111"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000147"; exon_number "1"; gene_name "DFFB"; oId "uc009vln.1"; nearest_ref "uc009vln.1"; class_code "="; tss_id "TSS79"; p_id "P113"; chr1 coding exon 3775282 3775415 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000147"; exon_number "2"; gene_name "DFFB"; oId "uc009vln.1"; nearest_ref "uc009vln.1"; class_code "="; tss_id "TSS79"; p_id "P113"; chr1 coding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000147"; exon_number "3"; gene_name "DFFB"; oId "uc009vln.1"; nearest_ref "uc009vln.1"; class_code "="; tss_id "TSS79"; p_id "P113"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000148"; exon_number "1"; gene_name "DFFB"; oId "uc001ala.1"; nearest_ref "uc001ala.1"; class_code "="; tss_id "TSS79"; p_id "P114"; chr1 coding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000148"; exon_number "2"; gene_name "DFFB"; oId "uc001ala.1"; nearest_ref "uc001ala.1"; class_code "="; tss_id "TSS79"; p_id "P114"; chr1 coding exon 3782848 3782962 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000148"; exon_number "3"; gene_name "DFFB"; oId "uc001ala.1"; nearest_ref "uc001ala.1"; class_code "="; tss_id "TSS79"; p_id "P114"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000149"; exon_number "1"; gene_name "DFFB"; oId "uc009vlo.1"; nearest_ref "uc009vlo.1"; class_code "="; tss_id "TSS79"; p_id "P112"; chr1 coding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000149"; exon_number "2"; gene_name "DFFB"; oId "uc009vlo.1"; nearest_ref "uc009vlo.1"; class_code "="; tss_id "TSS79"; p_id "P112"; chr1 coding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000149"; exon_number "3"; gene_name "DFFB"; oId "uc009vlo.1"; nearest_ref "uc009vlo.1"; class_code "="; tss_id "TSS79"; p_id "P112"; chr1 coding exon 3782848 3783050 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000149"; exon_number "4"; gene_name "DFFB"; oId "uc009vlo.1"; nearest_ref "uc009vlo.1"; class_code "="; tss_id "TSS79"; p_id "P112"; chr1 nearCoding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "1"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "2"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3776984 3777070 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "3"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "4"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "5"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "6"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "7"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000155"; exon_number "8"; gene_name "CAD"; oId "uc009vlq.2"; nearest_ref "uc009vlq.2"; class_code "="; tss_id "TSS79"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "1"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3775282 3775430 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "2"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3782326 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "3"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "4"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "5"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "6"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000157"; exon_number "7"; gene_name "DFFB"; oId "uc010nzn.1"; nearest_ref "uc010nzn.1"; class_code "="; tss_id "TSS79"; p_id "P118"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "1"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 coding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "2"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 coding exon 3782207 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "3"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 coding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "4"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 coding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "5"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 coding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "6"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 coding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000156"; exon_number "7"; gene_name "CAD"; oId "uc009vlr.2"; nearest_ref "uc009vlr.2"; class_code "="; tss_id "TSS79"; p_id "P117"; chr1 nearCoding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "1"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "2"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "3"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "4"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "5"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "6"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3789578 3789701 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "7"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000154"; exon_number "8"; gene_name "CAD"; oId "uc009vlp.2"; nearest_ref "uc009vlp.2"; class_code "="; tss_id "TSS79"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "1"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 coding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "2"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 coding exon 3782326 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "3"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 coding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "4"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 coding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "5"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 coding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "6"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 coding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000152"; exon_number "7"; gene_name "DFFB"; oId "uc001ald.2"; nearest_ref "uc001ald.2"; class_code "="; tss_id "TSS79"; p_id "P116"; chr1 nearCoding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "1"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3775282 3775430 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "2"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "3"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3782848 3782962 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "4"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "5"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "6"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "7"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000153"; exon_number "8"; gene_name "CAD"; oId "uc001ale.2"; nearest_ref "uc001ale.2"; class_code "="; tss_id "TSS79"; chr1 coding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "1"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 coding exon 3775282 3775408 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "2"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 coding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "3"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 coding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "4"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 coding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "5"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 coding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "6"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 coding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000151"; exon_number "7"; gene_name "DFFB"; oId "uc001alc.2"; nearest_ref "uc001alc.2"; class_code "="; tss_id "TSS79"; p_id "P115"; chr1 nearCoding exon 3773845 3774281 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "1"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3775282 3775430 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "2"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3782376 3782564 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "3"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3784538 3784617 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "4"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3786169 3786339 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "5"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3789036 3789136 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "6"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 nearCoding exon 3800071 3801992 . + . gene_id "XLOC_000059"; transcript_id "TCONS_00000150"; exon_number "7"; gene_name "CAD"; oId "uc001alb.2"; nearest_ref "uc001alb.2"; class_code "="; tss_id "TSS79"; chr1 noncoding exon 3816968 3817195 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000159"; exon_number "1"; oId "uc010nzo.1"; nearest_ref "uc010nzo.1"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3830959 3832009 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000159"; exon_number "2"; oId "uc010nzo.1"; nearest_ref "uc010nzo.1"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3816968 3817195 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000158"; exon_number "1"; oId "uc001alg.2"; nearest_ref "uc001alg.2"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3820529 3820600 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000158"; exon_number "2"; oId "uc001alg.2"; nearest_ref "uc001alg.2"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3830256 3830854 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000158"; exon_number "3"; oId "uc001alg.2"; nearest_ref "uc001alg.2"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3830959 3832009 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000158"; exon_number "4"; oId "uc001alg.2"; nearest_ref "uc001alg.2"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3816968 3817195 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000160"; exon_number "1"; oId "uc001alh.3"; nearest_ref "uc001alh.3"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 3833051 3833877 . + . gene_id "XLOC_000060"; transcript_id "TCONS_00000160"; exon_number "2"; oId "uc001alh.3"; nearest_ref "uc001alh.3"; class_code "="; tss_id "TSS80"; chr1 noncoding exon 4000677 4000758 . + . gene_id "XLOC_000061"; transcript_id "TCONS_00000161"; exon_number "1"; oId "uc001ali.1"; nearest_ref "uc001ali.1"; class_code "="; tss_id "TSS81"; chr1 noncoding exon 4001054 4001203 . + . gene_id "XLOC_000061"; transcript_id "TCONS_00000161"; exon_number "2"; oId "uc001ali.1"; nearest_ref "uc001ali.1"; class_code "="; tss_id "TSS81"; chr1 noncoding exon 4012313 4015322 . + . gene_id "XLOC_000061"; transcript_id "TCONS_00000161"; exon_number "3"; oId "uc001ali.1"; nearest_ref "uc001ali.1"; class_code "="; tss_id "TSS81"; chr1 noncoding exon 4472111 4472692 . + . gene_id "XLOC_000062"; transcript_id "TCONS_00000162"; exon_number "1"; oId "uc001alj.2"; nearest_ref "uc001alj.2"; class_code "="; tss_id "TSS82"; chr1 noncoding exon 4475613 4475647 . + . gene_id "XLOC_000062"; transcript_id "TCONS_00000162"; exon_number "2"; oId "uc001alj.2"; nearest_ref "uc001alj.2"; class_code "="; tss_id "TSS82"; chr1 noncoding exon 4476372 4476608 . + . gene_id "XLOC_000062"; transcript_id "TCONS_00000162"; exon_number "3"; oId "uc001alj.2"; nearest_ref "uc001alj.2"; class_code "="; tss_id "TSS82"; chr1 noncoding exon 4482820 4483247 . + . gene_id "XLOC_000062"; transcript_id "TCONS_00000162"; exon_number "4"; oId "uc001alj.2"; nearest_ref "uc001alj.2"; class_code "="; tss_id "TSS82"; chr1 noncoding exon 4483408 4483508 . + . gene_id "XLOC_000062"; transcript_id "TCONS_00000162"; exon_number "5"; oId "uc001alj.2"; nearest_ref "uc001alj.2"; class_code "="; tss_id "TSS82"; chr1 noncoding exon 4484054 4484744 . + . gene_id "XLOC_000062"; transcript_id "TCONS_00000162"; exon_number "6"; oId "uc001alj.2"; nearest_ref "uc001alj.2"; class_code "="; tss_id "TSS82"; chr1 coding exon 4715105 4715514 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000163"; exon_number "1"; gene_name "AJAP1"; oId "uc001alm.1"; nearest_ref "uc001alm.1"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4771960 4772759 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000163"; exon_number "2"; gene_name "AJAP1"; oId "uc001alm.1"; nearest_ref "uc001alm.1"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4829913 4830000 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000163"; exon_number "3"; gene_name "AJAP1"; oId "uc001alm.1"; nearest_ref "uc001alm.1"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4832340 4832585 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000163"; exon_number "4"; gene_name "AJAP1"; oId "uc001alm.1"; nearest_ref "uc001alm.1"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4834487 4834618 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000163"; exon_number "5"; gene_name "AJAP1"; oId "uc001alm.1"; nearest_ref "uc001alm.1"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4837461 4837854 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000163"; exon_number "6"; gene_name "AJAP1"; oId "uc001alm.1"; nearest_ref "uc001alm.1"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4715105 4715514 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000164"; exon_number "1"; gene_name "AJAP1"; oId "uc001aln.2"; nearest_ref "uc001aln.2"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4771960 4772759 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000164"; exon_number "2"; gene_name "AJAP1"; oId "uc001aln.2"; nearest_ref "uc001aln.2"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4829913 4830000 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000164"; exon_number "3"; gene_name "AJAP1"; oId "uc001aln.2"; nearest_ref "uc001aln.2"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4832340 4832585 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000164"; exon_number "4"; gene_name "AJAP1"; oId "uc001aln.2"; nearest_ref "uc001aln.2"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4834487 4834618 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000164"; exon_number "5"; gene_name "AJAP1"; oId "uc001aln.2"; nearest_ref "uc001aln.2"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4842605 4843850 . + . gene_id "XLOC_000063"; transcript_id "TCONS_00000164"; exon_number "6"; gene_name "AJAP1"; oId "uc001aln.2"; nearest_ref "uc001aln.2"; class_code "="; tss_id "TSS83"; p_id "P119"; chr1 coding exon 4847558 4852182 . + . gene_id "XLOC_000064"; transcript_id "TCONS_00000165"; exon_number "1"; oId "uc001alo.3"; nearest_ref "uc001alo.3"; class_code "="; p_id "P120"; chr1 coding exon 6052766 6052848 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "1"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6100577 6100705 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "2"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6101891 6101932 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "3"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "4"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "5"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "6"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "7"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "8"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "9"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "10"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "11"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "12"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "13"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "14"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6157329 6157417 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "15"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6158545 6160523 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000166"; exon_number "16"; gene_name "KCNAB2"; oId "uc009vlv.1"; nearest_ref "uc009vlv.1"; class_code "="; tss_id "TSS84"; p_id "P124"; chr1 coding exon 6086380 6086505 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "1"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6100577 6100705 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "2"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6101891 6101932 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "3"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "4"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "5"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "6"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "7"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "8"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "9"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "10"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "11"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "12"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "13"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "14"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6157329 6158613 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000167"; exon_number "15"; gene_name "KCNAB2"; oId "uc001alu.2"; nearest_ref "uc001alu.2"; class_code "="; tss_id "TSS85"; p_id "P123"; chr1 coding exon 6086380 6086505 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "1"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6100577 6100705 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "2"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "3"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "4"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "5"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "6"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "7"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "8"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "9"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "10"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "11"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "12"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "13"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6157329 6157417 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "14"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6158545 6160523 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000169"; exon_number "15"; gene_name "KCNAB2"; oId "uc001alw.1"; nearest_ref "uc001alw.1"; class_code "="; tss_id "TSS85"; p_id "P122"; chr1 coding exon 6086380 6086505 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "1"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6100577 6100705 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "2"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6101891 6101932 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "3"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "4"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "5"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "6"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "7"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "8"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "9"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "10"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "11"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "12"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "13"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "14"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6157329 6157417 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "15"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6158545 6160523 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000168"; exon_number "16"; gene_name "KCNAB2"; oId "uc001alv.1"; nearest_ref "uc001alv.1"; class_code "="; tss_id "TSS85"; p_id "P124"; chr1 coding exon 6094343 6094854 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "1"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6100577 6100705 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "2"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6101891 6101932 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "3"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "4"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "5"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "6"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "7"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "8"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "9"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "10"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "11"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "12"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "13"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "14"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6157329 6157417 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "15"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6158545 6160523 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000170"; exon_number "16"; gene_name "KCNAB2"; oId "uc001alx.1"; nearest_ref "uc001alx.1"; class_code "="; tss_id "TSS86"; p_id "P124"; chr1 coding exon 6105981 6106243 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "1"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "2"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "3"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "4"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "5"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "6"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "7"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "8"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "9"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "10"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "11"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "12"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6157329 6157417 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "13"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6158545 6160523 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000172"; exon_number "14"; gene_name "KCNAB2"; oId "uc009vlw.1"; nearest_ref "uc009vlw.1"; class_code "="; tss_id "TSS87"; p_id "P121"; chr1 coding exon 6105981 6106243 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "1"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6111571 6111814 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "2"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6132815 6132858 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "3"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6133793 6133830 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "4"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6142255 6142334 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "5"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6145264 6145308 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "6"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6147527 6147571 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "7"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6149068 6149111 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "8"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6150449 6150535 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "9"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6151323 6151367 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "10"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6154460 6154545 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "11"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6155383 6155503 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "12"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6155590 6155684 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "13"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6156696 6156816 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "14"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6157329 6157417 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "15"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6158545 6160523 . + . gene_id "XLOC_000065"; transcript_id "TCONS_00000171"; exon_number "16"; gene_name "KCNAB2"; oId "uc001aly.1"; nearest_ref "uc001aly.1"; class_code "="; tss_id "TSS87"; p_id "P125"; chr1 coding exon 6266189 6266362 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000173"; exon_number "1"; gene_name "RNF207"; oId "uc001amf.1"; nearest_ref "uc001amf.1"; class_code "="; tss_id "TSS88"; p_id "P128"; chr1 coding exon 6266596 6266786 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000173"; exon_number "2"; gene_name "RNF207"; oId "uc001amf.1"; nearest_ref "uc001amf.1"; class_code "="; tss_id "TSS88"; p_id "P128"; chr1 coding exon 6267439 6268366 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000173"; exon_number "3"; gene_name "RNF207"; oId "uc001amf.1"; nearest_ref "uc001amf.1"; class_code "="; tss_id "TSS88"; p_id "P128"; chr1 coding exon 6266189 6266362 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "1"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6266596 6266786 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "2"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6267439 6267571 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "3"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6268941 6269085 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "4"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6269175 6269256 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "5"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6269328 6269403 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "6"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6269474 6269599 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "7"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6269984 6270030 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "8"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6270283 6270355 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "9"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6270430 6270498 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "10"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6270930 6270998 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "11"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6271081 6271178 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "12"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6271927 6272113 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "13"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6272291 6272476 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "14"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6272742 6272793 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "15"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6273126 6273243 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "16"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6278349 6278429 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "17"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6279296 6281351 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000174"; exon_number "18"; gene_name "RNF207"; oId "uc001amg.2"; nearest_ref "uc001amg.2"; class_code "="; tss_id "TSS88"; p_id "P127"; chr1 coding exon 6268678 6269085 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000175"; exon_number "1"; gene_name "RNF207"; oId "uc001amh.2"; nearest_ref "uc001amh.2"; class_code "="; tss_id "TSS89"; p_id "P126"; chr1 coding exon 6269175 6269256 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000175"; exon_number "2"; gene_name "RNF207"; oId "uc001amh.2"; nearest_ref "uc001amh.2"; class_code "="; tss_id "TSS89"; p_id "P126"; chr1 coding exon 6269328 6269599 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000175"; exon_number "3"; gene_name "RNF207"; oId "uc001amh.2"; nearest_ref "uc001amh.2"; class_code "="; tss_id "TSS89"; p_id "P126"; chr1 coding exon 6269984 6270030 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000175"; exon_number "4"; gene_name "RNF207"; oId "uc001amh.2"; nearest_ref "uc001amh.2"; class_code "="; tss_id "TSS89"; p_id "P126"; chr1 coding exon 6270283 6270355 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000175"; exon_number "5"; gene_name "RNF207"; oId "uc001amh.2"; nearest_ref "uc001amh.2"; class_code "="; tss_id "TSS89"; p_id "P126"; chr1 coding exon 6270430 6270959 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000175"; exon_number "6"; gene_name "RNF207"; oId "uc001amh.2"; nearest_ref "uc001amh.2"; class_code "="; tss_id "TSS89"; p_id "P126"; chr1 nearCoding exon 6268941 6269085 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "1"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6269474 6269599 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "2"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6269984 6270030 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "3"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6270283 6270355 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "4"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6270430 6270498 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "5"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6270930 6270998 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "6"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6271081 6271178 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "7"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6271927 6272113 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "8"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6272291 6272476 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "9"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6272742 6272963 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "10"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6273126 6273243 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "11"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 nearCoding exon 6278349 6278429 . + . gene_id "XLOC_000066"; transcript_id "TCONS_00000176"; exon_number "12"; gene_name "RNF207"; oId "uc010nzp.1"; nearest_ref "uc010nzp.1"; class_code "="; tss_id "TSS90"; chr1 noncoding exon 6297871 6297908 . + . gene_id "XLOC_000067"; transcript_id "TCONS_00000177"; exon_number "1"; gene_name "C1orf211"; oId "uc001amm.2"; nearest_ref "uc001amm.2"; class_code "="; tss_id "TSS91"; chr1 noncoding exon 6298281 6299490 . + . gene_id "XLOC_000067"; transcript_id "TCONS_00000177"; exon_number "2"; gene_name "C1orf211"; oId "uc001amm.2"; nearest_ref "uc001amm.2"; class_code "="; tss_id "TSS91"; chr1 coding exon 6304262 6304301 . + . gene_id "XLOC_000068"; transcript_id "TCONS_00000178"; exon_number "1"; gene_name "HES3"; oId "uc009vly.1"; nearest_ref "uc009vly.1"; class_code "="; tss_id "TSS92"; p_id "P129"; chr1 coding exon 6304411 6304506 . + . gene_id "XLOC_000068"; transcript_id "TCONS_00000178"; exon_number "2"; gene_name "HES3"; oId "uc009vly.1"; nearest_ref "uc009vly.1"; class_code "="; tss_id "TSS92"; p_id "P129"; chr1 coding exon 6304608 6304689 . + . gene_id "XLOC_000068"; transcript_id "TCONS_00000178"; exon_number "3"; gene_name "HES3"; oId "uc009vly.1"; nearest_ref "uc009vly.1"; class_code "="; tss_id "TSS92"; p_id "P129"; chr1 coding exon 6305170 6305638 . + . gene_id "XLOC_000068"; transcript_id "TCONS_00000178"; exon_number "4"; gene_name "HES3"; oId "uc009vly.1"; nearest_ref "uc009vly.1"; class_code "="; tss_id "TSS92"; p_id "P129"; chr1 coding exon 6484848 6485309 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "1"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6488286 6488479 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "2"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6500314 6500500 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "3"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6500686 6500868 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "4"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6500994 6501125 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "5"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6504541 6504742 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "6"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6505724 6505995 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "7"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6508701 6509151 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "8"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6511663 6511808 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "9"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6511893 6512156 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "10"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6517244 6517323 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "11"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6517421 6517432 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "12"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6520059 6521003 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000179"; exon_number "13"; gene_name "ESPN"; oId "uc001amy.2"; nearest_ref "uc001amy.2"; class_code "="; tss_id "TSS93"; p_id "P131"; chr1 coding exon 6508103 6508177 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "1"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6508701 6508862 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "2"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6508953 6509151 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "3"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6511663 6511808 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "4"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6511893 6512156 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "5"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6517244 6517323 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "6"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6517421 6517432 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "7"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6520059 6521003 . + . gene_id "XLOC_000069"; transcript_id "TCONS_00000180"; exon_number "8"; gene_name "ESPN"; oId "uc001amz.2"; nearest_ref "uc001amz.2"; class_code "="; tss_id "TSS94"; p_id "P130"; chr1 coding exon 6615434 6615624 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000183"; exon_number "1"; gene_name "TAS1R1"; oId "uc001anv.2"; nearest_ref "uc001anv.2"; class_code "="; tss_id "TSS95"; p_id "P135"; chr1 coding exon 6630969 6631275 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000183"; exon_number "2"; gene_name "TAS1R1"; oId "uc001anv.2"; nearest_ref "uc001anv.2"; class_code "="; tss_id "TSS95"; p_id "P135"; chr1 coding exon 6636475 6636687 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000183"; exon_number "3"; gene_name "TAS1R1"; oId "uc001anv.2"; nearest_ref "uc001anv.2"; class_code "="; tss_id "TSS95"; p_id "P135"; chr1 coding exon 6637010 6637130 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000183"; exon_number "4"; gene_name "TAS1R1"; oId "uc001anv.2"; nearest_ref "uc001anv.2"; class_code "="; tss_id "TSS95"; p_id "P135"; chr1 coding exon 6639356 6639816 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000183"; exon_number "5"; gene_name "TAS1R1"; oId "uc001anv.2"; nearest_ref "uc001anv.2"; class_code "="; tss_id "TSS95"; p_id "P135"; chr1 coding exon 6615434 6615624 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000184"; exon_number "1"; gene_name "TAS1R1"; oId "uc001anw.2"; nearest_ref "uc001anw.2"; class_code "="; tss_id "TSS95"; p_id "P133"; chr1 coding exon 6630969 6631275 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000184"; exon_number "2"; gene_name "TAS1R1"; oId "uc001anw.2"; nearest_ref "uc001anw.2"; class_code "="; tss_id "TSS95"; p_id "P133"; chr1 coding exon 6634691 6635452 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000184"; exon_number "3"; gene_name "TAS1R1"; oId "uc001anw.2"; nearest_ref "uc001anw.2"; class_code "="; tss_id "TSS95"; p_id "P133"; chr1 coding exon 6638713 6639816 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000184"; exon_number "4"; gene_name "TAS1R1"; oId "uc001anw.2"; nearest_ref "uc001anw.2"; class_code "="; tss_id "TSS95"; p_id "P133"; chr1 coding exon 6615434 6615624 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000182"; exon_number "1"; gene_name "TAS1R1"; oId "uc001anu.2"; nearest_ref "uc001anu.2"; class_code "="; tss_id "TSS95"; p_id "P132"; chr1 coding exon 6630969 6631275 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000182"; exon_number "2"; gene_name "TAS1R1"; oId "uc001anu.2"; nearest_ref "uc001anu.2"; class_code "="; tss_id "TSS95"; p_id "P132"; chr1 coding exon 6636475 6636687 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000182"; exon_number "3"; gene_name "TAS1R1"; oId "uc001anu.2"; nearest_ref "uc001anu.2"; class_code "="; tss_id "TSS95"; p_id "P132"; chr1 coding exon 6637010 6637130 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000182"; exon_number "4"; gene_name "TAS1R1"; oId "uc001anu.2"; nearest_ref "uc001anu.2"; class_code "="; tss_id "TSS95"; p_id "P132"; chr1 coding exon 6638713 6639816 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000182"; exon_number "5"; gene_name "TAS1R1"; oId "uc001anu.2"; nearest_ref "uc001anu.2"; class_code "="; tss_id "TSS95"; p_id "P132"; chr1 coding exon 6615434 6615624 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000181"; exon_number "1"; gene_name "TAS1R1"; oId "uc001ant.2"; nearest_ref "uc001ant.2"; class_code "="; tss_id "TSS95"; p_id "P134"; chr1 coding exon 6630969 6631275 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000181"; exon_number "2"; gene_name "TAS1R1"; oId "uc001ant.2"; nearest_ref "uc001ant.2"; class_code "="; tss_id "TSS95"; p_id "P134"; chr1 coding exon 6634691 6635452 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000181"; exon_number "3"; gene_name "TAS1R1"; oId "uc001ant.2"; nearest_ref "uc001ant.2"; class_code "="; tss_id "TSS95"; p_id "P134"; chr1 coding exon 6636475 6636687 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000181"; exon_number "4"; gene_name "TAS1R1"; oId "uc001ant.2"; nearest_ref "uc001ant.2"; class_code "="; tss_id "TSS95"; p_id "P134"; chr1 coding exon 6637010 6637130 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000181"; exon_number "5"; gene_name "TAS1R1"; oId "uc001ant.2"; nearest_ref "uc001ant.2"; class_code "="; tss_id "TSS95"; p_id "P134"; chr1 coding exon 6638713 6639816 . + . gene_id "XLOC_000070"; transcript_id "TCONS_00000181"; exon_number "6"; gene_name "TAS1R1"; oId "uc001ant.2"; nearest_ref "uc001ant.2"; class_code "="; tss_id "TSS95"; p_id "P134"; chr1 coding exon 6640056 6640109 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "1"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6640601 6641359 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "2"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6642118 6642359 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "3"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6645979 6646090 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "4"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6646755 6646847 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "5"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6647265 6647351 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "6"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6647538 6647692 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "7"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648120 6648256 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "8"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648338 6648502 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "9"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648816 6648904 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "10"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648976 6649339 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000185"; exon_number "11"; gene_name "ZBTB48"; oId "uc009vmc.1"; nearest_ref "uc009vmc.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6640063 6640196 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "1"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6640601 6641359 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "2"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6642118 6642359 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "3"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6645979 6646090 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "4"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6646755 6646847 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "5"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6647265 6647351 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "6"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6647538 6647692 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "7"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648120 6648256 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "8"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648338 6648502 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "9"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648816 6648904 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "10"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648976 6649339 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000186"; exon_number "11"; gene_name "ZBTB48"; oId "uc001anx.2"; nearest_ref "uc001anx.2"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6640069 6640130 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "1"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6640601 6641359 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "2"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6642118 6642359 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "3"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6645979 6646090 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "4"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6646755 6646847 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "5"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6647265 6647351 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "6"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6647538 6647692 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "7"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648120 6648256 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "8"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648338 6648502 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "9"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648816 6648904 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "10"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6648976 6649339 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000187"; exon_number "11"; gene_name "ZBTB48"; oId "uc009vmd.1"; nearest_ref "uc009vmd.1"; class_code "="; tss_id "TSS96"; p_id "P137"; chr1 coding exon 6645362 6646847 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "1"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6647265 6647351 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "2"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6647538 6647692 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "3"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6648120 6648256 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "4"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6648338 6648502 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "5"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6648816 6648904 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "6"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6648976 6649339 . + . gene_id "XLOC_000071"; transcript_id "TCONS_00000188"; exon_number "7"; oId "uc001any.1"; nearest_ref "uc001any.1"; class_code "="; tss_id "TSS97"; p_id "P136"; chr1 coding exon 6673756 6674165 . + . gene_id "XLOC_000072"; transcript_id "TCONS_00000189"; exon_number "1"; gene_name "PHF13"; oId "uc001aob.3"; nearest_ref "uc001aob.3"; class_code "="; tss_id "TSS98"; p_id "P138"; chr1 coding exon 6676817 6676918 . + . gene_id "XLOC_000072"; transcript_id "TCONS_00000189"; exon_number "2"; gene_name "PHF13"; oId "uc001aob.3"; nearest_ref "uc001aob.3"; class_code "="; tss_id "TSS98"; p_id "P138"; chr1 coding exon 6679863 6680397 . + . gene_id "XLOC_000072"; transcript_id "TCONS_00000189"; exon_number "3"; gene_name "PHF13"; oId "uc001aob.3"; nearest_ref "uc001aob.3"; class_code "="; tss_id "TSS98"; p_id "P138"; chr1 coding exon 6681471 6684092 . + . gene_id "XLOC_000072"; transcript_id "TCONS_00000189"; exon_number "4"; gene_name "PHF13"; oId "uc001aob.3"; nearest_ref "uc001aob.3"; class_code "="; tss_id "TSS98"; p_id "P138"; chr1 coding exon 6684925 6685014 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000190"; exon_number "1"; gene_name "THAP3"; oId "uc001aoc.2"; nearest_ref "uc001aoc.2"; class_code "="; tss_id "TSS99"; p_id "P140"; chr1 coding exon 6685210 6685352 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000190"; exon_number "2"; gene_name "THAP3"; oId "uc001aoc.2"; nearest_ref "uc001aoc.2"; class_code "="; tss_id "TSS99"; p_id "P140"; chr1 coding exon 6688559 6688751 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000190"; exon_number "3"; gene_name "THAP3"; oId "uc001aoc.2"; nearest_ref "uc001aoc.2"; class_code "="; tss_id "TSS99"; p_id "P140"; chr1 coding exon 6690348 6690413 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000190"; exon_number "4"; gene_name "THAP3"; oId "uc001aoc.2"; nearest_ref "uc001aoc.2"; class_code "="; tss_id "TSS99"; p_id "P140"; chr1 coding exon 6692451 6692555 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000190"; exon_number "5"; gene_name "THAP3"; oId "uc001aoc.2"; nearest_ref "uc001aoc.2"; class_code "="; tss_id "TSS99"; p_id "P140"; chr1 coding exon 6692856 6693621 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000190"; exon_number "6"; gene_name "THAP3"; oId "uc001aoc.2"; nearest_ref "uc001aoc.2"; class_code "="; tss_id "TSS99"; p_id "P140"; chr1 coding exon 6685210 6685352 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000191"; exon_number "1"; gene_name "THAP3"; oId "uc001aod.2"; nearest_ref "uc001aod.2"; class_code "="; tss_id "TSS100"; p_id "P139"; chr1 coding exon 6688559 6688751 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000191"; exon_number "2"; gene_name "THAP3"; oId "uc001aod.2"; nearest_ref "uc001aod.2"; class_code "="; tss_id "TSS100"; p_id "P139"; chr1 coding exon 6690351 6690413 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000191"; exon_number "3"; gene_name "THAP3"; oId "uc001aod.2"; nearest_ref "uc001aod.2"; class_code "="; tss_id "TSS100"; p_id "P139"; chr1 coding exon 6692451 6692555 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000191"; exon_number "4"; gene_name "THAP3"; oId "uc001aod.2"; nearest_ref "uc001aod.2"; class_code "="; tss_id "TSS100"; p_id "P139"; chr1 coding exon 6692856 6693621 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000191"; exon_number "5"; gene_name "THAP3"; oId "uc001aod.2"; nearest_ref "uc001aod.2"; class_code "="; tss_id "TSS100"; p_id "P139"; chr1 coding exon 6685210 6685352 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000192"; exon_number "1"; gene_name "THAP3"; oId "uc001aoe.1"; nearest_ref "uc001aoe.1"; class_code "="; tss_id "TSS100"; p_id "P141"; chr1 coding exon 6688559 6688751 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000192"; exon_number "2"; gene_name "THAP3"; oId "uc001aoe.1"; nearest_ref "uc001aoe.1"; class_code "="; tss_id "TSS100"; p_id "P141"; chr1 coding exon 6690348 6690413 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000192"; exon_number "3"; gene_name "THAP3"; oId "uc001aoe.1"; nearest_ref "uc001aoe.1"; class_code "="; tss_id "TSS100"; p_id "P141"; chr1 coding exon 6692430 6692555 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000192"; exon_number "4"; gene_name "THAP3"; oId "uc001aoe.1"; nearest_ref "uc001aoe.1"; class_code "="; tss_id "TSS100"; p_id "P141"; chr1 coding exon 6694080 6695645 . + . gene_id "XLOC_000073"; transcript_id "TCONS_00000192"; exon_number "5"; gene_name "THAP3"; oId "uc001aoe.1"; nearest_ref "uc001aoe.1"; class_code "="; tss_id "TSS100"; p_id "P141"; chr1 nearCoding exon 6845384 6845635 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000193"; exon_number "1"; oId "uc001aoh.2"; nearest_ref "uc001aoh.2"; class_code "="; tss_id "TSS101"; chr1 nearCoding exon 6880241 6880310 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000193"; exon_number "2"; oId "uc001aoh.2"; nearest_ref "uc001aoh.2"; class_code "="; tss_id "TSS101"; chr1 nearCoding exon 6885152 6885270 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000193"; exon_number "3"; oId "uc001aoh.2"; nearest_ref "uc001aoh.2"; class_code "="; tss_id "TSS101"; chr1 nearCoding exon 6931817 6932097 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000193"; exon_number "4"; oId "uc001aoh.2"; nearest_ref "uc001aoh.2"; class_code "="; tss_id "TSS101"; chr1 coding exon 6845384 6845635 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "1"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 6880241 6880310 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "2"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 6885152 6885270 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "3"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7151364 7151431 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "4"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7309551 7309686 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "5"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7527890 7527961 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "6"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7700460 7700613 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "7"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7721786 7721926 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "8"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7723413 7725259 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "9"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7730971 7731097 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "10"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7737659 7737793 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "11"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7792508 7792659 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "12"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7796404 7796600 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "13"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7796991 7797069 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "14"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7797315 7797630 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "15"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7798019 7798542 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "16"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7804895 7805082 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "17"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7805905 7806151 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "18"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7807770 7807841 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "19"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7811259 7811452 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "20"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7812519 7812593 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "21"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7815698 7815728 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "22"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7826519 7829763 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000194"; exon_number "23"; gene_name "CAMTA1"; oId "uc001aoi.2"; nearest_ref "uc001aoi.2"; class_code "="; tss_id "TSS101"; p_id "P145"; chr1 coding exon 7740148 7740275 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "1"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7792508 7792659 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "2"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7796404 7796600 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "3"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7796991 7797069 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "4"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7797315 7797630 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "5"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7798019 7798542 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "6"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7804895 7805082 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "7"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7805905 7806151 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "8"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7807770 7807841 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "9"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7811259 7811452 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "10"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7812519 7812593 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "11"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7826519 7829763 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000195"; exon_number "12"; gene_name "CAMTA1"; oId "uc001aok.3"; nearest_ref "uc001aok.3"; class_code "="; tss_id "TSS102"; p_id "P144"; chr1 coding exon 7796404 7796600 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "1"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7796991 7797069 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "2"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7797315 7797630 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "3"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7798019 7798542 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "4"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7804895 7805082 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "5"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7805905 7806151 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "6"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7807770 7807841 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "7"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7809831 7809851 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "8"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7811259 7811452 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "9"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7812519 7812593 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "10"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7826519 7829763 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000196"; exon_number "11"; gene_name "CAMTA1"; oId "uc001aoj.2"; nearest_ref "uc001aoj.2"; class_code "="; tss_id "TSS103"; p_id "P143"; chr1 coding exon 7804895 7805082 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000197"; exon_number "1"; oId "uc009vmf.2"; nearest_ref "uc009vmf.2"; class_code "="; tss_id "TSS104"; p_id "P142"; chr1 coding exon 7805947 7806151 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000197"; exon_number "2"; oId "uc009vmf.2"; nearest_ref "uc009vmf.2"; class_code "="; tss_id "TSS104"; p_id "P142"; chr1 coding exon 7807770 7807841 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000197"; exon_number "3"; oId "uc009vmf.2"; nearest_ref "uc009vmf.2"; class_code "="; tss_id "TSS104"; p_id "P142"; chr1 coding exon 7811259 7811452 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000197"; exon_number "4"; oId "uc009vmf.2"; nearest_ref "uc009vmf.2"; class_code "="; tss_id "TSS104"; p_id "P142"; chr1 coding exon 7812519 7812593 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000197"; exon_number "5"; oId "uc009vmf.2"; nearest_ref "uc009vmf.2"; class_code "="; tss_id "TSS104"; p_id "P142"; chr1 coding exon 7826519 7829763 . + . gene_id "XLOC_000074"; transcript_id "TCONS_00000197"; exon_number "6"; oId "uc009vmf.2"; nearest_ref "uc009vmf.2"; class_code "="; tss_id "TSS104"; p_id "P142"; chr1 coding exon 7831329 7831445 . + . gene_id "XLOC_000075"; transcript_id "TCONS_00000198"; exon_number "1"; gene_name "VAMP3"; oId "uc001aol.2"; nearest_ref "uc001aol.2"; class_code "="; tss_id "TSS105"; p_id "P146"; chr1 coding exon 7833502 7833571 . + . gene_id "XLOC_000075"; transcript_id "TCONS_00000198"; exon_number "2"; gene_name "VAMP3"; oId "uc001aol.2"; nearest_ref "uc001aol.2"; class_code "="; tss_id "TSS105"; p_id "P146"; chr1 coding exon 7837220 7837378 . + . gene_id "XLOC_000075"; transcript_id "TCONS_00000198"; exon_number "3"; gene_name "VAMP3"; oId "uc001aol.2"; nearest_ref "uc001aol.2"; class_code "="; tss_id "TSS105"; p_id "P146"; chr1 coding exon 7838178 7838229 . + . gene_id "XLOC_000075"; transcript_id "TCONS_00000198"; exon_number "4"; gene_name "VAMP3"; oId "uc001aol.2"; nearest_ref "uc001aol.2"; class_code "="; tss_id "TSS105"; p_id "P146"; chr1 coding exon 7839686 7841491 . + . gene_id "XLOC_000075"; transcript_id "TCONS_00000198"; exon_number "5"; gene_name "VAMP3"; oId "uc001aol.2"; nearest_ref "uc001aol.2"; class_code "="; tss_id "TSS105"; p_id "P146"; chr1 coding exon 7844380 7844436 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "1"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7844714 7845065 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "2"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7845501 7845646 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "3"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7846781 7846896 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "4"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7848105 7848306 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "5"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7854020 7854068 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "6"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7858585 7858733 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "7"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7861173 7861251 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "8"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7863107 7863213 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "9"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7863752 7864017 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000199"; exon_number "10"; gene_name "PER3"; oId "uc001aon.2"; nearest_ref "uc001aon.2"; class_code "="; tss_id "TSS106"; p_id "P150"; chr1 coding exon 7844440 7844528 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "1"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7844714 7845065 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "2"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7845501 7845646 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "3"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7846781 7846896 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "4"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7848105 7848306 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "5"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7854017 7854068 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "6"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7858585 7858733 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "7"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7861173 7861251 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "8"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7863107 7863213 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "9"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7863752 7863908 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "10"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7868953 7869058 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "11"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7869953 7870081 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "12"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7870498 7870648 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "13"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7879345 7879480 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "14"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7880175 7880299 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "15"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7880527 7880700 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "16"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7886540 7886770 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "17"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7887178 7887875 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "18"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7889897 7890221 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000200"; exon_number "19"; gene_name "PER3"; oId "uc009vmg.1"; nearest_ref "uc009vmg.1"; class_code "="; tss_id "TSS106"; p_id "P148"; chr1 coding exon 7844714 7845065 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "1"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7845501 7845646 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "2"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7846781 7846896 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "3"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7848105 7848306 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "4"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7854017 7854068 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "5"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7858585 7858733 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "6"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7861173 7861251 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "7"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7863107 7863213 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "8"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7863752 7863908 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "9"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7868953 7869058 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "10"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7869953 7870081 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "11"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7870498 7870627 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "12"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7879345 7879480 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "13"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7880175 7880299 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "14"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7880527 7880700 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "15"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7886540 7886770 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "16"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7887178 7887875 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "17"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7889897 7890221 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000201"; exon_number "18"; gene_name "PER3"; oId "uc009vmh.1"; nearest_ref "uc009vmh.1"; class_code "="; tss_id "TSS107"; p_id "P147"; chr1 coding exon 7844714 7845065 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "1"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7845501 7845646 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "2"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7846781 7846896 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "3"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7848105 7848306 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "4"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7854020 7854068 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "5"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7858521 7858733 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "6"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7861173 7861251 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "7"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7863107 7863213 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "8"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7863752 7863908 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "9"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7868953 7869058 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "10"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7869953 7870081 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "11"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7870498 7870648 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "12"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7879345 7879480 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "13"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7880175 7880299 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "14"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7880527 7880700 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "15"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7886540 7886770 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "16"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7887178 7887875 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "17"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7889897 7890221 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "18"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7895822 7896005 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "19"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7897059 7897209 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "20"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7902732 7905236 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000204"; exon_number "21"; gene_name "PER3"; oId "uc010nzw.1"; nearest_ref "uc010nzw.1"; class_code "="; tss_id "TSS107"; p_id "P151"; chr1 coding exon 7844714 7845065 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "1"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7845501 7845646 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "2"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7846781 7846896 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "3"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7848105 7848306 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "4"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7854017 7854068 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "5"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7858585 7858733 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "6"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7861173 7861251 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "7"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7863107 7863213 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "8"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7863752 7863908 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "9"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7868953 7869058 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "10"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7869953 7870081 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "11"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7870498 7870648 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "12"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7879345 7879480 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "13"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7880175 7880299 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "14"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7880527 7880700 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "15"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7886540 7886770 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "16"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7887178 7887875 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "17"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7889894 7890221 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "18"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7895822 7896005 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "19"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7897059 7897209 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "20"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7902732 7905236 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000203"; exon_number "21"; gene_name "PER3"; oId "uc001aop.2"; nearest_ref "uc001aop.2"; class_code "="; tss_id "TSS107"; p_id "P152"; chr1 coding exon 7844714 7845065 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "1"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7845501 7845646 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "2"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7846781 7846896 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "3"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7848105 7848306 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "4"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7854020 7854068 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "5"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7858585 7858733 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "6"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7861173 7861251 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "7"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7863107 7863213 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "8"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7863752 7863908 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "9"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7868953 7869058 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "10"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7869953 7870081 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "11"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7870498 7870627 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "12"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7879345 7879480 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "13"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7880175 7880299 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "14"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7880527 7880700 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "15"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7886540 7886770 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "16"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7887178 7887875 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "17"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7889897 7890221 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "18"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7895822 7896005 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "19"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7897059 7897209 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "20"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 7902732 7905236 . + . gene_id "XLOC_000076"; transcript_id "TCONS_00000202"; exon_number "21"; gene_name "PER3"; oId "uc001aoo.2"; nearest_ref "uc001aoo.2"; class_code "="; tss_id "TSS107"; p_id "P149"; chr1 coding exon 8021714 8021853 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000205"; exon_number "1"; gene_name "PARK7"; oId "uc001aow.3"; nearest_ref "uc001aow.3"; class_code "="; tss_id "TSS108"; p_id "P153"; chr1 coding exon 8022823 8022935 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000205"; exon_number "2"; gene_name "PARK7"; oId "uc001aow.3"; nearest_ref "uc001aow.3"; class_code "="; tss_id "TSS108"; p_id "P153"; chr1 coding exon 8025384 8025485 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000205"; exon_number "3"; gene_name "PARK7"; oId "uc001aow.3"; nearest_ref "uc001aow.3"; class_code "="; tss_id "TSS108"; p_id "P153"; chr1 coding exon 8029405 8029464 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000205"; exon_number "4"; gene_name "PARK7"; oId "uc001aow.3"; nearest_ref "uc001aow.3"; class_code "="; tss_id "TSS108"; p_id "P153"; chr1 coding exon 8030954 8032014 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000205"; exon_number "5"; gene_name "PARK7"; oId "uc001aow.3"; nearest_ref "uc001aow.3"; class_code "="; tss_id "TSS108"; p_id "P153"; chr1 coding exon 8021714 8021853 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "1"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8022823 8022935 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "2"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8025384 8025485 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "3"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8029405 8029464 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "4"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8030954 8031023 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "5"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8037712 8037798 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "6"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8044954 8045341 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000208"; exon_number "7"; gene_name "PARK7"; oId "uc001aox.3"; nearest_ref "uc001aox.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8021714 8021795 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000207"; exon_number "1"; gene_name "PARK7"; oId "uc001aov.3"; nearest_ref "uc001aov.3"; class_code "="; tss_id "TSS108"; p_id "P154"; chr1 coding exon 8022823 8022935 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000207"; exon_number "2"; gene_name "PARK7"; oId "uc001aov.3"; nearest_ref "uc001aov.3"; class_code "="; tss_id "TSS108"; p_id "P154"; chr1 coding exon 8025384 8025485 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000207"; exon_number "3"; gene_name "PARK7"; oId "uc001aov.3"; nearest_ref "uc001aov.3"; class_code "="; tss_id "TSS108"; p_id "P154"; chr1 coding exon 8030954 8031023 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000207"; exon_number "4"; gene_name "PARK7"; oId "uc001aov.3"; nearest_ref "uc001aov.3"; class_code "="; tss_id "TSS108"; p_id "P154"; chr1 coding exon 8037712 8037798 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000207"; exon_number "5"; gene_name "PARK7"; oId "uc001aov.3"; nearest_ref "uc001aov.3"; class_code "="; tss_id "TSS108"; p_id "P154"; chr1 coding exon 8044954 8045341 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000207"; exon_number "6"; gene_name "PARK7"; oId "uc001aov.3"; nearest_ref "uc001aov.3"; class_code "="; tss_id "TSS108"; p_id "P154"; chr1 coding exon 8021714 8021795 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "1"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8022823 8022935 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "2"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8025384 8025485 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "3"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8029405 8029464 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "4"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8030954 8031023 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "5"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8037712 8037798 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "6"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 coding exon 8044954 8045341 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000206"; exon_number "7"; gene_name "PARK7"; oId "uc001aou.3"; nearest_ref "uc001aou.3"; class_code "="; tss_id "TSS108"; p_id "P155"; chr1 nearCoding exon 8043019 8045341 . + . gene_id "XLOC_000077"; transcript_id "TCONS_00000209"; exon_number "1"; oId "uc001aoy.1"; nearest_ref "uc001aoy.1"; class_code "="; chr1 coding exon 8384390 8384786 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "1"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8385358 8385450 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "2"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8385878 8386102 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "3"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8390269 8390996 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "4"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8395497 8395650 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "5"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8397876 8398052 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "6"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8399553 8399758 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "7"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8403807 8404226 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000210"; exon_number "8"; gene_name "SLC45A1"; oId "uc001apb.2"; nearest_ref "uc001apb.2"; class_code "="; tss_id "TSS109"; p_id "P156"; chr1 coding exon 8390198 8390996 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000211"; exon_number "1"; gene_name "SLC45A1"; oId "uc001apc.2"; nearest_ref "uc001apc.2"; class_code "="; tss_id "TSS110"; p_id "P157"; chr1 coding exon 8395497 8395650 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000211"; exon_number "2"; gene_name "SLC45A1"; oId "uc001apc.2"; nearest_ref "uc001apc.2"; class_code "="; tss_id "TSS110"; p_id "P157"; chr1 coding exon 8397876 8398052 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000211"; exon_number "3"; gene_name "SLC45A1"; oId "uc001apc.2"; nearest_ref "uc001apc.2"; class_code "="; tss_id "TSS110"; p_id "P157"; chr1 coding exon 8399553 8399758 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000211"; exon_number "4"; gene_name "SLC45A1"; oId "uc001apc.2"; nearest_ref "uc001apc.2"; class_code "="; tss_id "TSS110"; p_id "P157"; chr1 coding exon 8403807 8404226 . + . gene_id "XLOC_000078"; transcript_id "TCONS_00000211"; exon_number "5"; gene_name "SLC45A1"; oId "uc001apc.2"; nearest_ref "uc001apc.2"; class_code "="; tss_id "TSS110"; p_id "P157"; chr1 coding exon 9005922 9006024 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "1"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9017196 9017344 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "2"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9018969 9019061 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "3"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9022646 9022715 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "4"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9027718 9027875 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "5"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9030926 9031040 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "6"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9034681 9035146 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000213"; exon_number "7"; gene_name "CA6"; oId "uc009vmn.2"; nearest_ref "uc009vmn.2"; class_code "="; tss_id "TSS111"; p_id "P159"; chr1 coding exon 9005922 9006024 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "1"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9009322 9009501 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "2"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9017196 9017344 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "3"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9018969 9019061 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "4"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9022646 9022715 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "5"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9027718 9027875 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "6"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9030926 9031040 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "7"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9034681 9035146 . + . gene_id "XLOC_000079"; transcript_id "TCONS_00000212"; exon_number "8"; gene_name "CA6"; oId "uc001apm.2"; nearest_ref "uc001apm.2"; class_code "="; tss_id "TSS111"; p_id "P158"; chr1 coding exon 9294863 9295125 . + . gene_id "XLOC_000080"; transcript_id "TCONS_00000214"; exon_number "1"; gene_name "H6PD"; oId "uc001apt.2"; nearest_ref "uc001apt.2"; class_code "="; tss_id "TSS112"; p_id "P160"; chr1 coding exon 9304984 9305620 . + . gene_id "XLOC_000080"; transcript_id "TCONS_00000214"; exon_number "2"; gene_name "H6PD"; oId "uc001apt.2"; nearest_ref "uc001apt.2"; class_code "="; tss_id "TSS112"; p_id "P160"; chr1 coding exon 9307025 9307142 . + . gene_id "XLOC_000080"; transcript_id "TCONS_00000214"; exon_number "3"; gene_name "H6PD"; oId "uc001apt.2"; nearest_ref "uc001apt.2"; class_code "="; tss_id "TSS112"; p_id "P160"; chr1 coding exon 9322118 9322387 . + . gene_id "XLOC_000080"; transcript_id "TCONS_00000214"; exon_number "4"; gene_name "H6PD"; oId "uc001apt.2"; nearest_ref "uc001apt.2"; class_code "="; tss_id "TSS112"; p_id "P160"; chr1 coding exon 9323568 9331392 . + . gene_id "XLOC_000080"; transcript_id "TCONS_00000214"; exon_number "5"; gene_name "H6PD"; oId "uc001apt.2"; nearest_ref "uc001apt.2"; class_code "="; tss_id "TSS112"; p_id "P160"; chr1 coding exon 9352941 9353130 . + . gene_id "XLOC_000081"; transcript_id "TCONS_00000215"; exon_number "1"; gene_name "SPSB1"; oId "uc010oae.1"; nearest_ref "uc010oae.1"; class_code "="; tss_id "TSS113"; p_id "P161"; chr1 coding exon 9415802 9416644 . + . gene_id "XLOC_000081"; transcript_id "TCONS_00000215"; exon_number "2"; gene_name "SPSB1"; oId "uc010oae.1"; nearest_ref "uc010oae.1"; class_code "="; tss_id "TSS113"; p_id "P161"; chr1 coding exon 9427507 9429588 . + . gene_id "XLOC_000081"; transcript_id "TCONS_00000215"; exon_number "3"; gene_name "SPSB1"; oId "uc010oae.1"; nearest_ref "uc010oae.1"; class_code "="; tss_id "TSS113"; p_id "P161"; chr1 coding exon 9415766 9416644 . + . gene_id "XLOC_000081"; transcript_id "TCONS_00000216"; exon_number "1"; gene_name "SPSB1"; oId "uc001apv.2"; nearest_ref "uc001apv.2"; class_code "="; tss_id "TSS114"; p_id "P161"; chr1 coding exon 9427507 9429588 . + . gene_id "XLOC_000081"; transcript_id "TCONS_00000216"; exon_number "2"; gene_name "SPSB1"; oId "uc001apv.2"; nearest_ref "uc001apv.2"; class_code "="; tss_id "TSS114"; p_id "P161"; chr1 coding exon 9599528 9599806 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "1"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9613684 9613863 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "2"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9616240 9616315 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "3"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9627342 9627419 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "4"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9630316 9630416 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "5"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9633404 9633470 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "6"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9640012 9640292 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "7"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9642357 9642830 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000218"; exon_number "8"; gene_name "SLC25A33"; oId "uc001apx.2"; nearest_ref "uc001apx.2"; class_code "="; tss_id "TSS115"; p_id "P162"; chr1 coding exon 9599528 9599806 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "1"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9613684 9613863 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "2"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9627342 9627419 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "3"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9630316 9630416 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "4"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9633404 9633470 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "5"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9640012 9640292 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "6"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9642357 9642830 . + . gene_id "XLOC_000082"; transcript_id "TCONS_00000217"; exon_number "7"; gene_name "SLC25A33"; oId "uc001apw.2"; nearest_ref "uc001apw.2"; class_code "="; tss_id "TSS115"; p_id "P163"; chr1 coding exon 9648977 9649101 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000219"; exon_number "1"; gene_name "TMEM201"; oId "uc001apy.2"; nearest_ref "uc001apy.2"; class_code "="; tss_id "TSS116"; p_id "P164"; chr1 coding exon 9655948 9656068 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000219"; exon_number "2"; gene_name "TMEM201"; oId "uc001apy.2"; nearest_ref "uc001apy.2"; class_code "="; tss_id "TSS116"; p_id "P164"; chr1 coding exon 9656917 9657111 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000219"; exon_number "3"; gene_name "TMEM201"; oId "uc001apy.2"; nearest_ref "uc001apy.2"; class_code "="; tss_id "TSS116"; p_id "P164"; chr1 coding exon 9658507 9658683 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000219"; exon_number "4"; gene_name "TMEM201"; oId "uc001apy.2"; nearest_ref "uc001apy.2"; class_code "="; tss_id "TSS116"; p_id "P164"; chr1 coding exon 9661163 9661512 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000219"; exon_number "5"; gene_name "TMEM201"; oId "uc001apy.2"; nearest_ref "uc001apy.2"; class_code "="; tss_id "TSS116"; p_id "P164"; chr1 coding exon 9662127 9665006 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000219"; exon_number "6"; gene_name "TMEM201"; oId "uc001apy.2"; nearest_ref "uc001apy.2"; class_code "="; tss_id "TSS116"; p_id "P164"; chr1 coding exon 9648977 9649101 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "1"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9655948 9656068 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "2"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9656917 9657111 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "3"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9658507 9658683 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "4"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9661163 9661512 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "5"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9662127 9662330 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "6"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9667615 9667847 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "7"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9670564 9670863 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "8"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9671811 9671948 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "9"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9673044 9674935 . + . gene_id "XLOC_000083"; transcript_id "TCONS_00000220"; exon_number "10"; gene_name "TMEM201"; oId "uc001apz.2"; nearest_ref "uc001apz.2"; class_code "="; tss_id "TSS116"; p_id "P165"; chr1 coding exon 9711790 9711860 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "1"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9751525 9751629 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "2"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9770482 9770654 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "3"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9775599 9775827 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "4"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9775907 9776136 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "5"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9776498 9776677 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "6"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9777017 9777166 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "7"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9777595 9777684 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "8"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9778752 9778973 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "9"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9779979 9780075 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "10"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9780170 9780300 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "11"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9780669 9780719 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "12"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9780800 9780967 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "13"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9781185 9781306 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "14"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9781502 9781645 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "15"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9781819 9781918 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "16"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9782033 9782211 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "17"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9782302 9782414 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "18"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9782586 9782664 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "19"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9783183 9783350 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "20"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9784027 9784150 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "21"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9784334 9784479 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "22"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9784862 9784994 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "23"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9786967 9789171 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000221"; exon_number "24"; gene_name "PIK3CD"; oId "uc001aqb.3"; nearest_ref "uc001aqb.3"; class_code "="; tss_id "TSS117"; p_id "P167"; chr1 coding exon 9751525 9751629 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "1"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9770482 9770654 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "2"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9775599 9775827 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "3"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9775907 9776136 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "4"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9776498 9776677 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "5"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9777017 9777166 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "6"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9777595 9777684 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "7"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9778752 9778973 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "8"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9779979 9780075 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "9"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9780170 9780300 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "10"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9780669 9780719 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "11"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9780803 9780967 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "12"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9781185 9781306 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "13"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9781502 9781645 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "14"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9781819 9781918 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "15"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9782033 9782211 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "16"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9782302 9782414 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "17"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9782586 9782664 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "18"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9783183 9783350 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "19"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9784027 9784150 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "20"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9784334 9784479 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "21"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9784862 9784994 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "22"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9786967 9789171 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000222"; exon_number "23"; gene_name "PIK3CD"; oId "uc010oaf.1"; nearest_ref "uc010oaf.1"; class_code "="; tss_id "TSS118"; p_id "P168"; chr1 coding exon 9770163 9770338 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "1"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9770482 9770654 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "2"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9775599 9775827 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "3"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9775907 9776136 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "4"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9776498 9776677 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "5"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9777122 9777166 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "6"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9777595 9777684 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "7"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9778752 9778973 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "8"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9779979 9780075 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "9"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9780170 9780300 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "10"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9780492 9780719 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "11"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9780800 9780967 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "12"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9781185 9781306 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "13"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9781502 9781645 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "14"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9781819 9781918 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "15"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9782033 9782211 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "16"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9782302 9782414 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "17"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9782586 9782664 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "18"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9783183 9783350 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "19"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9784027 9784150 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "20"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9784334 9784479 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "21"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9784862 9784994 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "22"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 9786967 9789171 . + . gene_id "XLOC_000084"; transcript_id "TCONS_00000223"; exon_number "23"; gene_name "PIK3CD"; oId "uc001aqe.3"; nearest_ref "uc001aqe.3"; class_code "="; tss_id "TSS119"; p_id "P166"; chr1 coding exon 10003486 10003573 . + . gene_id "XLOC_000085"; transcript_id "TCONS_00000224"; exon_number "1"; gene_name "NMNAT1"; oId "uc001aqp.2"; nearest_ref "uc001aqp.2"; class_code "="; tss_id "TSS120"; p_id "P169"; chr1 coding exon 10032076 10032246 . + . gene_id "XLOC_000085"; transcript_id "TCONS_00000224"; exon_number "2"; gene_name "NMNAT1"; oId "uc001aqp.2"; nearest_ref "uc001aqp.2"; class_code "="; tss_id "TSS120"; p_id "P169"; chr1 coding exon 10035650 10035833 . + . gene_id "XLOC_000085"; transcript_id "TCONS_00000224"; exon_number "3"; gene_name "NMNAT1"; oId "uc001aqp.2"; nearest_ref "uc001aqp.2"; class_code "="; tss_id "TSS120"; p_id "P169"; chr1 coding exon 10041089 10041228 . + . gene_id "XLOC_000085"; transcript_id "TCONS_00000224"; exon_number "4"; gene_name "NMNAT1"; oId "uc001aqp.2"; nearest_ref "uc001aqp.2"; class_code "="; tss_id "TSS120"; p_id "P169"; chr1 coding exon 10042359 10045555 . + . gene_id "XLOC_000085"; transcript_id "TCONS_00000224"; exon_number "5"; gene_name "NMNAT1"; oId "uc001aqp.2"; nearest_ref "uc001aqp.2"; class_code "="; tss_id "TSS120"; p_id "P169"; chr1 nearCoding exon 10057255 10057389 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000226"; exon_number "1"; gene_name "RBP7"; oId "uc009vms.2"; nearest_ref "uc009vms.2"; class_code "="; tss_id "TSS121"; chr1 nearCoding exon 10064151 10064365 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000226"; exon_number "2"; gene_name "RBP7"; oId "uc009vms.2"; nearest_ref "uc009vms.2"; class_code "="; tss_id "TSS121"; chr1 nearCoding exon 10067628 10067806 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000226"; exon_number "3"; gene_name "RBP7"; oId "uc009vms.2"; nearest_ref "uc009vms.2"; class_code "="; tss_id "TSS121"; chr1 nearCoding exon 10068231 10068332 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000226"; exon_number "4"; gene_name "RBP7"; oId "uc009vms.2"; nearest_ref "uc009vms.2"; class_code "="; tss_id "TSS121"; chr1 nearCoding exon 10075840 10076077 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000226"; exon_number "5"; gene_name "RBP7"; oId "uc009vms.2"; nearest_ref "uc009vms.2"; class_code "="; tss_id "TSS121"; chr1 coding exon 10057255 10057389 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000225"; exon_number "1"; gene_name "RBP7"; oId "uc001aqq.2"; nearest_ref "uc001aqq.2"; class_code "="; tss_id "TSS121"; p_id "P170"; chr1 coding exon 10067628 10067806 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000225"; exon_number "2"; gene_name "RBP7"; oId "uc001aqq.2"; nearest_ref "uc001aqq.2"; class_code "="; tss_id "TSS121"; p_id "P170"; chr1 coding exon 10068231 10068332 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000225"; exon_number "3"; gene_name "RBP7"; oId "uc001aqq.2"; nearest_ref "uc001aqq.2"; class_code "="; tss_id "TSS121"; p_id "P170"; chr1 coding exon 10075840 10076077 . + . gene_id "XLOC_000086"; transcript_id "TCONS_00000225"; exon_number "4"; gene_name "RBP7"; oId "uc001aqq.2"; nearest_ref "uc001aqq.2"; class_code "="; tss_id "TSS121"; p_id "P170"; chr1 nearCoding exon 10093016 10093752 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "1"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10132086 10132272 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "2"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10155519 10155654 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "3"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10161166 10161253 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "4"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10163006 10163150 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "5"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10165574 10165802 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "6"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10177517 10177658 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "7"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10179571 10179671 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "8"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10182020 10182134 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "9"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10186852 10186935 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "10"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10189450 10189506 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "11"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10190558 10190674 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "12"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10190773 10190871 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "13"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10192427 10192540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "14"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10195046 10195244 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "15"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10197125 10197263 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "16"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10204998 10205097 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "17"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10207021 10207148 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "18"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10209242 10209340 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "19"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10211384 10211619 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "20"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10218414 10218540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "21"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10221200 10221344 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "22"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10228194 10228328 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "23"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10231163 10231387 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "24"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10238702 10238876 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "25"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10239474 10239620 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "26"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 nearCoding exon 10239953 10241294 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000229"; exon_number "27"; gene_name "UBE4B"; oId "uc010oai.1"; nearest_ref "uc010oai.1"; class_code "="; tss_id "TSS122"; chr1 coding exon 10093016 10093752 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "1"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10132086 10132272 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "2"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10155519 10155654 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "3"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10161166 10161253 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "4"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10163006 10163150 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "5"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10165574 10165802 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "6"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10177517 10177658 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "7"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10179571 10179671 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "8"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10186852 10186935 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "9"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10189450 10189506 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "10"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10190558 10190674 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "11"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10190773 10190871 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "12"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10192427 10192540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "13"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10195046 10195244 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "14"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10197125 10197263 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "15"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10204998 10205097 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "16"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10207021 10207148 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "17"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10209242 10209340 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "18"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10211384 10211619 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "19"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10218414 10218540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "20"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10221200 10221344 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "21"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10228194 10228328 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "22"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10231196 10231387 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "23"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10238702 10238876 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "24"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10239474 10239620 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "25"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10239953 10241294 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000230"; exon_number "26"; oId "uc010oaj.1"; nearest_ref "uc010oaj.1"; class_code "="; tss_id "TSS122"; p_id "P171"; chr1 coding exon 10093016 10093752 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "1"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10132086 10132272 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "2"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10155519 10155654 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "3"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10161166 10161253 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "4"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10163006 10163150 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "5"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10165574 10165802 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "6"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10166255 10166641 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "7"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10177517 10177658 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "8"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10179571 10179671 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "9"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10182020 10182134 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "10"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10186852 10186935 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "11"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10189450 10189506 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "12"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10190558 10190674 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "13"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10190773 10190871 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "14"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10192427 10192540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "15"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10195046 10195244 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "16"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10197125 10197263 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "17"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10204998 10205097 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "18"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10207021 10207148 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "19"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10209242 10209340 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "20"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10211384 10211619 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "21"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10218414 10218540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "22"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10221200 10221344 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "23"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10228194 10228328 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "24"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10231196 10231387 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "25"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10238702 10238876 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "26"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10239474 10239620 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "27"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10239953 10241294 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000228"; exon_number "28"; gene_name "UBE4B"; oId "uc001aqs.3"; nearest_ref "uc001aqs.3"; class_code "="; tss_id "TSS122"; p_id "P175"; chr1 coding exon 10093016 10093752 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "1"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10132086 10132272 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "2"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10155519 10155654 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "3"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10161166 10161253 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "4"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10163006 10163150 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "5"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10165574 10165802 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "6"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10177517 10177658 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "7"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10179571 10179671 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "8"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10182020 10182134 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "9"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10186852 10186935 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "10"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10189450 10189506 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "11"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10190558 10190674 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "12"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10190773 10190871 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "13"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10192427 10192540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "14"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10195046 10195244 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "15"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10197125 10197263 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "16"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10204998 10205097 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "17"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10207021 10207148 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "18"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10209242 10209340 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "19"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10211384 10211619 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "20"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10218414 10218540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "21"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10221200 10221344 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "22"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10228194 10228328 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "23"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10231196 10231387 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "24"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10238702 10238876 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "25"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10239474 10239620 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "26"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10239953 10241294 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000227"; exon_number "27"; gene_name "UBE4B"; oId "uc001aqr.3"; nearest_ref "uc001aqr.3"; class_code "="; tss_id "TSS122"; p_id "P173"; chr1 coding exon 10192427 10192540 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "1"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10195046 10195244 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "2"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10197125 10197263 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "3"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10204998 10205097 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "4"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10207021 10207148 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "5"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10209242 10209340 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "6"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10211384 10211639 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000231"; exon_number "7"; oId "uc001aqt.1"; nearest_ref "uc001aqt.1"; class_code "="; tss_id "TSS123"; p_id "P174"; chr1 coding exon 10231014 10231387 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000232"; exon_number "1"; oId "uc001aqu.2"; nearest_ref "uc001aqu.2"; class_code "="; tss_id "TSS124"; p_id "P172"; chr1 coding exon 10238702 10238876 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000232"; exon_number "2"; oId "uc001aqu.2"; nearest_ref "uc001aqu.2"; class_code "="; tss_id "TSS124"; p_id "P172"; chr1 coding exon 10239474 10239620 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000232"; exon_number "3"; oId "uc001aqu.2"; nearest_ref "uc001aqu.2"; class_code "="; tss_id "TSS124"; p_id "P172"; chr1 coding exon 10239953 10241294 . + . gene_id "XLOC_000087"; transcript_id "TCONS_00000232"; exon_number "4"; oId "uc001aqu.2"; nearest_ref "uc001aqu.2"; class_code "="; tss_id "TSS124"; p_id "P172"; chr1 nearCoding exon 10270764 10270936 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "1"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "2"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "3"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "4"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "5"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "6"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "7"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "8"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "9"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10333072 10333335 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "10"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 nearCoding exon 10334274 10334467 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000233"; exon_number "11"; oId "uc009vmt.2"; nearest_ref "uc009vmt.2"; class_code "="; tss_id "TSS125"; chr1 coding exon 10270764 10270936 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "1"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "2"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "3"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "4"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "5"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "6"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "7"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "8"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "9"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "10"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "11"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "12"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10342458 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "13"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "14"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "15"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "16"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "17"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "18"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "19"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "20"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10363221 10368653 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000234"; exon_number "21"; gene_name "KIF1B"; oId "uc001aqv.3"; nearest_ref "uc001aqv.3"; class_code "="; tss_id "TSS125"; p_id "P181"; chr1 coding exon 10270764 10270936 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "1"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "2"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "3"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "4"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "5"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "6"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "7"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "8"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "9"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "10"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "11"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "12"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10342458 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "13"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "14"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "15"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "16"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "17"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "18"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "19"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "20"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10380101 10380194 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "21"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10381767 10381915 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "22"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10383942 10384120 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "23"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10384816 10384953 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "24"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10386169 10386417 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "25"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10394578 10394696 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "26"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10396715 10396800 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "27"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10397132 10397261 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "28"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10397429 10397591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "29"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10399827 10399917 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "30"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10402108 10402226 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "31"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10403290 10403345 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "32"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10405903 10406011 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "33"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10407819 10407885 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "34"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10408707 10408791 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "35"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10412689 10412794 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "36"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10420987 10421101 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "37"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10421750 10421883 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "38"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10423341 10423402 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "39"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10425158 10425303 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "40"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10425467 10425706 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "41"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10428525 10428596 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "42"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10431199 10431320 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "43"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10434374 10434523 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "44"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10434912 10435104 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "45"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10435313 10435431 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "46"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10436603 10441659 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000235"; exon_number "47"; gene_name "KIF1B"; oId "uc001aqw.3"; nearest_ref "uc001aqw.3"; class_code "="; tss_id "TSS125"; p_id "P182"; chr1 coding exon 10271674 10271796 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "1"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "2"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "3"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "4"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "5"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "6"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "7"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "8"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "9"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10333072 10333089 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "10"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "11"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "12"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "13"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10339155 10339196 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "14"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10342380 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "15"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "16"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "17"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "18"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "19"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "20"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "21"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "22"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10380101 10380194 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "23"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10381767 10381915 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "24"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10383942 10384120 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "25"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10384816 10384953 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "26"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10386169 10386417 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "27"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10394578 10394696 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "28"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10396715 10396800 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "29"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10397132 10397261 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "30"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10397429 10397591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "31"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10399827 10399917 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "32"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10402108 10402226 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "33"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10403290 10403345 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "34"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10405903 10406011 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "35"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10407819 10407885 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "36"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10408707 10408791 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "37"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10412689 10412794 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "38"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10420987 10421101 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "39"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10421750 10421883 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "40"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10423341 10423402 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "41"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10425158 10425303 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "42"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10425467 10425706 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "43"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10428525 10428596 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "44"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10431199 10431320 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "45"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10434374 10434523 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "46"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10434912 10435104 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "47"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10435313 10435431 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "48"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10436603 10441659 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000236"; exon_number "49"; gene_name "KIF1B"; oId "uc001aqx.3"; nearest_ref "uc001aqx.3"; class_code "="; tss_id "TSS126"; p_id "P180"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "1"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "2"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "3"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "4"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "5"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "6"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "7"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "8"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10333072 10333089 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "9"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "10"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "11"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "12"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10342458 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "13"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "14"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "15"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "16"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "17"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "18"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "19"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "20"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10380101 10380194 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "21"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10381767 10381915 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "22"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10383942 10384120 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "23"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10384816 10384953 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "24"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10386169 10386417 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "25"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10394578 10394696 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "26"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10396715 10396800 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "27"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10397132 10397261 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "28"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10397429 10397591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "29"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10399827 10399917 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "30"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10402108 10402226 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "31"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10403290 10403345 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "32"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10405903 10406011 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "33"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10407819 10407885 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "34"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10408707 10408791 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "35"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10412689 10412794 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "36"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10420987 10421101 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "37"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10421750 10421883 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "38"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10423341 10423402 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "39"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10425158 10425303 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "40"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10425467 10425706 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "41"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10428525 10428596 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "42"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10431199 10431320 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "43"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10434374 10434523 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "44"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10434912 10435104 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "45"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10435313 10435431 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "46"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10438397 10441654 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000239"; exon_number "47"; gene_name "KIF1B"; oId "uc001ara.2"; nearest_ref "uc001ara.2"; class_code "="; tss_id "TSS127"; p_id "P176"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "1"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "2"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "3"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "4"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "5"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "6"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "7"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "8"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10333072 10333089 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "9"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "10"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "11"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "12"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10342380 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "13"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "14"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "15"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "16"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "17"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "18"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "19"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "20"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10380101 10380194 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "21"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10381767 10381915 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "22"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10383942 10384120 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "23"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10384816 10384953 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "24"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10386169 10386417 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "25"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10394578 10394696 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "26"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10396715 10396800 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "27"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10397132 10397261 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "28"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10397429 10397591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "29"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10399827 10399917 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "30"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10402108 10402226 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "31"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10403290 10403345 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "32"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10405903 10406011 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "33"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10407819 10407885 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "34"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10408707 10408791 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "35"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10412689 10412794 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "36"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10420987 10421101 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "37"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10421750 10421883 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "38"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10423341 10423402 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "39"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10425158 10425303 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "40"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10425467 10425706 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "41"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10428525 10428596 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "42"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10431199 10431320 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "43"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10434374 10434523 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "44"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10434912 10435104 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "45"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10435313 10435431 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "46"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10438397 10441654 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000240"; exon_number "47"; gene_name "KIF1B"; oId "uc001arb.2"; nearest_ref "uc001arb.2"; class_code "="; tss_id "TSS127"; p_id "P179"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "1"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "2"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "3"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "4"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "5"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "6"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "7"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "8"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10333072 10333089 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "9"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "10"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "11"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "12"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10339155 10339196 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "13"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10342380 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "14"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "15"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "16"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "17"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "18"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "19"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "20"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "21"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10380101 10380194 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "22"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10381767 10381915 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "23"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10383942 10384120 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "24"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10384816 10384953 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "25"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10386169 10386417 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "26"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10394578 10394696 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "27"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10396715 10396800 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "28"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10397132 10397261 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "29"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10397429 10397591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "30"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10399827 10399917 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "31"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10402108 10402226 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "32"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10403290 10403345 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "33"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10405903 10406011 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "34"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10407819 10407885 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "35"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10408707 10408791 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "36"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10412689 10412794 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "37"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10420987 10421101 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "38"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10421750 10421883 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "39"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10423341 10423402 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "40"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10425158 10425303 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "41"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10425467 10425706 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "42"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10428525 10428596 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "43"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10431199 10431320 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "44"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10434374 10434523 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "45"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10434912 10435104 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "46"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10435313 10435431 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "47"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10438397 10441654 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000238"; exon_number "48"; gene_name "KIF1B"; oId "uc001aqz.2"; nearest_ref "uc001aqz.2"; class_code "="; tss_id "TSS127"; p_id "P178"; chr1 coding exon 10292308 10292492 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "1"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10316305 10316381 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "2"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10318551 10318730 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "3"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10321963 10322028 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "4"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10327438 10327616 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "5"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10328210 10328321 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "6"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10331560 10331637 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "7"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10332299 10332364 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "8"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10333072 10333089 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "9"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10335486 10335561 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "10"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10336379 10336457 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "11"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10338044 10338186 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "12"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10339155 10339196 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "13"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10342458 10342591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "14"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10351140 10351219 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "15"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10352105 10352180 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "16"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10355144 10355223 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "17"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10355718 10355824 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "18"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10356640 10356723 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "19"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10356955 10357135 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "20"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10357232 10357304 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "21"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10380101 10380194 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "22"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10381767 10381915 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "23"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10383942 10384120 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "24"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10384816 10384953 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "25"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10386169 10386417 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "26"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10394578 10394696 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "27"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10396715 10396800 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "28"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10397132 10397261 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "29"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10397429 10397591 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "30"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10399827 10399917 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "31"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10402108 10402226 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "32"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10403290 10403345 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "33"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10405903 10406011 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "34"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10407819 10407885 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "35"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10408707 10408791 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "36"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10412689 10412794 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "37"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10420987 10421101 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "38"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10421750 10421883 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "39"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10423341 10423402 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "40"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10425158 10425303 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "41"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10425467 10425706 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "42"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10428525 10428596 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "43"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10431199 10431320 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "44"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10434374 10434523 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "45"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10434912 10435104 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "46"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10435313 10435431 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "47"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10438397 10441654 . + . gene_id "XLOC_000088"; transcript_id "TCONS_00000237"; exon_number "48"; gene_name "KIF1B"; oId "uc001aqy.2"; nearest_ref "uc001aqy.2"; class_code "="; tss_id "TSS127"; p_id "P177"; chr1 coding exon 10459085 10459182 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "1"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10459686 10459761 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "2"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10460450 10460629 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "3"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10464218 10464336 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "4"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10468128 10468197 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "5"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10471475 10471609 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "6"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10473119 10473308 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "7"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10477044 10477174 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "8"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10477433 10477566 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "9"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10478883 10478982 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "10"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10479474 10479596 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "11"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10479687 10480200 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000243"; exon_number "12"; gene_name "PGD"; oId "uc010oak.1"; nearest_ref "uc010oak.1"; class_code "="; tss_id "TSS128"; p_id "P186"; chr1 coding exon 10459085 10459182 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "1"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10459686 10459761 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "2"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10460450 10460629 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "3"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10463128 10463193 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "4"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10464218 10464336 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "5"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10468128 10468201 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "6"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10471475 10471609 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "7"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10473119 10473308 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "8"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10477044 10477174 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "9"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10477433 10477566 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "10"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10478883 10478982 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "11"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10479474 10479596 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "12"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10479687 10480200 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000242"; exon_number "13"; gene_name "PGD"; oId "uc001ard.2"; nearest_ref "uc001ard.2"; class_code "="; tss_id "TSS128"; p_id "P185"; chr1 coding exon 10459085 10459182 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "1"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10459686 10459761 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "2"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10460450 10460629 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "3"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10463128 10463193 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "4"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10464218 10464336 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "5"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10468128 10468197 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "6"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10471475 10471609 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "7"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10473119 10473308 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "8"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10477044 10477174 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "9"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10477433 10477566 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "10"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10478883 10478982 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "11"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10479474 10479596 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "12"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10479687 10480200 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000241"; exon_number "13"; gene_name "PGD"; oId "uc001arc.2"; nearest_ref "uc001arc.2"; class_code "="; tss_id "TSS128"; p_id "P183"; chr1 coding exon 10459175 10459387 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "1"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10459686 10459761 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "2"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10460450 10460629 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "3"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10463128 10463193 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "4"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10464218 10464336 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "5"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10468128 10468197 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "6"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10471475 10471609 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "7"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10473119 10473308 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "8"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10477044 10477174 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "9"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10477433 10477566 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "10"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10478883 10478982 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "11"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10479474 10479596 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "12"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10479687 10480200 . + . gene_id "XLOC_000089"; transcript_id "TCONS_00000244"; exon_number "13"; gene_name "PGD"; oId "uc010oal.1"; nearest_ref "uc010oal.1"; class_code "="; tss_id "TSS128"; p_id "P184"; chr1 coding exon 10490159 10490625 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000245"; exon_number "1"; gene_name "APITD1"; oId "uc001are.2"; nearest_ref "uc001are.2"; class_code "="; tss_id "TSS129"; p_id "P190"; chr1 coding exon 10493899 10494022 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000245"; exon_number "2"; gene_name "APITD1"; oId "uc001are.2"; nearest_ref "uc001are.2"; class_code "="; tss_id "TSS129"; p_id "P190"; chr1 coding exon 10494714 10494747 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000245"; exon_number "3"; gene_name "APITD1"; oId "uc001are.2"; nearest_ref "uc001are.2"; class_code "="; tss_id "TSS129"; p_id "P190"; chr1 coding exon 10500404 10500470 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000245"; exon_number "4"; gene_name "APITD1"; oId "uc001are.2"; nearest_ref "uc001are.2"; class_code "="; tss_id "TSS129"; p_id "P190"; chr1 coding exon 10502322 10502864 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000245"; exon_number "5"; gene_name "APITD1"; oId "uc001are.2"; nearest_ref "uc001are.2"; class_code "="; tss_id "TSS129"; p_id "P190"; chr1 coding exon 10490159 10490625 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000247"; exon_number "1"; gene_name "Cort"; oId "uc001arg.2"; nearest_ref "uc001arg.2"; class_code "="; tss_id "TSS129"; p_id "P189"; chr1 coding exon 10493899 10494022 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000247"; exon_number "2"; gene_name "Cort"; oId "uc001arg.2"; nearest_ref "uc001arg.2"; class_code "="; tss_id "TSS129"; p_id "P189"; chr1 coding exon 10494714 10494747 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000247"; exon_number "3"; gene_name "Cort"; oId "uc001arg.2"; nearest_ref "uc001arg.2"; class_code "="; tss_id "TSS129"; p_id "P189"; chr1 coding exon 10511434 10512208 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000247"; exon_number "4"; gene_name "Cort"; oId "uc001arg.2"; nearest_ref "uc001arg.2"; class_code "="; tss_id "TSS129"; p_id "P189"; chr1 coding exon 10490159 10490625 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000246"; exon_number "1"; gene_name "APITD1"; oId "uc001arf.2"; nearest_ref "uc001arf.2"; class_code "="; tss_id "TSS129"; p_id "P191"; chr1 coding exon 10493899 10494022 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000246"; exon_number "2"; gene_name "APITD1"; oId "uc001arf.2"; nearest_ref "uc001arf.2"; class_code "="; tss_id "TSS129"; p_id "P191"; chr1 coding exon 10494714 10494747 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000246"; exon_number "3"; gene_name "APITD1"; oId "uc001arf.2"; nearest_ref "uc001arf.2"; class_code "="; tss_id "TSS129"; p_id "P191"; chr1 coding exon 10500404 10500470 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000246"; exon_number "4"; gene_name "APITD1"; oId "uc001arf.2"; nearest_ref "uc001arf.2"; class_code "="; tss_id "TSS129"; p_id "P191"; chr1 coding exon 10511434 10512208 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000246"; exon_number "5"; gene_name "APITD1"; oId "uc001arf.2"; nearest_ref "uc001arf.2"; class_code "="; tss_id "TSS129"; p_id "P191"; chr1 coding exon 10490800 10491458 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000248"; exon_number "1"; gene_name "APITD1"; oId "uc001arh.2"; nearest_ref "uc001arh.2"; class_code "="; tss_id "TSS130"; p_id "P188"; chr1 coding exon 10493899 10494022 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000248"; exon_number "2"; gene_name "APITD1"; oId "uc001arh.2"; nearest_ref "uc001arh.2"; class_code "="; tss_id "TSS130"; p_id "P188"; chr1 coding exon 10494714 10494747 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000248"; exon_number "3"; gene_name "APITD1"; oId "uc001arh.2"; nearest_ref "uc001arh.2"; class_code "="; tss_id "TSS130"; p_id "P188"; chr1 coding exon 10500404 10500470 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000248"; exon_number "4"; gene_name "APITD1"; oId "uc001arh.2"; nearest_ref "uc001arh.2"; class_code "="; tss_id "TSS130"; p_id "P188"; chr1 coding exon 10502322 10502864 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000248"; exon_number "5"; gene_name "APITD1"; oId "uc001arh.2"; nearest_ref "uc001arh.2"; class_code "="; tss_id "TSS130"; p_id "P188"; chr1 coding exon 10509971 10510379 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000249"; exon_number "1"; gene_name "CORT"; oId "uc001ari.2"; nearest_ref "uc001ari.2"; class_code "="; tss_id "TSS131"; p_id "P187"; chr1 coding exon 10511434 10512208 . + . gene_id "XLOC_000090"; transcript_id "TCONS_00000249"; exon_number "2"; gene_name "CORT"; oId "uc001ari.2"; nearest_ref "uc001ari.2"; class_code "="; tss_id "TSS131"; p_id "P187"; chr1 nearCoding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000250"; exon_number "1"; gene_name "Pex14"; oId "uc001arl.2"; nearest_ref "uc001arl.2"; class_code "="; tss_id "TSS132"; chr1 nearCoding exon 10555331 10555378 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000250"; exon_number "2"; gene_name "Pex14"; oId "uc001arl.2"; nearest_ref "uc001arl.2"; class_code "="; tss_id "TSS132"; chr1 nearCoding exon 10579860 10580063 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000250"; exon_number "3"; gene_name "Pex14"; oId "uc001arl.2"; nearest_ref "uc001arl.2"; class_code "="; tss_id "TSS132"; chr1 nearCoding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000251"; exon_number "1"; gene_name "Pex14"; oId "uc001arm.1"; nearest_ref "uc001arm.1"; class_code "="; tss_id "TSS132"; chr1 nearCoding exon 10555331 10555378 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000251"; exon_number "2"; gene_name "Pex14"; oId "uc001arm.1"; nearest_ref "uc001arm.1"; class_code "="; tss_id "TSS132"; chr1 nearCoding exon 10636835 10637247 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000251"; exon_number "3"; gene_name "Pex14"; oId "uc001arm.1"; nearest_ref "uc001arm.1"; class_code "="; tss_id "TSS132"; chr1 nearCoding exon 10637871 10638484 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000251"; exon_number "4"; gene_name "Pex14"; oId "uc001arm.1"; nearest_ref "uc001arm.1"; class_code "="; tss_id "TSS132"; chr1 coding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000252"; exon_number "1"; gene_name "Pex14"; oId "uc009vmu.1"; nearest_ref "uc009vmu.1"; class_code "="; tss_id "TSS132"; p_id "P195"; chr1 coding exon 10555331 10555378 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000252"; exon_number "2"; gene_name "Pex14"; oId "uc009vmu.1"; nearest_ref "uc009vmu.1"; class_code "="; tss_id "TSS132"; p_id "P195"; chr1 coding exon 10596270 10596354 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000252"; exon_number "3"; gene_name "Pex14"; oId "uc009vmu.1"; nearest_ref "uc009vmu.1"; class_code "="; tss_id "TSS132"; p_id "P195"; chr1 coding exon 10678389 10678474 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000252"; exon_number "4"; gene_name "Pex14"; oId "uc009vmu.1"; nearest_ref "uc009vmu.1"; class_code "="; tss_id "TSS132"; p_id "P195"; chr1 coding exon 10683076 10683924 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000252"; exon_number "5"; gene_name "Pex14"; oId "uc009vmu.1"; nearest_ref "uc009vmu.1"; class_code "="; tss_id "TSS132"; p_id "P195"; chr1 coding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "1"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10555331 10555378 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "2"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10659295 10659423 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "3"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10678389 10678474 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "4"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10683076 10683178 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "5"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10684397 10684494 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "6"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10687329 10687420 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "7"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10689588 10690813 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000255"; exon_number "8"; gene_name "PEX14"; oId "uc010oam.1"; nearest_ref "uc010oam.1"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "1"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10555331 10555378 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "2"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10596270 10596354 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "3"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10678389 10678474 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "4"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10683076 10683178 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "5"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10684397 10684494 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "6"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10687329 10687420 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "7"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10689588 10690813 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000256"; exon_number "8"; gene_name "PEX14"; oId "uc010oan.1"; nearest_ref "uc010oan.1"; class_code "="; tss_id "TSS132"; p_id "P193"; chr1 coding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "1"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10555331 10555349 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "2"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10596288 10596354 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "3"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10659295 10659423 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "4"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10678389 10678474 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "5"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10683076 10683178 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "6"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10684397 10684494 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "7"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10687329 10687420 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "8"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10689588 10690813 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000254"; exon_number "9"; gene_name "PEX14"; oId "uc009vmv.2"; nearest_ref "uc009vmv.2"; class_code "="; tss_id "TSS132"; p_id "P194"; chr1 coding exon 10535003 10535059 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "1"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10555331 10555378 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "2"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10596270 10596354 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "3"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10659295 10659423 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "4"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10678389 10678474 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "5"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10683076 10683178 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "6"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10684397 10684494 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "7"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10687329 10687420 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "8"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10689588 10690813 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000253"; exon_number "9"; gene_name "PEX14"; oId "uc001arn.2"; nearest_ref "uc001arn.2"; class_code "="; tss_id "TSS132"; p_id "P192"; chr1 coding exon 10588312 10588416 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "1"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10596270 10596354 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "2"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10659295 10659423 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "3"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10678389 10678474 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "4"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10683076 10683178 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "5"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10684397 10684494 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "6"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10687329 10687420 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "7"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 10689588 10690813 . + . gene_id "XLOC_000091"; transcript_id "TCONS_00000257"; exon_number "8"; gene_name "PEX14"; oId "uc009vmw.2"; nearest_ref "uc009vmw.2"; class_code "="; tss_id "TSS133"; p_id "P194"; chr1 coding exon 11072679 11072800 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000259"; exon_number "1"; gene_name "TARDBP"; oId "uc010oap.1"; nearest_ref "uc010oap.1"; class_code "="; tss_id "TSS134"; p_id "P197"; chr1 coding exon 11073773 11074022 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000259"; exon_number "2"; gene_name "TARDBP"; oId "uc010oap.1"; nearest_ref "uc010oap.1"; class_code "="; tss_id "TSS134"; p_id "P197"; chr1 coding exon 11078790 11078930 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000259"; exon_number "3"; gene_name "TARDBP"; oId "uc010oap.1"; nearest_ref "uc010oap.1"; class_code "="; tss_id "TSS134"; p_id "P197"; chr1 coding exon 11080486 11080656 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000259"; exon_number "4"; gene_name "TARDBP"; oId "uc010oap.1"; nearest_ref "uc010oap.1"; class_code "="; tss_id "TSS134"; p_id "P197"; chr1 coding exon 11082181 11085548 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000259"; exon_number "5"; gene_name "TARDBP"; oId "uc010oap.1"; nearest_ref "uc010oap.1"; class_code "="; tss_id "TSS134"; p_id "P197"; chr1 coding exon 11072679 11072800 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000258"; exon_number "1"; gene_name "TARDBP"; oId "uc001art.2"; nearest_ref "uc001art.2"; class_code "="; tss_id "TSS134"; p_id "P196"; chr1 coding exon 11073773 11074022 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000258"; exon_number "2"; gene_name "TARDBP"; oId "uc001art.2"; nearest_ref "uc001art.2"; class_code "="; tss_id "TSS134"; p_id "P196"; chr1 coding exon 11076901 11077064 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000258"; exon_number "3"; gene_name "TARDBP"; oId "uc001art.2"; nearest_ref "uc001art.2"; class_code "="; tss_id "TSS134"; p_id "P196"; chr1 coding exon 11078790 11078930 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000258"; exon_number "4"; gene_name "TARDBP"; oId "uc001art.2"; nearest_ref "uc001art.2"; class_code "="; tss_id "TSS134"; p_id "P196"; chr1 coding exon 11080486 11080656 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000258"; exon_number "5"; gene_name "TARDBP"; oId "uc001art.2"; nearest_ref "uc001art.2"; class_code "="; tss_id "TSS134"; p_id "P196"; chr1 coding exon 11082181 11085548 . + . gene_id "XLOC_000092"; transcript_id "TCONS_00000258"; exon_number "6"; gene_name "TARDBP"; oId "uc001art.2"; nearest_ref "uc001art.2"; class_code "="; tss_id "TSS134"; p_id "P196"; chr1 coding exon 11249398 11250012 . + . gene_id "XLOC_000093"; transcript_id "TCONS_00000260"; exon_number "1"; gene_name "ANGPTL7"; oId "uc001ase.2"; nearest_ref "uc001ase.2"; class_code "="; tss_id "TSS135"; p_id "P198"; chr1 coding exon 11252327 11252427 . + . gene_id "XLOC_000093"; transcript_id "TCONS_00000260"; exon_number "2"; gene_name "ANGPTL7"; oId "uc001ase.2"; nearest_ref "uc001ase.2"; class_code "="; tss_id "TSS135"; p_id "P198"; chr1 coding exon 11253637 11253831 . + . gene_id "XLOC_000093"; transcript_id "TCONS_00000260"; exon_number "3"; gene_name "ANGPTL7"; oId "uc001ase.2"; nearest_ref "uc001ase.2"; class_code "="; tss_id "TSS135"; p_id "P198"; chr1 coding exon 11254518 11254716 . + . gene_id "XLOC_000093"; transcript_id "TCONS_00000260"; exon_number "4"; gene_name "ANGPTL7"; oId "uc001ase.2"; nearest_ref "uc001ase.2"; class_code "="; tss_id "TSS135"; p_id "P198"; chr1 coding exon 11254911 11256037 . + . gene_id "XLOC_000093"; transcript_id "TCONS_00000260"; exon_number "5"; gene_name "ANGPTL7"; oId "uc001ase.2"; nearest_ref "uc001ase.2"; class_code "="; tss_id "TSS135"; p_id "P198"; chr1 coding exon 11333255 11334117 . + . gene_id "XLOC_000094"; transcript_id "TCONS_00000261"; exon_number "1"; gene_name "UBIAD1"; oId "uc001asg.2"; nearest_ref "uc001asg.2"; class_code "="; tss_id "TSS136"; p_id "P199"; chr1 coding exon 11345701 11348490 . + . gene_id "XLOC_000094"; transcript_id "TCONS_00000261"; exon_number "2"; gene_name "UBIAD1"; oId "uc001asg.2"; nearest_ref "uc001asg.2"; class_code "="; tss_id "TSS136"; p_id "P199"; chr1 nearCoding exon 11539295 11539429 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000262"; exon_number "1"; oId "uc009vmz.1"; nearest_ref "uc009vmz.1"; class_code "="; tss_id "TSS137"; chr1 nearCoding exon 11541315 11541938 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000262"; exon_number "2"; oId "uc009vmz.1"; nearest_ref "uc009vmz.1"; class_code "="; tss_id "TSS137"; chr1 coding exon 11539295 11539429 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "1"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11561047 11562145 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "2"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11562735 11562954 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "3"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11574447 11574583 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "4"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11575426 11575560 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "5"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11576058 11576218 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "6"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11577520 11577659 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "7"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11579412 11579560 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "8"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11579776 11579937 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "9"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11580744 11580905 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "10"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11583999 11584112 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "11"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11585233 11585369 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "12"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11586708 11586892 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "13"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11589613 11589743 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "14"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11589844 11590016 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "15"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11590964 11591090 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "16"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11591622 11591767 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "17"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11594438 11594597 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "18"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11595068 11595181 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "19"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11595535 11595701 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "20"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11596381 11597639 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000263"; exon_number "21"; gene_name "PTCHD2"; oId "uc001ash.3"; nearest_ref "uc001ash.3"; class_code "="; tss_id "TSS137"; p_id "P200"; chr1 coding exon 11561047 11562145 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "1"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11562735 11562954 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "2"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11574447 11574583 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "3"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11575426 11575560 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "4"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11576058 11576218 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "5"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11577520 11577659 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "6"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11579412 11579560 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "7"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11579776 11579937 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "8"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11580744 11580905 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "9"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11583999 11584112 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "10"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11585233 11585369 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "11"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11586708 11586928 . + . gene_id "XLOC_000095"; transcript_id "TCONS_00000264"; exon_number "12"; gene_name "PTCHD2"; oId "uc001asi.1"; nearest_ref "uc001asi.1"; class_code "="; tss_id "TSS138"; p_id "P201"; chr1 coding exon 11714432 11714638 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000265"; exon_number "1"; gene_name "FBXO44"; oId "uc001ask.2"; nearest_ref "uc001ask.2"; class_code "="; tss_id "TSS139"; p_id "P203"; chr1 coding exon 11715863 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000265"; exon_number "2"; gene_name "FBXO44"; oId "uc001ask.2"; nearest_ref "uc001ask.2"; class_code "="; tss_id "TSS139"; p_id "P203"; chr1 coding exon 11718324 11718421 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000265"; exon_number "3"; gene_name "FBXO44"; oId "uc001ask.2"; nearest_ref "uc001ask.2"; class_code "="; tss_id "TSS139"; p_id "P203"; chr1 coding exon 11718793 11718928 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000265"; exon_number "4"; gene_name "FBXO44"; oId "uc001ask.2"; nearest_ref "uc001ask.2"; class_code "="; tss_id "TSS139"; p_id "P203"; chr1 coding exon 11721187 11723383 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000265"; exon_number "5"; gene_name "FBXO44"; oId "uc001ask.2"; nearest_ref "uc001ask.2"; class_code "="; tss_id "TSS139"; p_id "P203"; chr1 coding exon 11714914 11715009 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000266"; exon_number "1"; gene_name "FBXO44"; oId "uc010oaq.1"; nearest_ref "uc010oaq.1"; class_code "="; tss_id "TSS140"; p_id "P205"; chr1 coding exon 11715863 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000266"; exon_number "2"; gene_name "FBXO44"; oId "uc010oaq.1"; nearest_ref "uc010oaq.1"; class_code "="; tss_id "TSS140"; p_id "P205"; chr1 coding exon 11718324 11718713 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000266"; exon_number "3"; gene_name "FBXO44"; oId "uc010oaq.1"; nearest_ref "uc010oaq.1"; class_code "="; tss_id "TSS140"; p_id "P205"; chr1 coding exon 11714914 11715009 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000271"; exon_number "1"; gene_name "FBXO44"; oId "uc010oas.1"; nearest_ref "uc010oas.1"; class_code "="; tss_id "TSS140"; p_id "P204"; chr1 coding exon 11715997 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000271"; exon_number "2"; gene_name "FBXO44"; oId "uc010oas.1"; nearest_ref "uc010oas.1"; class_code "="; tss_id "TSS140"; p_id "P204"; chr1 coding exon 11718324 11718421 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000271"; exon_number "3"; gene_name "FBXO44"; oId "uc010oas.1"; nearest_ref "uc010oas.1"; class_code "="; tss_id "TSS140"; p_id "P204"; chr1 coding exon 11718793 11718928 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000271"; exon_number "4"; gene_name "FBXO44"; oId "uc010oas.1"; nearest_ref "uc010oas.1"; class_code "="; tss_id "TSS140"; p_id "P204"; chr1 coding exon 11721187 11723383 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000271"; exon_number "5"; gene_name "FBXO44"; oId "uc010oas.1"; nearest_ref "uc010oas.1"; class_code "="; tss_id "TSS140"; p_id "P204"; chr1 coding exon 11714914 11715009 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000270"; exon_number "1"; gene_name "FBXO44"; oId "uc010oar.1"; nearest_ref "uc010oar.1"; class_code "="; tss_id "TSS140"; p_id "P202"; chr1 coding exon 11715863 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000270"; exon_number "2"; gene_name "FBXO44"; oId "uc010oar.1"; nearest_ref "uc010oar.1"; class_code "="; tss_id "TSS140"; p_id "P202"; chr1 coding exon 11718324 11718421 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000270"; exon_number "3"; gene_name "FBXO44"; oId "uc010oar.1"; nearest_ref "uc010oar.1"; class_code "="; tss_id "TSS140"; p_id "P202"; chr1 coding exon 11718590 11718685 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000270"; exon_number "4"; gene_name "FBXO44"; oId "uc010oar.1"; nearest_ref "uc010oar.1"; class_code "="; tss_id "TSS140"; p_id "P202"; chr1 coding exon 11718793 11718928 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000270"; exon_number "5"; gene_name "FBXO44"; oId "uc010oar.1"; nearest_ref "uc010oar.1"; class_code "="; tss_id "TSS140"; p_id "P202"; chr1 coding exon 11721187 11723383 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000270"; exon_number "6"; gene_name "FBXO44"; oId "uc010oar.1"; nearest_ref "uc010oar.1"; class_code "="; tss_id "TSS140"; p_id "P202"; chr1 coding exon 11714914 11715009 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000269"; exon_number "1"; gene_name "FBXO44"; oId "uc001asn.2"; nearest_ref "uc001asn.2"; class_code "="; tss_id "TSS140"; p_id "P203"; chr1 coding exon 11715863 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000269"; exon_number "2"; gene_name "FBXO44"; oId "uc001asn.2"; nearest_ref "uc001asn.2"; class_code "="; tss_id "TSS140"; p_id "P203"; chr1 coding exon 11718324 11718421 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000269"; exon_number "3"; gene_name "FBXO44"; oId "uc001asn.2"; nearest_ref "uc001asn.2"; class_code "="; tss_id "TSS140"; p_id "P203"; chr1 coding exon 11718793 11718928 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000269"; exon_number "4"; gene_name "FBXO44"; oId "uc001asn.2"; nearest_ref "uc001asn.2"; class_code "="; tss_id "TSS140"; p_id "P203"; chr1 coding exon 11721187 11723383 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000269"; exon_number "5"; gene_name "FBXO44"; oId "uc001asn.2"; nearest_ref "uc001asn.2"; class_code "="; tss_id "TSS140"; p_id "P203"; chr1 coding exon 11714914 11715009 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000268"; exon_number "1"; gene_name "FBXO44"; oId "uc001asm.2"; nearest_ref "uc001asm.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11715863 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000268"; exon_number "2"; gene_name "FBXO44"; oId "uc001asm.2"; nearest_ref "uc001asm.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11718324 11718450 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000268"; exon_number "3"; gene_name "FBXO44"; oId "uc001asm.2"; nearest_ref "uc001asm.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11718590 11718685 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000268"; exon_number "4"; gene_name "FBXO44"; oId "uc001asm.2"; nearest_ref "uc001asm.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11718793 11718928 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000268"; exon_number "5"; gene_name "FBXO44"; oId "uc001asm.2"; nearest_ref "uc001asm.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11721187 11723383 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000268"; exon_number "6"; gene_name "FBXO44"; oId "uc001asm.2"; nearest_ref "uc001asm.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11714914 11715009 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "1"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11715385 11715756 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "2"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11715863 11716157 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "3"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11718324 11718450 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "4"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11718590 11718685 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "5"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11718793 11718928 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "6"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11721187 11723383 . + . gene_id "XLOC_000096"; transcript_id "TCONS_00000267"; exon_number "7"; gene_name "FBXO44"; oId "uc001asl.2"; nearest_ref "uc001asl.2"; class_code "="; tss_id "TSS140"; p_id "P206"; chr1 coding exon 11724150 11724312 . + . gene_id "XLOC_000097"; transcript_id "TCONS_00000272"; exon_number "1"; gene_name "FBXO6"; oId "uc001aso.2"; nearest_ref "uc001aso.2"; class_code "="; tss_id "TSS141"; p_id "P207"; chr1 coding exon 11728713 11729001 . + . gene_id "XLOC_000097"; transcript_id "TCONS_00000272"; exon_number "2"; gene_name "FBXO6"; oId "uc001aso.2"; nearest_ref "uc001aso.2"; class_code "="; tss_id "TSS141"; p_id "P207"; chr1 coding exon 11731323 11731449 . + . gene_id "XLOC_000097"; transcript_id "TCONS_00000272"; exon_number "3"; gene_name "FBXO6"; oId "uc001aso.2"; nearest_ref "uc001aso.2"; class_code "="; tss_id "TSS141"; p_id "P207"; chr1 coding exon 11731985 11732080 . + . gene_id "XLOC_000097"; transcript_id "TCONS_00000272"; exon_number "4"; gene_name "FBXO6"; oId "uc001aso.2"; nearest_ref "uc001aso.2"; class_code "="; tss_id "TSS141"; p_id "P207"; chr1 coding exon 11733334 11733469 . + . gene_id "XLOC_000097"; transcript_id "TCONS_00000272"; exon_number "5"; gene_name "FBXO6"; oId "uc001aso.2"; nearest_ref "uc001aso.2"; class_code "="; tss_id "TSS141"; p_id "P207"; chr1 coding exon 11733672 11734407 . + . gene_id "XLOC_000097"; transcript_id "TCONS_00000272"; exon_number "6"; gene_name "FBXO6"; oId "uc001aso.2"; nearest_ref "uc001aso.2"; class_code "="; tss_id "TSS141"; p_id "P207"; chr1 coding exon 11751781 11751910 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "1"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 coding exon 11766306 11766766 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "2"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 coding exon 11769332 11769522 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "3"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 coding exon 11771908 11772022 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "4"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 coding exon 11772397 11772486 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "5"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 coding exon 11775176 11775265 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "6"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 coding exon 11779641 11780336 . + . gene_id "XLOC_000098"; transcript_id "TCONS_00000273"; exon_number "7"; gene_name "C1orf187"; oId "uc001asr.1"; nearest_ref "uc001asr.1"; class_code "="; tss_id "TSS142"; p_id "P208"; chr1 noncoding exon 11782187 11785914 . + . gene_id "XLOC_000099"; transcript_id "TCONS_00000274"; exon_number "1"; oId "uc001ass.1"; nearest_ref "uc001ass.1"; class_code "="; chr1 coding exon 11796142 11796292 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000277"; exon_number "1"; gene_name "AGTRAP"; oId "uc001asv.2"; nearest_ref "uc001asv.2"; class_code "="; tss_id "TSS143"; p_id "P211"; chr1 coding exon 11805860 11805894 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000277"; exon_number "2"; gene_name "AGTRAP"; oId "uc001asv.2"; nearest_ref "uc001asv.2"; class_code "="; tss_id "TSS143"; p_id "P211"; chr1 coding exon 11807497 11807602 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000277"; exon_number "3"; gene_name "AGTRAP"; oId "uc001asv.2"; nearest_ref "uc001asv.2"; class_code "="; tss_id "TSS143"; p_id "P211"; chr1 coding exon 11808472 11808667 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000277"; exon_number "4"; gene_name "AGTRAP"; oId "uc001asv.2"; nearest_ref "uc001asv.2"; class_code "="; tss_id "TSS143"; p_id "P211"; chr1 coding exon 11810134 11810827 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000277"; exon_number "5"; gene_name "AGTRAP"; oId "uc001asv.2"; nearest_ref "uc001asv.2"; class_code "="; tss_id "TSS143"; p_id "P211"; chr1 coding exon 11796142 11796292 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000279"; exon_number "1"; gene_name "AGTRAP"; oId "uc001asx.2"; nearest_ref "uc001asx.2"; class_code "="; tss_id "TSS143"; p_id "P210"; chr1 coding exon 11807497 11807602 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000279"; exon_number "2"; gene_name "AGTRAP"; oId "uc001asx.2"; nearest_ref "uc001asx.2"; class_code "="; tss_id "TSS143"; p_id "P210"; chr1 coding exon 11808472 11808646 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000279"; exon_number "3"; gene_name "AGTRAP"; oId "uc001asx.2"; nearest_ref "uc001asx.2"; class_code "="; tss_id "TSS143"; p_id "P210"; chr1 coding exon 11810134 11810827 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000279"; exon_number "4"; gene_name "AGTRAP"; oId "uc001asx.2"; nearest_ref "uc001asx.2"; class_code "="; tss_id "TSS143"; p_id "P210"; chr1 coding exon 11796142 11796292 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000278"; exon_number "1"; gene_name "AGTRAP"; oId "uc001asw.2"; nearest_ref "uc001asw.2"; class_code "="; tss_id "TSS143"; p_id "P213"; chr1 coding exon 11805860 11805894 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000278"; exon_number "2"; gene_name "AGTRAP"; oId "uc001asw.2"; nearest_ref "uc001asw.2"; class_code "="; tss_id "TSS143"; p_id "P213"; chr1 coding exon 11807497 11807602 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000278"; exon_number "3"; gene_name "AGTRAP"; oId "uc001asw.2"; nearest_ref "uc001asw.2"; class_code "="; tss_id "TSS143"; p_id "P213"; chr1 coding exon 11808472 11808646 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000278"; exon_number "4"; gene_name "AGTRAP"; oId "uc001asw.2"; nearest_ref "uc001asw.2"; class_code "="; tss_id "TSS143"; p_id "P213"; chr1 coding exon 11810134 11810827 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000278"; exon_number "5"; gene_name "AGTRAP"; oId "uc001asw.2"; nearest_ref "uc001asw.2"; class_code "="; tss_id "TSS143"; p_id "P213"; chr1 coding exon 11796142 11796292 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000276"; exon_number "1"; gene_name "AGTRAP"; oId "uc001asu.2"; nearest_ref "uc001asu.2"; class_code "="; tss_id "TSS143"; p_id "P209"; chr1 coding exon 11805860 11805894 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000276"; exon_number "2"; gene_name "AGTRAP"; oId "uc001asu.2"; nearest_ref "uc001asu.2"; class_code "="; tss_id "TSS143"; p_id "P209"; chr1 coding exon 11806184 11806280 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000276"; exon_number "3"; gene_name "AGTRAP"; oId "uc001asu.2"; nearest_ref "uc001asu.2"; class_code "="; tss_id "TSS143"; p_id "P209"; chr1 coding exon 11807497 11807602 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000276"; exon_number "4"; gene_name "AGTRAP"; oId "uc001asu.2"; nearest_ref "uc001asu.2"; class_code "="; tss_id "TSS143"; p_id "P209"; chr1 coding exon 11808472 11808646 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000276"; exon_number "5"; gene_name "AGTRAP"; oId "uc001asu.2"; nearest_ref "uc001asu.2"; class_code "="; tss_id "TSS143"; p_id "P209"; chr1 coding exon 11810134 11810827 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000276"; exon_number "6"; gene_name "AGTRAP"; oId "uc001asu.2"; nearest_ref "uc001asu.2"; class_code "="; tss_id "TSS143"; p_id "P209"; chr1 coding exon 11796142 11796292 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000275"; exon_number "1"; gene_name "AGTRAP"; oId "uc001ast.2"; nearest_ref "uc001ast.2"; class_code "="; tss_id "TSS143"; p_id "P212"; chr1 coding exon 11805860 11805894 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000275"; exon_number "2"; gene_name "AGTRAP"; oId "uc001ast.2"; nearest_ref "uc001ast.2"; class_code "="; tss_id "TSS143"; p_id "P212"; chr1 coding exon 11806184 11806280 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000275"; exon_number "3"; gene_name "AGTRAP"; oId "uc001ast.2"; nearest_ref "uc001ast.2"; class_code "="; tss_id "TSS143"; p_id "P212"; chr1 coding exon 11807497 11807602 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000275"; exon_number "4"; gene_name "AGTRAP"; oId "uc001ast.2"; nearest_ref "uc001ast.2"; class_code "="; tss_id "TSS143"; p_id "P212"; chr1 coding exon 11808472 11808667 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000275"; exon_number "5"; gene_name "AGTRAP"; oId "uc001ast.2"; nearest_ref "uc001ast.2"; class_code "="; tss_id "TSS143"; p_id "P212"; chr1 coding exon 11810134 11810827 . + . gene_id "XLOC_000100"; transcript_id "TCONS_00000275"; exon_number "6"; gene_name "AGTRAP"; oId "uc001ast.2"; nearest_ref "uc001ast.2"; class_code "="; tss_id "TSS143"; p_id "P212"; chr1 noncoding exon 11824462 11824527 . + . gene_id "XLOC_000101"; transcript_id "TCONS_00000280"; exon_number "1"; gene_name "C1orf167"; oId "uc001asy.1"; nearest_ref "uc001asy.1"; class_code "="; tss_id "TSS144"; chr1 noncoding exon 11825914 11826573 . + . gene_id "XLOC_000101"; transcript_id "TCONS_00000280"; exon_number "2"; gene_name "C1orf167"; oId "uc001asy.1"; nearest_ref "uc001asy.1"; class_code "="; tss_id "TSS144"; chr1 coding exon 11832139 11832316 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "1"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11835492 11835667 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "2"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11836521 11836695 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "3"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11838717 11838873 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "4"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11838983 11839137 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "5"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11839859 11840067 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "6"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11842246 11842390 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "7"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11844231 11844650 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "8"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11845205 11845346 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "9"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11847445 11847550 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "10"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11847930 11848104 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "11"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11848221 11848435 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "12"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11848709 11848803 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "13"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11849327 11849641 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000281"; exon_number "14"; gene_name "C1orf167"; oId "uc001asz.2"; nearest_ref "uc001asz.2"; class_code "="; tss_id "TSS145"; p_id "P215"; chr1 coding exon 11839859 11840067 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "1"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11842251 11842390 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "2"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11844231 11844650 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "3"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11845205 11845346 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "4"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11847445 11847550 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "5"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11847930 11848104 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "6"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11848300 11848435 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "7"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11848709 11848803 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "8"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11849327 11849641 . + . gene_id "XLOC_000102"; transcript_id "TCONS_00000282"; exon_number "9"; gene_name "C1orf167"; oId "uc001ata.2"; nearest_ref "uc001ata.2"; class_code "="; tss_id "TSS146"; p_id "P214"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000283"; exon_number "1"; gene_name "CLCN6"; oId "uc009vne.1"; nearest_ref "uc009vne.1"; class_code "="; tss_id "TSS147"; p_id "P219"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000283"; exon_number "2"; gene_name "CLCN6"; oId "uc009vne.1"; nearest_ref "uc009vne.1"; class_code "="; tss_id "TSS147"; p_id "P219"; chr1 coding exon 11875903 11876844 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000283"; exon_number "3"; gene_name "CLCN6"; oId "uc009vne.1"; nearest_ref "uc009vne.1"; class_code "="; tss_id "TSS147"; p_id "P219"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "1"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "2"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11875903 11875968 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "3"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11876672 11876737 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "4"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11879545 11879611 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "5"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11882752 11882858 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "6"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11883764 11883890 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "7"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11884543 11884610 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "8"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11886213 11886271 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "9"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11887172 11887278 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "10"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11888163 11888276 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000285"; exon_number "11"; gene_name "CLCN6"; oId "uc009vng.1"; nearest_ref "uc009vng.1"; class_code "="; tss_id "TSS147"; p_id "P217"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "1"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "2"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11875903 11875968 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "3"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11876672 11876737 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "4"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11879545 11879611 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "5"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11882752 11882858 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "6"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11883764 11883890 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "7"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11884543 11884610 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "8"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11886213 11886281 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "9"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11887146 11887278 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "10"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11888163 11888276 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000284"; exon_number "11"; gene_name "CLCN6"; oId "uc009vnf.1"; nearest_ref "uc009vnf.1"; class_code "="; tss_id "TSS147"; p_id "P216"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "1"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "2"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11875903 11875968 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "3"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11876672 11876737 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "4"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11879545 11879611 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "5"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11882752 11882858 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "6"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11883764 11883890 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "7"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11884543 11884610 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "8"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11886213 11886271 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "9"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11887146 11887278 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "10"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11888163 11888276 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "11"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11889253 11889379 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000286"; exon_number "12"; gene_name "CLCN6"; oId "uc009vnh.1"; nearest_ref "uc009vnh.1"; class_code "="; tss_id "TSS147"; p_id "P222"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "1"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "2"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11876672 11876737 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "3"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11879545 11879611 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "4"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11882752 11882858 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "5"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11883764 11883890 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "6"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11884543 11884610 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "7"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11886213 11886271 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "8"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11887146 11887278 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "9"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11888163 11888276 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "10"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11888515 11888681 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "11"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11889253 11889379 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "12"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11893572 11893695 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "13"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11893934 11894087 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "14"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11894293 11894452 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "15"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11894541 11894647 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "16"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11896024 11896210 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "17"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11897056 11897213 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "18"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11897400 11897556 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "19"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11898392 11898499 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "20"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11898592 11898717 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "21"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11900200 11903200 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000289"; exon_number "22"; gene_name "CLCN6"; oId "uc010oau.1"; nearest_ref "uc010oau.1"; class_code "="; tss_id "TSS147"; p_id "P218"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "1"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "2"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11875903 11875968 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "3"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11876672 11876737 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "4"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11879545 11879611 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "5"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11882752 11882858 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "6"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11883764 11883890 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "7"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11884543 11884610 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "8"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11886213 11886281 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "9"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11887172 11887278 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "10"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11888163 11888276 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "11"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11888515 11888681 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "12"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11889253 11889379 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "13"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11893572 11893695 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "14"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11893934 11894087 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "15"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11894293 11894452 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "16"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11894541 11894647 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "17"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11896024 11896210 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "18"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11897056 11897213 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "19"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11897400 11897556 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "20"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11898392 11898499 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "21"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11898592 11898717 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "22"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11900200 11903200 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000288"; exon_number "23"; gene_name "CLCN6"; oId "uc010oat.1"; nearest_ref "uc010oat.1"; class_code "="; tss_id "TSS147"; p_id "P221"; chr1 coding exon 11866207 11866406 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "1"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11867188 11867247 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "2"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11875903 11875968 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "3"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11876672 11876737 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "4"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11879545 11879611 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "5"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11882752 11882858 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "6"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11883764 11883890 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "7"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11884543 11884610 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "8"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11886213 11886271 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "9"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11887146 11887278 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "10"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11888163 11888276 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "11"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11888515 11888681 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "12"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11889253 11889379 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "13"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11893572 11893695 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "14"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11893934 11894087 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "15"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11894293 11894452 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "16"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11894541 11894647 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "17"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11896024 11896210 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "18"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11897056 11897213 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "19"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11897400 11897556 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "20"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11898392 11898499 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "21"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11898592 11898717 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "22"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 coding exon 11900200 11903200 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000287"; exon_number "23"; gene_name "CLCN6"; oId "uc001ate.3"; nearest_ref "uc001ate.3"; class_code "="; tss_id "TSS147"; p_id "P220"; chr1 nearCoding exon 11900376 11900428 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000293"; exon_number "1"; oId "uc010oay.1"; nearest_ref "uc010oay.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11901112 11901264 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000293"; exon_number "2"; oId "uc010oay.1"; nearest_ref "uc010oay.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11905604 11905823 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000293"; exon_number "3"; oId "uc010oay.1"; nearest_ref "uc010oay.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11907634 11907674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000293"; exon_number "4"; oId "uc010oay.1"; nearest_ref "uc010oay.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11900376 11900428 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000295"; exon_number "1"; oId "uc010oba.1"; nearest_ref "uc010oba.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11901112 11901264 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000295"; exon_number "2"; oId "uc010oba.1"; nearest_ref "uc010oba.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11902578 11902674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000295"; exon_number "3"; oId "uc010oba.1"; nearest_ref "uc010oba.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11903761 11904130 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000295"; exon_number "4"; oId "uc010oba.1"; nearest_ref "uc010oba.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11905604 11905823 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000295"; exon_number "5"; oId "uc010oba.1"; nearest_ref "uc010oba.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11907634 11907674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000295"; exon_number "6"; oId "uc010oba.1"; nearest_ref "uc010oba.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11900376 11900428 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000294"; exon_number "1"; oId "uc010oaz.1"; nearest_ref "uc010oaz.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11901112 11901264 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000294"; exon_number "2"; oId "uc010oaz.1"; nearest_ref "uc010oaz.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11905697 11905823 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000294"; exon_number "3"; oId "uc010oaz.1"; nearest_ref "uc010oaz.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11907634 11907674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000294"; exon_number "4"; oId "uc010oaz.1"; nearest_ref "uc010oaz.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11900376 11900428 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000292"; exon_number "1"; oId "uc010oax.1"; nearest_ref "uc010oax.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11901086 11901264 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000292"; exon_number "2"; oId "uc010oax.1"; nearest_ref "uc010oax.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11903871 11904130 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000292"; exon_number "3"; oId "uc010oax.1"; nearest_ref "uc010oax.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11905697 11905823 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000292"; exon_number "4"; oId "uc010oax.1"; nearest_ref "uc010oax.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11907634 11907674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000292"; exon_number "5"; oId "uc010oax.1"; nearest_ref "uc010oax.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11900376 11900578 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000291"; exon_number "1"; oId "uc010oaw.1"; nearest_ref "uc010oaw.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11901112 11901264 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000291"; exon_number "2"; oId "uc010oaw.1"; nearest_ref "uc010oaw.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11903791 11904130 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000291"; exon_number "3"; oId "uc010oaw.1"; nearest_ref "uc010oaw.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11905604 11905823 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000291"; exon_number "4"; oId "uc010oaw.1"; nearest_ref "uc010oaw.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11907634 11907674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000291"; exon_number "5"; oId "uc010oaw.1"; nearest_ref "uc010oaw.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11900376 11900428 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000290"; exon_number "1"; oId "uc010oav.1"; nearest_ref "uc010oav.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11901112 11901264 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000290"; exon_number "2"; oId "uc010oav.1"; nearest_ref "uc010oav.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11903761 11904130 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000290"; exon_number "3"; oId "uc010oav.1"; nearest_ref "uc010oav.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11905604 11905823 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000290"; exon_number "4"; oId "uc010oav.1"; nearest_ref "uc010oav.1"; class_code "="; tss_id "TSS148"; chr1 nearCoding exon 11907634 11907674 . + . gene_id "XLOC_000103"; transcript_id "TCONS_00000290"; exon_number "5"; oId "uc010oav.1"; nearest_ref "uc010oav.1"; class_code "="; tss_id "TSS148"; chr1 coding exon 11994746 11994912 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "1"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12004579 12004719 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "2"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12008033 12008124 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "3"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12009830 12009963 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "4"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12010414 12010577 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "5"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12012680 12012792 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "6"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12014887 12014950 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "7"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12016974 12017071 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "8"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12017899 12018000 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "9"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12018573 12018704 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "10"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12020703 12020824 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "11"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12023589 12023693 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "12"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12024232 12024357 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "13"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12024701 12024842 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "14"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12025537 12025650 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "15"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12026308 12026373 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "16"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12027044 12027148 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "17"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12030727 12030873 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "18"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12032929 12033054 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "19"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 12034710 12035593 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000297"; exon_number "20"; gene_name "PLOD1"; oId "uc010obb.1"; nearest_ref "uc010obb.1"; class_code "="; tss_id "TSS149"; p_id "P223"; chr1 coding exon 11994746 11994912 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "1"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12008033 12008124 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "2"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12009830 12009963 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "3"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12010414 12010577 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "4"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12012680 12012792 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "5"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12014887 12014950 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "6"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12016974 12017071 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "7"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12017899 12018000 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "8"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12018573 12018704 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "9"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12020703 12020824 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "10"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12023589 12023693 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "11"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12024232 12024357 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "12"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12024701 12024842 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "13"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12025537 12025650 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "14"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12026308 12026373 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "15"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12027044 12027148 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "16"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12030727 12030873 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "17"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12032929 12033054 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "18"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12034710 12035593 . + . gene_id "XLOC_000104"; transcript_id "TCONS_00000296"; exon_number "19"; gene_name "PLOD1"; oId "uc001atm.2"; nearest_ref "uc001atm.2"; class_code "="; tss_id "TSS149"; p_id "P224"; chr1 coding exon 12040238 12040541 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "1"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12049222 12049400 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "2"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12052612 12052747 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "3"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12056213 12056375 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "4"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12057354 12057478 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "5"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12058827 12058935 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "6"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12059045 12059152 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "7"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12061458 12061611 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "8"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12061826 12061893 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "9"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12062039 12062160 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "10"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12064049 12064175 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "11"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12064566 12064670 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "12"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12064882 12064984 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "13"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12065768 12065988 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "14"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12066595 12066750 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "15"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12067110 12067306 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "16"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12069649 12069783 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "17"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12071553 12073571 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000299"; exon_number "18"; gene_name "MFN2"; oId "uc009vni.2"; nearest_ref "uc009vni.2"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12040238 12040541 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "1"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12042027 12042171 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "2"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12049222 12049400 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "3"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12052612 12052747 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "4"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12056213 12056375 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "5"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12057354 12057478 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "6"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12058827 12058935 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "7"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12059045 12059152 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "8"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12061458 12061611 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "9"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12061826 12061893 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "10"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12062039 12062160 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "11"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12064049 12064175 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "12"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12064566 12064670 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "13"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12064882 12064984 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "14"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12065768 12065988 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "15"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12066595 12066750 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "16"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12067110 12067306 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "17"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12069649 12069783 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "18"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12071553 12073571 . + . gene_id "XLOC_000105"; transcript_id "TCONS_00000298"; exon_number "19"; gene_name "MFN2"; oId "uc001atn.3"; nearest_ref "uc001atn.3"; class_code "="; tss_id "TSS150"; p_id "P225"; chr1 coding exon 12079512 12079609 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "1"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12081702 12081897 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "2"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12082152 12082499 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "3"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12082890 12082974 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "4"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12089090 12089198 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "5"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12089280 12089338 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "6"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12089822 12089951 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "7"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12090085 12090181 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "8"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12091323 12091460 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "9"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12091779 12092106 . + . gene_id "XLOC_000106"; transcript_id "TCONS_00000300"; exon_number "10"; gene_name "MIIP"; oId "uc001ato.1"; nearest_ref "uc001ato.1"; class_code "="; tss_id "TSS151"; p_id "P226"; chr1 coding exon 12123434 12123718 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "1"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12157158 12157274 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "2"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12164436 12164588 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "3"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12169623 12169713 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "4"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12170098 12170261 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "5"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12171955 12172071 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "6"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12175634 12175786 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "7"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12183341 12183434 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "8"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12183772 12183884 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "9"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12186008 12186109 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "10"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12186240 12186293 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "11"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12195645 12195670 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "12"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12198289 12198493 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "13"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12202344 12204262 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000302"; exon_number "14"; gene_name "TNFRSF8"; oId "uc010obc.1"; nearest_ref "uc010obc.1"; class_code "="; tss_id "TSS152"; p_id "P229"; chr1 coding exon 12123434 12123718 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "1"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12144521 12144608 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "2"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12157158 12157274 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "3"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12164436 12164588 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "4"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12169623 12169713 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "5"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12170098 12170261 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "6"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12171955 12172071 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "7"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12175634 12175786 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "8"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12183341 12183434 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "9"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12183772 12183884 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "10"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12186008 12186109 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "11"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12186240 12186293 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "12"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12195645 12195670 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "13"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12198286 12198493 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "14"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12202344 12204262 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000301"; exon_number "15"; gene_name "TNFRSF8"; oId "uc001atq.2"; nearest_ref "uc001atq.2"; class_code "="; tss_id "TSS152"; p_id "P228"; chr1 coding exon 12185958 12186109 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000304"; exon_number "1"; gene_name "TNFRSF8"; oId "uc001ats.2"; nearest_ref "uc001ats.2"; class_code "="; tss_id "TSS153"; p_id "P227"; chr1 coding exon 12186240 12186293 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000304"; exon_number "2"; gene_name "TNFRSF8"; oId "uc001ats.2"; nearest_ref "uc001ats.2"; class_code "="; tss_id "TSS153"; p_id "P227"; chr1 coding exon 12195645 12195670 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000304"; exon_number "3"; gene_name "TNFRSF8"; oId "uc001ats.2"; nearest_ref "uc001ats.2"; class_code "="; tss_id "TSS153"; p_id "P227"; chr1 coding exon 12202344 12204262 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000304"; exon_number "4"; gene_name "TNFRSF8"; oId "uc001ats.2"; nearest_ref "uc001ats.2"; class_code "="; tss_id "TSS153"; p_id "P227"; chr1 coding exon 12185958 12186109 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000303"; exon_number "1"; gene_name "TNFRSF8"; oId "uc001atr.2"; nearest_ref "uc001atr.2"; class_code "="; tss_id "TSS153"; p_id "P230"; chr1 coding exon 12186240 12186293 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000303"; exon_number "2"; gene_name "TNFRSF8"; oId "uc001atr.2"; nearest_ref "uc001atr.2"; class_code "="; tss_id "TSS153"; p_id "P230"; chr1 coding exon 12195645 12195670 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000303"; exon_number "3"; gene_name "TNFRSF8"; oId "uc001atr.2"; nearest_ref "uc001atr.2"; class_code "="; tss_id "TSS153"; p_id "P230"; chr1 coding exon 12198286 12198493 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000303"; exon_number "4"; gene_name "TNFRSF8"; oId "uc001atr.2"; nearest_ref "uc001atr.2"; class_code "="; tss_id "TSS153"; p_id "P230"; chr1 coding exon 12202344 12204262 . + . gene_id "XLOC_000107"; transcript_id "TCONS_00000303"; exon_number "5"; gene_name "TNFRSF8"; oId "uc001atr.2"; nearest_ref "uc001atr.2"; class_code "="; tss_id "TSS153"; p_id "P230"; chr1 nearCoding exon 12227060 12227226 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "1"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12248853 12248952 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "2"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12251014 12251142 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "3"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12251831 12251980 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "4"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12252488 12252581 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "5"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12252920 12253155 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "6"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12262024 12262228 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "7"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 nearCoding exon 12266797 12269276 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000307"; exon_number "8"; gene_name "TNFRSF1B"; oId "uc009vnk.2"; nearest_ref "uc009vnk.2"; class_code "="; tss_id "TSS154"; chr1 coding exon 12227060 12227226 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "1"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12251014 12251142 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "2"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12251831 12251980 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "3"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12252488 12252581 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "4"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12252920 12253155 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "5"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12254012 12254089 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "6"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12254641 12254675 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "7"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12262024 12262228 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "8"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12266797 12269276 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000306"; exon_number "9"; gene_name "TNFRSF1B"; oId "uc001atu.2"; nearest_ref "uc001atu.2"; class_code "="; tss_id "TSS154"; p_id "P231"; chr1 coding exon 12227060 12227226 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "1"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12248853 12248952 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "2"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12251014 12251142 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "3"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12251831 12251980 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "4"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12252488 12252581 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "5"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12252920 12253155 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "6"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12254012 12254089 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "7"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12254641 12254675 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "8"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12262024 12262228 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "9"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12266797 12269276 . + . gene_id "XLOC_000108"; transcript_id "TCONS_00000305"; exon_number "10"; gene_name "TNFRSF1B"; oId "uc001att.2"; nearest_ref "uc001att.2"; class_code "="; tss_id "TSS154"; p_id "P232"; chr1 coding exon 12290113 12290177 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "1"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12294248 12294420 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "2"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12302570 12302647 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "3"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12304303 12304493 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "4"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12304594 12304674 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "5"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12309280 12309396 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "6"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12313779 12313883 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "7"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12316390 12316560 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "8"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12317044 12317144 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "9"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12317992 12318160 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "10"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12320750 12320851 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "11"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12321005 12321206 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "12"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12321958 12322137 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "13"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12326938 12327068 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "14"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12327902 12327977 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "15"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12328763 12328933 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "16"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12331051 12331181 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "17"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12333060 12333192 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "18"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12335882 12338095 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "19"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12339556 12339707 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "20"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12342762 12343793 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "21"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12348280 12348370 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "22"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12351055 12351181 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "23"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12353581 12353761 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "24"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12359259 12359441 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "25"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12364563 12364785 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "26"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12368488 12368698 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "27"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12371511 12371682 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "28"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12371870 12371982 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "29"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12374172 12374384 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "30"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12378129 12378394 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "31"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12379554 12379687 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "32"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12381866 12382021 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "33"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12382593 12382803 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "34"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12383763 12383837 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "35"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12387705 12387911 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "36"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12389886 12389975 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "37"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12393283 12393423 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "38"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12395762 12395884 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "39"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12401837 12401942 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "40"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12402956 12403108 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "41"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12405431 12405566 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "42"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12406662 12406709 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "43"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12408880 12409030 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "44"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12409221 12409431 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "45"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12414031 12414278 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "46"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12415956 12416147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "47"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12416455 12416581 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "48"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12418515 12418657 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "49"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12422776 12422906 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "50"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12423128 12423303 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "51"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12428523 12428646 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "52"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12429522 12429757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "53"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12433805 12433913 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "54"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12438482 12438645 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "55"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12439542 12439650 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "56"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12443035 12443214 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "57"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12445319 12445432 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "58"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12446244 12446393 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "59"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12460238 12460387 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "60"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12461661 12461757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "61"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12463878 12464026 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "62"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12475140 12475274 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "63"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12476713 12476880 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "64"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12516054 12516186 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "65"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12520256 12520451 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "66"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12557554 12557685 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "67"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12566907 12567147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "68"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12568947 12572096 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000309"; exon_number "69"; gene_name "VPS13D"; oId "uc001atw.2"; nearest_ref "uc001atw.2"; class_code "="; tss_id "TSS155"; p_id "P236"; chr1 coding exon 12290113 12290177 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "1"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12294248 12294420 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "2"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12302570 12302647 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "3"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12304303 12304493 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "4"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12304594 12304674 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "5"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12309280 12309396 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "6"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12313779 12313883 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "7"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12316390 12316560 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "8"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12317044 12317144 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "9"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12317992 12318160 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "10"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12320750 12320851 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "11"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12321005 12321206 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "12"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12321958 12322137 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "13"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12326938 12327068 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "14"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12327902 12327977 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "15"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12328763 12328933 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "16"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12331051 12331181 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "17"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12333060 12333192 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "18"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12335882 12338095 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "19"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12339556 12339707 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "20"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12342762 12343793 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "21"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12348280 12348370 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "22"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12351055 12351181 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "23"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12353581 12353761 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "24"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12359259 12359441 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "25"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12364563 12364785 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "26"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12368488 12368698 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "27"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12371511 12371682 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "28"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12371870 12371982 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "29"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12374172 12374384 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "30"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12378129 12378394 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "31"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12379554 12379687 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "32"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12381866 12382021 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "33"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12382593 12382803 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "34"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12383763 12383837 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "35"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12387705 12387911 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "36"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12389886 12389975 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "37"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12393283 12393423 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "38"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12395762 12395884 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "39"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12398288 12398362 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "40"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12401837 12401942 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "41"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12402956 12403108 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "42"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12405431 12405566 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "43"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12406662 12406709 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "44"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12408880 12409030 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "45"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12409221 12409431 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "46"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12414031 12414278 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "47"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12415956 12416147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "48"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12416455 12416581 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "49"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12418515 12418657 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "50"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12422776 12422906 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "51"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12423128 12423303 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "52"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12428523 12428646 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "53"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12429522 12429757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "54"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12433805 12433913 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "55"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12438482 12438645 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "56"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12439542 12439650 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "57"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12443035 12443214 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "58"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12445319 12445432 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "59"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12446244 12446393 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "60"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12460238 12460387 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "61"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12461661 12461757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "62"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12463878 12464026 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "63"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12475140 12475274 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "64"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12476713 12476880 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "65"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12516054 12516186 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "66"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12520256 12520451 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "67"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12557554 12557685 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "68"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12566907 12567147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "69"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12568947 12572096 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000308"; exon_number "70"; gene_name "VPS13D"; oId "uc001atv.2"; nearest_ref "uc001atv.2"; class_code "="; tss_id "TSS155"; p_id "P234"; chr1 coding exon 12335882 12338095 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "1"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12339556 12339707 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "2"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12342762 12343793 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "3"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12348280 12348370 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "4"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12351055 12351181 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "5"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12353581 12353761 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "6"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12359259 12359441 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "7"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12364563 12364785 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "8"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12368488 12368698 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "9"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12371511 12371682 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "10"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12371870 12371982 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "11"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12374172 12374384 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "12"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12378129 12378394 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "13"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12379554 12379687 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "14"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12381866 12382021 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "15"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12382593 12382803 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "16"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12383763 12383837 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "17"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12387705 12387911 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "18"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12389886 12389975 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "19"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12393283 12393423 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "20"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12395762 12395884 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "21"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12398288 12398362 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "22"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12401840 12401942 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "23"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12402956 12403108 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "24"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12405431 12405566 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "25"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12406662 12406709 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "26"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12408880 12409030 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "27"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12409221 12409431 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "28"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12414031 12414278 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "29"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12415956 12416147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "30"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12416455 12416581 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "31"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12418515 12418657 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "32"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12422776 12422906 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "33"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12423128 12423303 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "34"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12428523 12428646 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "35"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12429522 12429757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "36"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12433805 12433913 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "37"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12438482 12438645 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "38"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12439542 12439650 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "39"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12443035 12443214 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "40"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12445319 12445432 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "41"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12446244 12446393 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "42"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12460238 12460387 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "43"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12461661 12461757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "44"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12463878 12464026 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "45"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12475140 12475274 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "46"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12476713 12476880 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "47"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12516054 12516186 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "48"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12520256 12520451 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "49"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12557554 12557685 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "50"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12566907 12567147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "51"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12568947 12572096 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000310"; exon_number "52"; gene_name "VPS13D"; oId "uc001atx.2"; nearest_ref "uc001atx.2"; class_code "="; tss_id "TSS156"; p_id "P237"; chr1 coding exon 12371511 12371682 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "1"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12371870 12371982 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "2"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12374172 12374384 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "3"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12378129 12378394 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "4"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12379554 12379687 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "5"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12381866 12382021 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "6"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12382593 12382803 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "7"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12383763 12383837 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "8"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12387705 12387911 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "9"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12389886 12389975 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "10"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12393283 12393423 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "11"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 coding exon 12395762 12398045 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000311"; exon_number "12"; oId "uc001aty.1"; nearest_ref "uc001aty.1"; class_code "="; tss_id "TSS157"; p_id "P233"; chr1 nearCoding exon 12427725 12427756 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "1"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12428523 12428646 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "2"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12429522 12429757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "3"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12433805 12433913 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "4"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12438482 12438645 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "5"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12439542 12439650 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "6"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12443035 12443214 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "7"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12445319 12445432 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "8"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12446244 12446393 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "9"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12460238 12460387 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "10"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12461661 12461757 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "11"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12463878 12464026 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "12"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12475140 12475274 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "13"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12476713 12476880 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "14"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12516054 12516127 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "15"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12520295 12520451 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "16"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12557554 12557685 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "17"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12566907 12567147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "18"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 nearCoding exon 12568947 12572096 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000312"; exon_number "19"; oId "uc009vnl.2"; nearest_ref "uc009vnl.2"; class_code "="; tss_id "TSS158"; chr1 coding exon 12469884 12469947 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "1"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12475140 12475274 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "2"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12476713 12476880 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "3"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12516054 12516186 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "4"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12520256 12520451 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "5"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12557554 12557685 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "6"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12566907 12567147 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "7"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 coding exon 12568947 12572096 . + . gene_id "XLOC_000109"; transcript_id "TCONS_00000313"; exon_number "8"; oId "uc010obd.1"; nearest_ref "uc010obd.1"; class_code "="; tss_id "TSS159"; p_id "P235"; chr1 noncoding exon 12567300 12567451 . + . gene_id "XLOC_000110"; transcript_id "TCONS_00000314"; exon_number "1"; gene_name "SNORA59B"; oId "uc001atz.1"; nearest_ref "uc001atz.1"; class_code "="; chr1 coding exon 12704566 12704733 . + . gene_id "XLOC_000111"; transcript_id "TCONS_00000315"; exon_number "1"; gene_name "AADACL4"; oId "uc001auf.2"; nearest_ref "uc001auf.2"; class_code "="; tss_id "TSS160"; p_id "P238"; chr1 coding exon 12711142 12711358 . + . gene_id "XLOC_000111"; transcript_id "TCONS_00000315"; exon_number "2"; gene_name "AADACL4"; oId "uc001auf.2"; nearest_ref "uc001auf.2"; class_code "="; tss_id "TSS160"; p_id "P238"; chr1 coding exon 12721802 12721865 . + . gene_id "XLOC_000111"; transcript_id "TCONS_00000315"; exon_number "3"; gene_name "AADACL4"; oId "uc001auf.2"; nearest_ref "uc001auf.2"; class_code "="; tss_id "TSS160"; p_id "P238"; chr1 coding exon 12725972 12727096 . + . gene_id "XLOC_000111"; transcript_id "TCONS_00000315"; exon_number "4"; gene_name "AADACL4"; oId "uc001auf.2"; nearest_ref "uc001auf.2"; class_code "="; tss_id "TSS160"; p_id "P238"; chr1 coding exon 12776118 12776347 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000317"; exon_number "1"; gene_name "AADACL3"; oId "uc009vnn.1"; nearest_ref "uc009vnn.1"; class_code "="; tss_id "TSS161"; p_id "P240"; chr1 coding exon 12779477 12779693 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000317"; exon_number "2"; gene_name "AADACL3"; oId "uc009vnn.1"; nearest_ref "uc009vnn.1"; class_code "="; tss_id "TSS161"; p_id "P240"; chr1 coding exon 12780885 12780948 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000317"; exon_number "3"; gene_name "AADACL3"; oId "uc009vnn.1"; nearest_ref "uc009vnn.1"; class_code "="; tss_id "TSS161"; p_id "P240"; chr1 coding exon 12785189 12788726 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000317"; exon_number "4"; gene_name "AADACL3"; oId "uc009vnn.1"; nearest_ref "uc009vnn.1"; class_code "="; tss_id "TSS161"; p_id "P240"; chr1 coding exon 12776118 12776347 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000316"; exon_number "1"; gene_name "AADACL3"; oId "uc001aug.1"; nearest_ref "uc001aug.1"; class_code "="; tss_id "TSS161"; p_id "P239"; chr1 coding exon 12780885 12780948 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000316"; exon_number "2"; gene_name "AADACL3"; oId "uc001aug.1"; nearest_ref "uc001aug.1"; class_code "="; tss_id "TSS161"; p_id "P239"; chr1 coding exon 12785189 12788726 . + . gene_id "XLOC_000112"; transcript_id "TCONS_00000316"; exon_number "3"; gene_name "AADACL3"; oId "uc001aug.1"; nearest_ref "uc001aug.1"; class_code "="; tss_id "TSS161"; p_id "P239"; chr1 coding exon 12806163 12806489 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000318"; exon_number "1"; gene_name "C1orf158"; oId "uc010obe.1"; nearest_ref "uc010obe.1"; class_code "="; tss_id "TSS162"; p_id "P242"; chr1 coding exon 12815650 12815763 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000318"; exon_number "2"; gene_name "C1orf158"; oId "uc010obe.1"; nearest_ref "uc010obe.1"; class_code "="; tss_id "TSS162"; p_id "P242"; chr1 coding exon 12819243 12819698 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000318"; exon_number "3"; gene_name "C1orf158"; oId "uc010obe.1"; nearest_ref "uc010obe.1"; class_code "="; tss_id "TSS162"; p_id "P242"; chr1 coding exon 12806163 12806489 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000319"; exon_number "1"; gene_name "C1orf158"; oId "uc001auh.2"; nearest_ref "uc001auh.2"; class_code "="; tss_id "TSS162"; p_id "P241"; chr1 coding exon 12815650 12815763 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000319"; exon_number "2"; gene_name "C1orf158"; oId "uc001auh.2"; nearest_ref "uc001auh.2"; class_code "="; tss_id "TSS162"; p_id "P241"; chr1 coding exon 12819243 12819420 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000319"; exon_number "3"; gene_name "C1orf158"; oId "uc001auh.2"; nearest_ref "uc001auh.2"; class_code "="; tss_id "TSS162"; p_id "P241"; chr1 coding exon 12820703 12821101 . + . gene_id "XLOC_000113"; transcript_id "TCONS_00000319"; exon_number "4"; gene_name "C1orf158"; oId "uc001auh.2"; nearest_ref "uc001auh.2"; class_code "="; tss_id "TSS162"; p_id "P241"; chr1 coding exon 12834984 12835297 . + . gene_id "XLOC_000114"; transcript_id "TCONS_00000320"; exon_number "1"; gene_name "PRAMEF12"; oId "uc001aui.2"; nearest_ref "uc001aui.2"; class_code "="; tss_id "TSS163"; p_id "P243"; chr1 coding exon 12835686 12836261 . + . gene_id "XLOC_000114"; transcript_id "TCONS_00000320"; exon_number "2"; gene_name "PRAMEF12"; oId "uc001aui.2"; nearest_ref "uc001aui.2"; class_code "="; tss_id "TSS163"; p_id "P243"; chr1 coding exon 12837154 12838046 . + . gene_id "XLOC_000114"; transcript_id "TCONS_00000320"; exon_number "3"; gene_name "PRAMEF12"; oId "uc001aui.2"; nearest_ref "uc001aui.2"; class_code "="; tss_id "TSS163"; p_id "P243"; chr1 coding exon 12851546 12851623 . + . gene_id "XLOC_000115"; transcript_id "TCONS_00000321"; exon_number "1"; gene_name "PRAMEF1"; oId "uc001auj.1"; nearest_ref "uc001auj.1"; class_code "="; tss_id "TSS164"; p_id "P244"; chr1 coding exon 12853352 12853663 . + . gene_id "XLOC_000115"; transcript_id "TCONS_00000321"; exon_number "2"; gene_name "PRAMEF1"; oId "uc001auj.1"; nearest_ref "uc001auj.1"; class_code "="; tss_id "TSS164"; p_id "P244"; chr1 coding exon 12854064 12854642 . + . gene_id "XLOC_000115"; transcript_id "TCONS_00000321"; exon_number "3"; gene_name "PRAMEF1"; oId "uc001auj.1"; nearest_ref "uc001auj.1"; class_code "="; tss_id "TSS164"; p_id "P244"; chr1 coding exon 12855587 12856223 . + . gene_id "XLOC_000115"; transcript_id "TCONS_00000321"; exon_number "4"; gene_name "PRAMEF1"; oId "uc001auj.1"; nearest_ref "uc001auj.1"; class_code "="; tss_id "TSS164"; p_id "P244"; chr1 coding exon 12916941 12917002 . + . gene_id "XLOC_000116"; transcript_id "TCONS_00000322"; exon_number "1"; gene_name "PRAMEF2"; oId "uc001aum.1"; nearest_ref "uc001aum.1"; class_code "="; tss_id "TSS165"; p_id "P245"; chr1 coding exon 12918840 12919151 . + . gene_id "XLOC_000116"; transcript_id "TCONS_00000322"; exon_number "2"; gene_name "PRAMEF2"; oId "uc001aum.1"; nearest_ref "uc001aum.1"; class_code "="; tss_id "TSS165"; p_id "P245"; chr1 coding exon 12919548 12920126 . + . gene_id "XLOC_000116"; transcript_id "TCONS_00000322"; exon_number "3"; gene_name "PRAMEF2"; oId "uc001aum.1"; nearest_ref "uc001aum.1"; class_code "="; tss_id "TSS165"; p_id "P245"; chr1 coding exon 12921076 12921764 . + . gene_id "XLOC_000116"; transcript_id "TCONS_00000322"; exon_number "4"; gene_name "PRAMEF2"; oId "uc001aum.1"; nearest_ref "uc001aum.1"; class_code "="; tss_id "TSS165"; p_id "P245"; chr1 coding exon 12976450 12976507 . + . gene_id "XLOC_000117"; transcript_id "TCONS_00000323"; exon_number "1"; gene_name "PRAMEF8"; oId "uc001aup.2"; nearest_ref "uc001aup.2"; class_code "="; tss_id "TSS166"; p_id "P246"; chr1 coding exon 12977488 12977799 . + . gene_id "XLOC_000117"; transcript_id "TCONS_00000323"; exon_number "2"; gene_name "PRAMEF8"; oId "uc001aup.2"; nearest_ref "uc001aup.2"; class_code "="; tss_id "TSS166"; p_id "P246"; chr1 coding exon 12978182 12978757 . + . gene_id "XLOC_000117"; transcript_id "TCONS_00000323"; exon_number "3"; gene_name "PRAMEF8"; oId "uc001aup.2"; nearest_ref "uc001aup.2"; class_code "="; tss_id "TSS166"; p_id "P246"; chr1 coding exon 12979672 12980566 . + . gene_id "XLOC_000117"; transcript_id "TCONS_00000323"; exon_number "4"; gene_name "PRAMEF8"; oId "uc001aup.2"; nearest_ref "uc001aup.2"; class_code "="; tss_id "TSS166"; p_id "P246"; chr1 coding exon 13035543 13035835 . + . gene_id "XLOC_000118"; transcript_id "TCONS_00000324"; exon_number "1"; gene_name "PRAMEF22"; oId "uc009vnq.1"; nearest_ref "uc009vnq.1"; class_code "="; tss_id "TSS167"; p_id "P247"; chr1 coding exon 13036222 13036800 . + . gene_id "XLOC_000118"; transcript_id "TCONS_00000324"; exon_number "2"; gene_name "PRAMEF22"; oId "uc009vnq.1"; nearest_ref "uc009vnq.1"; class_code "="; tss_id "TSS167"; p_id "P247"; chr1 coding exon 13037808 13038381 . + . gene_id "XLOC_000118"; transcript_id "TCONS_00000324"; exon_number "3"; gene_name "PRAMEF22"; oId "uc009vnq.1"; nearest_ref "uc009vnq.1"; class_code "="; tss_id "TSS167"; p_id "P247"; chr1 coding exon 13359819 13359896 . + . gene_id "XLOC_000119"; transcript_id "TCONS_00000325"; exon_number "1"; gene_name "PRAMEF6"; oId "uc001auu.1"; nearest_ref "uc001auu.1"; class_code "="; tss_id "TSS168"; p_id "P248"; chr1 coding exon 13364869 13365177 . + . gene_id "XLOC_000119"; transcript_id "TCONS_00000325"; exon_number "2"; gene_name "PRAMEF6"; oId "uc001auu.1"; nearest_ref "uc001auu.1"; class_code "="; tss_id "TSS168"; p_id "P248"; chr1 coding exon 13365844 13366425 . + . gene_id "XLOC_000119"; transcript_id "TCONS_00000325"; exon_number "3"; gene_name "PRAMEF6"; oId "uc001auu.1"; nearest_ref "uc001auu.1"; class_code "="; tss_id "TSS168"; p_id "P248"; chr1 coding exon 13368172 13369057 . + . gene_id "XLOC_000119"; transcript_id "TCONS_00000325"; exon_number "4"; gene_name "PRAMEF6"; oId "uc001auu.1"; nearest_ref "uc001auu.1"; class_code "="; tss_id "TSS168"; p_id "P248"; chr1 coding exon 13421176 13421253 . + . gene_id "XLOC_000120"; transcript_id "TCONS_00000326"; exon_number "1"; gene_name "PRAMEF9"; oId "uc001auw.1"; nearest_ref "uc001auw.1"; class_code "="; tss_id "TSS169"; p_id "P249"; chr1 coding exon 13423987 13424295 . + . gene_id "XLOC_000120"; transcript_id "TCONS_00000326"; exon_number "2"; gene_name "PRAMEF9"; oId "uc001auw.1"; nearest_ref "uc001auw.1"; class_code "="; tss_id "TSS169"; p_id "P249"; chr1 coding exon 13424967 13425548 . + . gene_id "XLOC_000120"; transcript_id "TCONS_00000326"; exon_number "3"; gene_name "PRAMEF9"; oId "uc001auw.1"; nearest_ref "uc001auw.1"; class_code "="; tss_id "TSS169"; p_id "P249"; chr1 coding exon 13427298 13428191 . + . gene_id "XLOC_000120"; transcript_id "TCONS_00000326"; exon_number "4"; gene_name "PRAMEF9"; oId "uc001auw.1"; nearest_ref "uc001auw.1"; class_code "="; tss_id "TSS169"; p_id "P249"; chr1 coding exon 13495254 13495570 . + . gene_id "XLOC_000121"; transcript_id "TCONS_00000327"; exon_number "1"; gene_name "PRAMEF16"; oId "uc001aux.2"; nearest_ref "uc001aux.2"; class_code "="; tss_id "TSS170"; p_id "P250"; chr1 coding exon 13495967 13496545 . + . gene_id "XLOC_000121"; transcript_id "TCONS_00000327"; exon_number "2"; gene_name "PRAMEF16"; oId "uc001aux.2"; nearest_ref "uc001aux.2"; class_code "="; tss_id "TSS170"; p_id "P250"; chr1 coding exon 13497570 13498257 . + . gene_id "XLOC_000121"; transcript_id "TCONS_00000327"; exon_number "3"; gene_name "PRAMEF16"; oId "uc001aux.2"; nearest_ref "uc001aux.2"; class_code "="; tss_id "TSS170"; p_id "P250"; chr1 coding exon 13516066 13516160 . + . gene_id "XLOC_000122"; transcript_id "TCONS_00000328"; exon_number "1"; gene_name "PRAMEF20"; oId "uc009vnv.1"; nearest_ref "uc009vnv.1"; class_code "="; tss_id "TSS171"; p_id "P251"; chr1 coding exon 13521969 13522259 . + . gene_id "XLOC_000122"; transcript_id "TCONS_00000328"; exon_number "2"; gene_name "PRAMEF20"; oId "uc009vnv.1"; nearest_ref "uc009vnv.1"; class_code "="; tss_id "TSS171"; p_id "P251"; chr1 coding exon 13523737 13524315 . + . gene_id "XLOC_000122"; transcript_id "TCONS_00000328"; exon_number "3"; gene_name "PRAMEF20"; oId "uc009vnv.1"; nearest_ref "uc009vnv.1"; class_code "="; tss_id "TSS171"; p_id "P251"; chr1 coding exon 13526312 13526943 . + . gene_id "XLOC_000122"; transcript_id "TCONS_00000328"; exon_number "4"; gene_name "PRAMEF20"; oId "uc009vnv.1"; nearest_ref "uc009vnv.1"; class_code "="; tss_id "TSS171"; p_id "P251"; chr1 noncoding exon 13629938 13629979 . + . gene_id "XLOC_000123"; transcript_id "TCONS_00000329"; exon_number "1"; gene_name "PRAMEF10"; oId "uc001auz.3"; nearest_ref "uc001auz.3"; class_code "="; tss_id "TSS172"; chr1 noncoding exon 13632323 13632634 . + . gene_id "XLOC_000123"; transcript_id "TCONS_00000329"; exon_number "2"; gene_name "PRAMEF10"; oId "uc001auz.3"; nearest_ref "uc001auz.3"; class_code "="; tss_id "TSS172"; chr1 noncoding exon 13633031 13633609 . + . gene_id "XLOC_000123"; transcript_id "TCONS_00000329"; exon_number "3"; gene_name "PRAMEF10"; oId "uc001auz.3"; nearest_ref "uc001auz.3"; class_code "="; tss_id "TSS172"; chr1 noncoding exon 13634721 13635298 . + . gene_id "XLOC_000123"; transcript_id "TCONS_00000329"; exon_number "4"; gene_name "PRAMEF10"; oId "uc001auz.3"; nearest_ref "uc001auz.3"; class_code "="; tss_id "TSS172"; chr1 coding exon 13641973 13642050 . + . gene_id "XLOC_000124"; transcript_id "TCONS_00000330"; exon_number "1"; gene_name "PRAMEF9"; oId "uc001ava.1"; nearest_ref "uc001ava.1"; class_code "="; tss_id "TSS173"; p_id "P252"; chr1 coding exon 13644784 13645092 . + . gene_id "XLOC_000124"; transcript_id "TCONS_00000330"; exon_number "2"; gene_name "PRAMEF9"; oId "uc001ava.1"; nearest_ref "uc001ava.1"; class_code "="; tss_id "TSS173"; p_id "P252"; chr1 coding exon 13645764 13646345 . + . gene_id "XLOC_000124"; transcript_id "TCONS_00000330"; exon_number "3"; gene_name "PRAMEF9"; oId "uc001ava.1"; nearest_ref "uc001ava.1"; class_code "="; tss_id "TSS173"; p_id "P252"; chr1 coding exon 13648095 13648988 . + . gene_id "XLOC_000124"; transcript_id "TCONS_00000330"; exon_number "4"; gene_name "PRAMEF9"; oId "uc001ava.1"; nearest_ref "uc001ava.1"; class_code "="; tss_id "TSS173"; p_id "P252"; chr1 coding exon 13716088 13716404 . + . gene_id "XLOC_000125"; transcript_id "TCONS_00000331"; exon_number "1"; gene_name "PRAMEF17"; oId "uc009vnz.1"; nearest_ref "uc009vnz.1"; class_code "="; tss_id "TSS174"; p_id "P253"; chr1 coding exon 13716801 13717379 . + . gene_id "XLOC_000125"; transcript_id "TCONS_00000331"; exon_number "2"; gene_name "PRAMEF17"; oId "uc009vnz.1"; nearest_ref "uc009vnz.1"; class_code "="; tss_id "TSS174"; p_id "P253"; chr1 coding exon 13718404 13719064 . + . gene_id "XLOC_000125"; transcript_id "TCONS_00000331"; exon_number "3"; gene_name "PRAMEF17"; oId "uc009vnz.1"; nearest_ref "uc009vnz.1"; class_code "="; tss_id "TSS174"; p_id "P253"; chr1 coding exon 13736907 13737001 . + . gene_id "XLOC_000126"; transcript_id "TCONS_00000332"; exon_number "1"; gene_name "PRAMEF20"; oId "uc009voa.1"; nearest_ref "uc009voa.1"; class_code "="; tss_id "TSS175"; p_id "P254"; chr1 coding exon 13742808 13743098 . + . gene_id "XLOC_000126"; transcript_id "TCONS_00000332"; exon_number "2"; gene_name "PRAMEF20"; oId "uc009voa.1"; nearest_ref "uc009voa.1"; class_code "="; tss_id "TSS175"; p_id "P254"; chr1 coding exon 13744597 13745175 . + . gene_id "XLOC_000126"; transcript_id "TCONS_00000332"; exon_number "3"; gene_name "PRAMEF20"; oId "uc009voa.1"; nearest_ref "uc009voa.1"; class_code "="; tss_id "TSS175"; p_id "P254"; chr1 coding exon 13747172 13747803 . + . gene_id "XLOC_000126"; transcript_id "TCONS_00000332"; exon_number "4"; gene_name "PRAMEF20"; oId "uc009voa.1"; nearest_ref "uc009voa.1"; class_code "="; tss_id "TSS175"; p_id "P254"; chr1 coding exon 13910252 13910595 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000334"; exon_number "1"; gene_name "PDPN"; oId "uc001avd.2"; nearest_ref "uc001avd.2"; class_code "="; tss_id "TSS176"; p_id "P256"; chr1 coding exon 13933668 13933801 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000334"; exon_number "2"; gene_name "PDPN"; oId "uc001avd.2"; nearest_ref "uc001avd.2"; class_code "="; tss_id "TSS176"; p_id "P256"; chr1 coding exon 13936882 13937011 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000334"; exon_number "3"; gene_name "PDPN"; oId "uc001avd.2"; nearest_ref "uc001avd.2"; class_code "="; tss_id "TSS176"; p_id "P256"; chr1 coding exon 13940182 13940220 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000334"; exon_number "4"; gene_name "PDPN"; oId "uc001avd.2"; nearest_ref "uc001avd.2"; class_code "="; tss_id "TSS176"; p_id "P256"; chr1 coding exon 13940795 13940906 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000334"; exon_number "5"; gene_name "PDPN"; oId "uc001avd.2"; nearest_ref "uc001avd.2"; class_code "="; tss_id "TSS176"; p_id "P256"; chr1 coding exon 13942400 13944450 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000334"; exon_number "6"; gene_name "PDPN"; oId "uc001avd.2"; nearest_ref "uc001avd.2"; class_code "="; tss_id "TSS176"; p_id "P256"; chr1 coding exon 13910252 13910595 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000333"; exon_number "1"; gene_name "PDPN"; oId "uc001avc.2"; nearest_ref "uc001avc.2"; class_code "="; tss_id "TSS176"; p_id "P255"; chr1 coding exon 13933668 13933801 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000333"; exon_number "2"; gene_name "PDPN"; oId "uc001avc.2"; nearest_ref "uc001avc.2"; class_code "="; tss_id "TSS176"; p_id "P255"; chr1 coding exon 13936882 13937011 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000333"; exon_number "3"; gene_name "PDPN"; oId "uc001avc.2"; nearest_ref "uc001avc.2"; class_code "="; tss_id "TSS176"; p_id "P255"; chr1 coding exon 13940182 13940220 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000333"; exon_number "4"; gene_name "PDPN"; oId "uc001avc.2"; nearest_ref "uc001avc.2"; class_code "="; tss_id "TSS176"; p_id "P255"; chr1 coding exon 13940795 13940900 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000333"; exon_number "5"; gene_name "PDPN"; oId "uc001avc.2"; nearest_ref "uc001avc.2"; class_code "="; tss_id "TSS176"; p_id "P255"; chr1 coding exon 13942400 13944450 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000333"; exon_number "6"; gene_name "PDPN"; oId "uc001avc.2"; nearest_ref "uc001avc.2"; class_code "="; tss_id "TSS176"; p_id "P255"; chr1 coding exon 13910762 13910836 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000336"; exon_number "1"; gene_name "PDPN"; oId "uc009voc.2"; nearest_ref "uc009voc.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13933668 13933801 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000336"; exon_number "2"; gene_name "PDPN"; oId "uc009voc.2"; nearest_ref "uc009voc.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13936882 13937011 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000336"; exon_number "3"; gene_name "PDPN"; oId "uc009voc.2"; nearest_ref "uc009voc.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13940182 13940220 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000336"; exon_number "4"; gene_name "PDPN"; oId "uc009voc.2"; nearest_ref "uc009voc.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13940795 13940906 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000336"; exon_number "5"; gene_name "PDPN"; oId "uc009voc.2"; nearest_ref "uc009voc.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13942400 13944450 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000336"; exon_number "6"; gene_name "PDPN"; oId "uc009voc.2"; nearest_ref "uc009voc.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13910762 13910836 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "1"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13922322 13922479 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "2"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13933668 13933801 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "3"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13936882 13937011 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "4"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13940182 13940220 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "5"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13940795 13940906 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "6"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13942400 13944450 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000335"; exon_number "7"; gene_name "PDPN"; oId "uc009vob.2"; nearest_ref "uc009vob.2"; class_code "="; tss_id "TSS177"; p_id "P258"; chr1 coding exon 13911967 13912134 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000338"; exon_number "1"; gene_name "PDPN"; oId "uc001avf.2"; nearest_ref "uc001avf.2"; class_code "="; tss_id "TSS178"; p_id "P258"; chr1 coding exon 13933668 13933801 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000338"; exon_number "2"; gene_name "PDPN"; oId "uc001avf.2"; nearest_ref "uc001avf.2"; class_code "="; tss_id "TSS178"; p_id "P258"; chr1 coding exon 13936882 13937011 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000338"; exon_number "3"; gene_name "PDPN"; oId "uc001avf.2"; nearest_ref "uc001avf.2"; class_code "="; tss_id "TSS178"; p_id "P258"; chr1 coding exon 13940182 13940220 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000338"; exon_number "4"; gene_name "PDPN"; oId "uc001avf.2"; nearest_ref "uc001avf.2"; class_code "="; tss_id "TSS178"; p_id "P258"; chr1 coding exon 13940795 13940906 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000338"; exon_number "5"; gene_name "PDPN"; oId "uc001avf.2"; nearest_ref "uc001avf.2"; class_code "="; tss_id "TSS178"; p_id "P258"; chr1 coding exon 13942400 13944450 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000338"; exon_number "6"; gene_name "PDPN"; oId "uc001avf.2"; nearest_ref "uc001avf.2"; class_code "="; tss_id "TSS178"; p_id "P258"; chr1 coding exon 13911967 13912134 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000337"; exon_number "1"; gene_name "PDPN"; oId "uc001ave.2"; nearest_ref "uc001ave.2"; class_code "="; tss_id "TSS178"; p_id "P257"; chr1 coding exon 13933668 13933801 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000337"; exon_number "2"; gene_name "PDPN"; oId "uc001ave.2"; nearest_ref "uc001ave.2"; class_code "="; tss_id "TSS178"; p_id "P257"; chr1 coding exon 13936882 13937011 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000337"; exon_number "3"; gene_name "PDPN"; oId "uc001ave.2"; nearest_ref "uc001ave.2"; class_code "="; tss_id "TSS178"; p_id "P257"; chr1 coding exon 13940182 13940220 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000337"; exon_number "4"; gene_name "PDPN"; oId "uc001ave.2"; nearest_ref "uc001ave.2"; class_code "="; tss_id "TSS178"; p_id "P257"; chr1 coding exon 13940795 13940900 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000337"; exon_number "5"; gene_name "PDPN"; oId "uc001ave.2"; nearest_ref "uc001ave.2"; class_code "="; tss_id "TSS178"; p_id "P257"; chr1 coding exon 13942400 13944450 . + . gene_id "XLOC_000127"; transcript_id "TCONS_00000337"; exon_number "6"; gene_name "PDPN"; oId "uc001ave.2"; nearest_ref "uc001ave.2"; class_code "="; tss_id "TSS178"; p_id "P257"; chr1 coding exon 14026735 14026795 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "1"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14042036 14042109 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "2"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14057495 14057612 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "3"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14059274 14059377 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "4"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14068500 14068652 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "5"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "6"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14142922 14143065 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "7"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14149654 14151572 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000339"; exon_number "8"; gene_name "PRDM2"; oId "uc001avg.2"; nearest_ref "uc001avg.2"; class_code "="; tss_id "TSS179"; p_id "P261"; chr1 coding exon 14031350 14032140 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "1"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14042036 14042109 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "2"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14057495 14057612 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "3"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14059274 14059377 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "4"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14068500 14068652 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "5"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "6"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "7"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14104913 14109326 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "8"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14113010 14114573 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000340"; exon_number "9"; gene_name "PRDM2"; oId "uc001avh.2"; nearest_ref "uc001avh.2"; class_code "="; tss_id "TSS180"; p_id "P260"; chr1 coding exon 14031350 14032140 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "1"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14042036 14042109 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "2"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14057495 14057612 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "3"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14059274 14059377 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "4"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14068500 14068652 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "5"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "6"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "7"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14104913 14109326 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "8"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14142922 14143065 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "9"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 coding exon 14149654 14151572 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000341"; exon_number "10"; gene_name "PRDM2"; oId "uc001avi.2"; nearest_ref "uc001avi.2"; class_code "="; tss_id "TSS180"; p_id "P259"; chr1 nearCoding exon 14057495 14057612 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000342"; exon_number "1"; gene_name "PRDM2"; oId "uc001avj.2"; nearest_ref "uc001avj.2"; class_code "="; tss_id "TSS181"; chr1 nearCoding exon 14068500 14068652 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000342"; exon_number "2"; gene_name "PRDM2"; oId "uc001avj.2"; nearest_ref "uc001avj.2"; class_code "="; tss_id "TSS181"; chr1 nearCoding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000342"; exon_number "3"; gene_name "PRDM2"; oId "uc001avj.2"; nearest_ref "uc001avj.2"; class_code "="; tss_id "TSS181"; chr1 nearCoding exon 14095613 14095668 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000342"; exon_number "4"; gene_name "PRDM2"; oId "uc001avj.2"; nearest_ref "uc001avj.2"; class_code "="; tss_id "TSS181"; chr1 nearCoding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000342"; exon_number "5"; gene_name "PRDM2"; oId "uc001avj.2"; nearest_ref "uc001avj.2"; class_code "="; tss_id "TSS181"; chr1 nearCoding exon 14113010 14114573 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000342"; exon_number "6"; gene_name "PRDM2"; oId "uc001avj.2"; nearest_ref "uc001avj.2"; class_code "="; tss_id "TSS181"; chr1 coding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000343"; exon_number "1"; gene_name "PRDM2"; oId "uc009vod.1"; nearest_ref "uc009vod.1"; class_code "="; tss_id "TSS182"; p_id "P262"; chr1 coding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000343"; exon_number "2"; gene_name "PRDM2"; oId "uc009vod.1"; nearest_ref "uc009vod.1"; class_code "="; tss_id "TSS182"; p_id "P262"; chr1 coding exon 14104913 14104992 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000343"; exon_number "3"; gene_name "PRDM2"; oId "uc009vod.1"; nearest_ref "uc009vod.1"; class_code "="; tss_id "TSS182"; p_id "P262"; chr1 coding exon 14105119 14106820 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000343"; exon_number "4"; gene_name "PRDM2"; oId "uc009vod.1"; nearest_ref "uc009vod.1"; class_code "="; tss_id "TSS182"; p_id "P262"; chr1 coding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000344"; exon_number "1"; gene_name "PRDM2"; oId "uc001avk.2"; nearest_ref "uc001avk.2"; class_code "="; tss_id "TSS182"; p_id "P263"; chr1 coding exon 14095613 14095668 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000344"; exon_number "2"; gene_name "PRDM2"; oId "uc001avk.2"; nearest_ref "uc001avk.2"; class_code "="; tss_id "TSS182"; p_id "P263"; chr1 coding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000344"; exon_number "3"; gene_name "PRDM2"; oId "uc001avk.2"; nearest_ref "uc001avk.2"; class_code "="; tss_id "TSS182"; p_id "P263"; chr1 coding exon 14104913 14109326 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000344"; exon_number "4"; gene_name "PRDM2"; oId "uc001avk.2"; nearest_ref "uc001avk.2"; class_code "="; tss_id "TSS182"; p_id "P263"; chr1 coding exon 14113010 14114573 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000344"; exon_number "5"; gene_name "PRDM2"; oId "uc001avk.2"; nearest_ref "uc001avk.2"; class_code "="; tss_id "TSS182"; p_id "P263"; chr1 nearCoding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000346"; exon_number "1"; gene_name "PRDM2"; oId "uc009vof.2"; nearest_ref "uc009vof.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14095613 14095668 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000346"; exon_number "2"; gene_name "PRDM2"; oId "uc009vof.2"; nearest_ref "uc009vof.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000346"; exon_number "3"; gene_name "PRDM2"; oId "uc009vof.2"; nearest_ref "uc009vof.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14142922 14143065 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000346"; exon_number "4"; gene_name "PRDM2"; oId "uc009vof.2"; nearest_ref "uc009vof.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14149654 14151572 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000346"; exon_number "5"; gene_name "PRDM2"; oId "uc009vof.2"; nearest_ref "uc009vof.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14075856 14075982 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000345"; exon_number "1"; gene_name "PRDM2"; oId "uc009voe.2"; nearest_ref "uc009voe.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14099573 14099683 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000345"; exon_number "2"; gene_name "PRDM2"; oId "uc009voe.2"; nearest_ref "uc009voe.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14142922 14143065 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000345"; exon_number "3"; gene_name "PRDM2"; oId "uc009voe.2"; nearest_ref "uc009voe.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14149654 14151572 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000345"; exon_number "4"; gene_name "PRDM2"; oId "uc009voe.2"; nearest_ref "uc009voe.2"; class_code "="; tss_id "TSS182"; chr1 nearCoding exon 14146462 14150513 . + . gene_id "XLOC_000128"; transcript_id "TCONS_00000347"; exon_number "1"; oId "uc001avl.1"; nearest_ref "uc001avl.1"; class_code "="; chr1 coding exon 14925213 14925406 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "1"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 14925479 14925719 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "2"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "3"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "4"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "5"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "6"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15386668 15386798 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "7"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "8"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15392126 15394651 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000349"; exon_number "9"; oId "uc010obj.1"; nearest_ref "uc010obj.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 14925213 14925719 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "1"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "2"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "3"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "4"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "5"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15386668 15386798 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "6"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "7"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 15392126 15394651 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000348"; exon_number "8"; oId "uc009vog.1"; nearest_ref "uc009vog.1"; class_code "="; tss_id "TSS183"; p_id "P267"; chr1 coding exon 14925213 14925719 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "1"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "2"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "3"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "4"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "5"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15386668 15386798 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "6"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "7"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15392126 15392249 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "8"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15420676 15420881 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "9"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15421311 15421429 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "10"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15428039 15428270 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "11"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15429855 15429956 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "12"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15430519 15430685 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "13"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15438923 15439037 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "14"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15440967 15444543 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000350"; exon_number "15"; oId "uc001avm.3"; nearest_ref "uc001avm.3"; class_code "="; tss_id "TSS183"; p_id "P266"; chr1 coding exon 15250625 15251068 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "1"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "2"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "3"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "4"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "5"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15386668 15386798 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "6"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "7"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15392126 15394651 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000351"; exon_number "8"; oId "uc001avo.2"; nearest_ref "uc001avo.2"; class_code "="; tss_id "TSS184"; p_id "P265"; chr1 coding exon 15256296 15256540 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "1"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "2"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "3"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "4"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "5"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15386668 15386798 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "6"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "7"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15392126 15394651 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000352"; exon_number "8"; oId "uc001avp.2"; nearest_ref "uc001avp.2"; class_code "="; tss_id "TSS185"; p_id "P269"; chr1 coding exon 15272415 15272669 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "1"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "2"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "3"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "4"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "5"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15386668 15386798 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "6"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "7"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15392126 15394651 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000353"; exon_number "8"; oId "uc001avq.2"; nearest_ref "uc001avq.2"; class_code "="; tss_id "TSS186"; p_id "P269"; chr1 coding exon 15287180 15287371 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "1"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15361245 15361381 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "2"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15370485 15370655 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "3"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15382587 15382776 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "4"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15386668 15386793 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "5"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15390068 15390118 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "6"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15392126 15394651 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000354"; exon_number "7"; oId "uc001avr.2"; nearest_ref "uc001avr.2"; class_code "="; tss_id "TSS187"; p_id "P268"; chr1 coding exon 15427704 15428270 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000355"; exon_number "1"; oId "uc001avs.3"; nearest_ref "uc001avs.3"; class_code "="; tss_id "TSS188"; p_id "P264"; chr1 coding exon 15429855 15429956 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000355"; exon_number "2"; oId "uc001avs.3"; nearest_ref "uc001avs.3"; class_code "="; tss_id "TSS188"; p_id "P264"; chr1 coding exon 15430519 15430685 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000355"; exon_number "3"; oId "uc001avs.3"; nearest_ref "uc001avs.3"; class_code "="; tss_id "TSS188"; p_id "P264"; chr1 coding exon 15438923 15439037 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000355"; exon_number "4"; oId "uc001avs.3"; nearest_ref "uc001avs.3"; class_code "="; tss_id "TSS188"; p_id "P264"; chr1 coding exon 15440967 15444543 . + . gene_id "XLOC_000129"; transcript_id "TCONS_00000355"; exon_number "5"; oId "uc001avs.3"; nearest_ref "uc001avs.3"; class_code "="; tss_id "TSS188"; p_id "P264"; chr1 coding exon 15479028 15479280 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000357"; exon_number "1"; gene_name "TMEM51"; oId "uc010obk.1"; nearest_ref "uc010obk.1"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15541391 15541927 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000357"; exon_number "2"; gene_name "TMEM51"; oId "uc010obk.1"; nearest_ref "uc010obk.1"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15545822 15546973 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000357"; exon_number "3"; gene_name "TMEM51"; oId "uc010obk.1"; nearest_ref "uc010obk.1"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15479028 15479280 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000356"; exon_number "1"; gene_name "TMEM51"; oId "uc001avw.3"; nearest_ref "uc001avw.3"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15536986 15537058 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000356"; exon_number "2"; gene_name "TMEM51"; oId "uc001avw.3"; nearest_ref "uc001avw.3"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15541391 15541927 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000356"; exon_number "3"; gene_name "TMEM51"; oId "uc001avw.3"; nearest_ref "uc001avw.3"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15545822 15546973 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000356"; exon_number "4"; gene_name "TMEM51"; oId "uc001avw.3"; nearest_ref "uc001avw.3"; class_code "="; tss_id "TSS189"; p_id "P271"; chr1 coding exon 15480229 15480450 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000358"; exon_number "1"; gene_name "TMEM51"; oId "uc001avz.2"; nearest_ref "uc001avz.2"; class_code "="; tss_id "TSS190"; p_id "P270"; chr1 coding exon 15536986 15537058 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000358"; exon_number "2"; gene_name "TMEM51"; oId "uc001avz.2"; nearest_ref "uc001avz.2"; class_code "="; tss_id "TSS190"; p_id "P270"; chr1 coding exon 15541391 15541927 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000358"; exon_number "3"; gene_name "TMEM51"; oId "uc001avz.2"; nearest_ref "uc001avz.2"; class_code "="; tss_id "TSS190"; p_id "P270"; chr1 coding exon 15545826 15546872 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000358"; exon_number "4"; gene_name "TMEM51"; oId "uc001avz.2"; nearest_ref "uc001avz.2"; class_code "="; tss_id "TSS190"; p_id "P270"; chr1 coding exon 15480229 15480450 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000360"; exon_number "1"; gene_name "TMEM51"; oId "uc001avy.2"; nearest_ref "uc001avy.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15536986 15537058 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000360"; exon_number "2"; gene_name "TMEM51"; oId "uc001avy.2"; nearest_ref "uc001avy.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15541391 15541927 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000360"; exon_number "3"; gene_name "TMEM51"; oId "uc001avy.2"; nearest_ref "uc001avy.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15545822 15546973 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000360"; exon_number "4"; gene_name "TMEM51"; oId "uc001avy.2"; nearest_ref "uc001avy.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15480229 15480450 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000359"; exon_number "1"; gene_name "TMEM51"; oId "uc001avx.2"; nearest_ref "uc001avx.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15541391 15541927 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000359"; exon_number "2"; gene_name "TMEM51"; oId "uc001avx.2"; nearest_ref "uc001avx.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15545822 15546973 . + . gene_id "XLOC_000130"; transcript_id "TCONS_00000359"; exon_number "3"; gene_name "TMEM51"; oId "uc001avx.2"; nearest_ref "uc001avx.2"; class_code "="; tss_id "TSS190"; p_id "P271"; chr1 coding exon 15573768 15573891 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "1"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15578267 15578373 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "2"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15598819 15599025 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "3"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15615895 15616162 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "4"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15623180 15623289 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "5"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15627701 15627937 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "6"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15635109 15635232 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "7"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15639553 15639683 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "8"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15642874 15642963 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "9"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15644320 15644424 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "10"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15650948 15651055 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "11"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15653555 15653638 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "12"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15654773 15654925 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "13"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15655842 15656037 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "14"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15668232 15668389 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "15"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15671579 15671686 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "16"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15671912 15672019 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "17"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15675538 15675645 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "18"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15679373 15679480 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "19"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15684606 15684779 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "20"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15686974 15687199 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "21"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15689138 15689222 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "22"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15692323 15692429 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "23"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15693959 15694118 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "24"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15695866 15695998 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "25"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15700998 15701127 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "26"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15702099 15702226 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "27"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15707197 15707292 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "28"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15707727 15707947 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "29"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15708524 15708689 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "30"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15723793 15724622 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000361"; exon_number "31"; gene_name "FHAD1"; oId "uc001awb.2"; nearest_ref "uc001awb.2"; class_code "="; tss_id "TSS191"; p_id "P275"; chr1 coding exon 15668232 15668384 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "1"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15671579 15671686 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "2"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15671912 15672019 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "3"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15679373 15679480 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "4"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15684606 15684779 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "5"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15686974 15687199 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "6"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15689138 15689222 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "7"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15692323 15692429 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "8"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15693959 15694118 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "9"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15695866 15695998 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "10"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15700998 15701127 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "11"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15702099 15702226 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "12"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15707197 15707292 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "13"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15707727 15707947 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "14"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15708524 15708689 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "15"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15709652 15711054 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000362"; exon_number "16"; gene_name "FHAD1"; oId "uc001awd.1"; nearest_ref "uc001awd.1"; class_code "="; tss_id "TSS192"; p_id "P274"; chr1 coding exon 15671579 15671686 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "1"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15671912 15672019 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "2"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15679373 15679480 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "3"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15684606 15684779 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "4"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15686974 15687199 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "5"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15689138 15689222 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "6"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15692323 15692429 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "7"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15693959 15694118 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "8"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15695866 15695998 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "9"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15700998 15701127 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "10"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15702099 15702226 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "11"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15707197 15707292 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "12"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15707727 15707947 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "13"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15708524 15708689 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "14"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15717706 15717759 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "15"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15723793 15724622 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000363"; exon_number "16"; oId "uc010obl.1"; nearest_ref "uc010obl.1"; class_code "="; tss_id "TSS193"; p_id "P273"; chr1 coding exon 15671912 15672019 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "1"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15679373 15679480 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "2"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15684606 15684779 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "3"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15686974 15687199 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "4"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15689138 15689222 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "5"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15692323 15692429 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "6"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15693959 15694118 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "7"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15695866 15695998 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "8"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15700998 15701127 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "9"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15702099 15702226 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "10"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15707197 15707292 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "11"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15707727 15707947 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "12"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15708524 15708689 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "13"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15723793 15724622 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000364"; exon_number "14"; gene_name "FHAD1"; oId "uc001awe.1"; nearest_ref "uc001awe.1"; class_code "="; tss_id "TSS194"; p_id "P272"; chr1 coding exon 15684287 15684779 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000365"; exon_number "1"; gene_name "FHAD1"; oId "uc001awf.2"; nearest_ref "uc001awf.2"; class_code "="; tss_id "TSS195"; p_id "P276"; chr1 coding exon 15686974 15687199 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000365"; exon_number "2"; gene_name "FHAD1"; oId "uc001awf.2"; nearest_ref "uc001awf.2"; class_code "="; tss_id "TSS195"; p_id "P276"; chr1 coding exon 15689138 15689222 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000365"; exon_number "3"; gene_name "FHAD1"; oId "uc001awf.2"; nearest_ref "uc001awf.2"; class_code "="; tss_id "TSS195"; p_id "P276"; chr1 coding exon 15690237 15690810 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000365"; exon_number "4"; gene_name "FHAD1"; oId "uc001awf.2"; nearest_ref "uc001awf.2"; class_code "="; tss_id "TSS195"; p_id "P276"; chr1 nearCoding exon 15707197 15707292 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "1"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15707727 15707947 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "2"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15708524 15708689 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "3"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15714547 15714627 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "4"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15714842 15714918 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "5"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15719596 15719713 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "6"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15723793 15723945 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "7"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 nearCoding exon 15726450 15726776 . + . gene_id "XLOC_000131"; transcript_id "TCONS_00000366"; exon_number "8"; oId "uc001awg.2"; nearest_ref "uc001awg.2"; class_code "="; tss_id "TSS196"; chr1 coding exon 15736391 15736775 . + . gene_id "XLOC_000132"; transcript_id "TCONS_00000367"; exon_number "1"; gene_name "EFHD2"; oId "uc001awh.2"; nearest_ref "uc001awh.2"; class_code "="; tss_id "TSS197"; p_id "P277"; chr1 coding exon 15752367 15752514 . + . gene_id "XLOC_000132"; transcript_id "TCONS_00000367"; exon_number "2"; gene_name "EFHD2"; oId "uc001awh.2"; nearest_ref "uc001awh.2"; class_code "="; tss_id "TSS197"; p_id "P277"; chr1 coding exon 15753646 15753780 . + . gene_id "XLOC_000132"; transcript_id "TCONS_00000367"; exon_number "3"; gene_name "EFHD2"; oId "uc001awh.2"; nearest_ref "uc001awh.2"; class_code "="; tss_id "TSS197"; p_id "P277"; chr1 coding exon 15755089 15756839 . + . gene_id "XLOC_000132"; transcript_id "TCONS_00000367"; exon_number "4"; gene_name "EFHD2"; oId "uc001awh.2"; nearest_ref "uc001awh.2"; class_code "="; tss_id "TSS197"; p_id "P277"; chr1 coding exon 15764938 15765000 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "1"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15766796 15766887 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "2"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15766989 15767086 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "3"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15768943 15769068 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "4"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15769914 15770050 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "5"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15772092 15772244 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "6"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15773070 15773153 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000369"; exon_number "7"; gene_name "CTRC"; oId "uc001awj.1"; nearest_ref "uc001awj.1"; class_code "="; tss_id "TSS198"; p_id "P279"; chr1 coding exon 15764938 15765000 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "1"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15766796 15766887 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "2"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15766989 15767086 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "3"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15768943 15769068 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "4"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15769914 15770050 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "5"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15771101 15771246 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "6"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15772092 15772244 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "7"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15773070 15773153 . + . gene_id "XLOC_000133"; transcript_id "TCONS_00000368"; exon_number "8"; gene_name "CTRC"; oId "uc001awi.1"; nearest_ref "uc001awi.1"; class_code "="; tss_id "TSS198"; p_id "P278"; chr1 coding exon 15783223 15783288 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "1"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15783581 15783669 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "2"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15788056 15788153 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "3"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15789228 15789356 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "4"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15789881 15790017 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "5"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15792494 15792639 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "6"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15793881 15794033 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "7"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15798485 15798585 . + . gene_id "XLOC_000134"; transcript_id "TCONS_00000370"; exon_number "8"; gene_name "CELA2A"; oId "uc001awk.2"; nearest_ref "uc001awk.2"; class_code "="; tss_id "TSS199"; p_id "P280"; chr1 coding exon 15802596 15802660 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "1"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15802952 15803040 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "2"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15807593 15807690 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "3"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15808760 15808888 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "4"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15809759 15809895 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "5"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15812396 15812541 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "6"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15813780 15813932 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "7"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15817790 15817894 . + . gene_id "XLOC_000135"; transcript_id "TCONS_00000371"; exon_number "8"; gene_name "CELA2B"; oId "uc001awl.2"; nearest_ref "uc001awl.2"; class_code "="; tss_id "TSS200"; p_id "P281"; chr1 coding exon 15853352 15853453 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "1"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15855583 15855767 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "2"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15860732 15860798 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "3"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15862970 15863309 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "4"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15870894 15871078 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "5"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15873262 15873366 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "6"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15874765 15874923 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "7"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15886021 15886151 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "8"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15888637 15888820 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "9"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15890424 15890606 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "10"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15890778 15890854 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "11"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15892414 15892494 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "12"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15892577 15893091 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000372"; exon_number "13"; gene_name "DNAJC16"; oId "uc001awr.1"; nearest_ref "uc001awr.1"; class_code "="; tss_id "TSS201"; p_id "P282"; chr1 coding exon 15853352 15853453 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "1"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15860732 15860798 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "2"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15862970 15863309 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "3"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15870894 15871078 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "4"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15873262 15873366 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "5"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15874765 15874923 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "6"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15886021 15886151 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "7"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15888637 15888820 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "8"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15890424 15890606 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "9"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15890778 15890854 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "10"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15892414 15892494 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "11"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15892577 15892675 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "12"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15893594 15893764 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "13"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15894273 15898226 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000374"; exon_number "14"; gene_name "DNAJC16"; oId "uc001awt.2"; nearest_ref "uc001awt.2"; class_code "="; tss_id "TSS201"; p_id "P284"; chr1 coding exon 15853352 15853453 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "1"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15855583 15855767 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "2"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15860732 15860798 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "3"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15862970 15863309 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "4"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15870894 15871078 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "5"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15873262 15873366 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "6"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15874765 15874923 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "7"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15886021 15886151 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "8"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15888637 15888820 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "9"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15890424 15890606 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "10"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15890778 15890854 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "11"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15892414 15892494 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "12"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15892577 15892675 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "13"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15893594 15893764 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "14"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 coding exon 15894273 15898226 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000373"; exon_number "15"; gene_name "DNAJC16"; oId "uc001aws.2"; nearest_ref "uc001aws.2"; class_code "="; tss_id "TSS201"; p_id "P283"; chr1 nearCoding exon 15886021 15886151 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "1"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15886626 15886824 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "2"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15888637 15888820 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "3"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15890424 15890606 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "4"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15890778 15890854 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "5"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15891677 15891948 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "6"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15892414 15892494 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "7"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15892577 15892905 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "8"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15893594 15893764 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "9"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15894273 15894730 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "10"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15895272 15895466 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "11"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15901255 15901644 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "12"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15901830 15901967 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "13"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 nearCoding exon 15918754 15918872 . + . gene_id "XLOC_000136"; transcript_id "TCONS_00000375"; exon_number "14"; oId "uc001awu.2"; nearest_ref "uc001awu.2"; class_code "="; tss_id "TSS202"; chr1 coding exon 15944070 15944303 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000376"; exon_number "1"; gene_name "DDI2"; oId "uc001aww.2"; nearest_ref "uc001aww.2"; class_code "="; tss_id "TSS203"; p_id "P286"; chr1 coding exon 15953164 15953293 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000376"; exon_number "2"; gene_name "DDI2"; oId "uc001aww.2"; nearest_ref "uc001aww.2"; class_code "="; tss_id "TSS203"; p_id "P286"; chr1 coding exon 15956820 15957056 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000376"; exon_number "3"; gene_name "DDI2"; oId "uc001aww.2"; nearest_ref "uc001aww.2"; class_code "="; tss_id "TSS203"; p_id "P286"; chr1 coding exon 15959934 15960794 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000376"; exon_number "4"; gene_name "DDI2"; oId "uc001aww.2"; nearest_ref "uc001aww.2"; class_code "="; tss_id "TSS203"; p_id "P286"; chr1 coding exon 15944070 15944303 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "1"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15953164 15953293 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "2"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15956820 15957056 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "3"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15959934 15960060 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "4"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15964802 15964929 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "5"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15970017 15970145 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "6"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15976215 15976318 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "7"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15978201 15978390 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "8"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15983112 15983174 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "9"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15986332 15986748 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000377"; exon_number "10"; gene_name "DDI2"; oId "uc001awx.1"; nearest_ref "uc001awx.1"; class_code "="; tss_id "TSS203"; p_id "P288"; chr1 coding exon 15956820 15957056 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "1"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15959934 15960060 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "2"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15960293 15960374 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "3"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15970017 15970145 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "4"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15976215 15976318 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "5"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15978201 15978390 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "6"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15983112 15983174 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "7"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15986332 15986748 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000378"; exon_number "8"; gene_name "DDI2"; oId "uc009voj.1"; nearest_ref "uc009voj.1"; class_code "="; tss_id "TSS204"; p_id "P285"; chr1 coding exon 15986364 15988216 . + . gene_id "XLOC_000137"; transcript_id "TCONS_00000379"; exon_number "1"; gene_name "RSC1A1"; oId "uc010obn.1"; nearest_ref "uc010obn.1"; class_code "="; p_id "P287"; chr1 noncoding exon 15992766 15995535 . + . gene_id "XLOC_000138"; transcript_id "TCONS_00000380"; exon_number "1"; oId "uc001awz.2"; nearest_ref "uc001awz.2"; class_code "="; chr1 coding exon 16010827 16011113 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "1"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16042732 16042838 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "2"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16043202 16043311 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "3"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16044388 16044487 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "4"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16045033 16045120 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "5"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16046229 16046415 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "6"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16047824 16047883 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "7"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16051812 16052040 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "8"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16053509 16054327 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "9"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16054574 16054643 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "10"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16054762 16054852 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "11"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16055164 16055228 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "12"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16055597 16055685 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "13"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16056292 16056424 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "14"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16057027 16057217 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "15"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16057687 16057752 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "16"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16058384 16058543 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "17"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16058845 16059024 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "18"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16059107 16059223 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "19"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16060292 16061262 . + . gene_id "XLOC_000139"; transcript_id "TCONS_00000381"; exon_number "20"; gene_name "PLEKHM2"; oId "uc010obo.1"; nearest_ref "uc010obo.1"; class_code "="; tss_id "TSS205"; p_id "P289"; chr1 coding exon 16062809 16063358 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000382"; exon_number "1"; gene_name "SLC25A34"; oId "uc001axb.1"; nearest_ref "uc001axb.1"; class_code "="; tss_id "TSS206"; p_id "P290"; chr1 coding exon 16064424 16064489 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000382"; exon_number "2"; gene_name "SLC25A34"; oId "uc001axb.1"; nearest_ref "uc001axb.1"; class_code "="; tss_id "TSS206"; p_id "P290"; chr1 coding exon 16064588 16064740 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000382"; exon_number "3"; gene_name "SLC25A34"; oId "uc001axb.1"; nearest_ref "uc001axb.1"; class_code "="; tss_id "TSS206"; p_id "P290"; chr1 coding exon 16065089 16065223 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000382"; exon_number "4"; gene_name "SLC25A34"; oId "uc001axb.1"; nearest_ref "uc001axb.1"; class_code "="; tss_id "TSS206"; p_id "P290"; chr1 coding exon 16065719 16067884 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000382"; exon_number "5"; gene_name "SLC25A34"; oId "uc001axb.1"; nearest_ref "uc001axb.1"; class_code "="; tss_id "TSS206"; p_id "P290"; chr1 nearCoding exon 16065740 16067050 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000383"; exon_number "1"; oId "uc009vok.1"; nearest_ref "uc009vok.1"; class_code "="; tss_id "TSS207"; chr1 nearCoding exon 16067456 16067885 . + . gene_id "XLOC_000140"; transcript_id "TCONS_00000383"; exon_number "2"; oId "uc009vok.1"; nearest_ref "uc009vok.1"; class_code "="; tss_id "TSS207"; chr1 coding exon 16068917 16069142 . + . gene_id "XLOC_000141"; transcript_id "TCONS_00000384"; exon_number "1"; gene_name "TMEM82"; oId "uc001axc.2"; nearest_ref "uc001axc.2"; class_code "="; tss_id "TSS208"; p_id "P291"; chr1 coding exon 16069330 16069402 . + . gene_id "XLOC_000141"; transcript_id "TCONS_00000384"; exon_number "2"; gene_name "TMEM82"; oId "uc001axc.2"; nearest_ref "uc001axc.2"; class_code "="; tss_id "TSS208"; p_id "P291"; chr1 coding exon 16069515 16069689 . + . gene_id "XLOC_000141"; transcript_id "TCONS_00000384"; exon_number "3"; gene_name "TMEM82"; oId "uc001axc.2"; nearest_ref "uc001axc.2"; class_code "="; tss_id "TSS208"; p_id "P291"; chr1 coding exon 16070655 16071075 . + . gene_id "XLOC_000141"; transcript_id "TCONS_00000384"; exon_number "4"; gene_name "TMEM82"; oId "uc001axc.2"; nearest_ref "uc001axc.2"; class_code "="; tss_id "TSS208"; p_id "P291"; chr1 coding exon 16073362 16073549 . + . gene_id "XLOC_000141"; transcript_id "TCONS_00000384"; exon_number "5"; gene_name "TMEM82"; oId "uc001axc.2"; nearest_ref "uc001axc.2"; class_code "="; tss_id "TSS208"; p_id "P291"; chr1 coding exon 16074041 16074475 . + . gene_id "XLOC_000141"; transcript_id "TCONS_00000384"; exon_number "6"; gene_name "TMEM82"; oId "uc001axc.2"; nearest_ref "uc001axc.2"; class_code "="; tss_id "TSS208"; p_id "P291"; chr1 coding exon 16083154 16083227 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "1"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16084669 16084824 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "2"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16090988 16091180 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "3"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16091459 16091728 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "4"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16093871 16094058 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "5"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16095023 16095125 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "6"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16096904 16097073 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "7"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16101113 16101291 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "8"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16103665 16103782 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "9"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16111043 16113084 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000385"; exon_number "10"; gene_name "FBLIM1"; oId "uc001axd.1"; nearest_ref "uc001axd.1"; class_code "="; tss_id "TSS209"; p_id "P294"; chr1 coding exon 16085255 16085343 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "1"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16090991 16091180 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "2"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16091459 16091728 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "3"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16093871 16094058 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "4"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16095023 16095125 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "5"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16096904 16097073 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "6"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16101113 16101291 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "7"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16103665 16103782 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "8"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 coding exon 16111043 16113084 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000386"; exon_number "9"; gene_name "FBLIM1"; oId "uc001axe.1"; nearest_ref "uc001axe.1"; class_code "="; tss_id "TSS210"; p_id "P294"; chr1 nearCoding exon 16085255 16085343 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "1"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16090991 16091180 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "2"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16091459 16091728 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "3"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16093871 16094058 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "4"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16095023 16095125 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "5"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16096904 16097073 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "6"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16101113 16101291 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "7"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16103665 16103782 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "8"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16111043 16111765 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "9"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 nearCoding exon 16114416 16114431 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000387"; exon_number "10"; gene_name "FBLIM1"; oId "uc001axf.2"; nearest_ref "uc001axf.2"; class_code "="; tss_id "TSS210"; chr1 coding exon 16090991 16091180 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000388"; exon_number "1"; gene_name "FBLIM1"; oId "uc001axg.1"; nearest_ref "uc001axg.1"; class_code "="; tss_id "TSS211"; p_id "P293"; chr1 coding exon 16091459 16091728 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000388"; exon_number "2"; gene_name "FBLIM1"; oId "uc001axg.1"; nearest_ref "uc001axg.1"; class_code "="; tss_id "TSS211"; p_id "P293"; chr1 coding exon 16093871 16094058 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000388"; exon_number "3"; gene_name "FBLIM1"; oId "uc001axg.1"; nearest_ref "uc001axg.1"; class_code "="; tss_id "TSS211"; p_id "P293"; chr1 coding exon 16095023 16095125 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000388"; exon_number "4"; gene_name "FBLIM1"; oId "uc001axg.1"; nearest_ref "uc001axg.1"; class_code "="; tss_id "TSS211"; p_id "P293"; chr1 coding exon 16096904 16097073 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000388"; exon_number "5"; gene_name "FBLIM1"; oId "uc001axg.1"; nearest_ref "uc001axg.1"; class_code "="; tss_id "TSS211"; p_id "P293"; chr1 coding exon 16101113 16101715 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000388"; exon_number "6"; gene_name "FBLIM1"; oId "uc001axg.1"; nearest_ref "uc001axg.1"; class_code "="; tss_id "TSS211"; p_id "P293"; chr1 coding exon 16091030 16091042 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000389"; exon_number "1"; gene_name "FBLIM1"; oId "uc001axh.1"; nearest_ref "uc001axh.1"; class_code "="; tss_id "TSS211"; p_id "P292"; chr1 coding exon 16091459 16091728 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000389"; exon_number "2"; gene_name "FBLIM1"; oId "uc001axh.1"; nearest_ref "uc001axh.1"; class_code "="; tss_id "TSS211"; p_id "P292"; chr1 coding exon 16096904 16097073 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000389"; exon_number "3"; gene_name "FBLIM1"; oId "uc001axh.1"; nearest_ref "uc001axh.1"; class_code "="; tss_id "TSS211"; p_id "P292"; chr1 coding exon 16101113 16101291 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000389"; exon_number "4"; gene_name "FBLIM1"; oId "uc001axh.1"; nearest_ref "uc001axh.1"; class_code "="; tss_id "TSS211"; p_id "P292"; chr1 coding exon 16103665 16103782 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000389"; exon_number "5"; gene_name "FBLIM1"; oId "uc001axh.1"; nearest_ref "uc001axh.1"; class_code "="; tss_id "TSS211"; p_id "P292"; chr1 coding exon 16111043 16113084 . + . gene_id "XLOC_000142"; transcript_id "TCONS_00000389"; exon_number "6"; gene_name "FBLIM1"; oId "uc001axh.1"; nearest_ref "uc001axh.1"; class_code "="; tss_id "TSS211"; p_id "P292"; chr1 coding exon 16174359 16174645 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "1"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16199311 16199631 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "2"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16202697 16203173 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "3"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16235816 16235976 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "4"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16237596 16237796 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "5"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16242623 16242774 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "6"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16245421 16245546 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "7"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16245899 16246012 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "8"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16247365 16247478 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "9"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16248744 16248844 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "10"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16254586 16262761 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "11"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16263658 16264140 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "12"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16264307 16264501 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "13"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16265213 16265371 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "14"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16265791 16266950 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000390"; exon_number "15"; gene_name "SPEN"; oId "uc001axk.1"; nearest_ref "uc001axk.1"; class_code "="; tss_id "TSS212"; p_id "P295"; chr1 coding exon 16200610 16200890 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "1"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16202697 16203173 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "2"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16235816 16235976 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "3"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16237596 16237796 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "4"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16242623 16242774 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "5"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16245421 16245546 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "6"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16245899 16246012 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "7"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16247365 16247478 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "8"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16248744 16248844 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "9"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16254586 16262761 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "10"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16263658 16264140 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "11"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16264307 16264501 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "12"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16265213 16265371 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "13"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16265791 16266950 . + . gene_id "XLOC_000143"; transcript_id "TCONS_00000391"; exon_number "14"; gene_name "SPEN"; oId "uc010obp.1"; nearest_ref "uc010obp.1"; class_code "="; tss_id "TSS213"; p_id "P296"; chr1 coding exon 16330731 16330880 . + . gene_id "XLOC_000144"; transcript_id "TCONS_00000392"; exon_number "1"; gene_name "C1orf64"; oId "uc001axn.2"; nearest_ref "uc001axn.2"; class_code "="; tss_id "TSS214"; p_id "P297"; chr1 coding exon 16332414 16333180 . + . gene_id "XLOC_000144"; transcript_id "TCONS_00000392"; exon_number "2"; gene_name "C1orf64"; oId "uc001axn.2"; nearest_ref "uc001axn.2"; class_code "="; tss_id "TSS214"; p_id "P297"; chr1 nearCoding exon 16345370 16345469 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "1"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16346531 16346728 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "2"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16347526 16347589 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "3"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16347792 16348008 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "4"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16348486 16348558 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "5"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16349108 16349214 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "6"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16350295 16350423 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "7"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16351354 16351386 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "8"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16352603 16352742 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "9"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16353031 16353108 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "10"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16353192 16353270 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "11"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16353805 16353930 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "12"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16354316 16354400 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "13"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16354513 16354614 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "14"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16355215 16355340 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "15"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16355621 16355794 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "16"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16356226 16356295 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "17"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16356460 16356570 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "18"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16356956 16357169 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "19"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16358205 16358338 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "20"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16358698 16358786 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "21"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16358938 16359021 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "22"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16359665 16359751 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "23"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 nearCoding exon 16360106 16360544 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000393"; exon_number "24"; gene_name "CLCNKA"; oId "uc001axt.2"; nearest_ref "uc001axt.2"; class_code "="; tss_id "TSS215"; chr1 coding exon 16348486 16348558 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "1"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16349108 16349214 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "2"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16350295 16350423 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "3"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16352603 16352742 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "4"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16353031 16353108 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "5"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16353192 16353270 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "6"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16353805 16353930 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "7"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16354316 16354400 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "8"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16354513 16354614 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "9"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16355256 16355340 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "10"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16355621 16355794 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "11"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16356226 16356295 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "12"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16356460 16356570 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "13"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16356956 16357169 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "14"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16358205 16358338 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "15"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16358698 16358786 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "16"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16358938 16359021 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "17"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16359665 16359751 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "18"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16360106 16360544 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000396"; exon_number "19"; gene_name "CLCNKA"; oId "uc010obw.1"; nearest_ref "uc010obw.1"; class_code "="; tss_id "TSS216"; p_id "P301"; chr1 coding exon 16348486 16348558 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "1"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16349108 16349214 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "2"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16350295 16350423 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "3"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16351258 16351386 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "4"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16352603 16352742 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "5"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16353031 16353108 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "6"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16353192 16353270 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "7"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16353805 16353930 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "8"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16354316 16354400 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "9"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16354513 16354614 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "10"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16355256 16355340 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "11"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16355621 16355794 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "12"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16356226 16356295 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "13"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16356460 16356570 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "14"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16356956 16357169 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "15"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16358205 16358338 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "16"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16358698 16358786 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "17"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16358941 16359021 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "18"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16359665 16359751 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "19"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16360106 16360544 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000395"; exon_number "20"; gene_name "CLCNKA"; oId "uc001axv.2"; nearest_ref "uc001axv.2"; class_code "="; tss_id "TSS216"; p_id "P299"; chr1 coding exon 16348486 16348558 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "1"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16349108 16349214 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "2"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16350295 16350423 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "3"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16351258 16351386 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "4"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16352603 16352742 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "5"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16353031 16353108 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "6"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16353192 16353270 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "7"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16353805 16353930 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "8"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16354316 16354400 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "9"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16354513 16354614 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "10"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16355256 16355340 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "11"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16355621 16355794 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "12"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16356226 16356295 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "13"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16356460 16356570 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "14"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16356956 16357169 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "15"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16358205 16358338 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "16"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16358698 16358786 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "17"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16358938 16359021 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "18"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16359665 16359751 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "19"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16360106 16360544 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000394"; exon_number "20"; gene_name "CLCNKA"; oId "uc001axu.2"; nearest_ref "uc001axu.2"; class_code "="; tss_id "TSS216"; p_id "P300"; chr1 coding exon 16348486 16348558 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "1"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16370981 16371087 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "2"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16372053 16372181 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "3"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16373030 16373158 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "4"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16374400 16374539 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "5"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16374838 16374915 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "6"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16374999 16375077 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "7"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16375615 16375740 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "8"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16376113 16376197 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "9"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16376310 16376411 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "10"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16377011 16377095 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "11"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16377370 16377543 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "12"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16377973 16378042 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "13"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16378205 16378315 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "14"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16378693 16378906 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "15"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16380134 16380267 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "16"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16381930 16382018 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "17"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16382170 16382253 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "18"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16382917 16383003 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "19"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16383364 16383802 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000397"; exon_number "20"; gene_name "CLCNKB"; oId "uc001axw.3"; nearest_ref "uc001axw.3"; class_code "="; tss_id "TSS216"; p_id "P303"; chr1 coding exon 16355007 16355340 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000398"; exon_number "1"; gene_name "CLCNKA"; oId "uc010obx.1"; nearest_ref "uc010obx.1"; class_code "="; tss_id "TSS217"; p_id "P302"; chr1 coding exon 16355621 16355794 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000398"; exon_number "2"; gene_name "CLCNKA"; oId "uc010obx.1"; nearest_ref "uc010obx.1"; class_code "="; tss_id "TSS217"; p_id "P302"; chr1 coding exon 16356226 16356295 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000398"; exon_number "3"; gene_name "CLCNKA"; oId "uc010obx.1"; nearest_ref "uc010obx.1"; class_code "="; tss_id "TSS217"; p_id "P302"; chr1 coding exon 16356460 16356570 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000398"; exon_number "4"; gene_name "CLCNKA"; oId "uc010obx.1"; nearest_ref "uc010obx.1"; class_code "="; tss_id "TSS217"; p_id "P302"; chr1 coding exon 16356956 16357169 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000398"; exon_number "5"; gene_name "CLCNKA"; oId "uc010obx.1"; nearest_ref "uc010obx.1"; class_code "="; tss_id "TSS217"; p_id "P302"; chr1 coding exon 16355007 16355340 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "1"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16355621 16355814 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "2"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16356226 16356295 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "3"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16356460 16356570 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "4"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16356956 16357169 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "5"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16358205 16358289 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "6"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16358698 16358786 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000399"; exon_number "7"; gene_name "CLCNKA"; oId "uc010oby.1"; nearest_ref "uc010oby.1"; class_code "="; tss_id "TSS217"; p_id "P298"; chr1 coding exon 16370247 16370375 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "1"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16370981 16371087 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "2"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16372053 16372181 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "3"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16373030 16373158 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "4"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16374400 16374539 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "5"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16374838 16374915 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "6"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16374999 16375077 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "7"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16375615 16375740 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "8"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16376113 16376197 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "9"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16376310 16376411 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "10"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16377011 16377095 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "11"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16377370 16377543 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "12"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16377973 16378042 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "13"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16378205 16378315 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "14"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16378693 16378906 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "15"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16380134 16380267 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "16"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16381930 16382018 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "17"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16382170 16382253 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "18"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16382917 16383003 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "19"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16383364 16383802 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000400"; exon_number "20"; gene_name "CLCNKB"; oId "uc001axx.3"; nearest_ref "uc001axx.3"; class_code "="; tss_id "TSS218"; p_id "P303"; chr1 coding exon 16375284 16375740 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "1"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16376113 16376197 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "2"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16376310 16376411 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "3"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16377011 16377095 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "4"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16377370 16377543 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "5"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16377973 16378042 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "6"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16378205 16378315 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "7"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16378693 16378906 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "8"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16380134 16380267 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "9"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16381930 16382018 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "10"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16382173 16382253 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "11"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16382917 16383003 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "12"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16383364 16383802 . + . gene_id "XLOC_000145"; transcript_id "TCONS_00000401"; exon_number "13"; gene_name "CLCNKB"; oId "uc001axy.3"; nearest_ref "uc001axy.3"; class_code "="; tss_id "TSS219"; p_id "P304"; chr1 coding exon 16693583 16693803 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000402"; exon_number "1"; gene_name "C1orf144"; oId "uc010ocb.1"; nearest_ref "uc010ocb.1"; class_code "="; tss_id "TSS220"; p_id "P308"; chr1 coding exon 16719726 16719977 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000402"; exon_number "2"; gene_name "C1orf144"; oId "uc010ocb.1"; nearest_ref "uc010ocb.1"; class_code "="; tss_id "TSS220"; p_id "P308"; chr1 coding exon 16721533 16721565 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000402"; exon_number "3"; gene_name "C1orf144"; oId "uc010ocb.1"; nearest_ref "uc010ocb.1"; class_code "="; tss_id "TSS220"; p_id "P308"; chr1 coding exon 16721616 16722607 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000402"; exon_number "4"; gene_name "C1orf144"; oId "uc010ocb.1"; nearest_ref "uc010ocb.1"; class_code "="; tss_id "TSS220"; p_id "P308"; chr1 coding exon 16693583 16693803 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000405"; exon_number "1"; gene_name "C1orf144"; oId "uc001aym.3"; nearest_ref "uc001aym.3"; class_code "="; tss_id "TSS220"; p_id "P307"; chr1 coding exon 16717870 16717919 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000405"; exon_number "2"; gene_name "C1orf144"; oId "uc001aym.3"; nearest_ref "uc001aym.3"; class_code "="; tss_id "TSS220"; p_id "P307"; chr1 coding exon 16719723 16719977 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000405"; exon_number "3"; gene_name "C1orf144"; oId "uc001aym.3"; nearest_ref "uc001aym.3"; class_code "="; tss_id "TSS220"; p_id "P307"; chr1 coding exon 16721533 16724639 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000405"; exon_number "4"; gene_name "C1orf144"; oId "uc001aym.3"; nearest_ref "uc001aym.3"; class_code "="; tss_id "TSS220"; p_id "P307"; chr1 coding exon 16693583 16693803 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000404"; exon_number "1"; gene_name "C1orf144"; oId "uc001ayk.3"; nearest_ref "uc001ayk.3"; class_code "="; tss_id "TSS220"; p_id "P306"; chr1 coding exon 16719726 16719977 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000404"; exon_number "2"; gene_name "C1orf144"; oId "uc001ayk.3"; nearest_ref "uc001ayk.3"; class_code "="; tss_id "TSS220"; p_id "P306"; chr1 coding exon 16721533 16724639 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000404"; exon_number "3"; gene_name "C1orf144"; oId "uc001ayk.3"; nearest_ref "uc001ayk.3"; class_code "="; tss_id "TSS220"; p_id "P306"; chr1 coding exon 16693583 16693803 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000403"; exon_number "1"; gene_name "C1orf144"; oId "uc001ayi.3"; nearest_ref "uc001ayi.3"; class_code "="; tss_id "TSS220"; p_id "P305"; chr1 coding exon 16719723 16719977 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000403"; exon_number "2"; gene_name "C1orf144"; oId "uc001ayi.3"; nearest_ref "uc001ayi.3"; class_code "="; tss_id "TSS220"; p_id "P305"; chr1 coding exon 16721533 16724639 . + . gene_id "XLOC_000146"; transcript_id "TCONS_00000403"; exon_number "3"; gene_name "C1orf144"; oId "uc001ayi.3"; nearest_ref "uc001ayi.3"; class_code "="; tss_id "TSS220"; p_id "P305"; chr1 nearCoding exon 16767167 16767348 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "1"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16770127 16770227 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "2"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16774365 16774469 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "3"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16774555 16774636 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "4"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16775588 16775696 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "5"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16778333 16778510 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "6"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16782313 16782388 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "7"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16785337 16785544 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "8"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 nearCoding exon 16786272 16786572 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000406"; exon_number "9"; gene_name "NECAP2"; oId "uc001ayp.3"; nearest_ref "uc001ayp.3"; class_code "="; tss_id "TSS221"; chr1 coding exon 16767167 16767270 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "1"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16770127 16770227 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "2"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16774365 16774469 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "3"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16774555 16774636 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "4"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16775588 16775696 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "5"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16778333 16778510 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "6"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16782313 16782388 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "7"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16785337 16786582 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000409"; exon_number "8"; gene_name "NECAP2"; oId "uc010ocd.1"; nearest_ref "uc010ocd.1"; class_code "="; tss_id "TSS221"; p_id "P310"; chr1 coding exon 16767167 16767348 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "1"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16770127 16770227 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "2"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16774365 16774469 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "3"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16774555 16774636 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "4"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16775588 16775696 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "5"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16778333 16778510 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "6"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16785337 16786582 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000408"; exon_number "7"; gene_name "NECAP2"; oId "uc001ayq.2"; nearest_ref "uc001ayq.2"; class_code "="; tss_id "TSS221"; p_id "P311"; chr1 coding exon 16767167 16767348 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "1"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16770127 16770227 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "2"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16774365 16774469 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "3"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16774555 16774636 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "4"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16775588 16775696 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "5"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16778333 16778510 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "6"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16782313 16782388 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "7"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 coding exon 16785337 16786582 . + . gene_id "XLOC_000147"; transcript_id "TCONS_00000407"; exon_number "8"; gene_name "NECAP2"; oId "uc001ayo.2"; nearest_ref "uc001ayo.2"; class_code "="; tss_id "TSS221"; p_id "P309"; chr1 noncoding exon 16862255 16864669 . + . gene_id "XLOC_000148"; transcript_id "TCONS_00000410"; exon_number "1"; oId "uc001ayv.1"; nearest_ref "uc001ayv.1"; class_code "="; chr1 noncoding exon 16972069 16972173 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000412"; exon_number "1"; gene_name "MST1"; oId "uc010ocg.1"; nearest_ref "uc010ocg.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16972864 16973010 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000412"; exon_number "2"; gene_name "MST1"; oId "uc010ocg.1"; nearest_ref "uc010ocg.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973092 16973204 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000412"; exon_number "3"; gene_name "MST1"; oId "uc010ocg.1"; nearest_ref "uc010ocg.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973282 16973607 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000412"; exon_number "4"; gene_name "MST1"; oId "uc010ocg.1"; nearest_ref "uc010ocg.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973693 16974587 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000412"; exon_number "5"; gene_name "MST1"; oId "uc010ocg.1"; nearest_ref "uc010ocg.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16972069 16972173 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000411"; exon_number "1"; gene_name "MST1"; oId "uc009vow.2"; nearest_ref "uc009vow.2"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16972864 16973010 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000411"; exon_number "2"; gene_name "MST1"; oId "uc009vow.2"; nearest_ref "uc009vow.2"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973092 16973204 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000411"; exon_number "3"; gene_name "MST1"; oId "uc009vow.2"; nearest_ref "uc009vow.2"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973475 16973611 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000411"; exon_number "4"; gene_name "MST1"; oId "uc009vow.2"; nearest_ref "uc009vow.2"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973693 16974587 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000411"; exon_number "5"; gene_name "MST1"; oId "uc009vow.2"; nearest_ref "uc009vow.2"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16972069 16972173 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "1"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16972864 16973010 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "2"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973092 16973204 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "3"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973475 16973611 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "4"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973693 16973809 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "5"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16973958 16974076 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "6"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16974279 16975159 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "7"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16975251 16975287 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "8"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16975376 16975536 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "9"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16975669 16975746 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "10"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16975874 16976020 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "11"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16976102 16976208 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "12"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16976305 16976444 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "13"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16976569 16976914 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000413"; exon_number "14"; gene_name "MST1"; oId "uc010och.1"; nearest_ref "uc010och.1"; class_code "="; tss_id "TSS222"; chr1 noncoding exon 16972864 16973010 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000414"; exon_number "1"; gene_name "MST1"; oId "uc010oci.1"; nearest_ref "uc010oci.1"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973092 16973204 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000414"; exon_number "2"; gene_name "MST1"; oId "uc010oci.1"; nearest_ref "uc010oci.1"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973282 16973396 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000414"; exon_number "3"; gene_name "MST1"; oId "uc010oci.1"; nearest_ref "uc010oci.1"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973475 16973607 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000414"; exon_number "4"; gene_name "MST1"; oId "uc010oci.1"; nearest_ref "uc010oci.1"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973693 16974587 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000414"; exon_number "5"; gene_name "MST1"; oId "uc010oci.1"; nearest_ref "uc010oci.1"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16972864 16973010 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "1"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973092 16973204 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "2"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973282 16973611 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "3"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973693 16973813 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "4"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973958 16974076 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "5"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16974279 16975159 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "6"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16975251 16975287 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000415"; exon_number "7"; gene_name "MST1"; oId "uc001azk.2"; nearest_ref "uc001azk.2"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16972864 16973010 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "1"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973092 16973208 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "2"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973475 16973607 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "3"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973693 16973813 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "4"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973958 16975159 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "5"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16975251 16975287 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "6"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16975376 16975536 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "7"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16975669 16975746 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "8"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16975874 16976020 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "9"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16976102 16976208 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "10"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16976305 16976444 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "11"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16976569 16976914 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000416"; exon_number "12"; gene_name "MST1"; oId "uc001azl.3"; nearest_ref "uc001azl.3"; class_code "="; tss_id "TSS223"; chr1 noncoding exon 16973908 16974076 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "1"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16974279 16975159 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "2"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16975251 16975287 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "3"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16975376 16975496 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "4"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16975669 16975746 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "5"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16975874 16976020 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "6"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16976102 16976208 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "7"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16976305 16976444 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "8"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16976569 16976914 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000418"; exon_number "9"; gene_name "MST1"; oId "uc009vox.2"; nearest_ref "uc009vox.2"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16973908 16974076 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000417"; exon_number "1"; gene_name "MST1"; oId "uc001azm.3"; nearest_ref "uc001azm.3"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16974279 16975159 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000417"; exon_number "2"; gene_name "MST1"; oId "uc001azm.3"; nearest_ref "uc001azm.3"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16975251 16976020 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000417"; exon_number "3"; gene_name "MST1"; oId "uc001azm.3"; nearest_ref "uc001azm.3"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16976102 16976208 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000417"; exon_number "4"; gene_name "MST1"; oId "uc001azm.3"; nearest_ref "uc001azm.3"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16976305 16976444 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000417"; exon_number "5"; gene_name "MST1"; oId "uc001azm.3"; nearest_ref "uc001azm.3"; class_code "="; tss_id "TSS224"; chr1 noncoding exon 16976569 16976914 . + . gene_id "XLOC_000149"; transcript_id "TCONS_00000417"; exon_number "6"; gene_name "MST1"; oId "uc001azm.3"; nearest_ref "uc001azm.3"; class_code "="; tss_id "TSS224"; chr1 coding exon 17066768 17066892 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "1"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17256781 17256842 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "2"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17256924 17257089 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "3"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17263132 17263368 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "4"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17264136 17264232 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "5"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17264895 17264978 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "6"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17265404 17265637 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "7"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17266389 17266588 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "8"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17267267 17267729 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000419"; exon_number "9"; oId "uc009voy.1"; nearest_ref "uc009voy.1"; class_code "="; tss_id "TSS225"; p_id "P313"; chr1 coding exon 17248445 17248573 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "1"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17249158 17249293 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "2"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17250820 17250974 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "3"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17256341 17256526 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "4"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17256619 17256702 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "5"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17256781 17256842 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "6"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17256924 17257089 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "7"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17257786 17257892 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "8"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17263132 17263368 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "9"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17264136 17264232 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "10"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17264895 17264978 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "11"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17265404 17265637 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "12"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17266389 17266588 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "13"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17270595 17270777 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "14"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17271957 17272101 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "15"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17272754 17272900 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "16"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17273256 17273486 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "17"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17274826 17275019 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "18"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17275294 17275421 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "19"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17277448 17277617 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "20"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17279797 17279976 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "21"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17280718 17280852 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "22"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17281229 17281372 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "23"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17281807 17282045 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "24"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17282492 17282651 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "25"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17285078 17285245 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "26"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17287253 17287625 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "27"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17292218 17292387 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "28"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17292494 17292614 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "29"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17292903 17293066 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "30"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17294698 17294913 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "31"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17295611 17295835 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "32"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17296280 17296429 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "33"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17296748 17296948 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "34"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17297131 17297262 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "35"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17297960 17298142 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "36"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17298855 17299474 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000420"; exon_number "37"; gene_name "CROCC"; oId "uc001azt.2"; nearest_ref "uc001azt.2"; class_code "="; tss_id "TSS226"; p_id "P315"; chr1 coding exon 17249158 17249293 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "1"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17256341 17256526 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "2"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17256619 17256702 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "3"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17256781 17256842 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "4"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17256924 17257089 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "5"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17257786 17257892 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "6"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17263132 17263368 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "7"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17264136 17264232 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "8"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17264895 17264978 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "9"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17265404 17265637 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "10"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17266389 17266588 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "11"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17270595 17270777 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "12"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17271957 17272101 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "13"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17272754 17272900 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "14"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17273256 17273486 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "15"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17279797 17279976 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "16"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17280718 17280852 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000421"; exon_number "17"; gene_name "CROCC"; oId "uc009voz.1"; nearest_ref "uc009voz.1"; class_code "="; tss_id "TSS227"; p_id "P314"; chr1 coding exon 17266389 17266588 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "1"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17270595 17272101 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "2"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17272754 17272900 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "3"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17273256 17273486 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "4"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17274826 17275019 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "5"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17275294 17275421 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "6"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17277448 17277617 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "7"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17279797 17279976 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "8"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17280718 17280852 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "9"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17281229 17281372 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "10"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17281807 17282045 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "11"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17282492 17282651 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "12"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17285078 17285245 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "13"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17287253 17287625 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "14"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17292218 17292387 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "15"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17292494 17292614 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "16"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17292903 17293066 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "17"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17294698 17294913 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "18"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17295611 17295835 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "19"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17296280 17296429 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "20"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17296748 17296948 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "21"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17297131 17297262 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "22"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17297960 17298121 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "23"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17298855 17299474 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000422"; exon_number "24"; gene_name "CROCC"; oId "uc001azu.2"; nearest_ref "uc001azu.2"; class_code "="; tss_id "TSS228"; p_id "P316"; chr1 coding exon 17294698 17295835 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000423"; exon_number "1"; oId "uc001azv.2"; nearest_ref "uc001azv.2"; class_code "="; tss_id "TSS229"; p_id "P312"; chr1 coding exon 17296280 17296429 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000423"; exon_number "2"; oId "uc001azv.2"; nearest_ref "uc001azv.2"; class_code "="; tss_id "TSS229"; p_id "P312"; chr1 coding exon 17296748 17296948 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000423"; exon_number "3"; oId "uc001azv.2"; nearest_ref "uc001azv.2"; class_code "="; tss_id "TSS229"; p_id "P312"; chr1 coding exon 17297131 17297262 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000423"; exon_number "4"; oId "uc001azv.2"; nearest_ref "uc001azv.2"; class_code "="; tss_id "TSS229"; p_id "P312"; chr1 coding exon 17297960 17298142 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000423"; exon_number "5"; oId "uc001azv.2"; nearest_ref "uc001azv.2"; class_code "="; tss_id "TSS229"; p_id "P312"; chr1 coding exon 17298855 17299474 . + . gene_id "XLOC_000150"; transcript_id "TCONS_00000423"; exon_number "6"; oId "uc001azv.2"; nearest_ref "uc001azv.2"; class_code "="; tss_id "TSS229"; p_id "P312"; chr1 coding exon 17531621 17531804 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "1"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17548785 17548965 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "2"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17550116 17550188 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "3"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17550862 17550923 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "4"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17552306 17552423 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "5"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17552528 17552653 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "6"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17555120 17555292 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "7"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17555443 17555546 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "8"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17556580 17556703 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "9"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17557067 17557174 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "10"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17559314 17559465 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "11"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17563809 17563953 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "12"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17565111 17565204 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "13"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17566199 17566278 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "14"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17567130 17567255 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "15"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17570505 17572501 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000424"; exon_number "16"; gene_name "PADI1"; oId "uc001bah.1"; nearest_ref "uc001bah.1"; class_code "="; tss_id "TSS230"; p_id "P319"; chr1 coding exon 17559776 17559933 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000427"; exon_number "1"; oId "uc010ocq.1"; nearest_ref "uc010ocq.1"; class_code "="; tss_id "TSS231"; p_id "P318"; chr1 coding exon 17565111 17565204 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000427"; exon_number "2"; oId "uc010ocq.1"; nearest_ref "uc010ocq.1"; class_code "="; tss_id "TSS231"; p_id "P318"; chr1 coding exon 17566199 17566278 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000427"; exon_number "3"; oId "uc010ocq.1"; nearest_ref "uc010ocq.1"; class_code "="; tss_id "TSS231"; p_id "P318"; chr1 coding exon 17567130 17567255 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000427"; exon_number "4"; oId "uc010ocq.1"; nearest_ref "uc010ocq.1"; class_code "="; tss_id "TSS231"; p_id "P318"; chr1 coding exon 17570505 17572501 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000427"; exon_number "5"; oId "uc010ocq.1"; nearest_ref "uc010ocq.1"; class_code "="; tss_id "TSS231"; p_id "P318"; chr1 coding exon 17559776 17559933 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000426"; exon_number "1"; oId "uc010ocp.1"; nearest_ref "uc010ocp.1"; class_code "="; tss_id "TSS231"; p_id "P317"; chr1 coding exon 17563809 17563953 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000426"; exon_number "2"; oId "uc010ocp.1"; nearest_ref "uc010ocp.1"; class_code "="; tss_id "TSS231"; p_id "P317"; chr1 coding exon 17565111 17565204 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000426"; exon_number "3"; oId "uc010ocp.1"; nearest_ref "uc010ocp.1"; class_code "="; tss_id "TSS231"; p_id "P317"; chr1 coding exon 17566199 17566278 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000426"; exon_number "4"; oId "uc010ocp.1"; nearest_ref "uc010ocp.1"; class_code "="; tss_id "TSS231"; p_id "P317"; chr1 coding exon 17570505 17572501 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000426"; exon_number "5"; oId "uc010ocp.1"; nearest_ref "uc010ocp.1"; class_code "="; tss_id "TSS231"; p_id "P317"; chr1 coding exon 17559776 17559933 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000425"; exon_number "1"; gene_name "PADI1"; oId "uc010oco.1"; nearest_ref "uc010oco.1"; class_code "="; tss_id "TSS231"; p_id "P320"; chr1 coding exon 17563809 17563953 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000425"; exon_number "2"; gene_name "PADI1"; oId "uc010oco.1"; nearest_ref "uc010oco.1"; class_code "="; tss_id "TSS231"; p_id "P320"; chr1 coding exon 17565111 17565204 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000425"; exon_number "3"; gene_name "PADI1"; oId "uc010oco.1"; nearest_ref "uc010oco.1"; class_code "="; tss_id "TSS231"; p_id "P320"; chr1 coding exon 17566199 17566278 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000425"; exon_number "4"; gene_name "PADI1"; oId "uc010oco.1"; nearest_ref "uc010oco.1"; class_code "="; tss_id "TSS231"; p_id "P320"; chr1 coding exon 17567130 17567255 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000425"; exon_number "5"; gene_name "PADI1"; oId "uc010oco.1"; nearest_ref "uc010oco.1"; class_code "="; tss_id "TSS231"; p_id "P320"; chr1 coding exon 17570505 17572501 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000425"; exon_number "6"; gene_name "PADI1"; oId "uc010oco.1"; nearest_ref "uc010oco.1"; class_code "="; tss_id "TSS231"; p_id "P320"; chr1 coding exon 17566190 17566278 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000428"; exon_number "1"; oId "uc009vpb.1"; nearest_ref "uc009vpb.1"; class_code "="; tss_id "TSS232"; p_id "P321"; chr1 coding exon 17570505 17572501 . + . gene_id "XLOC_000151"; transcript_id "TCONS_00000428"; exon_number "2"; oId "uc009vpb.1"; nearest_ref "uc009vpb.1"; class_code "="; tss_id "TSS232"; p_id "P321"; chr1 coding exon 17575593 17575724 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "1"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17586073 17586253 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "2"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17588628 17588700 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "3"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17592154 17592215 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "4"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17593214 17593331 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "5"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17594332 17594457 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "6"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17596728 17596906 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "7"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17597374 17597477 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "8"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17597562 17597673 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "9"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17599835 17599942 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "10"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17601130 17601281 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "11"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17603014 17603158 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "12"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17603269 17603371 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "13"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17606845 17606924 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "14"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17607166 17607291 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "15"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17609341 17610725 . + . gene_id "XLOC_000152"; transcript_id "TCONS_00000429"; exon_number "16"; gene_name "PADI3"; oId "uc001bai.2"; nearest_ref "uc001bai.2"; class_code "="; tss_id "TSS233"; p_id "P322"; chr1 coding exon 17634690 17634809 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "1"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17657464 17657644 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "2"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17660438 17660504 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "3"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17662654 17662721 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "4"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17664533 17664650 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "5"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17666183 17666308 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "6"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17668438 17668616 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "7"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17668794 17668897 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "8"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17672523 17672634 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "9"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17674436 17674911 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000430"; exon_number "10"; gene_name "PADI4"; oId "uc009vpc.2"; nearest_ref "uc009vpc.2"; class_code "="; tss_id "TSS234"; p_id "P324"; chr1 coding exon 17634690 17634809 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "1"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17657464 17657644 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "2"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17660438 17660504 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "3"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17662654 17662721 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "4"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17664533 17664650 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "5"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17666183 17666308 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "6"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17668438 17668616 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "7"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17668794 17668897 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "8"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17672523 17672634 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "9"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17674436 17674543 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "10"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17681028 17681182 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "11"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17682478 17682622 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "12"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17682852 17682954 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "13"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17685333 17685403 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "14"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17685775 17685903 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "15"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17690017 17690495 . + . gene_id "XLOC_000153"; transcript_id "TCONS_00000431"; exon_number "16"; gene_name "PADI4"; oId "uc001baj.2"; nearest_ref "uc001baj.2"; class_code "="; tss_id "TSS234"; p_id "P323"; chr1 coding exon 17698741 17698856 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "1"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17699551 17699728 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "2"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17701922 17701994 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "3"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17706415 17706482 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "4"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17707542 17707659 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "5"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17708462 17708587 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "6"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17714876 17715054 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "7"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17715272 17715375 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "8"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17718609 17718721 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "9"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17720471 17720578 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "10"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17720796 17720950 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "11"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17721447 17721603 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "12"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17722036 17722159 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "13"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17723567 17723637 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "14"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17725182 17725343 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "15"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17727701 17728195 . + . gene_id "XLOC_000154"; transcript_id "TCONS_00000432"; exon_number "16"; gene_name "PADI6"; oId "uc001bak.1"; nearest_ref "uc001bak.1"; class_code "="; tss_id "TSS235"; p_id "P325"; chr1 coding exon 17866330 17866445 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17907048 17907127 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17913955 17914140 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17914941 17914974 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17928622 17928713 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17930003 17930086 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17934297 17934472 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17942589 17942697 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17961043 17961057 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "19"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "20"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "21"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "22"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "23"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "24"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "25"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "26"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 18016233 18016673 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000433"; exon_number "27"; gene_name "ARHGEF10L"; oId "uc009vpe.1"; nearest_ref "uc009vpe.1"; class_code "="; tss_id "TSS236"; p_id "P329"; chr1 coding exon 17866330 17866445 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17907048 17907127 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17913955 17914140 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17914941 17914974 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17928622 17928713 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17930003 17930086 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17934297 17934472 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17939553 17939669 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17942589 17942697 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17961043 17961057 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "19"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "20"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "21"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "22"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "23"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "24"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "25"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "26"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "27"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "28"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000434"; exon_number "29"; gene_name "ARHGEF10L"; oId "uc001ban.2"; nearest_ref "uc001ban.2"; class_code "="; tss_id "TSS236"; p_id "P328"; chr1 coding exon 17907048 17907127 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17913955 17914140 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17914941 17914974 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17928622 17928713 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17930003 17930086 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17934297 17934472 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17942589 17942697 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "19"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "20"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "21"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "22"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "23"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "24"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "25"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000436"; exon_number "26"; gene_name "ARHGEF10L"; oId "uc001bap.2"; nearest_ref "uc001bap.2"; class_code "="; tss_id "TSS237"; p_id "P327"; chr1 coding exon 17907048 17907127 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17913955 17914140 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17914941 17914974 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17928622 17928713 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17930003 17930086 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17934297 17934472 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17942589 17942697 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17961043 17961057 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "19"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "20"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "21"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "22"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "23"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "24"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "25"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "26"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000435"; exon_number "27"; gene_name "ARHGEF10L"; oId "uc001bao.2"; nearest_ref "uc001bao.2"; class_code "="; tss_id "TSS237"; p_id "P331"; chr1 coding exon 17914911 17914974 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17928622 17928713 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17930003 17930086 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17934297 17934472 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17942589 17942697 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17961043 17961057 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17966327 17966476 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000437"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc010ocr.1"; nearest_ref "uc010ocr.1"; class_code "="; tss_id "TSS238"; p_id "P332"; chr1 coding exon 17941583 17942697 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "19"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000438"; exon_number "20"; gene_name "ARHGEF10L"; oId "uc001baq.2"; nearest_ref "uc001baq.2"; class_code "="; tss_id "TSS239"; p_id "P334"; chr1 coding exon 17944811 17945017 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17950882 17950998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "19"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000440"; exon_number "20"; gene_name "ARHGEF10L"; oId "uc010ocs.1"; nearest_ref "uc010ocs.1"; class_code "="; tss_id "TSS240"; p_id "P330"; chr1 coding exon 17944811 17945017 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "1"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17945834 17945940 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "2"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17948359 17948436 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "3"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17949491 17949670 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "4"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "5"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "6"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "7"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "8"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "9"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "10"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "11"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "12"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "13"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "14"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "15"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "16"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "17"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000439"; exon_number "18"; gene_name "ARHGEF10L"; oId "uc001bar.2"; nearest_ref "uc001bar.2"; class_code "="; tss_id "TSS240"; p_id "P326"; chr1 nearCoding exon 17952451 17952543 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "1"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17953825 17953998 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "2"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17958816 17958961 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "3"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17961330 17961511 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "4"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17964383 17964498 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "5"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17965057 17965184 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "6"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17966697 17966797 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "7"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17975049 17975170 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "8"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17981131 17981217 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "9"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17982374 17982597 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "10"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17983049 17983203 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "11"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 17990942 17991090 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "12"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 18014068 18014242 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "13"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 18017615 18017687 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "14"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 18021653 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "15"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 nearCoding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000441"; exon_number "16"; oId "uc009vpf.2"; nearest_ref "uc009vpf.2"; class_code "="; tss_id "TSS241"; chr1 coding exon 18020542 18021775 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000442"; exon_number "1"; oId "uc001bas.2"; nearest_ref "uc001bas.2"; class_code "="; tss_id "TSS242"; p_id "P333"; chr1 coding exon 18023343 18024369 . + . gene_id "XLOC_000155"; transcript_id "TCONS_00000442"; exon_number "2"; oId "uc001bas.2"; nearest_ref "uc001bas.2"; class_code "="; tss_id "TSS242"; p_id "P333"; chr1 coding exon 18081808 18081999 . + . gene_id "XLOC_000156"; transcript_id "TCONS_00000443"; exon_number "1"; gene_name "ACTL8"; oId "uc001bat.2"; nearest_ref "uc001bat.2"; class_code "="; tss_id "TSS243"; p_id "P335"; chr1 coding exon 18149480 18149851 . + . gene_id "XLOC_000156"; transcript_id "TCONS_00000443"; exon_number "2"; gene_name "ACTL8"; oId "uc001bat.2"; nearest_ref "uc001bat.2"; class_code "="; tss_id "TSS243"; p_id "P335"; chr1 coding exon 18152262 18153556 . + . gene_id "XLOC_000156"; transcript_id "TCONS_00000443"; exon_number "3"; gene_name "ACTL8"; oId "uc001bat.2"; nearest_ref "uc001bat.2"; class_code "="; tss_id "TSS243"; p_id "P335"; chr1 coding exon 18434240 18434692 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "1"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18554392 18554504 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "2"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18618360 18618481 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "3"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18661386 18661504 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "4"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18688609 18688724 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "5"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18691717 18692191 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "6"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18702804 18702889 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "7"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18703294 18703486 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "8"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18703887 18703925 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "9"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18704750 18704976 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000444"; exon_number "10"; gene_name "IGSF21"; oId "uc001bau.1"; nearest_ref "uc001bau.1"; class_code "="; tss_id "TSS244"; p_id "P336"; chr1 coding exon 18687861 18688724 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000445"; exon_number "1"; gene_name "IGSF21"; oId "uc001bav.1"; nearest_ref "uc001bav.1"; class_code "="; tss_id "TSS245"; p_id "P337"; chr1 coding exon 18691717 18692191 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000445"; exon_number "2"; gene_name "IGSF21"; oId "uc001bav.1"; nearest_ref "uc001bav.1"; class_code "="; tss_id "TSS245"; p_id "P337"; chr1 coding exon 18702804 18702889 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000445"; exon_number "3"; gene_name "IGSF21"; oId "uc001bav.1"; nearest_ref "uc001bav.1"; class_code "="; tss_id "TSS245"; p_id "P337"; chr1 coding exon 18703294 18703486 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000445"; exon_number "4"; gene_name "IGSF21"; oId "uc001bav.1"; nearest_ref "uc001bav.1"; class_code "="; tss_id "TSS245"; p_id "P337"; chr1 coding exon 18703887 18703925 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000445"; exon_number "5"; gene_name "IGSF21"; oId "uc001bav.1"; nearest_ref "uc001bav.1"; class_code "="; tss_id "TSS245"; p_id "P337"; chr1 coding exon 18704750 18704976 . + . gene_id "XLOC_000157"; transcript_id "TCONS_00000445"; exon_number "6"; gene_name "IGSF21"; oId "uc001bav.1"; nearest_ref "uc001bav.1"; class_code "="; tss_id "TSS245"; p_id "P337"; chr1 noncoding exon 18701064 18702174 . + . gene_id "XLOC_000158"; transcript_id "TCONS_00000446"; exon_number "1"; oId "uc001baw.1"; nearest_ref "uc001baw.1"; class_code "="; chr1 coding exon 18807424 18812478 . + . gene_id "XLOC_000159"; transcript_id "TCONS_00000447"; exon_number "1"; gene_name "KLHDC7A"; oId "uc001bax.2"; nearest_ref "uc001bax.2"; class_code "="; p_id "P338"; chr1 coding exon 18807665 18809706 . + . gene_id "XLOC_000159"; transcript_id "TCONS_00000448"; exon_number "1"; gene_name "KLHDC7A"; oId "uc009vpg.2"; nearest_ref "uc009vpg.2"; class_code "="; tss_id "TSS246"; p_id "P339"; chr1 coding exon 18810489 18812539 . + . gene_id "XLOC_000159"; transcript_id "TCONS_00000448"; exon_number "2"; gene_name "KLHDC7A"; oId "uc009vpg.2"; nearest_ref "uc009vpg.2"; class_code "="; tss_id "TSS246"; p_id "P339"; chr1 coding exon 18957500 18958182 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "1"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 18960797 18961032 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "2"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 18961605 18961734 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "3"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 18962737 18962865 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "4"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 19018248 19018447 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "5"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 19027147 19027312 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "6"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 19029588 19029790 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "7"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 19062126 19062631 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000450"; exon_number "8"; gene_name "PAX7"; oId "uc001baz.2"; nearest_ref "uc001baz.2"; class_code "="; tss_id "TSS247"; p_id "P341"; chr1 coding exon 18957500 18958182 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "1"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 18960797 18961032 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "2"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 18961605 18961734 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "3"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 18962731 18962865 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "4"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 19018248 19018447 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "5"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 19027147 19027312 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "6"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 19029588 19029790 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "7"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 19062126 19062631 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000449"; exon_number "8"; gene_name "PAX7"; oId "uc001bay.2"; nearest_ref "uc001bay.2"; class_code "="; tss_id "TSS247"; p_id "P342"; chr1 coding exon 18957500 18958182 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "1"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 18960797 18961032 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "2"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 18961605 18961734 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "3"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 18962731 18962865 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "4"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 19018248 19018447 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "5"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 19027147 19027312 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "6"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 19029588 19029790 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "7"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 19062126 19062372 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "8"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 19071308 19075359 . + . gene_id "XLOC_000160"; transcript_id "TCONS_00000451"; exon_number "9"; gene_name "PAX7"; oId "uc010oct.1"; nearest_ref "uc010oct.1"; class_code "="; tss_id "TSS247"; p_id "P340"; chr1 coding exon 19578075 19578357 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "1"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19581276 19581334 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "2"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19582442 19582545 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "3"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19583558 19583639 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "4"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19583948 19584015 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "5"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19584327 19584478 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "6"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19584971 19585047 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "7"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19585175 19586621 . + . gene_id "XLOC_000161"; transcript_id "TCONS_00000452"; exon_number "8"; gene_name "MRTO4"; oId "uc001bbs.2"; nearest_ref "uc001bbs.2"; class_code "="; tss_id "TSS248"; p_id "P343"; chr1 coding exon 19638740 19639383 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "1"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19644094 19644335 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "2"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19651127 19651256 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "3"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19651989 19652076 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "4"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19652739 19652881 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "5"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19653025 19653117 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "6"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19653721 19653906 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "7"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19655066 19655793 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000455"; exon_number "8"; gene_name "PQLC2"; oId "uc001bca.2"; nearest_ref "uc001bca.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19638740 19638852 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "1"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19639223 19639383 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "2"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19651127 19651256 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "3"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19652020 19652076 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "4"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19652739 19652881 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "5"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19653025 19653117 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "6"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19653721 19653906 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "7"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19655066 19655793 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000456"; exon_number "8"; gene_name "PQLC2"; oId "uc001bcb.2"; nearest_ref "uc001bcb.2"; class_code "="; tss_id "TSS249"; p_id "P346"; chr1 coding exon 19638740 19638852 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "1"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19639223 19639383 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "2"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19651127 19651256 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "3"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19651989 19652076 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "4"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19652739 19652881 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "5"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19653025 19653117 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "6"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19653721 19653906 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "7"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19655066 19655793 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000454"; exon_number "8"; gene_name "PQLC2"; oId "uc001bbz.2"; nearest_ref "uc001bbz.2"; class_code "="; tss_id "TSS249"; p_id "P345"; chr1 coding exon 19638740 19638852 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "1"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19639223 19639383 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "2"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19644094 19644335 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "3"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19651127 19651256 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "4"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19651989 19652076 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "5"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19652739 19652881 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "6"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19653025 19653117 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "7"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19653721 19653906 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "8"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19655066 19655793 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000453"; exon_number "9"; gene_name "PQLC2"; oId "uc001bby.2"; nearest_ref "uc001bby.2"; class_code "="; tss_id "TSS249"; p_id "P344"; chr1 coding exon 19639223 19639383 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "1"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19644094 19644335 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "2"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19651127 19651256 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "3"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19652020 19652076 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "4"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19652739 19652881 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "5"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19653025 19653117 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "6"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19653721 19653906 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "7"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 coding exon 19655066 19655793 . + . gene_id "XLOC_000162"; transcript_id "TCONS_00000457"; exon_number "8"; gene_name "PQLC2"; oId "uc001bcc.2"; nearest_ref "uc001bcc.2"; class_code "="; tss_id "TSS250"; p_id "P346"; chr1 nearCoding exon 19923467 19923603 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000458"; exon_number "1"; gene_name "C1orf151"; oId "uc001bch.1"; nearest_ref "uc001bch.1"; class_code "="; tss_id "TSS251"; chr1 nearCoding exon 19943752 19943830 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000458"; exon_number "2"; gene_name "C1orf151"; oId "uc001bch.1"; nearest_ref "uc001bch.1"; class_code "="; tss_id "TSS251"; chr1 nearCoding exon 19948594 19948641 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000458"; exon_number "3"; gene_name "C1orf151"; oId "uc001bch.1"; nearest_ref "uc001bch.1"; class_code "="; tss_id "TSS251"; chr1 nearCoding exon 19949968 19950077 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000458"; exon_number "4"; gene_name "C1orf151"; oId "uc001bch.1"; nearest_ref "uc001bch.1"; class_code "="; tss_id "TSS251"; chr1 nearCoding exon 19952881 19954804 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000458"; exon_number "5"; gene_name "C1orf151"; oId "uc001bch.1"; nearest_ref "uc001bch.1"; class_code "="; tss_id "TSS251"; chr1 coding exon 19923467 19923603 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000459"; exon_number "1"; gene_name "C1orf151"; oId "uc001bci.1"; nearest_ref "uc001bci.1"; class_code "="; tss_id "TSS251"; p_id "P347"; chr1 coding exon 19948594 19948641 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000459"; exon_number "2"; gene_name "C1orf151"; oId "uc001bci.1"; nearest_ref "uc001bci.1"; class_code "="; tss_id "TSS251"; p_id "P347"; chr1 coding exon 19949968 19950077 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000459"; exon_number "3"; gene_name "C1orf151"; oId "uc001bci.1"; nearest_ref "uc001bci.1"; class_code "="; tss_id "TSS251"; p_id "P347"; chr1 coding exon 19952881 19955174 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000459"; exon_number "4"; gene_name "C1orf151"; oId "uc001bci.1"; nearest_ref "uc001bci.1"; class_code "="; tss_id "TSS251"; p_id "P347"; chr1 coding exon 19923467 19923603 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000460"; exon_number "1"; gene_name "NBL1"; oId "uc009vpl.1"; nearest_ref "uc009vpl.1"; class_code "="; tss_id "TSS251"; p_id "P349"; chr1 coding exon 19981505 19981693 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000460"; exon_number "2"; gene_name "NBL1"; oId "uc009vpl.1"; nearest_ref "uc009vpl.1"; class_code "="; tss_id "TSS251"; p_id "P349"; chr1 coding exon 19981817 19981928 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000460"; exon_number "3"; gene_name "NBL1"; oId "uc009vpl.1"; nearest_ref "uc009vpl.1"; class_code "="; tss_id "TSS251"; p_id "P349"; chr1 coding exon 19983359 19984945 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000460"; exon_number "4"; gene_name "NBL1"; oId "uc009vpl.1"; nearest_ref "uc009vpl.1"; class_code "="; tss_id "TSS251"; p_id "P349"; chr1 coding exon 19969726 19969891 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000461"; exon_number "1"; gene_name "NBL1"; oId "uc001bcj.1"; nearest_ref "uc001bcj.1"; class_code "="; tss_id "TSS252"; p_id "P348"; chr1 coding exon 19981505 19981693 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000461"; exon_number "2"; gene_name "NBL1"; oId "uc001bcj.1"; nearest_ref "uc001bcj.1"; class_code "="; tss_id "TSS252"; p_id "P348"; chr1 coding exon 19981817 19981928 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000461"; exon_number "3"; gene_name "NBL1"; oId "uc001bcj.1"; nearest_ref "uc001bcj.1"; class_code "="; tss_id "TSS252"; p_id "P348"; chr1 coding exon 19983359 19984945 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000461"; exon_number "4"; gene_name "NBL1"; oId "uc001bcj.1"; nearest_ref "uc001bcj.1"; class_code "="; tss_id "TSS252"; p_id "P348"; chr1 coding exon 19970249 19970448 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000462"; exon_number "1"; gene_name "NBL1"; oId "uc009vpm.1"; nearest_ref "uc009vpm.1"; class_code "="; tss_id "TSS253"; p_id "P349"; chr1 coding exon 19981505 19981693 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000462"; exon_number "2"; gene_name "NBL1"; oId "uc009vpm.1"; nearest_ref "uc009vpm.1"; class_code "="; tss_id "TSS253"; p_id "P349"; chr1 coding exon 19981817 19981928 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000462"; exon_number "3"; gene_name "NBL1"; oId "uc009vpm.1"; nearest_ref "uc009vpm.1"; class_code "="; tss_id "TSS253"; p_id "P349"; chr1 coding exon 19983359 19984945 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000462"; exon_number "4"; gene_name "NBL1"; oId "uc009vpm.1"; nearest_ref "uc009vpm.1"; class_code "="; tss_id "TSS253"; p_id "P349"; chr1 coding exon 19970808 19970940 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000463"; exon_number "1"; gene_name "NBL1"; oId "uc001bck.1"; nearest_ref "uc001bck.1"; class_code "="; tss_id "TSS254"; p_id "P350"; chr1 coding exon 19981505 19981693 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000463"; exon_number "2"; gene_name "NBL1"; oId "uc001bck.1"; nearest_ref "uc001bck.1"; class_code "="; tss_id "TSS254"; p_id "P350"; chr1 coding exon 19981817 19981928 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000463"; exon_number "3"; gene_name "NBL1"; oId "uc001bck.1"; nearest_ref "uc001bck.1"; class_code "="; tss_id "TSS254"; p_id "P350"; chr1 coding exon 19983359 19984945 . + . gene_id "XLOC_000163"; transcript_id "TCONS_00000463"; exon_number "4"; gene_name "NBL1"; oId "uc001bck.1"; nearest_ref "uc001bck.1"; class_code "="; tss_id "TSS254"; p_id "P350"; chr1 coding exon 19991780 19992960 . + . gene_id "XLOC_000164"; transcript_id "TCONS_00000464"; exon_number "1"; gene_name "HTR6"; oId "uc001bcl.2"; nearest_ref "uc001bcl.2"; class_code "="; tss_id "TSS255"; p_id "P351"; chr1 coding exon 20005060 20005218 . + . gene_id "XLOC_000164"; transcript_id "TCONS_00000464"; exon_number "2"; gene_name "HTR6"; oId "uc001bcl.2"; nearest_ref "uc001bcl.2"; class_code "="; tss_id "TSS255"; p_id "P351"; chr1 coding exon 20005412 20006054 . + . gene_id "XLOC_000164"; transcript_id "TCONS_00000464"; exon_number "3"; gene_name "HTR6"; oId "uc001bcl.2"; nearest_ref "uc001bcl.2"; class_code "="; tss_id "TSS255"; p_id "P351"; chr1 coding exon 20208888 20209227 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "1"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20216878 20217026 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "2"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20220861 20220973 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "3"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20224033 20224155 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "4"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20230760 20230891 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "5"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20231384 20231480 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "6"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20232925 20233109 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "7"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20234063 20239429 . + . gene_id "XLOC_000165"; transcript_id "TCONS_00000465"; exon_number "8"; gene_name "OTUD3"; oId "uc001bcs.3"; nearest_ref "uc001bcs.3"; class_code "="; tss_id "TSS256"; p_id "P352"; chr1 coding exon 20354672 20355202 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "1"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20372595 20372634 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "2"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20381285 20381332 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "3"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20386125 20386185 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "4"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20392517 20392622 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "5"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20395366 20395525 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "6"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20411314 20411363 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "7"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20412576 20412720 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "8"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20416282 20416388 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "9"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 coding exon 20417061 20418393 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000467"; exon_number "10"; gene_name "PLA2G5"; oId "uc001bcx.2"; nearest_ref "uc001bcx.2"; class_code "="; tss_id "TSS257"; p_id "P354"; chr1 nearCoding exon 20354672 20355202 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "1"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20386125 20386185 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "2"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20395366 20395525 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "3"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20396787 20396958 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "4"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20397338 20397437 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "5"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20411314 20411363 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "6"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20412576 20412720 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "7"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20415318 20415394 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "8"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20416225 20416388 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "9"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 nearCoding exon 20417061 20418393 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000466"; exon_number "10"; gene_name "PLA2G5"; oId "uc001bcw.2"; nearest_ref "uc001bcw.2"; class_code "="; tss_id "TSS257"; chr1 coding exon 20396701 20396958 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000468"; exon_number "1"; gene_name "PLA2G5"; oId "uc001bcy.2"; nearest_ref "uc001bcy.2"; class_code "="; tss_id "TSS258"; p_id "P353"; chr1 coding exon 20411314 20411363 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000468"; exon_number "2"; gene_name "PLA2G5"; oId "uc001bcy.2"; nearest_ref "uc001bcy.2"; class_code "="; tss_id "TSS258"; p_id "P353"; chr1 coding exon 20412576 20412720 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000468"; exon_number "3"; gene_name "PLA2G5"; oId "uc001bcy.2"; nearest_ref "uc001bcy.2"; class_code "="; tss_id "TSS258"; p_id "P353"; chr1 coding exon 20416282 20416388 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000468"; exon_number "4"; gene_name "PLA2G5"; oId "uc001bcy.2"; nearest_ref "uc001bcy.2"; class_code "="; tss_id "TSS258"; p_id "P353"; chr1 coding exon 20417061 20418393 . + . gene_id "XLOC_000166"; transcript_id "TCONS_00000468"; exon_number "5"; gene_name "PLA2G5"; oId "uc001bcy.2"; nearest_ref "uc001bcy.2"; class_code "="; tss_id "TSS258"; p_id "P353"; chr1 coding exon 20465823 20466036 . + . gene_id "XLOC_000167"; transcript_id "TCONS_00000469"; exon_number "1"; gene_name "PLA2G2F"; oId "uc009vpp.1"; nearest_ref "uc009vpp.1"; class_code "="; tss_id "TSS259"; p_id "P355"; chr1 coding exon 20466659 20466711 . + . gene_id "XLOC_000167"; transcript_id "TCONS_00000469"; exon_number "2"; gene_name "PLA2G2F"; oId "uc009vpp.1"; nearest_ref "uc009vpp.1"; class_code "="; tss_id "TSS259"; p_id "P355"; chr1 coding exon 20469939 20470083 . + . gene_id "XLOC_000167"; transcript_id "TCONS_00000469"; exon_number "3"; gene_name "PLA2G2F"; oId "uc009vpp.1"; nearest_ref "uc009vpp.1"; class_code "="; tss_id "TSS259"; p_id "P355"; chr1 coding exon 20471073 20471182 . + . gene_id "XLOC_000167"; transcript_id "TCONS_00000469"; exon_number "4"; gene_name "PLA2G2F"; oId "uc009vpp.1"; nearest_ref "uc009vpp.1"; class_code "="; tss_id "TSS259"; p_id "P355"; chr1 coding exon 20474683 20476879 . + . gene_id "XLOC_000167"; transcript_id "TCONS_00000469"; exon_number "5"; gene_name "PLA2G2F"; oId "uc009vpp.1"; nearest_ref "uc009vpp.1"; class_code "="; tss_id "TSS259"; p_id "P355"; chr1 coding exon 20512578 20512646 . + . gene_id "XLOC_000168"; transcript_id "TCONS_00000470"; exon_number "1"; gene_name "UBXN10"; oId "uc001bdb.2"; nearest_ref "uc001bdb.2"; class_code "="; tss_id "TSS260"; p_id "P356"; chr1 coding exon 20517040 20519941 . + . gene_id "XLOC_000168"; transcript_id "TCONS_00000470"; exon_number "2"; gene_name "UBXN10"; oId "uc001bdb.2"; nearest_ref "uc001bdb.2"; class_code "="; tss_id "TSS260"; p_id "P356"; chr1 coding exon 20617412 20617581 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "1"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20637069 20637233 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "2"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20639329 20639481 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "3"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20640815 20641085 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "4"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20644023 20644168 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "5"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20644917 20645214 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "6"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20645875 20645999 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "7"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20649849 20650025 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "8"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20654383 20654493 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "9"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20656673 20656875 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "10"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20657362 20657476 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "11"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20659259 20659444 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "12"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20662796 20662979 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "13"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20664139 20664329 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "14"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20664468 20665715 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000471"; exon_number "15"; gene_name "VWA5B1"; oId "uc001bdd.2"; nearest_ref "uc001bdd.2"; class_code "="; tss_id "TSS261"; p_id "P360"; chr1 coding exon 20617412 20617581 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "1"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20637069 20637233 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "2"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20639329 20639481 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "3"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20640871 20641085 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "4"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20644023 20644168 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "5"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20645083 20645214 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "6"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20645875 20645999 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "7"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20649849 20650025 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "8"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20654383 20654493 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "9"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20656673 20656875 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "10"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20657362 20657476 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "11"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20659259 20659444 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "12"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20662796 20662979 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "13"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20664139 20664329 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "14"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20668925 20669102 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "15"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20669572 20669886 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "16"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20671949 20672086 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "17"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20674738 20674851 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "18"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20676649 20676723 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "19"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20677350 20677419 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "20"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20678548 20678665 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "21"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20680250 20681387 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000473"; exon_number "22"; gene_name "VWA5B1"; oId "uc010odc.1"; nearest_ref "uc010odc.1"; class_code "="; tss_id "TSS261"; p_id "P359"; chr1 coding exon 20617412 20617581 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "1"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20637069 20637233 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "2"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20639329 20639481 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "3"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20640815 20641085 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "4"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20644023 20644168 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "5"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20645083 20645214 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "6"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20645875 20645999 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "7"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20649849 20650025 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "8"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20654383 20654493 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "9"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20656673 20656875 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "10"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20657362 20657476 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "11"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20659259 20659444 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "12"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20662796 20662979 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "13"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20664139 20664329 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "14"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20668925 20669102 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "15"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20669572 20669886 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "16"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20671949 20672086 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "17"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20674738 20674851 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "18"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20676649 20676723 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "19"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20677350 20677419 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "20"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20678548 20678665 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "21"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20680250 20681387 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000472"; exon_number "22"; gene_name "VWA5B1"; oId "uc009vps.2"; nearest_ref "uc009vps.2"; class_code "="; tss_id "TSS261"; p_id "P358"; chr1 coding exon 20659259 20659444 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "1"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20662796 20662979 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "2"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20664139 20664329 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "3"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20668925 20669102 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "4"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20669572 20669886 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "5"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20671949 20672086 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "6"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20674738 20674851 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "7"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20677350 20677419 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "8"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20678548 20678665 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "9"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 coding exon 20680250 20681387 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000475"; exon_number "10"; gene_name "VWA5B1"; oId "uc009vpt.2"; nearest_ref "uc009vpt.2"; class_code "="; tss_id "TSS262"; p_id "P357"; chr1 nearCoding exon 20659259 20659444 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "1"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20662796 20662979 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "2"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20664139 20664329 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "3"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20668925 20669102 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "4"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20669572 20669886 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "5"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20671949 20672086 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "6"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20674738 20674851 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "7"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20675591 20675791 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "8"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20676649 20676723 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "9"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20677350 20677419 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "10"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20678548 20678665 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "11"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 nearCoding exon 20680250 20681387 . + . gene_id "XLOC_000169"; transcript_id "TCONS_00000474"; exon_number "12"; gene_name "VWA5B1"; oId "uc001bde.3"; nearest_ref "uc001bde.3"; class_code "="; tss_id "TSS262"; chr1 coding exon 20878932 20881512 . + . gene_id "XLOC_000170"; transcript_id "TCONS_00000476"; exon_number "1"; gene_name "FAM43B"; oId "uc001bdj.2"; nearest_ref "uc001bdj.2"; class_code "="; p_id "P361"; chr1 nearCoding exon 20915444 20915776 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000479"; exon_number "1"; oId "uc009vpv.2"; nearest_ref "uc009vpv.2"; class_code "="; tss_id "TSS263"; chr1 nearCoding exon 20944945 20945398 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000479"; exon_number "2"; oId "uc009vpv.2"; nearest_ref "uc009vpv.2"; class_code "="; tss_id "TSS263"; chr1 nearCoding exon 20915444 20915776 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000478"; exon_number "1"; oId "uc001bdl.2"; nearest_ref "uc001bdl.2"; class_code "="; tss_id "TSS263"; chr1 nearCoding exon 20920090 20920210 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000478"; exon_number "2"; oId "uc001bdl.2"; nearest_ref "uc001bdl.2"; class_code "="; tss_id "TSS263"; chr1 nearCoding exon 20931421 20931532 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000478"; exon_number "3"; oId "uc001bdl.2"; nearest_ref "uc001bdl.2"; class_code "="; tss_id "TSS263"; chr1 nearCoding exon 20940335 20940392 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000478"; exon_number "4"; oId "uc001bdl.2"; nearest_ref "uc001bdl.2"; class_code "="; tss_id "TSS263"; chr1 nearCoding exon 20944945 20945398 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000478"; exon_number "5"; oId "uc001bdl.2"; nearest_ref "uc001bdl.2"; class_code "="; tss_id "TSS263"; chr1 coding exon 20915444 20915776 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000477"; exon_number "1"; gene_name "CDA"; oId "uc001bdk.2"; nearest_ref "uc001bdk.2"; class_code "="; tss_id "TSS263"; p_id "P362"; chr1 coding exon 20931421 20931532 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000477"; exon_number "2"; gene_name "CDA"; oId "uc001bdk.2"; nearest_ref "uc001bdk.2"; class_code "="; tss_id "TSS263"; p_id "P362"; chr1 coding exon 20940335 20940392 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000477"; exon_number "3"; gene_name "CDA"; oId "uc001bdk.2"; nearest_ref "uc001bdk.2"; class_code "="; tss_id "TSS263"; p_id "P362"; chr1 coding exon 20944945 20945398 . + . gene_id "XLOC_000171"; transcript_id "TCONS_00000477"; exon_number "4"; gene_name "CDA"; oId "uc001bdk.2"; nearest_ref "uc001bdk.2"; class_code "="; tss_id "TSS263"; p_id "P362"; chr1 coding exon 20959948 20960428 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "1"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20964335 20964622 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "2"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20966385 20966485 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "3"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20970983 20971165 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "4"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20972053 20972216 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "5"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20974998 20975125 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "6"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20975488 20975724 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "7"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20976927 20978003 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000480"; exon_number "8"; gene_name "PINK1"; oId "uc001bdm.2"; nearest_ref "uc001bdm.2"; class_code "="; tss_id "TSS264"; p_id "P364"; chr1 coding exon 20972001 20972216 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000481"; exon_number "1"; gene_name "PINK1"; oId "uc001bdn.2"; nearest_ref "uc001bdn.2"; class_code "="; tss_id "TSS265"; p_id "P363"; chr1 coding exon 20974998 20975125 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000481"; exon_number "2"; gene_name "PINK1"; oId "uc001bdn.2"; nearest_ref "uc001bdn.2"; class_code "="; tss_id "TSS265"; p_id "P363"; chr1 coding exon 20975488 20975724 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000481"; exon_number "3"; gene_name "PINK1"; oId "uc001bdn.2"; nearest_ref "uc001bdn.2"; class_code "="; tss_id "TSS265"; p_id "P363"; chr1 coding exon 20976927 20978003 . + . gene_id "XLOC_000172"; transcript_id "TCONS_00000481"; exon_number "4"; gene_name "PINK1"; oId "uc001bdn.2"; nearest_ref "uc001bdn.2"; class_code "="; tss_id "TSS265"; p_id "P363"; chr1 noncoding exon 21619783 21620236 . + . gene_id "XLOC_000173"; transcript_id "TCONS_00000482"; exon_number "1"; oId "uc001beo.1"; nearest_ref "uc001beo.1"; class_code "="; tss_id "TSS266"; chr1 noncoding exon 21620427 21620703 . + . gene_id "XLOC_000173"; transcript_id "TCONS_00000482"; exon_number "2"; oId "uc001beo.1"; nearest_ref "uc001beo.1"; class_code "="; tss_id "TSS266"; chr1 noncoding exon 21624520 21626225 . + . gene_id "XLOC_000173"; transcript_id "TCONS_00000482"; exon_number "3"; oId "uc001beo.1"; nearest_ref "uc001beo.1"; class_code "="; tss_id "TSS266"; chr1 noncoding exon 21761833 21761887 . + . gene_id "XLOC_000174"; transcript_id "TCONS_00000483"; exon_number "1"; oId "uc001beq.1"; nearest_ref "uc001beq.1"; class_code "="; tss_id "TSS267"; chr1 noncoding exon 21762560 21762609 . + . gene_id "XLOC_000174"; transcript_id "TCONS_00000483"; exon_number "2"; oId "uc001beq.1"; nearest_ref "uc001beq.1"; class_code "="; tss_id "TSS267"; chr1 coding exon 21766631 21766841 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "1"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21771441 21771712 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "2"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21795181 21795390 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "3"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21797125 21797227 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "4"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21798062 21798276 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "5"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21799336 21799408 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "6"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21799873 21800078 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "7"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21801393 21801444 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "8"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21804562 21804689 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "9"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21805842 21805893 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "10"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21806544 21806716 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "11"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21807423 21807474 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "12"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21808090 21808262 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "13"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21808977 21809028 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "14"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21809636 21811392 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000486"; exon_number "15"; gene_name "NBPF3"; oId "uc009vqb.2"; nearest_ref "uc009vqb.2"; class_code "="; tss_id "TSS268"; p_id "P366"; chr1 coding exon 21766631 21766841 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "1"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21771441 21771712 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "2"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21797125 21797227 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "3"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21798062 21798276 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "4"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21799336 21799408 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "5"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21799873 21800078 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "6"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21801393 21801444 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "7"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21804637 21804800 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "8"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21805842 21805893 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "9"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21806544 21806716 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "10"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21807423 21807474 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "11"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21808090 21808262 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "12"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21808977 21809028 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "13"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21809636 21811392 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000487"; exon_number "14"; gene_name "NBPF3"; oId "uc010odm.1"; nearest_ref "uc010odm.1"; class_code "="; tss_id "TSS268"; p_id "P365"; chr1 coding exon 21766631 21766841 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "1"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21771441 21771712 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "2"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21792580 21792649 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "3"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21793489 21793802 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "4"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21794934 21795078 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "5"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21795181 21795390 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "6"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21797125 21797227 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "7"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21798062 21798276 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "8"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21799336 21799408 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "9"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21799873 21800078 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "10"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21801393 21801444 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "11"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21804637 21804800 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "12"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21805842 21805893 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "13"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21806544 21806716 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "14"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21807423 21807474 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "15"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21808090 21808262 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "16"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21808977 21809028 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "17"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21809636 21811392 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000485"; exon_number "18"; gene_name "NBPF3"; oId "uc001bes.2"; nearest_ref "uc001bes.2"; class_code "="; tss_id "TSS268"; p_id "P368"; chr1 coding exon 21766631 21766841 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "1"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21771441 21771712 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "2"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21795181 21795390 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "3"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21797125 21797227 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "4"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21798062 21798276 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "5"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21799336 21799408 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "6"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21799873 21800078 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "7"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21801393 21801444 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "8"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21804637 21804800 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "9"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21805842 21805893 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "10"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21806544 21806716 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "11"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21807423 21807474 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "12"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21808090 21808262 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "13"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21808977 21809028 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "14"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21809636 21811392 . + . gene_id "XLOC_000175"; transcript_id "TCONS_00000484"; exon_number "15"; gene_name "NBPF3"; oId "uc001ber.2"; nearest_ref "uc001ber.2"; class_code "="; tss_id "TSS268"; p_id "P367"; chr1 coding exon 21835858 21836010 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "1"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21887119 21887238 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "2"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21887590 21887705 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "3"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21889603 21889777 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "4"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21890534 21890709 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "5"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21894597 21894740 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "6"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21896798 21896867 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "7"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21900158 21900292 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "8"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21902226 21902417 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "9"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21903015 21903134 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "10"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21903876 21904904 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000490"; exon_number "11"; gene_name "ALPL"; oId "uc010odo.1"; nearest_ref "uc010odo.1"; class_code "="; tss_id "TSS269"; p_id "P371"; chr1 coding exon 21835858 21836010 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "1"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21887119 21887238 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "2"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21889603 21889777 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "3"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21890534 21890709 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "4"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21894597 21894740 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "5"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21896798 21896867 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "6"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21900158 21900292 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "7"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21902226 21902417 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "8"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21903015 21903134 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "9"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21903876 21904904 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000491"; exon_number "10"; gene_name "ALPL"; oId "uc010odp.1"; nearest_ref "uc010odp.1"; class_code "="; tss_id "TSS269"; p_id "P372"; chr1 coding exon 21835858 21836010 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "1"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21880471 21880635 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "2"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21887119 21887238 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "3"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21887631 21887705 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "4"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21889603 21889777 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "5"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21890534 21890709 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "6"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21894597 21894740 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "7"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21896798 21896867 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "8"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21900158 21900292 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "9"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21902226 21902417 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "10"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21903015 21903134 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "11"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21903876 21904904 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000489"; exon_number "12"; gene_name "ALPL"; oId "uc010odn.1"; nearest_ref "uc010odn.1"; class_code "="; tss_id "TSS269"; p_id "P370"; chr1 coding exon 21835858 21836010 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "1"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21880471 21880635 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "2"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21887119 21887238 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "3"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21887590 21887705 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "4"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21889603 21889777 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "5"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21890534 21890709 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "6"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21894597 21894740 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "7"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21896798 21896867 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "8"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21900158 21900292 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "9"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21902226 21902417 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "10"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21903015 21903134 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "11"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21903876 21904904 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000488"; exon_number "12"; gene_name "ALPL"; oId "uc001bet.2"; nearest_ref "uc001bet.2"; class_code "="; tss_id "TSS269"; p_id "P369"; chr1 coding exon 21877807 21877921 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "1"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21880471 21880635 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "2"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21887119 21887238 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "3"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21887590 21887705 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "4"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21889603 21889777 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "5"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21890534 21890709 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "6"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21894597 21894740 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "7"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21896798 21896867 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "8"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21900158 21900292 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "9"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21902226 21902417 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "10"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21903015 21903134 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "11"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 21903876 21904904 . + . gene_id "XLOC_000176"; transcript_id "TCONS_00000492"; exon_number "12"; gene_name "ALPL"; oId "uc001beu.3"; nearest_ref "uc001beu.3"; class_code "="; tss_id "TSS270"; p_id "P369"; chr1 coding exon 22138758 22139029 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000493"; exon_number "1"; gene_name "LDLRAD2"; oId "uc001bfg.1"; nearest_ref "uc001bfg.1"; class_code "="; tss_id "TSS271"; p_id "P373"; chr1 coding exon 22140891 22141316 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000493"; exon_number "2"; gene_name "LDLRAD2"; oId "uc001bfg.1"; nearest_ref "uc001bfg.1"; class_code "="; tss_id "TSS271"; p_id "P373"; chr1 coding exon 22142436 22142567 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000493"; exon_number "3"; gene_name "LDLRAD2"; oId "uc001bfg.1"; nearest_ref "uc001bfg.1"; class_code "="; tss_id "TSS271"; p_id "P373"; chr1 coding exon 22147943 22148104 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000493"; exon_number "4"; gene_name "LDLRAD2"; oId "uc001bfg.1"; nearest_ref "uc001bfg.1"; class_code "="; tss_id "TSS271"; p_id "P373"; chr1 coding exon 22148695 22151714 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000493"; exon_number "5"; gene_name "LDLRAD2"; oId "uc001bfg.1"; nearest_ref "uc001bfg.1"; class_code "="; tss_id "TSS271"; p_id "P373"; chr1 nearCoding exon 22147943 22148104 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000494"; exon_number "1"; gene_name "LDLRAD2"; oId "uc001bfh.1"; nearest_ref "uc001bfh.1"; class_code "="; tss_id "TSS272"; chr1 nearCoding exon 22148217 22149041 . + . gene_id "XLOC_000177"; transcript_id "TCONS_00000494"; exon_number "2"; gene_name "LDLRAD2"; oId "uc001bfh.1"; nearest_ref "uc001bfh.1"; class_code "="; tss_id "TSS272"; chr1 coding exon 22303418 22303575 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "1"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22304862 22304947 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "2"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22307317 22307414 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "3"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22307531 22307665 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "4"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22310187 22310323 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "5"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22310682 22310824 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "6"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22313024 22313176 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "7"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22315755 22315845 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000495"; exon_number "8"; gene_name "CELA3B"; oId "uc001bfk.2"; nearest_ref "uc001bfk.2"; class_code "="; tss_id "TSS273"; p_id "P374"; chr1 coding exon 22303418 22303575 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000496"; exon_number "1"; oId "uc009vqf.2"; nearest_ref "uc009vqf.2"; class_code "="; tss_id "TSS273"; p_id "P376"; chr1 coding exon 22304862 22304947 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000496"; exon_number "2"; oId "uc009vqf.2"; nearest_ref "uc009vqf.2"; class_code "="; tss_id "TSS273"; p_id "P376"; chr1 coding exon 22331940 22332037 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000496"; exon_number "3"; oId "uc009vqf.2"; nearest_ref "uc009vqf.2"; class_code "="; tss_id "TSS273"; p_id "P376"; chr1 coding exon 22332155 22333140 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000496"; exon_number "4"; oId "uc009vqf.2"; nearest_ref "uc009vqf.2"; class_code "="; tss_id "TSS273"; p_id "P376"; chr1 coding exon 22328149 22328210 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "1"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22329496 22329581 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "2"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22331940 22332037 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "3"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22332155 22332289 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "4"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22333371 22333507 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "5"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22333866 22334008 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "6"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22336198 22336350 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "7"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 coding exon 22338943 22339033 . + . gene_id "XLOC_000178"; transcript_id "TCONS_00000497"; exon_number "8"; gene_name "CELA3A"; oId "uc001bfl.2"; nearest_ref "uc001bfl.2"; class_code "="; tss_id "TSS274"; p_id "P375"; chr1 noncoding exon 22351707 22351865 . + . gene_id "XLOC_000179"; transcript_id "TCONS_00000498"; exon_number "1"; oId "uc001bfm.3"; nearest_ref "uc001bfm.3"; class_code "="; tss_id "TSS275"; chr1 noncoding exon 22356773 22357713 . + . gene_id "XLOC_000179"; transcript_id "TCONS_00000498"; exon_number "2"; oId "uc001bfm.3"; nearest_ref "uc001bfm.3"; class_code "="; tss_id "TSS275"; chr1 noncoding exon 22352042 22352136 . + . gene_id "XLOC_000179"; transcript_id "TCONS_00000499"; exon_number "1"; oId "uc001bfn.3"; nearest_ref "uc001bfn.3"; class_code "="; tss_id "TSS276"; chr1 noncoding exon 22356773 22357713 . + . gene_id "XLOC_000179"; transcript_id "TCONS_00000499"; exon_number "2"; oId "uc001bfn.3"; nearest_ref "uc001bfn.3"; class_code "="; tss_id "TSS276"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000500"; exon_number "1"; gene_name "CDC42"; oId "uc009vqg.1"; nearest_ref "uc009vqg.1"; class_code "="; tss_id "TSS277"; p_id "P382"; chr1 coding exon 22400647 22400712 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000500"; exon_number "2"; gene_name "CDC42"; oId "uc009vqg.1"; nearest_ref "uc009vqg.1"; class_code "="; tss_id "TSS277"; p_id "P382"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000500"; exon_number "3"; gene_name "CDC42"; oId "uc009vqg.1"; nearest_ref "uc009vqg.1"; class_code "="; tss_id "TSS277"; p_id "P382"; chr1 coding exon 22408215 22408287 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000500"; exon_number "4"; gene_name "CDC42"; oId "uc009vqg.1"; nearest_ref "uc009vqg.1"; class_code "="; tss_id "TSS277"; p_id "P382"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000500"; exon_number "5"; gene_name "CDC42"; oId "uc009vqg.1"; nearest_ref "uc009vqg.1"; class_code "="; tss_id "TSS277"; p_id "P382"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000500"; exon_number "6"; gene_name "CDC42"; oId "uc009vqg.1"; nearest_ref "uc009vqg.1"; class_code "="; tss_id "TSS277"; p_id "P382"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000501"; exon_number "1"; gene_name "CDC42"; oId "uc001bfp.2"; nearest_ref "uc001bfp.2"; class_code "="; tss_id "TSS277"; p_id "P378"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000501"; exon_number "2"; gene_name "CDC42"; oId "uc001bfp.2"; nearest_ref "uc001bfp.2"; class_code "="; tss_id "TSS277"; p_id "P378"; chr1 coding exon 22408215 22408287 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000501"; exon_number "3"; gene_name "CDC42"; oId "uc001bfp.2"; nearest_ref "uc001bfp.2"; class_code "="; tss_id "TSS277"; p_id "P378"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000501"; exon_number "4"; gene_name "CDC42"; oId "uc001bfp.2"; nearest_ref "uc001bfp.2"; class_code "="; tss_id "TSS277"; p_id "P378"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000501"; exon_number "5"; gene_name "CDC42"; oId "uc001bfp.2"; nearest_ref "uc001bfp.2"; class_code "="; tss_id "TSS277"; p_id "P378"; chr1 coding exon 22416436 22417295 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000501"; exon_number "6"; gene_name "CDC42"; oId "uc001bfp.2"; nearest_ref "uc001bfp.2"; class_code "="; tss_id "TSS277"; p_id "P378"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "1"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "2"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22405199 22405374 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "3"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22408215 22408287 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "4"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "5"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "6"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22417921 22419435 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000506"; exon_number "7"; gene_name "CDC42"; oId "uc010ods.1"; nearest_ref "uc010ods.1"; class_code "="; tss_id "TSS277"; p_id "P377"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "1"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "2"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22405240 22405374 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "3"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22408215 22408287 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "4"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "5"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "6"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22417921 22419435 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000505"; exon_number "7"; gene_name "CDC42"; oId "uc010odr.1"; nearest_ref "uc010odr.1"; class_code "="; tss_id "TSS277"; p_id "P381"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000504"; exon_number "1"; gene_name "CDC42"; oId "uc009vqh.2"; nearest_ref "uc009vqh.2"; class_code "="; tss_id "TSS277"; p_id "P380"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000504"; exon_number "2"; gene_name "CDC42"; oId "uc009vqh.2"; nearest_ref "uc009vqh.2"; class_code "="; tss_id "TSS277"; p_id "P380"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000504"; exon_number "3"; gene_name "CDC42"; oId "uc009vqh.2"; nearest_ref "uc009vqh.2"; class_code "="; tss_id "TSS277"; p_id "P380"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000504"; exon_number "4"; gene_name "CDC42"; oId "uc009vqh.2"; nearest_ref "uc009vqh.2"; class_code "="; tss_id "TSS277"; p_id "P380"; chr1 coding exon 22417921 22419435 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000504"; exon_number "5"; gene_name "CDC42"; oId "uc009vqh.2"; nearest_ref "uc009vqh.2"; class_code "="; tss_id "TSS277"; p_id "P380"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000503"; exon_number "1"; gene_name "CDC42"; oId "uc001bfr.2"; nearest_ref "uc001bfr.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000503"; exon_number "2"; gene_name "CDC42"; oId "uc001bfr.2"; nearest_ref "uc001bfr.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22408215 22408287 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000503"; exon_number "3"; gene_name "CDC42"; oId "uc001bfr.2"; nearest_ref "uc001bfr.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000503"; exon_number "4"; gene_name "CDC42"; oId "uc001bfr.2"; nearest_ref "uc001bfr.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000503"; exon_number "5"; gene_name "CDC42"; oId "uc001bfr.2"; nearest_ref "uc001bfr.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22417921 22419435 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000503"; exon_number "6"; gene_name "CDC42"; oId "uc001bfr.2"; nearest_ref "uc001bfr.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22379120 22379235 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "1"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22400587 22400712 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "2"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22404922 22405076 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "3"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22408215 22408287 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "4"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22412932 22413041 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "5"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22413162 22413359 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "6"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22417921 22419435 . + . gene_id "XLOC_000180"; transcript_id "TCONS_00000502"; exon_number "7"; gene_name "CDC42"; oId "uc001bfq.2"; nearest_ref "uc001bfq.2"; class_code "="; tss_id "TSS277"; p_id "P379"; chr1 coding exon 22778344 22778497 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "1"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22816373 22817138 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "2"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22817893 22818026 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "3"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22832542 22832734 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "4"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22834494 22834630 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "5"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22835023 22835224 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "6"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22835593 22835726 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "7"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22837672 22837840 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "8"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22838169 22838627 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "9"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22839417 22839623 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "10"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22843793 22843957 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "11"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22846554 22846768 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "12"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22847989 22848151 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "13"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22848870 22848956 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "14"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22850711 22850937 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "15"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22852695 22857650 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000509"; exon_number "16"; gene_name "ZBTB40"; oId "uc009vqi.1"; nearest_ref "uc009vqi.1"; class_code "="; tss_id "TSS278"; p_id "P383"; chr1 coding exon 22778344 22778497 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "1"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22816373 22817138 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "2"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22817893 22818026 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "3"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22827985 22828177 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "4"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22828792 22828934 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "5"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22832542 22832734 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "6"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22834494 22834630 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "7"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22835023 22835224 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "8"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22835593 22835726 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "9"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22837672 22837840 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "10"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22838169 22838627 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "11"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22839417 22839623 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "12"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22843793 22843957 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "13"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22846554 22846768 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "14"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22847989 22848151 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "15"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22848870 22848956 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "16"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22850711 22850937 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "17"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22852695 22857650 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000508"; exon_number "18"; gene_name "ZBTB40"; oId "uc001bfu.2"; nearest_ref "uc001bfu.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22778344 22778497 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "1"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22779152 22779439 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "2"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22816373 22817138 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "3"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22817893 22818026 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "4"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22827985 22828177 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "5"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22828792 22828934 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "6"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22832542 22832734 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "7"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22834494 22834630 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "8"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22835023 22835224 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "9"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22835593 22835726 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "10"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22837672 22837840 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "11"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22838169 22838627 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "12"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22839417 22839623 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "13"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22843793 22843957 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "14"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22846554 22846768 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "15"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22847989 22848151 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "16"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22848870 22848956 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "17"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22850711 22850937 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "18"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22852695 22857650 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000507"; exon_number "19"; gene_name "ZBTB40"; oId "uc001bft.2"; nearest_ref "uc001bft.2"; class_code "="; tss_id "TSS278"; p_id "P385"; chr1 coding exon 22828069 22828934 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "1"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22832542 22832734 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "2"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22834494 22834630 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "3"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22835023 22835224 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "4"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22835593 22835726 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "5"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22837672 22837840 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "6"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22838169 22838627 . + . gene_id "XLOC_000181"; transcript_id "TCONS_00000510"; exon_number "7"; oId "uc001bfv.1"; nearest_ref "uc001bfv.1"; class_code "="; tss_id "TSS279"; p_id "P384"; chr1 coding exon 22890004 22890222 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000511"; exon_number "1"; gene_name "EPHA8"; oId "uc001bfw.2"; nearest_ref "uc001bfw.2"; class_code "="; tss_id "TSS280"; p_id "P387"; chr1 coding exon 22895782 22895846 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000511"; exon_number "2"; gene_name "EPHA8"; oId "uc001bfw.2"; nearest_ref "uc001bfw.2"; class_code "="; tss_id "TSS280"; p_id "P387"; chr1 coding exon 22902710 22903373 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000511"; exon_number "3"; gene_name "EPHA8"; oId "uc001bfw.2"; nearest_ref "uc001bfw.2"; class_code "="; tss_id "TSS280"; p_id "P387"; chr1 coding exon 22912973 22913128 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000511"; exon_number "4"; gene_name "EPHA8"; oId "uc001bfw.2"; nearest_ref "uc001bfw.2"; class_code "="; tss_id "TSS280"; p_id "P387"; chr1 coding exon 22915364 22916103 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000511"; exon_number "5"; gene_name "EPHA8"; oId "uc001bfw.2"; nearest_ref "uc001bfw.2"; class_code "="; tss_id "TSS280"; p_id "P387"; chr1 coding exon 22890004 22890222 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "1"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22895782 22895846 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "2"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22902710 22903373 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "3"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22912973 22913128 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "4"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22915364 22915699 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "5"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22919819 22919943 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "6"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22920017 22920179 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "7"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22921723 22921816 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "8"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22922599 22922666 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "9"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22923805 22923969 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "10"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22924169 22924354 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "11"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22924644 22924705 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "12"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22925331 22925540 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "13"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22927154 22927303 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "14"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22927391 22927581 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "15"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22927793 22927966 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "16"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22928120 22930087 . + . gene_id "XLOC_000182"; transcript_id "TCONS_00000512"; exon_number "17"; gene_name "EPHA8"; oId "uc001bfx.1"; nearest_ref "uc001bfx.1"; class_code "="; tss_id "TSS280"; p_id "P386"; chr1 coding exon 22963118 22963195 . + . gene_id "XLOC_000183"; transcript_id "TCONS_00000513"; exon_number "1"; gene_name "C1QA"; oId "uc001bfy.2"; nearest_ref "uc001bfy.2"; class_code "="; tss_id "TSS281"; p_id "P388"; chr1 coding exon 22964103 22964272 . + . gene_id "XLOC_000183"; transcript_id "TCONS_00000513"; exon_number "2"; gene_name "C1QA"; oId "uc001bfy.2"; nearest_ref "uc001bfy.2"; class_code "="; tss_id "TSS281"; p_id "P388"; chr1 coding exon 22965326 22966174 . + . gene_id "XLOC_000183"; transcript_id "TCONS_00000513"; exon_number "3"; gene_name "C1QA"; oId "uc001bfy.2"; nearest_ref "uc001bfy.2"; class_code "="; tss_id "TSS281"; p_id "P388"; chr1 coding exon 22964073 22964272 . + . gene_id "XLOC_000183"; transcript_id "TCONS_00000514"; exon_number "1"; gene_name "C1QA"; oId "uc001bfz.2"; nearest_ref "uc001bfz.2"; class_code "="; tss_id "TSS282"; p_id "P388"; chr1 coding exon 22965326 22966174 . + . gene_id "XLOC_000183"; transcript_id "TCONS_00000514"; exon_number "2"; gene_name "C1QA"; oId "uc001bfz.2"; nearest_ref "uc001bfz.2"; class_code "="; tss_id "TSS282"; p_id "P388"; chr1 coding exon 22970118 22970207 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000516"; exon_number "1"; gene_name "C1QC"; oId "uc001bgc.3"; nearest_ref "uc001bgc.3"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22970504 22970697 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000516"; exon_number "2"; gene_name "C1QC"; oId "uc001bgc.3"; nearest_ref "uc001bgc.3"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22973720 22974602 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000516"; exon_number "3"; gene_name "C1QC"; oId "uc001bgc.3"; nearest_ref "uc001bgc.3"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22970118 22970230 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000515"; exon_number "1"; gene_name "C1QC"; oId "uc001bga.3"; nearest_ref "uc001bga.3"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22970504 22970697 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000515"; exon_number "2"; gene_name "C1QC"; oId "uc001bga.3"; nearest_ref "uc001bga.3"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22973720 22974602 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000515"; exon_number "3"; gene_name "C1QC"; oId "uc001bga.3"; nearest_ref "uc001bga.3"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22970146 22970379 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000517"; exon_number "1"; gene_name "C1QC"; oId "uc001bgb.2"; nearest_ref "uc001bgb.2"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22970504 22970697 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000517"; exon_number "2"; gene_name "C1QC"; oId "uc001bgb.2"; nearest_ref "uc001bgb.2"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22973720 22974602 . + . gene_id "XLOC_000184"; transcript_id "TCONS_00000517"; exon_number "3"; gene_name "C1QC"; oId "uc001bgb.2"; nearest_ref "uc001bgb.2"; class_code "="; tss_id "TSS283"; p_id "P389"; chr1 coding exon 22979682 22979796 . + . gene_id "XLOC_000185"; transcript_id "TCONS_00000518"; exon_number "1"; gene_name "C1QB"; oId "uc001bgd.2"; nearest_ref "uc001bgd.2"; class_code "="; tss_id "TSS284"; p_id "P390"; chr1 coding exon 22985933 22986136 . + . gene_id "XLOC_000185"; transcript_id "TCONS_00000518"; exon_number "2"; gene_name "C1QB"; oId "uc001bgd.2"; nearest_ref "uc001bgd.2"; class_code "="; tss_id "TSS284"; p_id "P390"; chr1 coding exon 22987305 22988028 . + . gene_id "XLOC_000185"; transcript_id "TCONS_00000518"; exon_number "3"; gene_name "C1QB"; oId "uc001bgd.2"; nearest_ref "uc001bgd.2"; class_code "="; tss_id "TSS284"; p_id "P390"; chr1 coding exon 23037331 23037536 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "1"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23107914 23107978 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "2"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23110885 23111569 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "3"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23189530 23189685 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "4"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23191370 23191705 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "5"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23208852 23208976 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "6"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23219377 23219539 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "7"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23221965 23222073 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "8"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23222907 23222971 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "9"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23232480 23232602 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "10"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23233203 23233450 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "11"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23234446 23234661 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "12"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23235515 23235664 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "13"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23236875 23237068 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "14"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23238937 23239092 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "15"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23239955 23240057 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "16"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23240151 23241082 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000519"; exon_number "17"; gene_name "EPHB2"; oId "uc009vqj.1"; nearest_ref "uc009vqj.1"; class_code "="; tss_id "TSS285"; p_id "P392"; chr1 coding exon 23037331 23037536 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "1"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23107914 23107978 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "2"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23110885 23111569 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "3"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23189530 23189685 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "4"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23191370 23191705 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "5"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23208852 23208976 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "6"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23219377 23219539 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "7"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23221965 23222073 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "8"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23222907 23222971 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "9"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23232480 23232602 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "10"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23233203 23233450 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "11"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23234446 23234661 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "12"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23235515 23235664 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "13"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23236875 23237068 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "14"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23238937 23239092 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "15"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23239955 23241822 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000521"; exon_number "16"; gene_name "EPHB2"; oId "uc001bgf.2"; nearest_ref "uc001bgf.2"; class_code "="; tss_id "TSS285"; p_id "P393"; chr1 coding exon 23037331 23037536 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "1"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23107914 23107978 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "2"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23110885 23111569 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "3"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23189530 23189685 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "4"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23191370 23191705 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "5"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23208852 23208976 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "6"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23219377 23219539 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "7"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23221965 23222073 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "8"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23222904 23222971 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "9"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23232480 23232602 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "10"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23233203 23233450 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "11"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23234446 23234661 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "12"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23235515 23235664 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "13"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23236875 23237068 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "14"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23238937 23239092 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "15"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23239955 23241822 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000520"; exon_number "16"; gene_name "EPHB2"; oId "uc001bge.2"; nearest_ref "uc001bge.2"; class_code "="; tss_id "TSS285"; p_id "P391"; chr1 coding exon 23037332 23037407 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "1"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23037469 23037536 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "2"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23107914 23107978 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "3"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23110885 23111569 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "4"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23189530 23189685 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "5"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23191370 23191705 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "6"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23208852 23208976 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "7"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23219377 23219539 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "8"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23232480 23232602 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "9"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23233203 23233450 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "10"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23234446 23234661 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "11"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23235515 23235664 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "12"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23236875 23237068 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "13"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23238937 23239092 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "14"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 coding exon 23239955 23241822 . + . gene_id "XLOC_000186"; transcript_id "TCONS_00000522"; exon_number "15"; gene_name "EPHB2"; oId "uc010odu.1"; nearest_ref "uc010odu.1"; class_code "="; tss_id "TSS285"; p_id "P394"; chr1 noncoding exon 23243783 23247347 . + . gene_id "XLOC_000187"; transcript_id "TCONS_00000523"; exon_number "1"; oId "uc001bgg.1"; nearest_ref "uc001bgg.1"; class_code "="; chr1 coding exon 23345941 23346440 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "1"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23356962 23357127 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "2"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23370920 23370979 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "3"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23376880 23377013 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "4"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23380254 23380332 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "5"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23381562 23381654 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "6"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23382425 23382531 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "7"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23383977 23384058 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "8"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23385566 23385660 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "9"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23392553 23392564 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "10"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23395032 23395174 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "11"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23395554 23395644 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "12"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23397718 23397852 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "13"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23398617 23398690 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "14"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23399785 23399896 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "15"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23403721 23403853 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "16"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23405483 23405670 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "17"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23406046 23406160 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "18"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23407939 23408066 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "19"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23408713 23408859 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "20"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23409672 23410184 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000525"; exon_number "21"; oId "uc001bgj.2"; nearest_ref "uc001bgj.2"; class_code "="; tss_id "TSS286"; p_id "P396"; chr1 coding exon 23345941 23346440 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "1"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23356962 23357127 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "2"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23376880 23377013 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "3"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23380254 23380332 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "4"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23381562 23381654 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "5"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23382425 23382531 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "6"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23383977 23384058 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "7"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23385566 23385660 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "8"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23395032 23395174 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "9"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23395554 23395644 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "10"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23397718 23397852 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "11"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23398617 23398690 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "12"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23399785 23399896 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "13"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23403721 23403853 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "14"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23405483 23405670 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "15"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23406046 23406160 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "16"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23407939 23408066 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "17"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23408713 23408859 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "18"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23409672 23410184 . + . gene_id "XLOC_000188"; transcript_id "TCONS_00000524"; exon_number "19"; oId "uc001bgi.2"; nearest_ref "uc001bgi.2"; class_code "="; tss_id "TSS286"; p_id "P395"; chr1 coding exon 23695464 23698278 . + . gene_id "XLOC_000189"; transcript_id "TCONS_00000527"; exon_number "1"; gene_name "C1orf213"; oId "uc001bgw.2"; nearest_ref "uc001bgw.2"; class_code "="; p_id "P398"; chr1 coding exon 23695464 23696006 . + . gene_id "XLOC_000189"; transcript_id "TCONS_00000526"; exon_number "1"; gene_name "C1orf213"; oId "uc001bgv.2"; nearest_ref "uc001bgv.2"; class_code "="; tss_id "TSS287"; p_id "P397"; chr1 coding exon 23697632 23697702 . + . gene_id "XLOC_000189"; transcript_id "TCONS_00000526"; exon_number "2"; gene_name "C1orf213"; oId "uc001bgv.2"; nearest_ref "uc001bgv.2"; class_code "="; tss_id "TSS287"; p_id "P397"; chr1 coding exon 23698006 23698278 . + . gene_id "XLOC_000189"; transcript_id "TCONS_00000526"; exon_number "3"; gene_name "C1orf213"; oId "uc001bgv.2"; nearest_ref "uc001bgv.2"; class_code "="; tss_id "TSS287"; p_id "P397"; chr1 noncoding exon 23853365 23855542 . + . gene_id "XLOC_000190"; transcript_id "TCONS_00000528"; exon_number "1"; oId "uc001bhf.1"; nearest_ref "uc001bhf.1"; class_code "="; chr1 noncoding exon 23907985 23908168 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "1"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23918972 23919302 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "2"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23953226 23954027 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "3"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23954997 23955087 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "4"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23955971 23956047 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "5"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23966170 23966285 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "6"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23966879 23967056 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000529"; exon_number "7"; gene_name "MDS2"; oId "uc001bhi.3"; nearest_ref "uc001bhi.3"; class_code "="; tss_id "TSS288"; chr1 noncoding exon 23953226 23954027 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "1"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 noncoding exon 23954271 23954488 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "2"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 noncoding exon 23954997 23955087 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "3"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 noncoding exon 23955971 23956047 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "4"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 noncoding exon 23965599 23965741 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "5"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 noncoding exon 23966170 23966285 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "6"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 noncoding exon 23966879 23967056 . + . gene_id "XLOC_000191"; transcript_id "TCONS_00000530"; exon_number "7"; gene_name "MDS2"; oId "uc001bhj.3"; nearest_ref "uc001bhj.3"; class_code "="; tss_id "TSS289"; chr1 coding exon 24018294 24018319 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000532"; exon_number "1"; gene_name "RPL11"; oId "uc001bhl.2"; nearest_ref "uc001bhl.2"; class_code "="; tss_id "TSS290"; p_id "P401"; chr1 coding exon 24019102 24019249 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000532"; exon_number "2"; gene_name "RPL11"; oId "uc001bhl.2"; nearest_ref "uc001bhl.2"; class_code "="; tss_id "TSS290"; p_id "P401"; chr1 coding exon 24020297 24020403 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000532"; exon_number "3"; gene_name "RPL11"; oId "uc001bhl.2"; nearest_ref "uc001bhl.2"; class_code "="; tss_id "TSS290"; p_id "P401"; chr1 coding exon 24021150 24021281 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000532"; exon_number "4"; gene_name "RPL11"; oId "uc001bhl.2"; nearest_ref "uc001bhl.2"; class_code "="; tss_id "TSS290"; p_id "P401"; chr1 coding exon 24022288 24022398 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000532"; exon_number "5"; gene_name "RPL11"; oId "uc001bhl.2"; nearest_ref "uc001bhl.2"; class_code "="; tss_id "TSS290"; p_id "P401"; chr1 coding exon 24022834 24022913 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000532"; exon_number "6"; gene_name "RPL11"; oId "uc001bhl.2"; nearest_ref "uc001bhl.2"; class_code "="; tss_id "TSS290"; p_id "P401"; chr1 coding exon 24018294 24018319 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000531"; exon_number "1"; gene_name "RPL11"; oId "uc001bhk.2"; nearest_ref "uc001bhk.2"; class_code "="; tss_id "TSS290"; p_id "P400"; chr1 coding exon 24019099 24019249 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000531"; exon_number "2"; gene_name "RPL11"; oId "uc001bhk.2"; nearest_ref "uc001bhk.2"; class_code "="; tss_id "TSS290"; p_id "P400"; chr1 coding exon 24020297 24020403 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000531"; exon_number "3"; gene_name "RPL11"; oId "uc001bhk.2"; nearest_ref "uc001bhk.2"; class_code "="; tss_id "TSS290"; p_id "P400"; chr1 coding exon 24021150 24021281 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000531"; exon_number "4"; gene_name "RPL11"; oId "uc001bhk.2"; nearest_ref "uc001bhk.2"; class_code "="; tss_id "TSS290"; p_id "P400"; chr1 coding exon 24022288 24022398 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000531"; exon_number "5"; gene_name "RPL11"; oId "uc001bhk.2"; nearest_ref "uc001bhk.2"; class_code "="; tss_id "TSS290"; p_id "P400"; chr1 coding exon 24022834 24022913 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000531"; exon_number "6"; gene_name "RPL11"; oId "uc001bhk.2"; nearest_ref "uc001bhk.2"; class_code "="; tss_id "TSS290"; p_id "P400"; chr1 coding exon 24019086 24019249 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000533"; exon_number "1"; gene_name "RPL11"; oId "uc001bhm.2"; nearest_ref "uc001bhm.2"; class_code "="; tss_id "TSS291"; p_id "P399"; chr1 coding exon 24020297 24020403 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000533"; exon_number "2"; gene_name "RPL11"; oId "uc001bhm.2"; nearest_ref "uc001bhm.2"; class_code "="; tss_id "TSS291"; p_id "P399"; chr1 coding exon 24021150 24021281 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000533"; exon_number "3"; gene_name "RPL11"; oId "uc001bhm.2"; nearest_ref "uc001bhm.2"; class_code "="; tss_id "TSS291"; p_id "P399"; chr1 coding exon 24022288 24022398 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000533"; exon_number "4"; gene_name "RPL11"; oId "uc001bhm.2"; nearest_ref "uc001bhm.2"; class_code "="; tss_id "TSS291"; p_id "P399"; chr1 coding exon 24022834 24022913 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000533"; exon_number "5"; gene_name "RPL11"; oId "uc001bhm.2"; nearest_ref "uc001bhm.2"; class_code "="; tss_id "TSS291"; p_id "P399"; chr1 coding exon 24019102 24019249 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000534"; exon_number "1"; gene_name "RPL11"; oId "uc001bhn.1"; nearest_ref "uc001bhn.1"; class_code "="; tss_id "TSS291"; p_id "P402"; chr1 coding exon 24020297 24020403 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000534"; exon_number "2"; gene_name "RPL11"; oId "uc001bhn.1"; nearest_ref "uc001bhn.1"; class_code "="; tss_id "TSS291"; p_id "P402"; chr1 coding exon 24021150 24022869 . + . gene_id "XLOC_000192"; transcript_id "TCONS_00000534"; exon_number "3"; gene_name "RPL11"; oId "uc001bhn.1"; nearest_ref "uc001bhn.1"; class_code "="; tss_id "TSS291"; p_id "P402"; chr1 coding exon 24069856 24070068 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "1"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24075511 24075567 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "2"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24076332 24076438 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "3"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24077335 24078520 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "4"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24078897 24079008 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "5"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24080590 24080745 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "6"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24080853 24080950 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "7"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24082333 24082513 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "8"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24082764 24082875 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "9"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24083443 24083615 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "10"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24086002 24088548 . + . gene_id "XLOC_000193"; transcript_id "TCONS_00000535"; exon_number "11"; gene_name "TCEB3"; oId "uc001bho.2"; nearest_ref "uc001bho.2"; class_code "="; tss_id "TSS292"; p_id "P403"; chr1 coding exon 24104876 24105203 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000537"; exon_number "1"; oId "uc010oeb.1"; nearest_ref "uc010oeb.1"; class_code "="; tss_id "TSS293"; p_id "P404"; chr1 coding exon 24106354 24106431 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000537"; exon_number "2"; oId "uc010oeb.1"; nearest_ref "uc010oeb.1"; class_code "="; tss_id "TSS293"; p_id "P404"; chr1 coding exon 24112165 24112269 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000537"; exon_number "3"; oId "uc010oeb.1"; nearest_ref "uc010oeb.1"; class_code "="; tss_id "TSS293"; p_id "P404"; chr1 coding exon 24112805 24112913 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000537"; exon_number "4"; oId "uc010oeb.1"; nearest_ref "uc010oeb.1"; class_code "="; tss_id "TSS293"; p_id "P404"; chr1 coding exon 24113765 24114720 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000537"; exon_number "5"; oId "uc010oeb.1"; nearest_ref "uc010oeb.1"; class_code "="; tss_id "TSS293"; p_id "P404"; chr1 coding exon 24104876 24105203 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000536"; exon_number "1"; gene_name "C1orf128"; oId "uc001bhq.2"; nearest_ref "uc001bhq.2"; class_code "="; tss_id "TSS293"; p_id "P405"; chr1 coding exon 24105928 24105971 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000536"; exon_number "2"; gene_name "C1orf128"; oId "uc001bhq.2"; nearest_ref "uc001bhq.2"; class_code "="; tss_id "TSS293"; p_id "P405"; chr1 coding exon 24106354 24106431 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000536"; exon_number "3"; gene_name "C1orf128"; oId "uc001bhq.2"; nearest_ref "uc001bhq.2"; class_code "="; tss_id "TSS293"; p_id "P405"; chr1 coding exon 24112165 24112269 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000536"; exon_number "4"; gene_name "C1orf128"; oId "uc001bhq.2"; nearest_ref "uc001bhq.2"; class_code "="; tss_id "TSS293"; p_id "P405"; chr1 coding exon 24112805 24112913 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000536"; exon_number "5"; gene_name "C1orf128"; oId "uc001bhq.2"; nearest_ref "uc001bhq.2"; class_code "="; tss_id "TSS293"; p_id "P405"; chr1 coding exon 24113765 24114720 . + . gene_id "XLOC_000194"; transcript_id "TCONS_00000536"; exon_number "6"; gene_name "C1orf128"; oId "uc001bhq.2"; nearest_ref "uc001bhq.2"; class_code "="; tss_id "TSS293"; p_id "P405"; chr1 coding exon 24117646 24117740 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "1"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24119147 24119250 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "2"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24119498 24119529 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "3"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24119641 24119706 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "4"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24120195 24120242 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "5"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24120350 24120420 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "6"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24120553 24120626 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "7"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24120714 24120815 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "8"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24120917 24122010 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000538"; exon_number "9"; gene_name "LYPLA2"; oId "uc001bhr.2"; nearest_ref "uc001bhr.2"; class_code "="; tss_id "TSS294"; p_id "P407"; chr1 coding exon 24117646 24117740 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "1"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24119147 24119250 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "2"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24119498 24119529 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "3"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24119641 24119706 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "4"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24120195 24120242 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "5"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24120350 24120420 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "6"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24120714 24122025 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000539"; exon_number "7"; gene_name "LYPLA2"; oId "uc001bhs.1"; nearest_ref "uc001bhs.1"; class_code "="; tss_id "TSS294"; p_id "P409"; chr1 coding exon 24117646 24117740 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "1"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24119147 24119250 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "2"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24119641 24119706 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "3"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24120195 24120242 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "4"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24120350 24120420 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "5"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24120553 24120626 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "6"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24120714 24120815 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "7"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24120917 24121090 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "8"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24121172 24122027 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000541"; exon_number "9"; gene_name "LYPLA2"; oId "uc001bhu.2"; nearest_ref "uc001bhu.2"; class_code "="; tss_id "TSS294"; p_id "P408"; chr1 coding exon 24117646 24117740 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "1"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24119147 24119250 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "2"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24119498 24119529 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "3"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24119641 24119706 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "4"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24120195 24120242 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "5"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24120350 24120420 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "6"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24120553 24120626 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "7"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24120714 24120815 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "8"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24120917 24121090 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "9"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24121172 24122027 . + . gene_id "XLOC_000195"; transcript_id "TCONS_00000540"; exon_number "10"; gene_name "LYPLA2"; oId "uc001bht.2"; nearest_ref "uc001bht.2"; class_code "="; tss_id "TSS294"; p_id "P406"; chr1 coding exon 24286301 24286488 . + . gene_id "XLOC_000196"; transcript_id "TCONS_00000542"; exon_number "1"; gene_name "PNRC2"; oId "uc001big.2"; nearest_ref "uc001big.2"; class_code "="; tss_id "TSS295"; p_id "P410"; chr1 coding exon 24287419 24287624 . + . gene_id "XLOC_000196"; transcript_id "TCONS_00000542"; exon_number "2"; gene_name "PNRC2"; oId "uc001big.2"; nearest_ref "uc001big.2"; class_code "="; tss_id "TSS295"; p_id "P410"; chr1 coding exon 24287930 24289947 . + . gene_id "XLOC_000196"; transcript_id "TCONS_00000542"; exon_number "3"; gene_name "PNRC2"; oId "uc001big.2"; nearest_ref "uc001big.2"; class_code "="; tss_id "TSS295"; p_id "P410"; chr1 noncoding exon 24526730 24526881 . + . gene_id "XLOC_000197"; transcript_id "TCONS_00000543"; exon_number "1"; oId "uc010oei.1"; nearest_ref "uc010oei.1"; class_code "="; tss_id "TSS296"; chr1 noncoding exon 24528954 24529089 . + . gene_id "XLOC_000197"; transcript_id "TCONS_00000543"; exon_number "2"; oId "uc010oei.1"; nearest_ref "uc010oei.1"; class_code "="; tss_id "TSS296"; chr1 noncoding exon 24536623 24538180 . + . gene_id "XLOC_000197"; transcript_id "TCONS_00000543"; exon_number "3"; oId "uc010oei.1"; nearest_ref "uc010oei.1"; class_code "="; tss_id "TSS296"; chr1 coding exon 24645881 24646058 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "1"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24657916 24658102 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "2"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24661135 24661196 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "3"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24662972 24663317 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "4"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24663568 24663641 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "5"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24664126 24664279 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "6"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24664482 24664593 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "7"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24666158 24666252 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "8"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24668605 24668763 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "9"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24669184 24669262 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "10"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24669382 24669515 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "11"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24671387 24671421 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "12"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24673043 24673131 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "13"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24673958 24674043 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "14"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24676548 24676612 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "15"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24680864 24681807 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000544"; exon_number "16"; gene_name "GRHL3"; oId "uc001bix.2"; nearest_ref "uc001bix.2"; class_code "="; tss_id "TSS297"; p_id "P412"; chr1 coding exon 24649530 24649607 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "1"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24661135 24661196 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "2"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24662972 24663317 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "3"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24663568 24663641 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "4"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24664126 24664279 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "5"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24664482 24664593 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "6"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24666158 24666252 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "7"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24668605 24668763 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "8"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24669184 24669262 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "9"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24669382 24669515 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "10"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24671387 24671421 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "11"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24673043 24673131 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "12"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24673958 24674043 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "13"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24676548 24676612 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "14"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24680864 24681807 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000546"; exon_number "15"; gene_name "GRHL3"; oId "uc001biz.2"; nearest_ref "uc001biz.2"; class_code "="; tss_id "TSS298"; p_id "P411"; chr1 coding exon 24649530 24649607 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "1"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24657916 24658102 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "2"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24661135 24661196 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "3"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24662972 24663317 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "4"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24663568 24663641 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "5"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24664126 24664279 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "6"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24664482 24664593 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "7"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24666158 24666252 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "8"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24668605 24668763 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "9"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24669184 24669262 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "10"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24669382 24669515 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "11"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24671387 24671421 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "12"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24673043 24673131 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "13"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24673958 24674043 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "14"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24676548 24676612 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "15"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24680864 24681807 . + . gene_id "XLOC_000198"; transcript_id "TCONS_00000545"; exon_number "16"; gene_name "GRHL3"; oId "uc001biy.2"; nearest_ref "uc001biy.2"; class_code "="; tss_id "TSS298"; p_id "P413"; chr1 coding exon 24742245 24742394 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "1"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24745781 24746130 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "2"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24766662 24766730 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "3"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24768545 24768716 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "4"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24771675 24771734 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "5"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24775971 24776116 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "6"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24779898 24779994 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "7"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24780544 24781313 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000547"; exon_number "8"; gene_name "NIPAL3"; oId "uc010oek.1"; nearest_ref "uc010oek.1"; class_code "="; tss_id "TSS299"; p_id "P416"; chr1 coding exon 24742245 24742394 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "1"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24745781 24746130 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "2"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24766662 24766730 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "3"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24768545 24768716 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "4"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24771675 24771734 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "5"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24775971 24776116 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "6"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24779898 24779994 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "7"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24782628 24782763 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "8"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24785378 24785466 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "9"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24786971 24787034 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "10"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24790516 24790610 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "11"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24792494 24792797 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000548"; exon_number "12"; gene_name "NIPAL3"; oId "uc001bjg.2"; nearest_ref "uc001bjg.2"; class_code "="; tss_id "TSS299"; p_id "P415"; chr1 coding exon 24742245 24742394 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "1"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24745781 24746130 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "2"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24759594 24759703 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "3"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24766662 24766730 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "4"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24768545 24768716 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "5"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24771675 24771734 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "6"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24775971 24776116 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "7"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24779898 24779994 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "8"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24782628 24782763 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "9"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24785378 24785466 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "10"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24786971 24787034 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "11"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24790516 24790610 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "12"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24795476 24799472 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000550"; exon_number "13"; gene_name "NIPAL3"; oId "uc009vrc.2"; nearest_ref "uc009vrc.2"; class_code "="; tss_id "TSS299"; p_id "P414"; chr1 coding exon 24742245 24742394 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "1"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24745781 24746130 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "2"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24766662 24766730 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "3"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24768545 24768716 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "4"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24771675 24771734 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "5"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24775971 24776116 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "6"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24779898 24779994 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "7"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24782628 24782763 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "8"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24785378 24785466 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "9"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24786971 24787034 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "10"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24790516 24790610 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "11"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24795476 24799472 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000549"; exon_number "12"; gene_name "NIPAL3"; oId "uc001bjh.2"; nearest_ref "uc001bjh.2"; class_code "="; tss_id "TSS299"; p_id "P417"; chr1 coding exon 24782628 24782763 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000551"; exon_number "1"; oId "uc001bji.2"; nearest_ref "uc001bji.2"; class_code "="; tss_id "TSS300"; p_id "P418"; chr1 coding exon 24784224 24784323 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000551"; exon_number "2"; oId "uc001bji.2"; nearest_ref "uc001bji.2"; class_code "="; tss_id "TSS300"; p_id "P418"; chr1 coding exon 24785378 24785466 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000551"; exon_number "3"; oId "uc001bji.2"; nearest_ref "uc001bji.2"; class_code "="; tss_id "TSS300"; p_id "P418"; chr1 coding exon 24786971 24787034 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000551"; exon_number "4"; oId "uc001bji.2"; nearest_ref "uc001bji.2"; class_code "="; tss_id "TSS300"; p_id "P418"; chr1 coding exon 24790516 24792862 . + . gene_id "XLOC_000199"; transcript_id "TCONS_00000551"; exon_number "5"; oId "uc001bji.2"; nearest_ref "uc001bji.2"; class_code "="; tss_id "TSS300"; p_id "P418"; chr1 coding exon 24829387 24829640 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000552"; exon_number "1"; gene_name "RCAN3"; oId "uc001bjj.2"; nearest_ref "uc001bjj.2"; class_code "="; tss_id "TSS301"; p_id "P422"; chr1 coding exon 24840804 24841057 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000552"; exon_number "2"; gene_name "RCAN3"; oId "uc001bjj.2"; nearest_ref "uc001bjj.2"; class_code "="; tss_id "TSS301"; p_id "P422"; chr1 coding exon 24857708 24857881 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000552"; exon_number "3"; gene_name "RCAN3"; oId "uc001bjj.2"; nearest_ref "uc001bjj.2"; class_code "="; tss_id "TSS301"; p_id "P422"; chr1 coding exon 24859573 24859744 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000552"; exon_number "4"; gene_name "RCAN3"; oId "uc001bjj.2"; nearest_ref "uc001bjj.2"; class_code "="; tss_id "TSS301"; p_id "P422"; chr1 coding exon 24861583 24862425 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000552"; exon_number "5"; gene_name "RCAN3"; oId "uc001bjj.2"; nearest_ref "uc001bjj.2"; class_code "="; tss_id "TSS301"; p_id "P422"; chr1 coding exon 24840804 24841057 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000556"; exon_number "1"; oId "uc009vrg.2"; nearest_ref "uc009vrg.2"; class_code "="; tss_id "TSS302"; p_id "P421"; chr1 coding exon 24861583 24862425 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000556"; exon_number "2"; oId "uc009vrg.2"; nearest_ref "uc009vrg.2"; class_code "="; tss_id "TSS302"; p_id "P421"; chr1 coding exon 24840804 24841057 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000555"; exon_number "1"; oId "uc009vrf.2"; nearest_ref "uc009vrf.2"; class_code "="; tss_id "TSS302"; p_id "P420"; chr1 coding exon 24857708 24857881 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000555"; exon_number "2"; oId "uc009vrf.2"; nearest_ref "uc009vrf.2"; class_code "="; tss_id "TSS302"; p_id "P420"; chr1 coding exon 24861583 24862425 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000555"; exon_number "3"; oId "uc009vrf.2"; nearest_ref "uc009vrf.2"; class_code "="; tss_id "TSS302"; p_id "P420"; chr1 coding exon 24840804 24841057 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000554"; exon_number "1"; oId "uc009vre.2"; nearest_ref "uc009vre.2"; class_code "="; tss_id "TSS302"; p_id "P419"; chr1 coding exon 24859573 24859744 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000554"; exon_number "2"; oId "uc009vre.2"; nearest_ref "uc009vre.2"; class_code "="; tss_id "TSS302"; p_id "P419"; chr1 coding exon 24861583 24862425 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000554"; exon_number "3"; oId "uc009vre.2"; nearest_ref "uc009vre.2"; class_code "="; tss_id "TSS302"; p_id "P419"; chr1 coding exon 24840804 24841057 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000553"; exon_number "1"; gene_name "RCAN3"; oId "uc009vrd.2"; nearest_ref "uc009vrd.2"; class_code "="; tss_id "TSS302"; p_id "P423"; chr1 coding exon 24857708 24857881 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000553"; exon_number "2"; gene_name "RCAN3"; oId "uc009vrd.2"; nearest_ref "uc009vrd.2"; class_code "="; tss_id "TSS302"; p_id "P423"; chr1 coding exon 24859603 24859744 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000553"; exon_number "3"; gene_name "RCAN3"; oId "uc009vrd.2"; nearest_ref "uc009vrd.2"; class_code "="; tss_id "TSS302"; p_id "P423"; chr1 coding exon 24861583 24862425 . + . gene_id "XLOC_000200"; transcript_id "TCONS_00000553"; exon_number "4"; gene_name "RCAN3"; oId "uc009vrd.2"; nearest_ref "uc009vrd.2"; class_code "="; tss_id "TSS302"; p_id "P423"; chr1 coding exon 24882602 24882660 . + . gene_id "XLOC_000201"; transcript_id "TCONS_00000557"; exon_number "1"; gene_name "C1orf130"; oId "uc001bjk.1"; nearest_ref "uc001bjk.1"; class_code "="; tss_id "TSS303"; p_id "P424"; chr1 coding exon 24921915 24922003 . + . gene_id "XLOC_000201"; transcript_id "TCONS_00000557"; exon_number "2"; gene_name "C1orf130"; oId "uc001bjk.1"; nearest_ref "uc001bjk.1"; class_code "="; tss_id "TSS303"; p_id "P424"; chr1 coding exon 24927431 24927515 . + . gene_id "XLOC_000201"; transcript_id "TCONS_00000557"; exon_number "3"; gene_name "C1orf130"; oId "uc001bjk.1"; nearest_ref "uc001bjk.1"; class_code "="; tss_id "TSS303"; p_id "P424"; chr1 coding exon 24932097 24935816 . + . gene_id "XLOC_000201"; transcript_id "TCONS_00000557"; exon_number "4"; gene_name "C1orf130"; oId "uc001bjk.1"; nearest_ref "uc001bjk.1"; class_code "="; tss_id "TSS303"; p_id "P424"; chr1 coding exon 24969594 24969838 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "1"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24972475 24972564 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "2"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24973158 24973280 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "3"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24975350 24975520 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "4"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24976462 24976577 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "5"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24977900 24978103 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "6"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24978925 24979119 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "7"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24979404 24979523 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "8"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24981346 24981614 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "9"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24987210 24987290 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "10"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24987801 24987887 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "11"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24989151 24989295 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "12"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24989674 24989715 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "13"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24993306 24993416 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "14"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24995614 24996078 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "15"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24996611 24996806 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "16"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24997877 24998086 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "17"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24998673 24999771 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000559"; exon_number "18"; gene_name "SRRM1"; oId "uc010oel.1"; nearest_ref "uc010oel.1"; class_code "="; tss_id "TSS304"; p_id "P425"; chr1 coding exon 24969594 24969838 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "1"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24972475 24972564 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "2"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24973158 24973280 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "3"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24975350 24975520 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "4"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24976462 24976577 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "5"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24977900 24978103 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "6"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24978925 24979119 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "7"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24979404 24979523 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "8"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24981346 24981620 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "9"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24987210 24987290 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "10"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24987801 24987887 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "11"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24989151 24989295 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "12"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24993306 24993416 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "13"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24995614 24996078 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "14"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24996611 24996806 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "15"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24997877 24998086 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "16"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24998673 24999771 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000558"; exon_number "17"; gene_name "SRRM1"; oId "uc001bjm.2"; nearest_ref "uc001bjm.2"; class_code "="; tss_id "TSS304"; p_id "P427"; chr1 coding exon 24970050 24970223 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "1"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24972475 24972564 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "2"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24973158 24973280 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "3"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24975350 24975520 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "4"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24976462 24976577 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "5"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24977900 24978103 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "6"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24978925 24979119 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "7"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24979404 24979523 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "8"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24981346 24981614 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "9"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24987210 24987290 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "10"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24987801 24987887 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "11"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24989151 24989295 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "12"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24989674 24989715 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "13"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24993306 24993416 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "14"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24995614 24996078 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000560"; exon_number "15"; gene_name "SRRM1"; oId "uc009vrh.1"; nearest_ref "uc009vrh.1"; class_code "="; tss_id "TSS305"; p_id "P426"; chr1 coding exon 24975252 24975520 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "1"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24976462 24976577 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "2"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24977900 24978103 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "3"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24978925 24979119 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "4"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24979404 24979523 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "5"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24981346 24981614 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "6"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24987210 24987290 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "7"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24987801 24987887 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "8"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24989151 24989295 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "9"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24989674 24989715 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "10"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24993306 24993416 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "11"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24995614 24996078 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "12"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24996611 24996806 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "13"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 coding exon 24997877 24998086 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000561"; exon_number "14"; gene_name "SRRM1"; oId "uc009vri.1"; nearest_ref "uc009vri.1"; class_code "="; tss_id "TSS306"; p_id "P428"; chr1 nearCoding exon 24975350 24975520 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "1"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24976462 24976577 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "2"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24977990 24978103 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "3"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24978925 24979119 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "4"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24979404 24979523 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "5"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24980797 24980834 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "6"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24981346 24981614 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "7"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24987210 24987290 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "8"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24987801 24987887 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "9"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24989151 24989295 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "10"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24989674 24989715 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "11"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 nearCoding exon 24993306 24993416 . + . gene_id "XLOC_000202"; transcript_id "TCONS_00000562"; exon_number "12"; oId "uc010oem.1"; nearest_ref "uc010oem.1"; class_code "="; tss_id "TSS306"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003803"; exon_number "1"; oId "uc009vis.2"; nearest_ref "uc009vis.2"; class_code "="; tss_id "TSS1906"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003803"; exon_number "2"; oId "uc009vis.2"; nearest_ref "uc009vis.2"; class_code "="; tss_id "TSS1906"; chr1 antisense exon 15796 15942 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003803"; exon_number "3"; oId "uc009vis.2"; nearest_ref "uc009vis.2"; class_code "="; tss_id "TSS1906"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003803"; exon_number "4"; oId "uc009vis.2"; nearest_ref "uc009vis.2"; class_code "="; tss_id "TSS1906"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "1"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "2"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "3"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "4"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "5"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17233 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "6"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "7"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18268 18369 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "8"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18501 18554 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "9"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18913 19759 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003806"; exon_number "10"; oId "uc009viu.2"; nearest_ref "uc009viu.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "1"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "2"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "3"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "4"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "5"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17233 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "6"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "7"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "8"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18913 19759 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003805"; exon_number "9"; oId "uc009vit.2"; nearest_ref "uc009vit.2"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "1"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "2"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "3"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "4"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "5"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "6"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "7"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "8"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "9"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 18913 19759 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003804"; exon_number "10"; oId "uc001aae.3"; nearest_ref "uc001aae.3"; class_code "="; tss_id "TSS1907"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "1"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "2"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "3"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "4"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 16854 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "5"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "6"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "7"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "8"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 18268 18379 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "9"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 24738 24901 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003807"; exon_number "10"; oId "uc001aab.3"; nearest_ref "uc001aab.3"; class_code "="; tss_id "TSS1908"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "1"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "2"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "3"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "4"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "5"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17233 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "6"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "7"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "8"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "9"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003811"; exon_number "10"; oId "uc009vir.2"; nearest_ref "uc009vir.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "1"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "2"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "3"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "4"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17606 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "5"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "6"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003810"; exon_number "7"; oId "uc009viq.2"; nearest_ref "uc009viq.2"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "1"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "2"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "3"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "4"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "5"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "6"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "7"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "8"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "9"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "10"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003809"; exon_number "11"; oId "uc001aah.3"; nearest_ref "uc001aah.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 14363 14829 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "1"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 14970 15038 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "2"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "3"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "4"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "5"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17259 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "6"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "7"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "8"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 18268 18369 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "9"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "10"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 antisense exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003808"; exon_number "11"; oId "uc001aac.3"; nearest_ref "uc001aac.3"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 14407 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "1"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "2"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17233 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "3"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "4"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "5"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "6"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003813"; exon_number "7"; oId "uc009viw.2"; nearest_ref "uc009viw.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 14407 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "1"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "2"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "3"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "4"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "5"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "6"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003812"; exon_number "7"; oId "uc009viv.2"; nearest_ref "uc009viv.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 15603 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "1"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "2"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "3"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "4"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "5"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "6"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003814"; exon_number "7"; oId "uc009vix.2"; nearest_ref "uc009vix.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 15796 15947 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003815"; exon_number "1"; oId "uc009vjd.2"; nearest_ref "uc009vjd.2"; class_code "="; tss_id "TSS1910"; chr1 noncoding exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003815"; exon_number "2"; oId "uc009vjd.2"; nearest_ref "uc009vjd.2"; class_code "="; tss_id "TSS1910"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003815"; exon_number "3"; oId "uc009vjd.2"; nearest_ref "uc009vjd.2"; class_code "="; tss_id "TSS1910"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003815"; exon_number "4"; oId "uc009vjd.2"; nearest_ref "uc009vjd.2"; class_code "="; tss_id "TSS1910"; chr1 noncoding exon 17606 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003815"; exon_number "5"; oId "uc009vjd.2"; nearest_ref "uc009vjd.2"; class_code "="; tss_id "TSS1910"; chr1 noncoding exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "1"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16854 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "2"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "3"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "4"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "5"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18268 18379 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "6"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "7"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003817"; exon_number "8"; oId "uc009viz.2"; nearest_ref "uc009viz.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16607 16765 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "1"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "2"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "3"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "4"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "5"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18268 18362 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "6"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18497 18554 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "7"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "8"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003816"; exon_number "9"; oId "uc009viy.2"; nearest_ref "uc009viy.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003818"; exon_number "1"; oId "uc009vjc.1"; nearest_ref "uc009vjc.1"; class_code "="; tss_id "TSS1911"; chr1 noncoding exon 17233 17751 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003818"; exon_number "2"; oId "uc009vjc.1"; nearest_ref "uc009vjc.1"; class_code "="; tss_id "TSS1911"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003819"; exon_number "1"; oId "uc001aai.1"; nearest_ref "uc001aai.1"; class_code "="; tss_id "TSS1907"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003819"; exon_number "2"; oId "uc001aai.1"; nearest_ref "uc001aai.1"; class_code "="; tss_id "TSS1907"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003819"; exon_number "3"; oId "uc001aai.1"; nearest_ref "uc001aai.1"; class_code "="; tss_id "TSS1907"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003819"; exon_number "4"; oId "uc001aai.1"; nearest_ref "uc001aai.1"; class_code "="; tss_id "TSS1907"; chr1 noncoding exon 18268 18379 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003819"; exon_number "5"; oId "uc001aai.1"; nearest_ref "uc001aai.1"; class_code "="; tss_id "TSS1907"; chr1 noncoding exon 18913 19759 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003819"; exon_number "6"; oId "uc001aai.1"; nearest_ref "uc001aai.1"; class_code "="; tss_id "TSS1907"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "1"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "2"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "3"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "4"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "5"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18913 19139 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "6"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "7"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003820"; exon_number "8"; oId "uc010nxs.1"; nearest_ref "uc010nxs.1"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 16858 17055 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "1"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 17233 17368 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "2"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "3"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "4"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 18268 18379 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "5"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "6"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 29824 29961 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003821"; exon_number "7"; oId "uc009vjb.1"; nearest_ref "uc009vjb.1"; class_code "="; tss_id "TSS1912"; chr1 noncoding exon 17233 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003822"; exon_number "1"; oId "uc009vje.2"; nearest_ref "uc009vje.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003822"; exon_number "2"; oId "uc009vje.2"; nearest_ref "uc009vje.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18268 18366 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003822"; exon_number "3"; oId "uc009vje.2"; nearest_ref "uc009vje.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003822"; exon_number "4"; oId "uc009vje.2"; nearest_ref "uc009vje.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17606 17742 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "1"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 17915 18061 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "2"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18268 18362 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "3"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18497 18554 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "4"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 18913 19139 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "5"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 24738 24891 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "6"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 29321 29370 . - . gene_id "XLOC_001217"; transcript_id "TCONS_00003823"; exon_number "7"; oId "uc009vjf.2"; nearest_ref "uc009vjf.2"; class_code "="; tss_id "TSS1909"; chr1 noncoding exon 34612 35174 . - . gene_id "XLOC_001218"; transcript_id "TCONS_00003824"; exon_number "1"; oId "uc001aak.2"; nearest_ref "uc001aak.2"; class_code "="; tss_id "TSS1913"; chr1 noncoding exon 35277 35481 . - . gene_id "XLOC_001218"; transcript_id "TCONS_00003824"; exon_number "2"; oId "uc001aak.2"; nearest_ref "uc001aak.2"; class_code "="; tss_id "TSS1913"; chr1 noncoding exon 35721 36081 . - . gene_id "XLOC_001218"; transcript_id "TCONS_00003824"; exon_number "3"; oId "uc001aak.2"; nearest_ref "uc001aak.2"; class_code "="; tss_id "TSS1913"; chr1 noncoding exon 89295 90404 . - . gene_id "XLOC_001219"; transcript_id "TCONS_00003825"; exon_number "1"; oId "uc010nxt.1"; nearest_ref "uc010nxt.1"; class_code "="; tss_id "TSS1914"; chr1 noncoding exon 236615 237877 . - . gene_id "XLOC_001219"; transcript_id "TCONS_00003825"; exon_number "2"; oId "uc010nxt.1"; nearest_ref "uc010nxt.1"; class_code "="; tss_id "TSS1914"; chr1 noncoding exon 137839 139228 . - . gene_id "XLOC_001220"; transcript_id "TCONS_00003826"; exon_number "1"; oId "uc001aam.3"; nearest_ref "uc001aam.3"; class_code "="; chr1 coding exon 621098 622034 . - . gene_id "XLOC_001221"; transcript_id "TCONS_00003827"; exon_number "1"; gene_name "OR4F16"; oId "uc010nxv.1"; nearest_ref "uc010nxv.1"; class_code "="; p_id "P2881"; chr1 coding exon 661140 665184 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003828"; exon_number "1"; oId "uc001abe.3"; nearest_ref "uc001abe.3"; class_code "="; tss_id "TSS1915"; p_id "P2882"; chr1 coding exon 665278 665335 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003828"; exon_number "2"; oId "uc001abe.3"; nearest_ref "uc001abe.3"; class_code "="; tss_id "TSS1915"; p_id "P2882"; chr1 coding exon 665563 665731 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003828"; exon_number "3"; oId "uc001abe.3"; nearest_ref "uc001abe.3"; class_code "="; tss_id "TSS1915"; p_id "P2882"; chr1 coding exon 661140 665184 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003829"; exon_number "1"; oId "uc009vjm.2"; nearest_ref "uc009vjm.2"; class_code "="; tss_id "TSS1916"; p_id "P2882"; chr1 coding exon 668687 668744 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003829"; exon_number "2"; oId "uc009vjm.2"; nearest_ref "uc009vjm.2"; class_code "="; tss_id "TSS1916"; p_id "P2882"; chr1 coding exon 670803 670994 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003829"; exon_number "3"; oId "uc009vjm.2"; nearest_ref "uc009vjm.2"; class_code "="; tss_id "TSS1916"; p_id "P2882"; chr1 nearCoding exon 661140 665184 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "1"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 nearCoding exon 665278 665335 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "2"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 nearCoding exon 667397 667587 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "3"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 nearCoding exon 675183 675415 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "4"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 nearCoding exon 675509 675566 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "5"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 nearCoding exon 678666 678730 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "6"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 nearCoding exon 679575 679736 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003830"; exon_number "7"; oId "uc002khh.2"; nearest_ref "uc002khh.2"; class_code "="; tss_id "TSS1917"; chr1 noncoding exon 674240 674404 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003835"; exon_number "1"; oId "uc001abm.2"; nearest_ref "uc001abm.2"; class_code "="; tss_id "TSS1917"; chr1 noncoding exon 675183 675415 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003835"; exon_number "2"; oId "uc001abm.2"; nearest_ref "uc001abm.2"; class_code "="; tss_id "TSS1917"; chr1 noncoding exon 675509 675566 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003835"; exon_number "3"; oId "uc001abm.2"; nearest_ref "uc001abm.2"; class_code "="; tss_id "TSS1917"; chr1 noncoding exon 678666 678730 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003835"; exon_number "4"; oId "uc001abm.2"; nearest_ref "uc001abm.2"; class_code "="; tss_id "TSS1917"; chr1 noncoding exon 679575 679736 . - . gene_id "XLOC_001222"; transcript_id "TCONS_00003835"; exon_number "5"; oId "uc001abm.2"; nearest_ref "uc001abm.2"; class_code "="; tss_id "TSS1917"; chr1 noncoding exon 668402 668479 . - . gene_id "XLOC_001223"; transcript_id "TCONS_00003831"; exon_number "1"; oId "uc001abi.1"; nearest_ref "uc001abi.1"; class_code "="; chr1 noncoding exon 668511 668541 . - . gene_id "XLOC_001224"; transcript_id "TCONS_00003832"; exon_number "1"; oId "uc001abj.2"; nearest_ref "uc001abj.2"; class_code "="; chr1 noncoding exon 671808 671885 . - . gene_id "XLOC_001225"; transcript_id "TCONS_00003833"; exon_number "1"; oId "uc010nxw.1"; nearest_ref "uc010nxw.1"; class_code "="; chr1 noncoding exon 671917 671947 . - . gene_id "XLOC_001226"; transcript_id "TCONS_00003834"; exon_number "1"; oId "uc001abl.2"; nearest_ref "uc001abl.2"; class_code "="; chr1 noncoding exon 700237 700627 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "1"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 noncoding exon 701709 701767 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "2"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 noncoding exon 703928 703993 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "3"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 noncoding exon 704877 705092 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "4"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 noncoding exon 708356 708487 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "5"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 noncoding exon 709551 709660 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "6"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 noncoding exon 713664 714006 . - . gene_id "XLOC_001227"; transcript_id "TCONS_00003836"; exon_number "7"; oId "uc001abo.2"; nearest_ref "uc001abo.2"; class_code "="; tss_id "TSS1918"; chr1 coding exon 761587 762902 . - . gene_id "XLOC_001228"; transcript_id "TCONS_00003837"; exon_number "1"; oId "uc010nxx.1"; nearest_ref "uc010nxx.1"; class_code "="; p_id "P2883"; chr1 noncoding exon 803453 804055 . - . gene_id "XLOC_001229"; transcript_id "TCONS_00003838"; exon_number "1"; gene_name "FAM41C"; oId "uc001abt.3"; nearest_ref "uc001abt.3"; class_code "="; tss_id "TSS1919"; chr1 noncoding exon 809492 810535 . - . gene_id "XLOC_001229"; transcript_id "TCONS_00003838"; exon_number "2"; gene_name "FAM41C"; oId "uc001abt.3"; nearest_ref "uc001abt.3"; class_code "="; tss_id "TSS1919"; chr1 noncoding exon 812126 812182 . - . gene_id "XLOC_001229"; transcript_id "TCONS_00003838"; exon_number "3"; gene_name "FAM41C"; oId "uc001abt.3"; nearest_ref "uc001abt.3"; class_code "="; tss_id "TSS1919"; chr1 noncoding exon 852953 853100 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003840"; exon_number "1"; oId "uc010nxz.1"; nearest_ref "uc010nxz.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 853402 853495 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003840"; exon_number "2"; oId "uc010nxz.1"; nearest_ref "uc010nxz.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 854205 854295 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003840"; exon_number "3"; oId "uc010nxz.1"; nearest_ref "uc010nxz.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 854715 854817 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003840"; exon_number "4"; oId "uc010nxz.1"; nearest_ref "uc010nxz.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 852953 853100 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003839"; exon_number "1"; oId "uc010nxy.1"; nearest_ref "uc010nxy.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 853402 853555 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003839"; exon_number "2"; oId "uc010nxy.1"; nearest_ref "uc010nxy.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 854205 854295 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003839"; exon_number "3"; oId "uc010nxy.1"; nearest_ref "uc010nxy.1"; class_code "="; tss_id "TSS1920"; chr1 noncoding exon 854715 854817 . - . gene_id "XLOC_001230"; transcript_id "TCONS_00003839"; exon_number "4"; oId "uc010nxy.1"; nearest_ref "uc010nxy.1"; class_code "="; tss_id "TSS1920"; chr1 coding exon 879584 880180 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "1"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 880422 880526 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "2"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 880898 881033 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "3"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 881553 881666 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "4"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 881782 881925 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "5"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 883511 883612 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "6"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 883870 883983 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "7"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 886507 886618 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "8"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 887380 887519 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "9"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 887792 887980 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "10"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 888555 888668 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "11"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 889162 889272 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "12"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 889384 889903 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "13"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 891303 891393 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "14"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 891475 891595 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "15"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 892274 892405 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "16"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 892479 893918 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003841"; exon_number "17"; gene_name "NOC2L"; oId "uc001aby.3"; nearest_ref "uc001aby.3"; class_code "="; tss_id "TSS1921"; p_id "P2887"; chr1 coding exon 879584 880180 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "1"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 880422 880526 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "2"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 880898 881033 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "3"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 881553 881666 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "4"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 881782 881925 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "5"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 883511 883612 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "6"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 883870 883983 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "7"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 886507 886618 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "8"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 887380 887519 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "9"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 887792 887980 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "10"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 888555 888668 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "11"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 889162 889272 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "12"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 889384 889462 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "13"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 891303 891393 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "14"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 891475 891595 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "15"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 892274 892405 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "16"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 892479 892653 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "17"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 894309 894461 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "18"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 894595 894679 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003843"; exon_number "19"; gene_name "NOC2L"; oId "uc009vjq.2"; nearest_ref "uc009vjq.2"; class_code "="; tss_id "TSS1922"; p_id "P2886"; chr1 coding exon 879584 880180 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "1"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 880437 880526 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "2"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 880898 881033 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "3"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 881553 881666 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "4"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 881782 881925 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "5"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 883511 883612 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "6"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 883870 883983 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "7"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 886507 886618 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "8"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 887380 887519 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "9"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 887792 887980 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "10"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 888555 888668 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "11"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 889162 889272 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "12"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 889384 889462 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "13"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 891303 891393 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "14"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 891475 891595 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "15"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 892274 892405 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "16"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 892479 892653 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "17"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 894309 894461 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "18"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 894595 894679 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003842"; exon_number "19"; gene_name "NOC2L"; oId "uc001abz.3"; nearest_ref "uc001abz.3"; class_code "="; tss_id "TSS1922"; p_id "P2885"; chr1 coding exon 893651 894461 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003844"; exon_number "1"; gene_name "NOC2L"; oId "uc009vjr.1"; nearest_ref "uc009vjr.1"; class_code "="; tss_id "TSS1922"; p_id "P2884"; chr1 coding exon 894595 894679 . - . gene_id "XLOC_001231"; transcript_id "TCONS_00003844"; exon_number "2"; gene_name "NOC2L"; oId "uc009vjr.1"; nearest_ref "uc009vjr.1"; class_code "="; tss_id "TSS1922"; p_id "P2884"; chr1 nearCoding exon 910579 911649 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003845"; exon_number "1"; gene_name "C1orf170"; oId "uc001acg.2"; nearest_ref "uc001acg.2"; class_code "="; tss_id "TSS1923"; chr1 nearCoding exon 911879 912021 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003845"; exon_number "2"; gene_name "C1orf170"; oId "uc001acg.2"; nearest_ref "uc001acg.2"; class_code "="; tss_id "TSS1923"; chr1 coding exon 910579 911649 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003846"; exon_number "1"; gene_name "C1orf170"; oId "uc001ach.2"; nearest_ref "uc001ach.2"; class_code "="; tss_id "TSS1924"; p_id "P2888"; chr1 coding exon 911879 912004 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003846"; exon_number "2"; gene_name "C1orf170"; oId "uc001ach.2"; nearest_ref "uc001ach.2"; class_code "="; tss_id "TSS1924"; p_id "P2888"; chr1 coding exon 914261 916037 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003846"; exon_number "3"; gene_name "C1orf170"; oId "uc001ach.2"; nearest_ref "uc001ach.2"; class_code "="; tss_id "TSS1924"; p_id "P2888"; chr1 coding exon 916517 916553 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003846"; exon_number "4"; gene_name "C1orf170"; oId "uc001ach.2"; nearest_ref "uc001ach.2"; class_code "="; tss_id "TSS1924"; p_id "P2888"; chr1 coding exon 917445 917473 . - . gene_id "XLOC_001232"; transcript_id "TCONS_00003846"; exon_number "5"; gene_name "C1orf170"; oId "uc001ach.2"; nearest_ref "uc001ach.2"; class_code "="; tss_id "TSS1924"; p_id "P2888"; chr1 coding exon 934342 934812 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003848"; exon_number "1"; gene_name "HES4"; oId "uc010nyc.1"; nearest_ref "uc010nyc.1"; class_code "="; tss_id "TSS1925"; p_id "P2890"; chr1 coding exon 934906 934993 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003848"; exon_number "2"; gene_name "HES4"; oId "uc010nyc.1"; nearest_ref "uc010nyc.1"; class_code "="; tss_id "TSS1925"; p_id "P2890"; chr1 coding exon 935072 935552 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003848"; exon_number "3"; gene_name "HES4"; oId "uc010nyc.1"; nearest_ref "uc010nyc.1"; class_code "="; tss_id "TSS1925"; p_id "P2890"; chr1 coding exon 934342 934812 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003847"; exon_number "1"; gene_name "HES4"; oId "uc001aci.2"; nearest_ref "uc001aci.2"; class_code "="; tss_id "TSS1925"; p_id "P2889"; chr1 coding exon 934906 934993 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003847"; exon_number "2"; gene_name "HES4"; oId "uc001aci.2"; nearest_ref "uc001aci.2"; class_code "="; tss_id "TSS1925"; p_id "P2889"; chr1 coding exon 935072 935167 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003847"; exon_number "3"; gene_name "HES4"; oId "uc001aci.2"; nearest_ref "uc001aci.2"; class_code "="; tss_id "TSS1925"; p_id "P2889"; chr1 coding exon 935246 935552 . - . gene_id "XLOC_001233"; transcript_id "TCONS_00003847"; exon_number "4"; gene_name "HES4"; oId "uc001aci.2"; nearest_ref "uc001aci.2"; class_code "="; tss_id "TSS1925"; p_id "P2889"; chr1 nearCoding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "1"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1019295 1019466 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "2"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1019733 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "3"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "4"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "5"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "6"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1022878 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "7"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "8"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 nearCoding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003849"; exon_number "9"; oId "uc010nyd.1"; nearest_ref "uc010nyd.1"; class_code "="; tss_id "TSS1926"; chr1 coding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "1"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1019733 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "2"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "3"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "4"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "5"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "6"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "7"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003851"; exon_number "8"; gene_name "C1orf159"; oId "uc009vju.1"; nearest_ref "uc009vju.1"; class_code "="; tss_id "TSS1927"; p_id "P2894"; chr1 coding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "1"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "2"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "3"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "4"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "5"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "6"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003850"; exon_number "7"; gene_name "C1orf159"; oId "uc001acm.2"; nearest_ref "uc001acm.2"; class_code "="; tss_id "TSS1927"; p_id "P2895"; chr1 coding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "1"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1019295 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "2"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "3"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "4"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "5"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "6"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "7"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1026852 1027554 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003852"; exon_number "8"; gene_name "C1orf159"; oId "uc001acn.2"; nearest_ref "uc001acn.2"; class_code "="; tss_id "TSS1927"; p_id "P2893"; chr1 coding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "1"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1019733 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "2"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "3"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "4"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "5"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "6"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "7"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "8"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "9"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1041336 1041507 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003853"; exon_number "10"; gene_name "C1orf159"; oId "uc001acp.2"; nearest_ref "uc001acp.2"; class_code "="; tss_id "TSS1928"; p_id "P2892"; chr1 coding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "1"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1019733 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "2"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "3"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "4"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "5"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "6"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "7"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "8"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "9"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1051440 1051736 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003857"; exon_number "10"; gene_name "C1orf159"; oId "uc001acu.2"; nearest_ref "uc001acu.2"; class_code "="; tss_id "TSS1929"; p_id "P2892"; chr1 coding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "1"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1019295 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "2"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "3"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "4"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "5"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "6"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "7"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1026256 1026363 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "8"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "9"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "10"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1050402 1050455 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "11"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 coding exon 1051440 1051736 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003856"; exon_number "12"; gene_name "C1orf159"; oId "uc001act.2"; nearest_ref "uc001act.2"; class_code "="; tss_id "TSS1929"; p_id "P2891"; chr1 nearCoding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "1"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1019295 1019466 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "2"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1019733 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "3"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "4"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "5"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "6"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "7"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "8"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "9"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "10"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1051440 1051736 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003855"; exon_number "11"; oId "uc001acs.2"; nearest_ref "uc001acs.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1017198 1018367 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "1"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1019295 1019466 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "2"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1019733 1019763 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "3"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1019861 1019886 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "4"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1021258 1021392 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "5"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1022519 1022584 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "6"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1022882 1022977 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "7"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1025733 1025808 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "8"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1026658 1026754 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "9"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1026852 1026945 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "10"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1027371 1027483 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "11"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 nearCoding exon 1051440 1051736 . - . gene_id "XLOC_001234"; transcript_id "TCONS_00003854"; exon_number "12"; oId "uc001acr.2"; nearest_ref "uc001acr.2"; class_code "="; tss_id "TSS1929"; chr1 coding exon 1108436 1111776 . - . gene_id "XLOC_001235"; transcript_id "TCONS_00003858"; exon_number "1"; oId "uc001acx.1"; nearest_ref "uc001acx.1"; class_code "="; tss_id "TSS1930"; p_id "P2896"; chr1 coding exon 1114745 1114935 . - . gene_id "XLOC_001235"; transcript_id "TCONS_00003858"; exon_number "2"; oId "uc001acx.1"; nearest_ref "uc001acx.1"; class_code "="; tss_id "TSS1930"; p_id "P2896"; chr1 coding exon 1138889 1139348 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003859"; exon_number "1"; gene_name "TNFRSF18"; oId "uc001ada.2"; nearest_ref "uc001ada.2"; class_code "="; tss_id "TSS1931"; p_id "P2900"; chr1 coding exon 1139414 1139616 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003859"; exon_number "2"; gene_name "TNFRSF18"; oId "uc001ada.2"; nearest_ref "uc001ada.2"; class_code "="; tss_id "TSS1931"; p_id "P2900"; chr1 coding exon 1139779 1139866 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003859"; exon_number "3"; gene_name "TNFRSF18"; oId "uc001ada.2"; nearest_ref "uc001ada.2"; class_code "="; tss_id "TSS1931"; p_id "P2900"; chr1 coding exon 1140750 1141060 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003859"; exon_number "4"; gene_name "TNFRSF18"; oId "uc001ada.2"; nearest_ref "uc001ada.2"; class_code "="; tss_id "TSS1931"; p_id "P2900"; chr1 coding exon 1138889 1139340 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003862"; exon_number "1"; gene_name "TNFRSF18"; oId "uc001add.2"; nearest_ref "uc001add.2"; class_code "="; tss_id "TSS1932"; p_id "P2899"; chr1 coding exon 1139779 1139866 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003862"; exon_number "2"; gene_name "TNFRSF18"; oId "uc001add.2"; nearest_ref "uc001add.2"; class_code "="; tss_id "TSS1932"; p_id "P2899"; chr1 coding exon 1140750 1140872 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003862"; exon_number "3"; gene_name "TNFRSF18"; oId "uc001add.2"; nearest_ref "uc001add.2"; class_code "="; tss_id "TSS1932"; p_id "P2899"; chr1 coding exon 1141765 1142089 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003862"; exon_number "4"; gene_name "TNFRSF18"; oId "uc001add.2"; nearest_ref "uc001add.2"; class_code "="; tss_id "TSS1932"; p_id "P2899"; chr1 coding exon 1138889 1139348 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003861"; exon_number "1"; gene_name "TNFRSF18"; oId "uc001adc.2"; nearest_ref "uc001adc.2"; class_code "="; tss_id "TSS1932"; p_id "P2898"; chr1 coding exon 1139414 1139616 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003861"; exon_number "2"; gene_name "TNFRSF18"; oId "uc001adc.2"; nearest_ref "uc001adc.2"; class_code "="; tss_id "TSS1932"; p_id "P2898"; chr1 coding exon 1139779 1139866 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003861"; exon_number "3"; gene_name "TNFRSF18"; oId "uc001adc.2"; nearest_ref "uc001adc.2"; class_code "="; tss_id "TSS1932"; p_id "P2898"; chr1 coding exon 1140750 1140872 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003861"; exon_number "4"; gene_name "TNFRSF18"; oId "uc001adc.2"; nearest_ref "uc001adc.2"; class_code "="; tss_id "TSS1932"; p_id "P2898"; chr1 coding exon 1141765 1142089 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003861"; exon_number "5"; gene_name "TNFRSF18"; oId "uc001adc.2"; nearest_ref "uc001adc.2"; class_code "="; tss_id "TSS1932"; p_id "P2898"; chr1 coding exon 1138889 1139348 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003860"; exon_number "1"; gene_name "TNFRSF18"; oId "uc001adb.2"; nearest_ref "uc001adb.2"; class_code "="; tss_id "TSS1932"; p_id "P2897"; chr1 coding exon 1139435 1139616 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003860"; exon_number "2"; gene_name "TNFRSF18"; oId "uc001adb.2"; nearest_ref "uc001adb.2"; class_code "="; tss_id "TSS1932"; p_id "P2897"; chr1 coding exon 1139779 1139866 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003860"; exon_number "3"; gene_name "TNFRSF18"; oId "uc001adb.2"; nearest_ref "uc001adb.2"; class_code "="; tss_id "TSS1932"; p_id "P2897"; chr1 coding exon 1140750 1140872 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003860"; exon_number "4"; gene_name "TNFRSF18"; oId "uc001adb.2"; nearest_ref "uc001adb.2"; class_code "="; tss_id "TSS1932"; p_id "P2897"; chr1 coding exon 1141765 1142089 . - . gene_id "XLOC_001236"; transcript_id "TCONS_00003860"; exon_number "5"; gene_name "TNFRSF18"; oId "uc001adb.2"; nearest_ref "uc001adb.2"; class_code "="; tss_id "TSS1932"; p_id "P2897"; chr1 coding exon 1146707 1147005 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "1"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1147084 1147212 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "2"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1147322 1147518 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "3"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1148018 1148084 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "4"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1148372 1148473 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "5"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1149043 1149165 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "6"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1149363 1149512 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003863"; exon_number "7"; gene_name "TNFRSF4"; oId "uc001ade.2"; nearest_ref "uc001ade.2"; class_code "="; tss_id "TSS1933"; p_id "P2902"; chr1 coding exon 1146721 1147212 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003864"; exon_number "1"; gene_name "TNFRSF4"; oId "uc001adf.2"; nearest_ref "uc001adf.2"; class_code "="; tss_id "TSS1933"; p_id "P2901"; chr1 coding exon 1147322 1147518 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003864"; exon_number "2"; gene_name "TNFRSF4"; oId "uc001adf.2"; nearest_ref "uc001adf.2"; class_code "="; tss_id "TSS1933"; p_id "P2901"; chr1 coding exon 1148018 1148084 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003864"; exon_number "3"; gene_name "TNFRSF4"; oId "uc001adf.2"; nearest_ref "uc001adf.2"; class_code "="; tss_id "TSS1933"; p_id "P2901"; chr1 coding exon 1148372 1149165 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003864"; exon_number "4"; gene_name "TNFRSF4"; oId "uc001adf.2"; nearest_ref "uc001adf.2"; class_code "="; tss_id "TSS1933"; p_id "P2901"; chr1 coding exon 1149363 1149512 . - . gene_id "XLOC_001237"; transcript_id "TCONS_00003864"; exon_number "5"; gene_name "TNFRSF4"; oId "uc001adf.2"; nearest_ref "uc001adf.2"; class_code "="; tss_id "TSS1933"; p_id "P2901"; chr1 nearCoding exon 1152289 1153068 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003865"; exon_number "1"; gene_name "SDF4"; oId "uc001adg.2"; nearest_ref "uc001adg.2"; class_code "="; tss_id "TSS1934"; chr1 nearCoding exon 1153838 1154013 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003865"; exon_number "2"; gene_name "SDF4"; oId "uc001adg.2"; nearest_ref "uc001adg.2"; class_code "="; tss_id "TSS1934"; chr1 nearCoding exon 1154149 1156731 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003865"; exon_number "3"; gene_name "SDF4"; oId "uc001adg.2"; nearest_ref "uc001adg.2"; class_code "="; tss_id "TSS1934"; chr1 nearCoding exon 1152289 1153184 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "1"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 nearCoding exon 1153838 1154013 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "2"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 nearCoding exon 1154149 1154323 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "3"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 nearCoding exon 1158624 1158737 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "4"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 nearCoding exon 1159212 1159348 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "5"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 nearCoding exon 1163848 1164326 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "6"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 nearCoding exon 1167272 1167447 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003869"; exon_number "7"; gene_name "SDF4"; oId "uc009vjw.2"; nearest_ref "uc009vjw.2"; class_code "="; tss_id "TSS1935"; chr1 coding exon 1152289 1153068 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003868"; exon_number "1"; gene_name "SDF4"; oId "uc009vjv.2"; nearest_ref "uc009vjv.2"; class_code "="; tss_id "TSS1935"; p_id "P2904"; chr1 coding exon 1153838 1154013 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003868"; exon_number "2"; gene_name "SDF4"; oId "uc009vjv.2"; nearest_ref "uc009vjv.2"; class_code "="; tss_id "TSS1935"; p_id "P2904"; chr1 coding exon 1154149 1154307 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003868"; exon_number "3"; gene_name "SDF4"; oId "uc009vjv.2"; nearest_ref "uc009vjv.2"; class_code "="; tss_id "TSS1935"; p_id "P2904"; chr1 coding exon 1158624 1158737 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003868"; exon_number "4"; gene_name "SDF4"; oId "uc009vjv.2"; nearest_ref "uc009vjv.2"; class_code "="; tss_id "TSS1935"; p_id "P2904"; chr1 coding exon 1159212 1159348 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003868"; exon_number "5"; gene_name "SDF4"; oId "uc009vjv.2"; nearest_ref "uc009vjv.2"; class_code "="; tss_id "TSS1935"; p_id "P2904"; chr1 coding exon 1167272 1167447 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003868"; exon_number "6"; gene_name "SDF4"; oId "uc009vjv.2"; nearest_ref "uc009vjv.2"; class_code "="; tss_id "TSS1935"; p_id "P2904"; chr1 coding exon 1152289 1153184 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "1"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1153838 1154013 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "2"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1154149 1154307 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "3"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1158624 1158737 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "4"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1159212 1159348 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "5"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1163848 1164326 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "6"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1167272 1167447 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003867"; exon_number "7"; gene_name "SDF4"; oId "uc001adi.3"; nearest_ref "uc001adi.3"; class_code "="; tss_id "TSS1935"; p_id "P2903"; chr1 coding exon 1152289 1153068 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "1"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1153838 1154013 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "2"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1154149 1154307 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "3"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1158624 1158737 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "4"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1159212 1159348 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "5"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1163848 1164326 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "6"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1167272 1167447 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003866"; exon_number "7"; gene_name "SDF4"; oId "uc001adh.3"; nearest_ref "uc001adh.3"; class_code "="; tss_id "TSS1935"; p_id "P2906"; chr1 coding exon 1158104 1158737 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003870"; exon_number "1"; gene_name "SDF4"; oId "uc001adj.1"; nearest_ref "uc001adj.1"; class_code "="; tss_id "TSS1936"; p_id "P2905"; chr1 coding exon 1159212 1159348 . - . gene_id "XLOC_001238"; transcript_id "TCONS_00003870"; exon_number "2"; gene_name "SDF4"; oId "uc001adj.1"; nearest_ref "uc001adj.1"; class_code "="; tss_id "TSS1936"; p_id "P2905"; chr1 coding exon 1177833 1178026 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "1"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1178215 1178293 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "2"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1178442 1178532 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "3"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1178824 1178932 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "4"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1179334 1179485 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "5"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1179571 1179655 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "6"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1179761 1179877 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "7"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1181894 1182102 . - . gene_id "XLOC_001239"; transcript_id "TCONS_00003871"; exon_number "8"; gene_name "FAM132A"; oId "uc001adl.1"; nearest_ref "uc001adl.1"; class_code "="; tss_id "TSS1937"; p_id "P2907"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "1"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "2"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "3"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "4"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "5"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1201478 1201670 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "6"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1203242 1203372 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003872"; exon_number "7"; gene_name "UBE2J2"; oId "uc001adm.2"; nearest_ref "uc001adm.2"; class_code "="; tss_id "TSS1938"; p_id "P2911"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "1"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "2"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "3"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "4"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "5"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1203242 1203372 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "6"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1208879 1209188 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003873"; exon_number "7"; gene_name "UBE2J2"; oId "uc001adn.2"; nearest_ref "uc001adn.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "1"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "2"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "3"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "4"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1197649 1197770 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "5"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "6"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1203242 1203372 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "7"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1209046 1209234 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003878"; exon_number "8"; gene_name "UBE2J2"; oId "uc001ads.2"; nearest_ref "uc001ads.2"; class_code "="; tss_id "TSS1939"; p_id "P2908"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003877"; exon_number "1"; gene_name "UBE2J2"; oId "uc001adr.2"; nearest_ref "uc001adr.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003877"; exon_number "2"; gene_name "UBE2J2"; oId "uc001adr.2"; nearest_ref "uc001adr.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003877"; exon_number "3"; gene_name "UBE2J2"; oId "uc001adr.2"; nearest_ref "uc001adr.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003877"; exon_number "4"; gene_name "UBE2J2"; oId "uc001adr.2"; nearest_ref "uc001adr.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003877"; exon_number "5"; gene_name "UBE2J2"; oId "uc001adr.2"; nearest_ref "uc001adr.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1209046 1209234 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003877"; exon_number "6"; gene_name "UBE2J2"; oId "uc001adr.2"; nearest_ref "uc001adr.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "1"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "2"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "3"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "4"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "5"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1203113 1203372 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "6"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1209046 1209234 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003876"; exon_number "7"; gene_name "UBE2J2"; oId "uc001adq.2"; nearest_ref "uc001adq.2"; class_code "="; tss_id "TSS1939"; p_id "P2909"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "1"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "2"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "3"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "4"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "5"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1203242 1203372 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "6"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1209046 1209234 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003875"; exon_number "7"; gene_name "UBE2J2"; oId "uc001adp.2"; nearest_ref "uc001adp.2"; class_code "="; tss_id "TSS1939"; p_id "P2910"; chr1 coding exon 1189294 1190867 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "1"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1191425 1191505 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "2"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1192372 1192510 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "3"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1192588 1192690 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "4"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1198726 1198766 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "5"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1200163 1200210 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "6"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1203242 1203372 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "7"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1209046 1209234 . - . gene_id "XLOC_001240"; transcript_id "TCONS_00003874"; exon_number "8"; gene_name "UBE2J2"; oId "uc001ado.2"; nearest_ref "uc001ado.2"; class_code "="; tss_id "TSS1939"; p_id "P2912"; chr1 coding exon 1193438 1196954 . - . gene_id "XLOC_001241"; transcript_id "TCONS_00003879"; exon_number "1"; oId "uc010nyh.1"; nearest_ref "uc010nyh.1"; class_code "="; p_id "P2913"; chr1 coding exon 1227764 1229088 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "1"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1229203 1229313 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "2"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1229470 1229579 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "3"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1229782 1230008 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "4"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1230098 1230196 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "5"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1230827 1230934 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "6"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1231116 1231318 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "7"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1231395 1231489 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "8"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1231591 1231660 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "9"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1231805 1232013 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "10"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1233202 1233313 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "11"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1233393 1233493 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "12"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1233750 1233801 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "13"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1233947 1234335 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003880"; exon_number "14"; gene_name "ACAP3"; oId "uc001ady.2"; nearest_ref "uc001ady.2"; class_code "="; tss_id "TSS1940"; p_id "P2915"; chr1 coding exon 1227764 1229088 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "1"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1229203 1229313 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "2"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1229470 1229579 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "3"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1229782 1230008 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "4"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1230827 1230934 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "5"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1231116 1231318 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "6"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1231395 1231489 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "7"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1231591 1231660 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "8"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1231805 1232013 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "9"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1233202 1233313 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "10"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1233393 1233493 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "11"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1233750 1233801 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "12"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1233947 1234059 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "13"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1234725 1234736 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "14"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1235211 1235285 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "15"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1235353 1235448 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "16"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1235538 1235582 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "17"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1235889 1236072 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "18"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1237368 1237426 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "19"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1238302 1238355 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "20"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1238542 1238661 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "21"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1239466 1241309 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003881"; exon_number "22"; gene_name "ACAP3"; oId "uc001aea.2"; nearest_ref "uc001aea.2"; class_code "="; tss_id "TSS1941"; p_id "P2917"; chr1 coding exon 1227764 1229088 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "1"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1229203 1229313 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "2"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1229470 1229579 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "3"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1229782 1230008 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "4"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1230098 1230196 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "5"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1230827 1230934 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "6"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1231116 1231318 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "7"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1231395 1231489 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "8"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1231591 1231660 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "9"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1231805 1232013 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "10"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1233202 1233313 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "11"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1233393 1233493 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "12"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1233750 1233801 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "13"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1233947 1234059 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "14"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1234725 1234736 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "15"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1235211 1235285 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "16"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1235353 1235448 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "17"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1235538 1235582 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "18"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1235889 1236072 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "19"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1237368 1237426 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "20"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1238302 1238355 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "21"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1238542 1238661 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "22"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1239466 1239523 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "23"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1243149 1243269 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003882"; exon_number "24"; gene_name "ACAP3"; oId "uc001aeb.2"; nearest_ref "uc001aeb.2"; class_code "="; tss_id "TSS1942"; p_id "P2914"; chr1 coding exon 1234124 1235285 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "1"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1235353 1235448 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "2"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1235538 1235582 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "3"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1235889 1236072 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "4"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1237368 1237426 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "5"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1238302 1238355 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "6"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1238542 1238661 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "7"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1239466 1239523 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "8"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 coding exon 1244822 1244989 . - . gene_id "XLOC_001242"; transcript_id "TCONS_00003883"; exon_number "9"; oId "uc001aec.1"; nearest_ref "uc001aec.1"; class_code "="; tss_id "TSS1943"; p_id "P2916"; chr1 nearCoding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "1"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "2"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "3"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "4"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "5"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "6"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "7"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "8"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "9"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "10"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "11"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "12"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 nearCoding exon 1251537 1252830 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003884"; exon_number "13"; gene_name "CPSF3L"; oId "uc009vjy.1"; nearest_ref "uc009vjy.1"; class_code "="; tss_id "TSS1944"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "14"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003888"; exon_number "15"; gene_name "CPSF3L"; oId "uc001aeh.1"; nearest_ref "uc001aeh.1"; class_code "="; tss_id "TSS1945"; p_id "P2921"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003890"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aej.1"; nearest_ref "uc001aej.1"; class_code "="; tss_id "TSS1945"; p_id "P2920"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "1"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "2"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "3"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "4"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "5"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "6"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "7"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "8"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "9"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "10"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "11"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "12"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1250900 1250932 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "13"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1254676 1254904 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "14"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1255836 1255909 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "15"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "16"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003892"; exon_number "17"; gene_name "CPSF3L"; oId "uc009vjz.1"; nearest_ref "uc009vjz.1"; class_code "="; tss_id "TSS1945"; p_id "P2928"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "1"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "2"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "3"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "4"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "5"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "6"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "7"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "8"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "9"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "10"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "11"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "12"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "13"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1254676 1254904 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "14"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1255836 1255909 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "15"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "16"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1258561 1258667 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "17"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003893"; exon_number "18"; gene_name "CPSF3L"; oId "uc010nyj.1"; nearest_ref "uc010nyj.1"; class_code "="; tss_id "TSS1945"; p_id "P2925"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1249112 1249485 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003891"; exon_number "14"; gene_name "CPSF3L"; oId "uc001aek.1"; nearest_ref "uc001aek.1"; class_code "="; tss_id "TSS1945"; p_id "P2923"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1250900 1250994 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1258557 1258667 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "14"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003889"; exon_number "15"; gene_name "CPSF3L"; oId "uc001aei.1"; nearest_ref "uc001aei.1"; class_code "="; tss_id "TSS1945"; p_id "P2918"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1254676 1254813 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "14"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1255836 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "15"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003887"; exon_number "16"; gene_name "CPSF3L"; oId "uc001aeg.1"; nearest_ref "uc001aeg.1"; class_code "="; tss_id "TSS1945"; p_id "P2924"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1254676 1254904 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "14"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1255836 1255909 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "15"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "16"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1257288 1257364 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "17"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1258272 1258667 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "18"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003886"; exon_number "19"; gene_name "CPSF3L"; oId "uc001aef.1"; nearest_ref "uc001aef.1"; class_code "="; tss_id "TSS1945"; p_id "P2927"; chr1 coding exon 1246965 1247304 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1247398 1247527 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1247606 1247748 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1247820 1247881 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1247973 1248080 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "5"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1248167 1248329 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "6"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1248415 1248504 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "7"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1248889 1248972 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "8"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1249112 1249301 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "9"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1249681 1249745 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "10"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1250204 1250342 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "11"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1250784 1250818 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "12"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1250900 1250998 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "13"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1254676 1254904 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "14"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1255836 1255909 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "15"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "16"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003885"; exon_number "17"; gene_name "CPSF3L"; oId "uc001aee.1"; nearest_ref "uc001aee.1"; class_code "="; tss_id "TSS1945"; p_id "P2926"; chr1 coding exon 1254059 1254904 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003895"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aem.1"; nearest_ref "uc001aem.1"; class_code "="; tss_id "TSS1945"; p_id "P2922"; chr1 coding exon 1255836 1255909 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003895"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aem.1"; nearest_ref "uc001aem.1"; class_code "="; tss_id "TSS1945"; p_id "P2922"; chr1 coding exon 1256376 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003895"; exon_number "3"; gene_name "CPSF3L"; oId "uc001aem.1"; nearest_ref "uc001aem.1"; class_code "="; tss_id "TSS1945"; p_id "P2922"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003895"; exon_number "4"; gene_name "CPSF3L"; oId "uc001aem.1"; nearest_ref "uc001aem.1"; class_code "="; tss_id "TSS1945"; p_id "P2922"; chr1 coding exon 1254059 1254904 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003894"; exon_number "1"; gene_name "CPSF3L"; oId "uc001ael.1"; nearest_ref "uc001ael.1"; class_code "="; tss_id "TSS1945"; p_id "P2929"; chr1 coding exon 1255836 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003894"; exon_number "2"; gene_name "CPSF3L"; oId "uc001ael.1"; nearest_ref "uc001ael.1"; class_code "="; tss_id "TSS1945"; p_id "P2929"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003894"; exon_number "3"; gene_name "CPSF3L"; oId "uc001ael.1"; nearest_ref "uc001ael.1"; class_code "="; tss_id "TSS1945"; p_id "P2929"; chr1 coding exon 1254077 1256473 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003896"; exon_number "1"; gene_name "CPSF3L"; oId "uc001aen.1"; nearest_ref "uc001aen.1"; class_code "="; tss_id "TSS1945"; p_id "P2919"; chr1 coding exon 1259961 1260046 . - . gene_id "XLOC_001243"; transcript_id "TCONS_00003896"; exon_number "2"; gene_name "CPSF3L"; oId "uc001aen.1"; nearest_ref "uc001aen.1"; class_code "="; tss_id "TSS1945"; p_id "P2919"; chr1 coding exon 1270659 1271895 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "1"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1273357 1273563 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "2"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1273649 1273816 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "3"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1273902 1274033 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "4"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1274742 1274819 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "5"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1274962 1275192 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "6"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1275418 1275557 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003898"; exon_number "7"; gene_name "DVL1L1"; oId "uc009vka.2"; nearest_ref "uc009vka.2"; class_code "="; tss_id "TSS1946"; p_id "P2933"; chr1 coding exon 1270659 1271895 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "1"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1273357 1273563 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "2"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1273649 1273816 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "3"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1273902 1274033 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "4"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1274667 1274819 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "5"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1274962 1275029 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "6"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1275116 1275192 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "7"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1275418 1275557 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003897"; exon_number "8"; gene_name "DVL1"; oId "uc002quu.2"; nearest_ref "uc002quu.2"; class_code "="; tss_id "TSS1946"; p_id "P2932"; chr1 coding exon 1270659 1271895 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "1"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1273357 1273563 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "2"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1273649 1273816 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "3"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1273902 1274033 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "4"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1274742 1274819 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "5"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1274962 1275029 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "6"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1275116 1275192 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "7"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1275418 1275557 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "8"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1275627 1275696 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "9"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1275790 1275883 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "10"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1277047 1277185 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "11"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1277433 1277536 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "12"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1277743 1277864 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "13"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1278069 1278138 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "14"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1284276 1284492 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003899"; exon_number "15"; gene_name "DVL1"; oId "uc001aer.3"; nearest_ref "uc001aer.3"; class_code "="; tss_id "TSS1947"; p_id "P2931"; chr1 coding exon 1270664 1273563 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "1"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1273649 1273816 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "2"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1273902 1274033 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "3"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1274667 1275029 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "4"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1275116 1275192 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "5"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1275418 1275557 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "6"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1275627 1275696 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "7"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1275790 1275883 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "8"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1277047 1277504 . - . gene_id "XLOC_001244"; transcript_id "TCONS_00003900"; exon_number "9"; gene_name "DVL1"; oId "uc001aeu.1"; nearest_ref "uc001aeu.1"; class_code "="; tss_id "TSS1948"; p_id "P2930"; chr1 coding exon 1288072 1288712 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "1"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1289228 1289308 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "2"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1289410 1289486 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "3"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1289573 1289612 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "4"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1289734 1289889 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "5"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1290062 1290532 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "6"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1290624 1290725 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "7"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1290830 1291132 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "8"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1292061 1292084 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "9"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1293836 1293927 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003902"; exon_number "10"; gene_name "MXRA8"; oId "uc001aey.3"; nearest_ref "uc001aey.3"; class_code "="; tss_id "TSS1949"; p_id "P2934"; chr1 coding exon 1288072 1288712 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "1"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1289228 1289326 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "2"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1289410 1289486 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "3"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1289573 1289612 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "4"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1289734 1289889 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "5"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1290062 1290532 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "6"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1290624 1290725 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "7"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1290830 1291132 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "8"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1292061 1292084 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "9"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1293836 1293927 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003901"; exon_number "10"; gene_name "MXRA8"; oId "uc001aex.3"; nearest_ref "uc001aex.3"; class_code "="; tss_id "TSS1949"; p_id "P2937"; chr1 coding exon 1288072 1289009 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "1"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1289228 1289308 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "2"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1289410 1289486 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "3"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1289573 1289612 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "4"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1289734 1289889 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "5"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1290062 1290532 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "6"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1290624 1290725 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "7"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1290830 1291132 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "8"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1292061 1292084 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "9"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1293836 1293942 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003904"; exon_number "10"; gene_name "MXRA8"; oId "uc010nyl.1"; nearest_ref "uc001aew.2"; class_code "="; tss_id "TSS1949"; p_id "P2936"; chr1 coding exon 1288072 1289009 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "1"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1289228 1289308 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "2"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1289410 1289486 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "3"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1289573 1289612 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "4"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1289734 1289889 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "5"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1290062 1290532 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "6"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1290624 1290725 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "7"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1292061 1292084 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "8"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1293836 1293942 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003903"; exon_number "9"; gene_name "MXRA8"; oId "uc001aez.2"; nearest_ref "uc001aez.2"; class_code "="; tss_id "TSS1949"; p_id "P2938"; chr1 coding exon 1288072 1289009 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "1"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1289228 1289308 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "2"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1289410 1289486 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "3"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1289573 1289612 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "4"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1289734 1289889 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "5"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1290062 1290532 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "6"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1290624 1290725 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "7"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1290830 1291132 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "8"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1292061 1292084 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "9"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1296622 1297157 . - . gene_id "XLOC_001245"; transcript_id "TCONS_00003905"; exon_number "10"; gene_name "MXRA8"; oId "uc001afa.2"; nearest_ref "uc001afa.2"; class_code "="; tss_id "TSS1950"; p_id "P2935"; chr1 coding exon 1309110 1309282 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003906"; exon_number "1"; gene_name "AURKAIP1"; oId "uc001afb.1"; nearest_ref "uc001afb.1"; class_code "="; tss_id "TSS1951"; p_id "P2939"; chr1 coding exon 1309380 1309825 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003906"; exon_number "2"; gene_name "AURKAIP1"; oId "uc001afb.1"; nearest_ref "uc001afb.1"; class_code "="; tss_id "TSS1951"; p_id "P2939"; chr1 coding exon 1310085 1310246 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003906"; exon_number "3"; gene_name "AURKAIP1"; oId "uc001afb.1"; nearest_ref "uc001afb.1"; class_code "="; tss_id "TSS1951"; p_id "P2939"; chr1 coding exon 1309110 1309282 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003907"; exon_number "1"; gene_name "AURKAIP1"; oId "uc009vkb.1"; nearest_ref "uc009vkb.1"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1309380 1309825 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003907"; exon_number "2"; gene_name "AURKAIP1"; oId "uc009vkb.1"; nearest_ref "uc009vkb.1"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1310085 1310170 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003907"; exon_number "3"; gene_name "AURKAIP1"; oId "uc009vkb.1"; nearest_ref "uc009vkb.1"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1310455 1310562 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003907"; exon_number "4"; gene_name "AURKAIP1"; oId "uc009vkb.1"; nearest_ref "uc009vkb.1"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1309110 1309282 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003908"; exon_number "1"; gene_name "AURKAIP1"; oId "uc001afd.2"; nearest_ref "uc001afd.2"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1309380 1309825 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003908"; exon_number "2"; gene_name "AURKAIP1"; oId "uc001afd.2"; nearest_ref "uc001afd.2"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1310085 1310170 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003908"; exon_number "3"; gene_name "AURKAIP1"; oId "uc001afd.2"; nearest_ref "uc001afd.2"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1310377 1310580 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003908"; exon_number "4"; gene_name "AURKAIP1"; oId "uc001afd.2"; nearest_ref "uc001afd.2"; class_code "="; tss_id "TSS1952"; p_id "P2939"; chr1 coding exon 1309110 1309282 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003909"; exon_number "1"; gene_name "AURKAIP1"; oId "uc001afc.2"; nearest_ref "uc001afc.2"; class_code "="; tss_id "TSS1953"; p_id "P2939"; chr1 coding exon 1309380 1309825 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003909"; exon_number "2"; gene_name "AURKAIP1"; oId "uc001afc.2"; nearest_ref "uc001afc.2"; class_code "="; tss_id "TSS1953"; p_id "P2939"; chr1 coding exon 1310085 1310170 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003909"; exon_number "3"; gene_name "AURKAIP1"; oId "uc001afc.2"; nearest_ref "uc001afc.2"; class_code "="; tss_id "TSS1953"; p_id "P2939"; chr1 coding exon 1310534 1310818 . - . gene_id "XLOC_001246"; transcript_id "TCONS_00003909"; exon_number "4"; gene_name "AURKAIP1"; oId "uc001afc.2"; nearest_ref "uc001afc.2"; class_code "="; tss_id "TSS1953"; p_id "P2939"; chr1 nearCoding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "1"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "2"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "3"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1323872 1323890 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "4"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1324006 1324123 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "5"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "6"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "7"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1326146 1326245 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "8"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 nearCoding exon 1326677 1327029 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003910"; exon_number "9"; oId "uc010nym.1"; nearest_ref "uc010nym.1"; class_code "="; tss_id "TSS1954"; chr1 coding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003911"; exon_number "1"; gene_name "CCNL2"; oId "uc001aff.1"; nearest_ref "uc001aff.1"; class_code "="; tss_id "TSS1955"; p_id "P2942"; chr1 coding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003911"; exon_number "2"; gene_name "CCNL2"; oId "uc001aff.1"; nearest_ref "uc001aff.1"; class_code "="; tss_id "TSS1955"; p_id "P2942"; chr1 coding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003911"; exon_number "3"; gene_name "CCNL2"; oId "uc001aff.1"; nearest_ref "uc001aff.1"; class_code "="; tss_id "TSS1955"; p_id "P2942"; chr1 coding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003911"; exon_number "4"; gene_name "CCNL2"; oId "uc001aff.1"; nearest_ref "uc001aff.1"; class_code "="; tss_id "TSS1955"; p_id "P2942"; chr1 coding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003911"; exon_number "5"; gene_name "CCNL2"; oId "uc001aff.1"; nearest_ref "uc001aff.1"; class_code "="; tss_id "TSS1955"; p_id "P2942"; chr1 coding exon 1326146 1328183 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003911"; exon_number "6"; gene_name "CCNL2"; oId "uc001aff.1"; nearest_ref "uc001aff.1"; class_code "="; tss_id "TSS1955"; p_id "P2942"; chr1 coding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "1"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "2"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "3"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "4"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "5"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1326146 1326245 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "6"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1328059 1328183 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "7"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1328776 1328840 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "8"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1330774 1330917 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "9"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1333613 1333722 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003912"; exon_number "10"; gene_name "CCNL2"; oId "uc001afg.1"; nearest_ref "uc001afg.1"; class_code "="; tss_id "TSS1956"; p_id "P2942"; chr1 coding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "1"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "2"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "3"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "4"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "5"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1326146 1326245 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "6"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1328170 1328183 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "7"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1328776 1328840 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "8"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1330774 1330894 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "9"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1333613 1333722 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "10"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1333977 1334051 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "11"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1334399 1334718 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003915"; exon_number "12"; gene_name "CCNL2"; oId "uc001afj.2"; nearest_ref "uc001afj.2"; class_code "="; tss_id "TSS1957"; p_id "P2941"; chr1 coding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "1"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "2"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "3"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "4"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "5"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1326146 1326955 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "6"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1328170 1328183 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "7"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1328776 1328840 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "8"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1330774 1330894 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "9"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1333613 1333722 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "10"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1333977 1334051 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "11"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1334399 1334718 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003916"; exon_number "12"; gene_name "CCNL2"; oId "uc001afk.2"; nearest_ref "uc001afk.2"; class_code "="; tss_id "TSS1957"; p_id "P2940"; chr1 coding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "1"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "2"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "3"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "4"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "5"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1326146 1326245 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "6"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1328776 1328840 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "7"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1330774 1330894 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "8"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1333613 1333722 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "9"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1333977 1334051 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "10"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1334399 1334718 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003914"; exon_number "11"; gene_name "CCNL2"; oId "uc001afi.2"; nearest_ref "uc001afi.2"; class_code "="; tss_id "TSS1957"; p_id "P2944"; chr1 coding exon 1321091 1322962 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "1"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1323157 1323249 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "2"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1323334 1323445 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "3"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1324006 1324123 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "4"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1324330 1324427 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "5"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1325610 1325751 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "6"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1325839 1325943 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "7"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1326146 1328183 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "8"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1328776 1328840 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "9"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1330774 1330894 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "10"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1333613 1333722 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "11"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1333977 1334051 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "12"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1334399 1334718 . - . gene_id "XLOC_001247"; transcript_id "TCONS_00003913"; exon_number "13"; gene_name "CCNL2"; oId "uc001afh.2"; nearest_ref "uc001afh.2"; class_code "="; tss_id "TSS1957"; p_id "P2943"; chr1 coding exon 1337277 1337636 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003917"; exon_number "1"; gene_name "MRPL20"; oId "uc001afo.3"; nearest_ref "uc001afo.3"; class_code "="; tss_id "TSS1958"; p_id "P2946"; chr1 coding exon 1341189 1341266 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003917"; exon_number "2"; gene_name "MRPL20"; oId "uc001afo.3"; nearest_ref "uc001afo.3"; class_code "="; tss_id "TSS1958"; p_id "P2946"; chr1 coding exon 1342289 1342399 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003917"; exon_number "3"; gene_name "MRPL20"; oId "uc001afo.3"; nearest_ref "uc001afo.3"; class_code "="; tss_id "TSS1958"; p_id "P2946"; chr1 coding exon 1342511 1342693 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003917"; exon_number "4"; gene_name "MRPL20"; oId "uc001afo.3"; nearest_ref "uc001afo.3"; class_code "="; tss_id "TSS1958"; p_id "P2946"; chr1 coding exon 1340413 1341266 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003918"; exon_number "1"; gene_name "MRPL20"; oId "uc010nyn.1"; nearest_ref "uc010nyn.1"; class_code "="; tss_id "TSS1958"; p_id "P2945"; chr1 coding exon 1342289 1342399 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003918"; exon_number "2"; gene_name "MRPL20"; oId "uc010nyn.1"; nearest_ref "uc010nyn.1"; class_code "="; tss_id "TSS1958"; p_id "P2945"; chr1 coding exon 1342511 1342693 . - . gene_id "XLOC_001248"; transcript_id "TCONS_00003918"; exon_number "3"; gene_name "MRPL20"; oId "uc010nyn.1"; nearest_ref "uc010nyn.1"; class_code "="; tss_id "TSS1958"; p_id "P2945"; chr1 coding exon 1353802 1354929 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003921"; exon_number "1"; oId "uc010nyo.1"; nearest_ref "uc010nyo.1"; class_code "="; tss_id "TSS1959"; p_id "P2947"; chr1 coding exon 1355432 1355972 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003921"; exon_number "2"; oId "uc010nyo.1"; nearest_ref "uc010nyo.1"; class_code "="; tss_id "TSS1959"; p_id "P2947"; chr1 coding exon 1356177 1356385 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003921"; exon_number "3"; oId "uc010nyo.1"; nearest_ref "uc010nyo.1"; class_code "="; tss_id "TSS1959"; p_id "P2947"; chr1 coding exon 1356513 1356650 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003921"; exon_number "4"; oId "uc010nyo.1"; nearest_ref "uc010nyo.1"; class_code "="; tss_id "TSS1959"; p_id "P2947"; chr1 coding exon 1353802 1354929 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003920"; exon_number "1"; oId "uc001afq.2"; nearest_ref "uc001afq.2"; class_code "="; tss_id "TSS1959"; p_id "P2948"; chr1 coding exon 1356177 1356385 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003920"; exon_number "2"; oId "uc001afq.2"; nearest_ref "uc001afq.2"; class_code "="; tss_id "TSS1959"; p_id "P2948"; chr1 coding exon 1356513 1356650 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003920"; exon_number "3"; oId "uc001afq.2"; nearest_ref "uc001afq.2"; class_code "="; tss_id "TSS1959"; p_id "P2948"; chr1 nearCoding exon 1353802 1354929 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003919"; exon_number "1"; oId "uc001afp.2"; nearest_ref "uc001afp.2"; class_code "="; tss_id "TSS1959"; chr1 nearCoding exon 1356196 1356385 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003919"; exon_number "2"; oId "uc001afp.2"; nearest_ref "uc001afp.2"; class_code "="; tss_id "TSS1959"; chr1 nearCoding exon 1356513 1356650 . - . gene_id "XLOC_001249"; transcript_id "TCONS_00003919"; exon_number "3"; oId "uc001afp.2"; nearest_ref "uc001afp.2"; class_code "="; tss_id "TSS1959"; chr1 coding exon 1470159 1470887 . - . gene_id "XLOC_001250"; transcript_id "TCONS_00003922"; exon_number "1"; gene_name "C1orf70"; oId "uc009vkf.2"; nearest_ref "uc009vkf.2"; class_code "="; tss_id "TSS1960"; p_id "P2949"; chr1 coding exon 1470969 1471177 . - . gene_id "XLOC_001250"; transcript_id "TCONS_00003922"; exon_number "2"; gene_name "C1orf70"; oId "uc009vkf.2"; nearest_ref "uc009vkf.2"; class_code "="; tss_id "TSS1960"; p_id "P2949"; chr1 coding exon 1475064 1475170 . - . gene_id "XLOC_001250"; transcript_id "TCONS_00003922"; exon_number "3"; gene_name "C1orf70"; oId "uc009vkf.2"; nearest_ref "uc009vkf.2"; class_code "="; tss_id "TSS1960"; p_id "P2949"; chr1 coding exon 1475670 1475740 . - . gene_id "XLOC_001250"; transcript_id "TCONS_00003922"; exon_number "4"; gene_name "C1orf70"; oId "uc009vkf.2"; nearest_ref "uc009vkf.2"; class_code "="; tss_id "TSS1960"; p_id "P2949"; chr1 coding exon 1477054 1477547 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003923"; exon_number "1"; gene_name "SSU72"; oId "uc001agd.2"; nearest_ref "uc001agd.2"; class_code "="; tss_id "TSS1961"; p_id "P2952"; chr1 coding exon 1479249 1479367 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003923"; exon_number "2"; gene_name "SSU72"; oId "uc001agd.2"; nearest_ref "uc001agd.2"; class_code "="; tss_id "TSS1961"; p_id "P2952"; chr1 coding exon 1480243 1480382 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003923"; exon_number "3"; gene_name "SSU72"; oId "uc001agd.2"; nearest_ref "uc001agd.2"; class_code "="; tss_id "TSS1961"; p_id "P2952"; chr1 coding exon 1500153 1500296 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003923"; exon_number "4"; gene_name "SSU72"; oId "uc001agd.2"; nearest_ref "uc001agd.2"; class_code "="; tss_id "TSS1961"; p_id "P2952"; chr1 coding exon 1509858 1510262 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003923"; exon_number "5"; gene_name "SSU72"; oId "uc001agd.2"; nearest_ref "uc001agd.2"; class_code "="; tss_id "TSS1961"; p_id "P2952"; chr1 coding exon 1478560 1479367 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003924"; exon_number "1"; gene_name "SSU72"; oId "uc009vkg.1"; nearest_ref "uc009vkg.1"; class_code "="; tss_id "TSS1961"; p_id "P2950"; chr1 coding exon 1480243 1480382 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003924"; exon_number "2"; gene_name "SSU72"; oId "uc009vkg.1"; nearest_ref "uc009vkg.1"; class_code "="; tss_id "TSS1961"; p_id "P2950"; chr1 coding exon 1500153 1500296 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003924"; exon_number "3"; gene_name "SSU72"; oId "uc009vkg.1"; nearest_ref "uc009vkg.1"; class_code "="; tss_id "TSS1961"; p_id "P2950"; chr1 coding exon 1509858 1510262 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003924"; exon_number "4"; gene_name "SSU72"; oId "uc009vkg.1"; nearest_ref "uc009vkg.1"; class_code "="; tss_id "TSS1961"; p_id "P2950"; chr1 coding exon 1497732 1500296 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003925"; exon_number "1"; gene_name "SSU72"; oId "uc001age.1"; nearest_ref "uc001age.1"; class_code "="; tss_id "TSS1961"; p_id "P2951"; chr1 coding exon 1509858 1510262 . - . gene_id "XLOC_001251"; transcript_id "TCONS_00003925"; exon_number "2"; gene_name "SSU72"; oId "uc001age.1"; nearest_ref "uc001age.1"; class_code "="; tss_id "TSS1961"; p_id "P2951"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "1"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "2"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "3"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "4"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "5"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "6"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "7"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "8"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "9"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "10"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1576409 1576737 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003926"; exon_number "11"; gene_name "CDC2L1"; oId "uc009vkj.2"; nearest_ref "uc009vkj.2"; class_code "="; tss_id "TSS1962"; p_id "P2968"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "1"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "2"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "3"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "4"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "5"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "6"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "7"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "8"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "9"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "10"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "11"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "12"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "13"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "14"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003928"; exon_number "15"; gene_name "CDC2L1"; oId "uc001agt.1"; nearest_ref "uc001agt.1"; class_code "="; tss_id "TSS1963"; p_id "P2967"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "1"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "2"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "3"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "4"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "5"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "6"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "7"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "8"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "9"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "10"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "11"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "12"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "13"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1577708 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "14"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "15"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003927"; exon_number "16"; gene_name "CDC2L1"; oId "uc001ags.1"; nearest_ref "uc001ags.1"; class_code "="; tss_id "TSS1963"; p_id "P2966"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "1"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "2"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "3"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "4"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "5"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "6"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "7"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "8"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "9"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "10"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "11"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "12"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "13"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "14"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "15"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "16"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "17"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "18"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1654027 1654073 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "19"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "20"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1655706 1655775 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003934"; exon_number "21"; gene_name "CDC2L1"; oId "uc001aha.1"; nearest_ref "uc001aha.1"; class_code "="; tss_id "TSS1964"; p_id "P2972"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "1"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "2"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "3"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "4"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "5"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "6"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "7"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "8"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "9"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "10"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "11"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "12"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "13"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "14"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "15"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "16"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "17"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1655706 1655775 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003933"; exon_number "18"; gene_name "CDC2L1"; oId "uc001agz.1"; nearest_ref "uc001agz.1"; class_code "="; tss_id "TSS1964"; p_id "P2971"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "1"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "2"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "3"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "4"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "5"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "6"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "7"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "8"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "9"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "10"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "11"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "12"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "13"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "14"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "15"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1647785 1647900 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "16"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1650798 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "17"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "18"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "19"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1655706 1655775 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003931"; exon_number "20"; gene_name "CDC2L1"; oId "uc001agx.1"; nearest_ref "uc001agx.1"; class_code "="; tss_id "TSS1964"; p_id "P2965"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "1"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "2"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "3"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "4"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "5"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "6"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "7"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "8"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "9"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "10"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "11"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "12"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "13"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "14"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1643703 1643866 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "15"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1647785 1647900 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "16"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1650798 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "17"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "18"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "19"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1655706 1655775 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003932"; exon_number "20"; gene_name "CDC2L1"; oId "uc001agy.1"; nearest_ref "uc001agy.1"; class_code "="; tss_id "TSS1964"; p_id "P2964"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "1"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "2"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "3"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "4"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "5"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "6"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "7"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "8"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "9"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "10"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "11"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "12"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "13"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "14"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "15"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1647785 1647900 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "16"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1650798 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "17"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "18"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1654027 1654073 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "19"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "20"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1655706 1655775 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003930"; exon_number "21"; gene_name "CDC2L1"; oId "uc001agw.1"; nearest_ref "uc001agw.1"; class_code "="; tss_id "TSS1964"; p_id "P2973"; chr1 coding exon 1571100 1571218 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "1"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1571299 1571488 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "2"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1571695 1571843 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "3"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1572044 1572160 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "4"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1572259 1572366 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "5"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1572443 1572564 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "6"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1572770 1572875 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "7"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1573124 1573245 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "8"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1573862 1573952 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "9"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1575638 1575813 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "10"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1576409 1576474 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "11"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1577023 1577181 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "12"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1577267 1577362 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "13"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "14"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "15"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "16"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "17"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "18"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "19"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 coding exon 1655706 1655775 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003929"; exon_number "20"; gene_name "CDC2L1"; oId "uc001agv.1"; nearest_ref "uc001agv.1"; class_code "="; tss_id "TSS1964"; p_id "P2970"; chr1 nearCoding exon 1577747 1577869 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003935"; exon_number "1"; gene_name "CDC2L1"; oId "uc010nyr.1"; nearest_ref "uc010nyr.1"; class_code "="; tss_id "TSS1965"; chr1 nearCoding exon 1580487 1580625 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003935"; exon_number "2"; gene_name "CDC2L1"; oId "uc010nyr.1"; nearest_ref "uc010nyr.1"; class_code "="; tss_id "TSS1965"; chr1 coding exon 1634172 1634438 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "1"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1634519 1634708 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "2"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1634915 1635063 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "3"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1635263 1635379 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "4"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1635478 1635585 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "5"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1635662 1635783 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "6"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1635989 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "7"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "8"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1638848 1639038 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "9"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 coding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003944"; exon_number "10"; gene_name "CDC2L2"; oId "uc001ahj.3"; nearest_ref "uc001ahj.3"; class_code "="; tss_id "TSS1966"; p_id "P2969"; chr1 nearCoding exon 1634172 1634438 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "1"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1634519 1634708 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "2"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1634915 1635063 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "3"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1635263 1635434 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "4"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1635662 1635783 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "5"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1635989 1636094 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "6"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1636343 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "7"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "8"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1638964 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "9"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "10"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 nearCoding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003946"; exon_number "11"; gene_name "CDC2L2"; oId "uc009vkq.2"; nearest_ref "uc009vkq.2"; class_code "="; tss_id "TSS1967"; chr1 coding exon 1634172 1634438 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "1"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1634519 1634708 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "2"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1634915 1635063 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "3"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1635263 1635379 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "4"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1635478 1635585 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "5"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1635662 1635783 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "6"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1635989 1636094 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "7"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1636343 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "8"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "9"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1638964 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "10"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "11"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003945"; exon_number "12"; gene_name "CDC2L2"; oId "uc009vkp.2"; nearest_ref "uc009vkp.2"; class_code "="; tss_id "TSS1967"; p_id "P2953"; chr1 coding exon 1634172 1634438 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "1"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1634519 1634708 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "2"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1634915 1635063 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "3"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1635263 1635379 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "4"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1635478 1635585 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "5"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1635662 1635783 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "6"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1635989 1636094 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "7"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1636343 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "8"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "9"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1638848 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "10"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "11"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "12"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "13"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "14"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "15"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "16"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "17"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "18"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "19"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003948"; exon_number "20"; gene_name "CDC2L2"; oId "uc009vks.2"; nearest_ref "uc009vks.2"; class_code "="; tss_id "TSS1964"; p_id "P2955"; chr1 coding exon 1634172 1634438 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "1"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1634519 1634708 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "2"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1634915 1635063 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "3"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1635263 1635379 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "4"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1635478 1635585 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "5"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1635662 1635783 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "6"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1635989 1636094 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "7"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1636343 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "8"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "9"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1638848 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "10"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "11"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "12"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "13"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "14"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "15"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "16"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "17"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "18"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "19"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003947"; exon_number "20"; gene_name "CDC2L2"; oId "uc009vkr.2"; nearest_ref "uc009vkr.2"; class_code "="; tss_id "TSS1964"; p_id "P2956"; chr1 coding exon 1635665 1636094 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "1"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1636343 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "2"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "3"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1638848 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "4"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "5"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "6"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "7"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "8"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "9"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "10"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "11"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "12"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "13"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003949"; exon_number "14"; gene_name "CDC2L2"; oId "uc010nys.1"; nearest_ref "uc010nys.1"; class_code "="; tss_id "TSS1964"; p_id "P2954"; chr1 coding exon 1635989 1636464 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "1"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "2"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1638848 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "3"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "4"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "5"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "6"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "7"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "8"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "9"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "10"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "11"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "12"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003950"; exon_number "13"; gene_name "CDC2L1"; oId "uc010nyt.1"; nearest_ref "uc010nyt.1"; class_code "="; tss_id "TSS1964"; p_id "P2957"; chr1 nearCoding exon 1637081 1637171 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "1"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1638848 1639023 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "2"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1639619 1639684 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "3"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "4"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "5"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "6"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "7"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "8"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "9"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "10"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 nearCoding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003951"; exon_number "11"; gene_name "CDC2L1"; oId "uc010nyu.1"; nearest_ref "uc010nyu.1"; class_code "="; tss_id "TSS1964"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "1"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "2"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1640918 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "3"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "4"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "5"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "6"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "7"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "8"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003954"; exon_number "9"; gene_name "CDC2L2"; oId "uc009vkv.1"; nearest_ref "uc009vkv.1"; class_code "="; tss_id "TSS1964"; p_id "P2958"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "1"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "2"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1640918 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "3"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "4"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "5"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "6"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "7"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "8"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003953"; exon_number "9"; gene_name "CDC2L2"; oId "uc009vku.1"; nearest_ref "uc009vku.1"; class_code "="; tss_id "TSS1964"; p_id "P2959"; chr1 coding exon 1640233 1640391 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "1"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1640477 1640572 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "2"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "3"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1643703 1643866 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "4"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "5"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "6"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "7"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "8"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1655697 1655791 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003952"; exon_number "9"; gene_name "CDC2L1"; oId "uc009vkt.1"; nearest_ref "uc009vkt.1"; class_code "="; tss_id "TSS1964"; p_id "P2960"; chr1 coding exon 1640957 1641079 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "1"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1643703 1643839 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "2"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "3"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "4"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "5"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "6"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1655388 1655543 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003955"; exon_number "7"; gene_name "CDC2L2"; oId "uc001aht.1"; nearest_ref "uc001aht.1"; class_code "="; tss_id "TSS1968"; p_id "P2961"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003957"; exon_number "1"; gene_name "CDC2L1"; oId "uc001ahv.1"; nearest_ref "uc001ahv.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003957"; exon_number "2"; gene_name "CDC2L1"; oId "uc001ahv.1"; nearest_ref "uc001ahv.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003957"; exon_number "3"; gene_name "CDC2L1"; oId "uc001ahv.1"; nearest_ref "uc001ahv.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003957"; exon_number "4"; gene_name "CDC2L1"; oId "uc001ahv.1"; nearest_ref "uc001ahv.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1655239 1655471 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003957"; exon_number "5"; gene_name "CDC2L1"; oId "uc001ahv.1"; nearest_ref "uc001ahv.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003956"; exon_number "1"; gene_name "CDC2L1"; oId "uc001ahu.1"; nearest_ref "uc001ahu.1"; class_code "="; tss_id "TSS1968"; p_id "P2963"; chr1 coding exon 1650797 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003956"; exon_number "2"; gene_name "CDC2L1"; oId "uc001ahu.1"; nearest_ref "uc001ahu.1"; class_code "="; tss_id "TSS1968"; p_id "P2963"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003956"; exon_number "3"; gene_name "CDC2L1"; oId "uc001ahu.1"; nearest_ref "uc001ahu.1"; class_code "="; tss_id "TSS1968"; p_id "P2963"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003956"; exon_number "4"; gene_name "CDC2L1"; oId "uc001ahu.1"; nearest_ref "uc001ahu.1"; class_code "="; tss_id "TSS1968"; p_id "P2963"; chr1 coding exon 1655239 1655471 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003956"; exon_number "5"; gene_name "CDC2L1"; oId "uc001ahu.1"; nearest_ref "uc001ahu.1"; class_code "="; tss_id "TSS1968"; p_id "P2963"; chr1 coding exon 1647785 1647917 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003958"; exon_number "1"; gene_name "CDC2L1"; oId "uc001ahw.1"; nearest_ref "uc001ahw.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1650767 1650894 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003958"; exon_number "2"; gene_name "CDC2L1"; oId "uc001ahw.1"; nearest_ref "uc001ahw.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1653035 1653150 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003958"; exon_number "3"; gene_name "CDC2L1"; oId "uc001ahw.1"; nearest_ref "uc001ahw.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1654147 1654270 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003958"; exon_number "4"; gene_name "CDC2L1"; oId "uc001ahw.1"; nearest_ref "uc001ahw.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 coding exon 1655388 1655543 . - . gene_id "XLOC_001252"; transcript_id "TCONS_00003958"; exon_number "5"; gene_name "CDC2L1"; oId "uc001ahw.1"; nearest_ref "uc001ahw.1"; class_code "="; tss_id "TSS1968"; p_id "P2962"; chr1 noncoding exon 1586823 1586938 . - . gene_id "XLOC_001253"; transcript_id "TCONS_00003936"; exon_number "1"; gene_name "CDC2L1"; oId "uc001ahc.1"; nearest_ref "uc001ahc.1"; class_code "="; tss_id "TSS1969"; chr1 noncoding exon 1588825 1588948 . - . gene_id "XLOC_001253"; transcript_id "TCONS_00003936"; exon_number "2"; gene_name "CDC2L1"; oId "uc001ahc.1"; nearest_ref "uc001ahc.1"; class_code "="; tss_id "TSS1969"; chr1 noncoding exon 1590375 1590469 . - . gene_id "XLOC_001253"; transcript_id "TCONS_00003936"; exon_number "3"; gene_name "CDC2L1"; oId "uc001ahc.1"; nearest_ref "uc001ahc.1"; class_code "="; tss_id "TSS1969"; chr1 coding exon 1590990 1591572 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "1"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1599766 1599911 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "2"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1606902 1607029 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "3"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1607503 1607638 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "4"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1607817 1608285 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "5"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1622415 1622832 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "6"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1623888 1624243 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003937"; exon_number "7"; gene_name "SLC35E2"; oId "uc009vkl.1"; nearest_ref "uc009vkl.1"; class_code "="; tss_id "TSS1970"; p_id "P2980"; chr1 coding exon 1592940 1597458 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003938"; exon_number "1"; oId "uc001ahe.3"; nearest_ref "uc001ahe.3"; class_code "="; tss_id "TSS1971"; p_id "P2976"; chr1 coding exon 1599766 1599911 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003938"; exon_number "2"; oId "uc001ahe.3"; nearest_ref "uc001ahe.3"; class_code "="; tss_id "TSS1971"; p_id "P2976"; chr1 coding exon 1601103 1601578 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003938"; exon_number "3"; oId "uc001ahe.3"; nearest_ref "uc001ahe.3"; class_code "="; tss_id "TSS1971"; p_id "P2976"; chr1 coding exon 1592940 1597458 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "1"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1599766 1599911 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "2"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1601103 1601175 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "3"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1601537 1601590 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "4"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1602948 1603068 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "5"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1606902 1607029 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "6"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1607503 1607638 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "7"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1607817 1608285 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "8"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1623888 1624243 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003940"; exon_number "9"; oId "uc001ahg.3"; nearest_ref "uc001ahg.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1592940 1597458 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "1"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1599766 1599911 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "2"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1601103 1601175 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "3"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1601537 1601590 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "4"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1602948 1603068 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "5"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1606902 1607029 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "6"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1607503 1607638 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "7"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1607817 1608285 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "8"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1622415 1622832 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "9"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1623888 1624243 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003939"; exon_number "10"; oId "uc001ahf.3"; nearest_ref "uc001ahf.3"; class_code "="; tss_id "TSS1970"; p_id "P2979"; chr1 coding exon 1592940 1597458 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "1"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1599766 1599911 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "2"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1601103 1601175 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "3"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1601537 1601590 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "4"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1602948 1603068 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "5"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1606902 1607029 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "6"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1607503 1607638 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "7"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1607817 1608285 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "8"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1677163 1677431 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003941"; exon_number "9"; oId "uc001ahh.3"; nearest_ref "uc001ahh.3"; class_code "="; tss_id "TSS1972"; p_id "P2979"; chr1 coding exon 1601214 1601590 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003942"; exon_number "1"; gene_name "SLC35E2"; oId "uc009vkm.1"; nearest_ref "uc009vkm.1"; class_code "="; tss_id "TSS1973"; p_id "P2978"; chr1 coding exon 1602948 1603068 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003942"; exon_number "2"; gene_name "SLC35E2"; oId "uc009vkm.1"; nearest_ref "uc009vkm.1"; class_code "="; tss_id "TSS1973"; p_id "P2978"; chr1 coding exon 1669760 1669887 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003942"; exon_number "3"; gene_name "SLC35E2"; oId "uc009vkm.1"; nearest_ref "uc009vkm.1"; class_code "="; tss_id "TSS1973"; p_id "P2978"; chr1 coding exon 1670361 1670496 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003942"; exon_number "4"; gene_name "SLC35E2"; oId "uc009vkm.1"; nearest_ref "uc009vkm.1"; class_code "="; tss_id "TSS1973"; p_id "P2978"; chr1 coding exon 1670675 1671143 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003942"; exon_number "5"; gene_name "SLC35E2"; oId "uc009vkm.1"; nearest_ref "uc009vkm.1"; class_code "="; tss_id "TSS1973"; p_id "P2978"; chr1 coding exon 1601879 1603068 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003943"; exon_number "1"; gene_name "SLC35E2"; oId "uc009vkn.1"; nearest_ref "uc009vkn.1"; class_code "="; tss_id "TSS1970"; p_id "P2977"; chr1 coding exon 1606902 1607029 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003943"; exon_number "2"; gene_name "SLC35E2"; oId "uc009vkn.1"; nearest_ref "uc009vkn.1"; class_code "="; tss_id "TSS1970"; p_id "P2977"; chr1 coding exon 1607503 1607638 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003943"; exon_number "3"; gene_name "SLC35E2"; oId "uc009vkn.1"; nearest_ref "uc009vkn.1"; class_code "="; tss_id "TSS1970"; p_id "P2977"; chr1 coding exon 1607817 1608285 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003943"; exon_number "4"; gene_name "SLC35E2"; oId "uc009vkn.1"; nearest_ref "uc009vkn.1"; class_code "="; tss_id "TSS1970"; p_id "P2977"; chr1 coding exon 1623888 1624243 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003943"; exon_number "5"; gene_name "SLC35E2"; oId "uc009vkn.1"; nearest_ref "uc009vkn.1"; class_code "="; tss_id "TSS1970"; p_id "P2977"; chr1 coding exon 1656279 1656861 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003960"; exon_number "1"; gene_name "SLC35E2"; oId "uc001ahz.2"; nearest_ref "uc001ahz.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1666129 1666274 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003960"; exon_number "2"; gene_name "SLC35E2"; oId "uc001ahz.2"; nearest_ref "uc001ahz.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1669760 1669887 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003960"; exon_number "3"; gene_name "SLC35E2"; oId "uc001ahz.2"; nearest_ref "uc001ahz.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1670361 1670496 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003960"; exon_number "4"; gene_name "SLC35E2"; oId "uc001ahz.2"; nearest_ref "uc001ahz.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1670675 1671143 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003960"; exon_number "5"; gene_name "SLC35E2"; oId "uc001ahz.2"; nearest_ref "uc001ahz.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1677163 1677431 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003960"; exon_number "6"; gene_name "SLC35E2"; oId "uc001ahz.2"; nearest_ref "uc001ahz.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1656279 1656861 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "1"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1666129 1666274 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "2"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1669760 1669887 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "3"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1670361 1670496 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "4"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1670675 1671143 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "5"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1675690 1676107 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "6"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1677163 1677431 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003959"; exon_number "7"; gene_name "SLC35E2"; oId "uc001ahy.2"; nearest_ref "uc001ahy.2"; class_code "="; tss_id "TSS1972"; p_id "P2975"; chr1 coding exon 1663681 1663962 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003962"; exon_number "1"; gene_name "SLC35E2"; oId "uc001aib.1"; nearest_ref "uc001aib.1"; class_code "="; tss_id "TSS1972"; p_id "P2974"; chr1 coding exon 1666129 1666274 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003962"; exon_number "2"; gene_name "SLC35E2"; oId "uc001aib.1"; nearest_ref "uc001aib.1"; class_code "="; tss_id "TSS1972"; p_id "P2974"; chr1 coding exon 1669760 1669887 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003962"; exon_number "3"; gene_name "SLC35E2"; oId "uc001aib.1"; nearest_ref "uc001aib.1"; class_code "="; tss_id "TSS1972"; p_id "P2974"; chr1 coding exon 1670361 1670496 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003962"; exon_number "4"; gene_name "SLC35E2"; oId "uc001aib.1"; nearest_ref "uc001aib.1"; class_code "="; tss_id "TSS1972"; p_id "P2974"; chr1 coding exon 1670675 1671143 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003962"; exon_number "5"; gene_name "SLC35E2"; oId "uc001aib.1"; nearest_ref "uc001aib.1"; class_code "="; tss_id "TSS1972"; p_id "P2974"; chr1 coding exon 1677163 1677431 . - . gene_id "XLOC_001254"; transcript_id "TCONS_00003962"; exon_number "6"; gene_name "SLC35E2"; oId "uc001aib.1"; nearest_ref "uc001aib.1"; class_code "="; tss_id "TSS1972"; p_id "P2974"; chr1 noncoding exon 1658825 1662665 . - . gene_id "XLOC_001255"; transcript_id "TCONS_00003961"; exon_number "1"; oId "uc001aia.1"; nearest_ref "uc001aia.1"; class_code "="; chr1 coding exon 1682678 1684499 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "1"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1685006 1685088 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "2"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1685490 1685647 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "3"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1685723 1685822 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "4"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1685983 1686137 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "5"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1686813 1686915 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "6"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1687697 1687782 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "7"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1687942 1688047 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "8"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1688620 1688749 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "9"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1689804 1690081 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003963"; exon_number "10"; gene_name "NADK"; oId "uc010nyv.1"; nearest_ref "uc010nyv.1"; class_code "="; tss_id "TSS1974"; p_id "P2983"; chr1 coding exon 1682678 1684499 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "1"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685006 1685088 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "2"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685490 1685647 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "3"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685723 1685822 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "4"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685983 1686137 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "5"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1686813 1686915 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "6"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1687697 1687782 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "7"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1687942 1688047 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "8"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1688620 1688749 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "9"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1693391 1693474 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "10"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1696667 1696885 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "11"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1709808 1709888 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003964"; exon_number "12"; gene_name "NADK"; oId "uc009vkw.2"; nearest_ref "uc009vkw.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1682678 1684499 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "1"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685006 1685088 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "2"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685490 1685647 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "3"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685723 1685822 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "4"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1685983 1686137 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "5"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1686813 1686915 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "6"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1687697 1687782 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "7"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1687942 1688047 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "8"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1688620 1688749 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "9"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1693391 1693474 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "10"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1696667 1696885 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "11"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1709728 1709909 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003965"; exon_number "12"; gene_name "NADK"; oId "uc001aic.2"; nearest_ref "uc001aic.2"; class_code "="; tss_id "TSS1975"; p_id "P2984"; chr1 coding exon 1682678 1684499 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "1"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1685006 1685088 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "2"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1685490 1685647 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "3"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1685723 1685822 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "4"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1685983 1686137 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "5"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1686813 1686915 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "6"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1687697 1687782 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "7"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1687942 1688047 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "8"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1688620 1688749 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "9"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1693391 1693474 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "10"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1696667 1696885 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "11"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1710185 1710290 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003966"; exon_number "12"; gene_name "NADK"; oId "uc001aid.3"; nearest_ref "uc001aid.3"; class_code "="; tss_id "TSS1976"; p_id "P2984"; chr1 coding exon 1682678 1684499 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "1"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1685006 1685088 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "2"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1685490 1685647 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "3"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1685723 1685822 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "4"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1685983 1686137 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "5"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1686813 1686915 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "6"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1687697 1687782 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "7"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1687942 1688096 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "8"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1688546 1688749 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "9"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1690540 1690682 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "10"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1691173 1691341 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "11"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1693391 1693474 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "12"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1696667 1696885 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "13"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1711344 1711508 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003967"; exon_number "14"; gene_name "NADK"; oId "uc001aie.2"; nearest_ref "uc001aie.2"; class_code "="; tss_id "TSS1977"; p_id "P2982"; chr1 coding exon 1685549 1685822 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "1"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1685983 1686137 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "2"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1686813 1686915 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "3"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1687697 1687782 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "4"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1687942 1688321 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "5"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1688620 1688749 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "6"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1693391 1693474 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "7"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1696667 1696885 . - . gene_id "XLOC_001256"; transcript_id "TCONS_00003968"; exon_number "8"; gene_name "NADK"; oId "uc009vkx.1"; nearest_ref "uc009vkx.1"; class_code "="; tss_id "TSS1978"; p_id "P2981"; chr1 coding exon 1716730 1718492 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "1"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1718761 1718876 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "2"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1720492 1720708 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "3"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1721834 1722035 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "4"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1724684 1724750 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "5"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1735858 1736020 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "6"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1737914 1737977 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "7"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1756836 1756938 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "8"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1770629 1770677 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "9"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1822259 1822495 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003970"; exon_number "10"; gene_name "GNB1"; oId "uc009vky.2"; nearest_ref "uc009vky.2"; class_code "="; tss_id "TSS1979"; p_id "P2986"; chr1 coding exon 1716730 1718492 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "1"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1718761 1718876 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "2"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1720492 1720708 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "3"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1721834 1722035 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "4"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1724684 1724750 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "5"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1735858 1736020 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "6"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1737914 1737977 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "7"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1747195 1747301 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "8"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1749276 1749314 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "9"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1756836 1756938 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "10"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1770629 1770677 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "11"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1822259 1822495 . - . gene_id "XLOC_001257"; transcript_id "TCONS_00003969"; exon_number "12"; gene_name "GNB1"; oId "uc001aif.2"; nearest_ref "uc001aif.2"; class_code "="; tss_id "TSS1979"; p_id "P2985"; chr1 coding exon 1849029 1849601 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003971"; exon_number "1"; gene_name "TMEM52"; oId "uc001aii.2"; nearest_ref "uc001aii.2"; class_code "="; tss_id "TSS1980"; p_id "P2988"; chr1 coding exon 1849692 1850236 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003971"; exon_number "2"; gene_name "TMEM52"; oId "uc001aii.2"; nearest_ref "uc001aii.2"; class_code "="; tss_id "TSS1980"; p_id "P2988"; chr1 coding exon 1849029 1849601 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003972"; exon_number "1"; gene_name "TMEM52"; oId "uc001aij.2"; nearest_ref "uc001aij.2"; class_code "="; tss_id "TSS1981"; p_id "P2987"; chr1 coding exon 1849692 1849870 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003972"; exon_number "2"; gene_name "TMEM52"; oId "uc001aij.2"; nearest_ref "uc001aij.2"; class_code "="; tss_id "TSS1981"; p_id "P2987"; chr1 coding exon 1850332 1850373 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003972"; exon_number "3"; gene_name "TMEM52"; oId "uc001aij.2"; nearest_ref "uc001aij.2"; class_code "="; tss_id "TSS1981"; p_id "P2987"; chr1 coding exon 1850484 1850527 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003972"; exon_number "4"; gene_name "TMEM52"; oId "uc001aij.2"; nearest_ref "uc001aij.2"; class_code "="; tss_id "TSS1981"; p_id "P2987"; chr1 coding exon 1850621 1850740 . - . gene_id "XLOC_001258"; transcript_id "TCONS_00003972"; exon_number "5"; gene_name "TMEM52"; oId "uc001aij.2"; nearest_ref "uc001aij.2"; class_code "="; tss_id "TSS1981"; p_id "P2987"; chr1 coding exon 1853397 1853827 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "1"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1854028 1854162 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "2"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1854424 1854584 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "3"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1854806 1854938 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "4"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1855214 1855368 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "5"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1855830 1855959 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "6"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1857222 1857377 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "7"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1857667 1857786 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "8"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1857896 1857951 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "9"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1858091 1858200 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "10"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1858333 1858842 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003973"; exon_number "11"; gene_name "C1orf222"; oId "uc001aik.2"; nearest_ref "uc001aik.2"; class_code "="; tss_id "TSS1982"; p_id "P2989"; chr1 coding exon 1853397 1853827 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "1"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1854028 1854162 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "2"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1854424 1854584 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "3"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1854806 1854938 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "4"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1855214 1855368 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "5"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1855830 1855959 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "6"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1857222 1857377 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "7"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1857667 1857786 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "8"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1857896 1857951 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "9"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1858091 1859368 . - . gene_id "XLOC_001259"; transcript_id "TCONS_00003974"; exon_number "10"; gene_name "C1orf222"; oId "uc001ail.2"; nearest_ref "uc001ail.2"; class_code "="; tss_id "TSS1983"; p_id "P2989"; chr1 coding exon 1884752 1887289 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "1"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1888059 1888223 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "2"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1890559 1890648 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "3"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1891403 1891469 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "4"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1895188 1895306 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "5"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1896327 1896500 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "6"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1897810 1897965 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "7"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1900074 1900272 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "8"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1902098 1902255 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "9"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1903419 1903521 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "10"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1904376 1904486 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "11"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1905464 1905637 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "12"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1916825 1916929 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "13"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1918376 1918474 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "14"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1919951 1920094 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "15"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1920328 1920412 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "16"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1922329 1922414 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "17"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1935140 1935276 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003975"; exon_number "18"; gene_name "KIAA1751"; oId "uc001aim.1"; nearest_ref "uc001aim.1"; class_code "="; tss_id "TSS1984"; p_id "P2992"; chr1 coding exon 1886586 1886962 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "1"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1887130 1887289 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "2"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1888059 1888223 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "3"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1890559 1890648 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "4"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1891403 1891469 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "5"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1895188 1895306 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "6"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1896327 1896500 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "7"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1897810 1897965 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "8"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1900074 1900272 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "9"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1902098 1902255 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "10"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1903419 1903521 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "11"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1904376 1904486 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "12"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1905464 1905637 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "13"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1916825 1916929 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "14"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1918376 1918474 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "15"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1919951 1920094 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "16"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1920328 1920412 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "17"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1922329 1922414 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003976"; exon_number "18"; gene_name "KIAA1751"; oId "uc009vkz.1"; nearest_ref "uc009vkz.1"; class_code "="; tss_id "TSS1985"; p_id "P2991"; chr1 coding exon 1915110 1916551 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "1"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 coding exon 1916778 1916929 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "2"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 coding exon 1918376 1918474 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "3"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 coding exon 1919951 1920094 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "4"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 coding exon 1920328 1920412 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "5"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 coding exon 1922329 1922414 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "6"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 coding exon 1935140 1935276 . - . gene_id "XLOC_001260"; transcript_id "TCONS_00003977"; exon_number "7"; gene_name "KIAA1751"; oId "uc001ain.1"; nearest_ref "uc001ain.1"; class_code "="; tss_id "TSS1984"; p_id "P2990"; chr1 noncoding exon 1944652 1946439 . - . gene_id "XLOC_001261"; transcript_id "TCONS_00003978"; exon_number "1"; oId "uc001aio.1"; nearest_ref "uc001aio.1"; class_code "="; tss_id "TSS1986"; chr1 noncoding exon 1946804 1946969 . - . gene_id "XLOC_001261"; transcript_id "TCONS_00003978"; exon_number "2"; oId "uc001aio.1"; nearest_ref "uc001aio.1"; class_code "="; tss_id "TSS1986"; chr1 coding exon 2113233 2114180 . - . gene_id "XLOC_001262"; transcript_id "TCONS_00003979"; exon_number "1"; oId "uc009vlc.1"; nearest_ref "uc009vlc.1"; class_code "="; tss_id "TSS1987"; p_id "P2993"; chr1 coding exon 2115010 2115314 . - . gene_id "XLOC_001262"; transcript_id "TCONS_00003979"; exon_number "2"; oId "uc009vlc.1"; nearest_ref "uc009vlc.1"; class_code "="; tss_id "TSS1987"; p_id "P2993"; chr1 nearCoding exon 2115917 2116952 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "1"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2117443 2117688 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "2"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2118277 2118645 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "3"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2121152 2121220 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "4"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2125078 2125349 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "5"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2125437 2125572 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "6"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2126127 2126214 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003981"; exon_number "7"; gene_name "C1orf86"; oId "uc001aiw.1"; nearest_ref "uc001aiw.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2115917 2116952 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "1"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2117443 2117688 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "2"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2118277 2118645 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "3"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2121152 2121220 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "4"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2124284 2124414 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "5"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2125078 2125349 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "6"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2125437 2125572 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "7"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 nearCoding exon 2126127 2126214 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003980"; exon_number "8"; oId "uc001aiv.1"; nearest_ref "uc001aiv.1"; class_code "="; tss_id "TSS1988"; chr1 coding exon 2115917 2116952 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "1"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2125078 2125349 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "2"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2129446 2129581 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "3"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2132489 2132664 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "4"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2134875 2135069 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "5"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2137744 2137863 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "6"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2137954 2138106 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "7"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2138995 2139172 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003982"; exon_number "8"; oId "uc001aix.1"; nearest_ref "uc001aix.1"; class_code "="; tss_id "TSS1989"; p_id "P2994"; chr1 coding exon 2120989 2121220 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003983"; exon_number "1"; gene_name "C1orf86"; oId "uc001aiy.2"; nearest_ref "uc001aiy.2"; class_code "="; tss_id "TSS1988"; p_id "P2995"; chr1 coding exon 2125078 2125349 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003983"; exon_number "2"; gene_name "C1orf86"; oId "uc001aiy.2"; nearest_ref "uc001aiy.2"; class_code "="; tss_id "TSS1988"; p_id "P2995"; chr1 coding exon 2125437 2125572 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003983"; exon_number "3"; gene_name "C1orf86"; oId "uc001aiy.2"; nearest_ref "uc001aiy.2"; class_code "="; tss_id "TSS1988"; p_id "P2995"; chr1 coding exon 2126127 2126214 . - . gene_id "XLOC_001263"; transcript_id "TCONS_00003983"; exon_number "4"; gene_name "C1orf86"; oId "uc001aiy.2"; nearest_ref "uc001aiy.2"; class_code "="; tss_id "TSS1988"; p_id "P2995"; chr1 coding exon 2252696 2253018 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "1"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2255536 2255582 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "2"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2267908 2267987 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "3"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2268156 2268289 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "4"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2288871 2289037 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "5"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2290031 2290154 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "6"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2303920 2304030 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "7"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2305900 2305996 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "8"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2316417 2316504 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "9"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2317246 2317336 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "10"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2318858 2318968 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "11"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2319678 2319776 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "12"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2321364 2321435 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "13"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2322897 2322993 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003984"; exon_number "14"; gene_name "MORN1"; oId "uc001ajb.1"; nearest_ref "uc001ajb.1"; class_code "="; tss_id "TSS1990"; p_id "P2999"; chr1 coding exon 2263566 2264192 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "1"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2267908 2267987 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "2"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2268156 2268289 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "3"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2288871 2289037 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "4"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2290031 2290154 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "5"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2303920 2304030 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "6"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2305900 2305996 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "7"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2316417 2316504 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "8"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2317246 2317336 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "9"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2318858 2318968 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "10"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2319678 2319776 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "11"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2322897 2322993 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003985"; exon_number "12"; gene_name "MORN1"; oId "uc009vld.2"; nearest_ref "uc009vld.2"; class_code "="; tss_id "TSS1990"; p_id "P2998"; chr1 coding exon 2286616 2286903 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "1"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2288871 2289037 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "2"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2290031 2290154 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "3"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2303920 2304030 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "4"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2305900 2305996 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "5"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2316417 2316504 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "6"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2317246 2317336 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "7"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2318858 2318968 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "8"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2319678 2319776 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "9"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2321364 2321435 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "10"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2322897 2322993 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003987"; exon_number "11"; gene_name "MORN1"; oId "uc001ajd.1"; nearest_ref "uc001ajd.1"; class_code "="; tss_id "TSS1990"; p_id "P2997"; chr1 coding exon 2309495 2310419 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "1"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 coding exon 2310548 2310666 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "2"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 coding exon 2316417 2316504 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "3"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 coding exon 2317246 2317336 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "4"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 coding exon 2318858 2318968 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "5"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 coding exon 2319678 2319776 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "6"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 coding exon 2322897 2322993 . - . gene_id "XLOC_001264"; transcript_id "TCONS_00003988"; exon_number "7"; gene_name "MORN1"; oId "uc010nyy.1"; nearest_ref "uc010nyy.1"; class_code "="; tss_id "TSS1990"; p_id "P2996"; chr1 noncoding exon 2281853 2284100 . - . gene_id "XLOC_001265"; transcript_id "TCONS_00003986"; exon_number "1"; oId "uc001ajc.3"; nearest_ref "uc001ajc.3"; class_code "="; chr1 coding exon 2336243 2337273 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003990"; exon_number "1"; gene_name "PEX10"; oId "uc001ajh.2"; nearest_ref "uc001ajh.2"; class_code "="; tss_id "TSS1991"; p_id "P3001"; chr1 coding exon 2337923 2338058 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003990"; exon_number "2"; gene_name "PEX10"; oId "uc001ajh.2"; nearest_ref "uc001ajh.2"; class_code "="; tss_id "TSS1991"; p_id "P3001"; chr1 coding exon 2338159 2338334 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003990"; exon_number "3"; gene_name "PEX10"; oId "uc001ajh.2"; nearest_ref "uc001ajh.2"; class_code "="; tss_id "TSS1991"; p_id "P3001"; chr1 coding exon 2339891 2340297 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003990"; exon_number "4"; gene_name "PEX10"; oId "uc001ajh.2"; nearest_ref "uc001ajh.2"; class_code "="; tss_id "TSS1991"; p_id "P3001"; chr1 coding exon 2341810 2341890 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003990"; exon_number "5"; gene_name "PEX10"; oId "uc001ajh.2"; nearest_ref "uc001ajh.2"; class_code "="; tss_id "TSS1991"; p_id "P3001"; chr1 coding exon 2343830 2344010 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003990"; exon_number "6"; gene_name "PEX10"; oId "uc001ajh.2"; nearest_ref "uc001ajh.2"; class_code "="; tss_id "TSS1991"; p_id "P3001"; chr1 coding exon 2336243 2337273 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003989"; exon_number "1"; gene_name "PEX10"; oId "uc001ajg.2"; nearest_ref "uc001ajg.2"; class_code "="; tss_id "TSS1991"; p_id "P3000"; chr1 coding exon 2337923 2338058 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003989"; exon_number "2"; gene_name "PEX10"; oId "uc001ajg.2"; nearest_ref "uc001ajg.2"; class_code "="; tss_id "TSS1991"; p_id "P3000"; chr1 coding exon 2338159 2338394 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003989"; exon_number "3"; gene_name "PEX10"; oId "uc001ajg.2"; nearest_ref "uc001ajg.2"; class_code "="; tss_id "TSS1991"; p_id "P3000"; chr1 coding exon 2339891 2340297 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003989"; exon_number "4"; gene_name "PEX10"; oId "uc001ajg.2"; nearest_ref "uc001ajg.2"; class_code "="; tss_id "TSS1991"; p_id "P3000"; chr1 coding exon 2341810 2341890 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003989"; exon_number "5"; gene_name "PEX10"; oId "uc001ajg.2"; nearest_ref "uc001ajg.2"; class_code "="; tss_id "TSS1991"; p_id "P3000"; chr1 coding exon 2343830 2344010 . - . gene_id "XLOC_001266"; transcript_id "TCONS_00003989"; exon_number "6"; gene_name "PEX10"; oId "uc001ajg.2"; nearest_ref "uc001ajg.2"; class_code "="; tss_id "TSS1991"; p_id "P3000"; chr1 coding exon 2439975 2440499 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "1"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2441301 2441369 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "2"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2441496 2441596 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "3"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2442117 2442221 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "4"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2442777 2442826 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "5"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2443067 2443122 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "6"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2444327 2444478 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "7"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2445441 2445528 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "8"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2445793 2445905 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "9"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2447001 2447156 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "10"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2449603 2449703 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "11"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2449955 2450036 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "12"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2450582 2450763 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "13"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2451240 2451393 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "14"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2451761 2451853 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "15"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2452162 2452272 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "16"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2452584 2452754 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "17"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2453157 2453239 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "18"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2457903 2458035 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003992"; exon_number "19"; gene_name "PANK4"; oId "uc010nza.1"; nearest_ref "uc010nza.1"; class_code "="; tss_id "TSS1992"; p_id "P3003"; chr1 coding exon 2439975 2440499 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "1"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2441301 2441369 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "2"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2441496 2441596 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "3"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2442117 2442221 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "4"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2442777 2442826 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "5"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2443067 2443122 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "6"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2444327 2444478 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "7"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2445441 2445528 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "8"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2445793 2445905 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "9"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2447001 2447156 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "10"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2449603 2449703 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "11"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2449955 2450036 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "12"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2450582 2450763 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "13"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2451240 2451393 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "14"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2451761 2451853 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "15"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2452162 2452345 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "16"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2452540 2452754 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "17"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2453157 2453239 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "18"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2457903 2458035 . - . gene_id "XLOC_001267"; transcript_id "TCONS_00003991"; exon_number "19"; gene_name "PANK4"; oId "uc001ajm.1"; nearest_ref "uc001ajm.1"; class_code "="; tss_id "TSS1992"; p_id "P3002"; chr1 coding exon 2460185 2461188 . - . gene_id "XLOC_001268"; transcript_id "TCONS_00003993"; exon_number "1"; gene_name "HES5"; oId "uc001ajn.2"; nearest_ref "uc001ajn.2"; class_code "="; tss_id "TSS1993"; p_id "P3004"; chr1 coding exon 2461285 2461450 . - . gene_id "XLOC_001268"; transcript_id "TCONS_00003993"; exon_number "2"; gene_name "HES5"; oId "uc001ajn.2"; nearest_ref "uc001ajn.2"; class_code "="; tss_id "TSS1993"; p_id "P3004"; chr1 coding exon 2461550 2461684 . - . gene_id "XLOC_001268"; transcript_id "TCONS_00003993"; exon_number "3"; gene_name "HES5"; oId "uc001ajn.2"; nearest_ref "uc001ajn.2"; class_code "="; tss_id "TSS1993"; p_id "P3004"; chr1 noncoding exon 2481359 2481713 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003995"; exon_number "1"; oId "uc001ajp.2"; nearest_ref "uc001ajp.2"; class_code "="; tss_id "TSS1994"; chr1 noncoding exon 2482431 2484284 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003995"; exon_number "2"; oId "uc001ajp.2"; nearest_ref "uc001ajp.2"; class_code "="; tss_id "TSS1994"; chr1 noncoding exon 2481359 2481713 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003994"; exon_number "1"; oId "uc001ajo.2"; nearest_ref "uc001ajo.2"; class_code "="; tss_id "TSS1994"; chr1 noncoding exon 2482012 2482170 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003994"; exon_number "2"; oId "uc001ajo.2"; nearest_ref "uc001ajo.2"; class_code "="; tss_id "TSS1994"; chr1 noncoding exon 2482431 2484284 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003994"; exon_number "3"; oId "uc001ajo.2"; nearest_ref "uc001ajo.2"; class_code "="; tss_id "TSS1994"; chr1 noncoding exon 2481722 2482170 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003996"; exon_number "1"; oId "uc001ajq.2"; nearest_ref "uc001ajq.2"; class_code "="; tss_id "TSS1994"; chr1 noncoding exon 2482431 2484284 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003996"; exon_number "2"; oId "uc001ajq.2"; nearest_ref "uc001ajq.2"; class_code "="; tss_id "TSS1994"; chr1 antisense exon 2483214 2484142 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003997"; exon_number "1"; oId "uc010nzb.1"; nearest_ref "uc010nzb.1"; class_code "="; tss_id "TSS1995"; chr1 antisense exon 2485065 2485253 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003997"; exon_number "2"; oId "uc010nzb.1"; nearest_ref "uc010nzb.1"; class_code "="; tss_id "TSS1995"; chr1 antisense exon 2485540 2485735 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003997"; exon_number "3"; oId "uc010nzb.1"; nearest_ref "uc010nzb.1"; class_code "="; tss_id "TSS1995"; chr1 antisense exon 2486163 2488135 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003997"; exon_number "4"; oId "uc010nzb.1"; nearest_ref "uc010nzb.1"; class_code "="; tss_id "TSS1995"; chr1 antisense exon 2488416 2488450 . - . gene_id "XLOC_001269"; transcript_id "TCONS_00003997"; exon_number "5"; oId "uc010nzb.1"; nearest_ref "uc010nzb.1"; class_code "="; tss_id "TSS1995"; chr1 nearCoding exon 2522081 2522528 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "1"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2522996 2523072 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "2"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2523371 2523466 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "3"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2524094 2524159 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "4"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2524272 2524405 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "5"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2525253 2525401 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "6"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2525824 2525882 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "7"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2526229 2526332 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "8"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2526715 2526798 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "9"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2527448 2527546 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "10"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2528000 2528128 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "11"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2529646 2529739 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "12"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2530093 2530229 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "13"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2535323 2535412 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "14"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2535586 2535720 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "15"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2536997 2537062 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "16"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2537687 2537805 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "17"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2538413 2538508 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "18"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2540778 2540858 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "19"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2541109 2541270 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "20"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2542720 2542779 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "21"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2543566 2543643 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "22"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 nearCoding exon 2560770 2560960 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003998"; exon_number "23"; gene_name "MMEL1"; oId "uc009vlg.1"; nearest_ref "uc009vlg.1"; class_code "="; tss_id "TSS1996"; chr1 coding exon 2522081 2522528 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "1"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2522996 2523072 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "2"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2523371 2523466 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "3"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2524094 2524159 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "4"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2524272 2524405 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "5"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2525253 2525372 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "6"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2525824 2525882 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "7"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2526229 2526332 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "8"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2526715 2526798 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "9"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2527448 2527546 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "10"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2528000 2528128 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "11"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2529646 2529739 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "12"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2530093 2530229 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "13"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2535323 2535412 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "14"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2535586 2535720 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "15"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2536997 2537062 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "16"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2537687 2537805 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "17"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2538413 2538508 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "18"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2540778 2540858 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "19"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2541109 2541270 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "20"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2542720 2542779 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "21"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2543566 2543643 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "22"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2560770 2560960 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "23"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 coding exon 2564305 2564481 . - . gene_id "XLOC_001270"; transcript_id "TCONS_00003999"; exon_number "24"; gene_name "MMEL1"; oId "uc001ajy.2"; nearest_ref "uc001ajy.2"; class_code "="; tss_id "TSS1997"; p_id "P3005"; chr1 noncoding exon 2976183 2976301 . - . gene_id "XLOC_001271"; transcript_id "TCONS_00004000"; exon_number "1"; oId "uc001aka.2"; nearest_ref "uc001aka.2"; class_code "="; tss_id "TSS1998"; chr1 noncoding exon 2976794 2976847 . - . gene_id "XLOC_001271"; transcript_id "TCONS_00004000"; exon_number "2"; oId "uc001aka.2"; nearest_ref "uc001aka.2"; class_code "="; tss_id "TSS1998"; chr1 noncoding exon 2977065 2977168 . - . gene_id "XLOC_001271"; transcript_id "TCONS_00004000"; exon_number "3"; oId "uc001aka.2"; nearest_ref "uc001aka.2"; class_code "="; tss_id "TSS1998"; chr1 noncoding exon 2977671 2977895 . - . gene_id "XLOC_001271"; transcript_id "TCONS_00004000"; exon_number "4"; oId "uc001aka.2"; nearest_ref "uc001aka.2"; class_code "="; tss_id "TSS1998"; chr1 noncoding exon 2978155 2978377 . - . gene_id "XLOC_001271"; transcript_id "TCONS_00004000"; exon_number "5"; oId "uc001aka.2"; nearest_ref "uc001aka.2"; class_code "="; tss_id "TSS1998"; chr1 noncoding exon 2978854 2980350 . - . gene_id "XLOC_001271"; transcript_id "TCONS_00004000"; exon_number "6"; oId "uc001aka.2"; nearest_ref "uc001aka.2"; class_code "="; tss_id "TSS1998"; chr1 coding exon 2980636 2980866 . - . gene_id "XLOC_001272"; transcript_id "TCONS_00004001"; exon_number "1"; oId "uc010nzg.1"; nearest_ref "uc010nzg.1"; class_code "="; tss_id "TSS1999"; p_id "P3006"; chr1 coding exon 2983901 2984289 . - . gene_id "XLOC_001272"; transcript_id "TCONS_00004001"; exon_number "2"; oId "uc010nzg.1"; nearest_ref "uc010nzg.1"; class_code "="; tss_id "TSS1999"; p_id "P3006"; chr1 coding exon 3404513 3407153 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "1"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3407476 3407523 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "2"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3409203 3409331 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "3"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3410335 3410361 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "4"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3410935 3411063 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "5"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3411177 3411305 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "6"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3412454 3412582 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "7"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3413219 3413347 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "8"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3413797 3413925 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "9"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3414935 3415063 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "10"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3416152 3416280 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "11"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3416360 3416488 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "12"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3417197 3417328 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "13"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3417530 3417658 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "14"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3417741 3417872 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "15"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3418360 3418485 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "16"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3421772 3421906 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "17"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3421986 3422120 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "18"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3422672 3422800 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "19"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3424359 3424487 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "20"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3425122 3425253 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "21"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3425639 3425809 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "22"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3426434 3426556 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "23"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3427347 3427466 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "24"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3428114 3428251 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "25"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3428570 3428692 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "26"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3431114 3431236 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "27"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3431966 3432091 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "28"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3440688 3440810 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "29"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3447644 3448012 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004002"; exon_number "30"; gene_name "MEGF6"; oId "uc001akk.2"; nearest_ref "uc001akk.2"; class_code "="; tss_id "TSS2000"; p_id "P3007"; chr1 coding exon 3404513 3407153 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "1"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3407476 3407523 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "2"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3409203 3409331 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "3"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3410335 3410463 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "4"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3410560 3410688 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "5"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3410935 3411063 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "6"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3411177 3411305 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "7"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3412454 3412582 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "8"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3413219 3413347 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "9"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3413552 3413683 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "10"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3413797 3413925 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "11"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3414935 3415063 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "12"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3415262 3415390 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "13"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3415702 3415830 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "14"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3416152 3416280 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "15"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3416360 3416488 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "16"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3417197 3417328 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "17"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3417530 3417658 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "18"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3417741 3417872 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "19"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3418360 3418485 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "20"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3421772 3421906 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "21"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3421986 3422120 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "22"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3422672 3422800 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "23"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3424359 3424487 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "24"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3425122 3425253 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "25"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3425639 3425809 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "26"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3426434 3426556 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "27"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3427347 3427466 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "28"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3428114 3428251 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "29"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3428570 3428692 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "30"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3431114 3431236 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "31"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3431966 3432091 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "32"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3440688 3440810 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "33"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3496389 3496493 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "34"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3511902 3512011 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "35"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3519030 3519164 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "36"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3527702 3528059 . - . gene_id "XLOC_001273"; transcript_id "TCONS_00004003"; exon_number "37"; gene_name "MEGF6"; oId "uc001akl.2"; nearest_ref "uc001akl.2"; class_code "="; tss_id "TSS2001"; p_id "P3008"; chr1 coding exon 3547332 3547681 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "1"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3548030 3548221 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "2"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3548777 3548902 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "3"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3549962 3550067 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "4"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3551561 3551638 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "5"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3551724 3551858 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "6"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3552508 3552594 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "7"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3553559 3553662 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "8"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3555314 3555386 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "9"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3563230 3563346 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "10"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3563972 3564124 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "11"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3566495 3566671 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004004"; exon_number "12"; gene_name "WDR8"; oId "uc001ako.2"; nearest_ref "uc001ako.2"; class_code "="; tss_id "TSS2002"; p_id "P3009"; chr1 coding exon 3547337 3548221 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "1"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3548777 3548902 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "2"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3549962 3550067 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "3"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3551561 3551638 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "4"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3551724 3551858 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "5"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3552508 3552594 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "6"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3553559 3553662 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "7"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3555314 3555386 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "8"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3563230 3563346 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "9"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3563972 3564124 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "10"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3566495 3566671 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004005"; exon_number "11"; gene_name "WDR8"; oId "uc001akn.3"; nearest_ref "uc001akn.3"; class_code "="; tss_id "TSS2002"; p_id "P3010"; chr1 coding exon 3548459 3553662 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004006"; exon_number "1"; gene_name "WDR8"; oId "uc010nzi.1"; nearest_ref "uc010nzi.1"; class_code "="; tss_id "TSS2002"; p_id "P3011"; chr1 coding exon 3555314 3555386 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004006"; exon_number "2"; gene_name "WDR8"; oId "uc010nzi.1"; nearest_ref "uc010nzi.1"; class_code "="; tss_id "TSS2002"; p_id "P3011"; chr1 coding exon 3563230 3563346 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004006"; exon_number "3"; gene_name "WDR8"; oId "uc010nzi.1"; nearest_ref "uc010nzi.1"; class_code "="; tss_id "TSS2002"; p_id "P3011"; chr1 coding exon 3563972 3564124 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004006"; exon_number "4"; gene_name "WDR8"; oId "uc010nzi.1"; nearest_ref "uc010nzi.1"; class_code "="; tss_id "TSS2002"; p_id "P3011"; chr1 coding exon 3566495 3566671 . - . gene_id "XLOC_001274"; transcript_id "TCONS_00004006"; exon_number "5"; gene_name "WDR8"; oId "uc010nzi.1"; nearest_ref "uc010nzi.1"; class_code "="; tss_id "TSS2002"; p_id "P3011"; chr1 nearCoding exon 3652550 3654418 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004007"; exon_number "1"; oId "uc001akt.3"; nearest_ref "uc001akt.3"; class_code "="; tss_id "TSS2003"; chr1 nearCoding exon 3656797 3656951 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004007"; exon_number "2"; oId "uc001akt.3"; nearest_ref "uc001akt.3"; class_code "="; tss_id "TSS2003"; chr1 nearCoding exon 3659368 3659475 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004007"; exon_number "3"; oId "uc001akt.3"; nearest_ref "uc001akt.3"; class_code "="; tss_id "TSS2003"; chr1 nearCoding exon 3659625 3659754 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004007"; exon_number "4"; oId "uc001akt.3"; nearest_ref "uc001akt.3"; class_code "="; tss_id "TSS2003"; chr1 nearCoding exon 3662171 3662745 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004007"; exon_number "5"; oId "uc001akt.3"; nearest_ref "uc001akt.3"; class_code "="; tss_id "TSS2003"; chr1 nearCoding exon 3662851 3663335 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004007"; exon_number "6"; oId "uc001akt.3"; nearest_ref "uc001akt.3"; class_code "="; tss_id "TSS2003"; chr1 coding exon 3652550 3656951 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004008"; exon_number "1"; gene_name "KIAA0495"; oId "uc009vlm.2"; nearest_ref "uc009vlm.2"; class_code "="; tss_id "TSS2004"; p_id "P3012"; chr1 coding exon 3659368 3659475 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004008"; exon_number "2"; gene_name "KIAA0495"; oId "uc009vlm.2"; nearest_ref "uc009vlm.2"; class_code "="; tss_id "TSS2004"; p_id "P3012"; chr1 coding exon 3659625 3659754 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004008"; exon_number "3"; gene_name "KIAA0495"; oId "uc009vlm.2"; nearest_ref "uc009vlm.2"; class_code "="; tss_id "TSS2004"; p_id "P3012"; chr1 coding exon 3662171 3663886 . - . gene_id "XLOC_001275"; transcript_id "TCONS_00004008"; exon_number "4"; gene_name "KIAA0495"; oId "uc009vlm.2"; nearest_ref "uc009vlm.2"; class_code "="; tss_id "TSS2004"; p_id "P3012"; chr1 coding exon 3696784 3697900 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "1"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3698076 3698165 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "2"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3699225 3699327 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "3"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3700560 3700675 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "4"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3701651 3701767 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "5"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3703413 3703874 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "6"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3712426 3713068 . - . gene_id "XLOC_001276"; transcript_id "TCONS_00004009"; exon_number "7"; gene_name "LRRC47"; oId "uc001akx.1"; nearest_ref "uc001akx.1"; class_code "="; tss_id "TSS2005"; p_id "P3013"; chr1 coding exon 3728645 3732081 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "1"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3732844 3732934 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "2"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3739738 3739805 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "3"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3739988 3740126 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "4"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3742322 3742430 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "5"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3742934 3743000 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "6"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3743272 3743308 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "7"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3745830 3745937 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "8"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3746355 3746561 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "9"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3747610 3747786 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "10"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3750426 3750599 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "11"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3751489 3751656 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "12"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3753059 3753256 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "13"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3753856 3754083 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "14"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3755528 3755683 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "15"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3756172 3756340 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "16"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3761471 3761547 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "17"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3761853 3761915 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "18"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3764039 3764177 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "19"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3765172 3765345 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "20"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3768859 3768985 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "21"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 coding exon 3773453 3773797 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004010"; exon_number "22"; gene_name "KIAA0562"; oId "uc001aky.2"; nearest_ref "uc001aky.2"; class_code "="; tss_id "TSS2006"; p_id "P3015"; chr1 nearCoding exon 3728653 3729855 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "1"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3730414 3732081 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "2"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3732844 3732934 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "3"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3739738 3739805 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "4"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3739988 3740126 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "5"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3742322 3742430 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "6"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3742934 3743000 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "7"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3743272 3743308 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "8"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3745830 3745937 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "9"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3746355 3746561 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "10"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3747610 3747786 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "11"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3750426 3750599 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "12"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3751489 3751656 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "13"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3753059 3753256 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "14"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3753856 3754083 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "15"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3755528 3755683 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "16"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3756172 3756340 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "17"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3761471 3761547 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "18"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3761853 3761915 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "19"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3764039 3764177 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "20"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3765172 3765345 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "21"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3768859 3768985 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "22"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 nearCoding exon 3773453 3773797 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004011"; exon_number "23"; gene_name "KIAA0562"; oId "uc010nzm.1"; nearest_ref "uc010nzm.1"; class_code "="; tss_id "TSS2006"; chr1 coding exon 3750236 3750599 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "1"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3751489 3751656 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "2"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3753059 3753256 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "3"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3753856 3754083 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "4"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3755528 3755683 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "5"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3756172 3756340 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "6"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3761471 3761547 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "7"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3761853 3761915 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "8"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3764039 3764177 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "9"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3765172 3765345 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "10"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3768859 3768985 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "11"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 coding exon 3773453 3773797 . - . gene_id "XLOC_001277"; transcript_id "TCONS_00004012"; exon_number "12"; gene_name "KIAA0562"; oId "uc001akz.2"; nearest_ref "uc001akz.2"; class_code "="; tss_id "TSS2006"; p_id "P3014"; chr1 nearCoding exon 3805703 3806637 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004014"; exon_number "1"; gene_name "C1orf174"; oId "uc009vls.2"; nearest_ref "uc009vls.2"; class_code "="; tss_id "TSS2007"; chr1 nearCoding exon 3807133 3807621 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004014"; exon_number "2"; gene_name "C1orf174"; oId "uc009vls.2"; nearest_ref "uc009vls.2"; class_code "="; tss_id "TSS2007"; chr1 nearCoding exon 3809447 3809560 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004014"; exon_number "3"; gene_name "C1orf174"; oId "uc009vls.2"; nearest_ref "uc009vls.2"; class_code "="; tss_id "TSS2007"; chr1 nearCoding exon 3811859 3812106 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004014"; exon_number "4"; gene_name "C1orf174"; oId "uc009vls.2"; nearest_ref "uc009vls.2"; class_code "="; tss_id "TSS2007"; chr1 nearCoding exon 3812151 3812747 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004014"; exon_number "5"; gene_name "C1orf174"; oId "uc009vls.2"; nearest_ref "uc009vls.2"; class_code "="; tss_id "TSS2007"; chr1 nearCoding exon 3816736 3816857 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004014"; exon_number "6"; gene_name "C1orf174"; oId "uc009vls.2"; nearest_ref "uc009vls.2"; class_code "="; tss_id "TSS2007"; chr1 coding exon 3805703 3806637 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004013"; exon_number "1"; gene_name "C1orf174"; oId "uc001alf.2"; nearest_ref "uc001alf.2"; class_code "="; tss_id "TSS2007"; p_id "P3016"; chr1 coding exon 3807133 3807621 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004013"; exon_number "2"; gene_name "C1orf174"; oId "uc001alf.2"; nearest_ref "uc001alf.2"; class_code "="; tss_id "TSS2007"; p_id "P3016"; chr1 coding exon 3809447 3809560 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004013"; exon_number "3"; gene_name "C1orf174"; oId "uc001alf.2"; nearest_ref "uc001alf.2"; class_code "="; tss_id "TSS2007"; p_id "P3016"; chr1 coding exon 3816736 3816857 . - . gene_id "XLOC_001278"; transcript_id "TCONS_00004013"; exon_number "4"; gene_name "C1orf174"; oId "uc001alf.2"; nearest_ref "uc001alf.2"; class_code "="; tss_id "TSS2007"; p_id "P3016"; chr1 noncoding exon 5621769 5622314 . - . gene_id "XLOC_001279"; transcript_id "TCONS_00004015"; exon_number "1"; oId "uc001alp.1"; nearest_ref "uc001alp.1"; class_code "="; tss_id "TSS2008"; chr1 noncoding exon 5623230 5623415 . - . gene_id "XLOC_001279"; transcript_id "TCONS_00004015"; exon_number "2"; oId "uc001alp.1"; nearest_ref "uc001alp.1"; class_code "="; tss_id "TSS2008"; chr1 noncoding exon 5728201 5728315 . - . gene_id "XLOC_001279"; transcript_id "TCONS_00004015"; exon_number "3"; oId "uc001alp.1"; nearest_ref "uc001alp.1"; class_code "="; tss_id "TSS2008"; chr1 coding exon 5922870 5923465 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "1"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5923950 5924093 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "2"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5924398 5924577 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "3"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5925162 5925333 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "4"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5926433 5926518 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "5"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5927090 5927175 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "6"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5927800 5927956 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "7"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5933312 5933395 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "8"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5934531 5934717 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "9"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5934934 5935160 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "10"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5937153 5937358 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "11"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5940174 5940299 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "12"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5947346 5947526 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "13"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5950928 5951088 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "14"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5964677 5964864 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "15"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5965352 5965543 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "16"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5965692 5965843 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "17"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5967175 5967282 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "18"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5969212 5969273 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "19"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5987709 5987847 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "20"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5993207 5993389 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "21"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6007164 6007290 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "22"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6008130 6008311 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "23"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6012760 6012896 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "24"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6021854 6022009 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "25"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6027359 6027423 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "26"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6029147 6029319 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "27"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6038330 6038473 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "28"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6046215 6046387 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "29"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 6052304 6052531 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004016"; exon_number "30"; gene_name "NPHP4"; oId "uc001alq.1"; nearest_ref "uc001alq.1"; class_code "="; tss_id "TSS2009"; p_id "P3018"; chr1 coding exon 5922871 5926518 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004017"; exon_number "1"; gene_name "NPHP4"; oId "uc001alr.1"; nearest_ref "uc001alr.1"; class_code "="; tss_id "TSS2010"; p_id "P3017"; chr1 coding exon 5927090 5927175 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004017"; exon_number "2"; gene_name "NPHP4"; oId "uc001alr.1"; nearest_ref "uc001alr.1"; class_code "="; tss_id "TSS2010"; p_id "P3017"; chr1 coding exon 5927800 5928435 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004017"; exon_number "3"; gene_name "NPHP4"; oId "uc001alr.1"; nearest_ref "uc001alr.1"; class_code "="; tss_id "TSS2010"; p_id "P3017"; chr1 nearCoding exon 5936014 5936138 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "1"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5936446 5936583 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "2"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5937153 5937358 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "3"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5939406 5939692 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "4"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5940174 5940299 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "5"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5947346 5947526 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "6"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5950928 5951088 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "7"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5964677 5964864 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "8"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5965352 5965543 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "9"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5965692 5965840 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "10"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5967175 5967282 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "11"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5969212 5969273 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "12"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5987709 5987847 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "13"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5993207 5993389 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "14"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6007164 6007290 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "15"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6008130 6008311 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "16"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6012760 6012896 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "17"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6021854 6022009 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "18"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6027359 6027423 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "19"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6029147 6029319 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "20"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6038330 6038473 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "21"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6046215 6046387 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "22"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6052304 6052531 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004018"; exon_number "23"; oId "uc001als.1"; nearest_ref "uc001als.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5937153 5937358 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "1"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5940174 5940299 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "2"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5947346 5947526 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "3"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5950928 5951088 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "4"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5964677 5964864 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "5"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5965352 5965543 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "6"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5965692 5965840 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "7"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5987709 5987847 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "8"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5993207 5993389 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "9"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6007164 6007290 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "10"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6008130 6008311 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "11"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6021854 6022009 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "12"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6027359 6027423 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "13"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6029147 6029319 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "14"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6038330 6038473 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "15"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6046215 6046387 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "16"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6052304 6052531 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004020"; exon_number "17"; oId "uc009vlt.1"; nearest_ref "uc009vlt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5937153 5937358 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "1"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5940174 5940299 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "2"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5947346 5947526 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "3"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5950928 5951088 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "4"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5964677 5964864 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "5"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5965352 5965543 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "6"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5965692 5965843 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "7"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5987709 5987847 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "8"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5993207 5993389 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "9"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6007164 6007290 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "10"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6008130 6008311 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "11"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6012760 6012896 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "12"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6021854 6022009 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "13"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6027359 6027423 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "14"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6029147 6029319 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "15"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 6052304 6052531 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004019"; exon_number "16"; oId "uc001alt.1"; nearest_ref "uc001alt.1"; class_code "="; tss_id "TSS2009"; chr1 nearCoding exon 5946557 5947032 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004021"; exon_number "1"; oId "uc009vlu.1"; nearest_ref "uc009vlu.1"; class_code "="; tss_id "TSS2011"; chr1 nearCoding exon 5947346 5947526 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004021"; exon_number "2"; oId "uc009vlu.1"; nearest_ref "uc009vlu.1"; class_code "="; tss_id "TSS2011"; chr1 nearCoding exon 5948520 5948670 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004021"; exon_number "3"; oId "uc009vlu.1"; nearest_ref "uc009vlu.1"; class_code "="; tss_id "TSS2011"; chr1 nearCoding exon 5950928 5951088 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004021"; exon_number "4"; oId "uc009vlu.1"; nearest_ref "uc009vlu.1"; class_code "="; tss_id "TSS2011"; chr1 nearCoding exon 5964677 5964864 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004021"; exon_number "5"; oId "uc009vlu.1"; nearest_ref "uc009vlu.1"; class_code "="; tss_id "TSS2011"; chr1 nearCoding exon 5965352 5965543 . - . gene_id "XLOC_001280"; transcript_id "TCONS_00004021"; exon_number "6"; oId "uc009vlu.1"; nearest_ref "uc009vlu.1"; class_code "="; tss_id "TSS2011"; chr1 coding exon 6161853 6165487 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "1"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6166294 6166347 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "2"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6166676 6166839 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "3"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6169855 6170050 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "4"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6170454 6170586 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "5"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6171835 6171943 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "6"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6172200 6172337 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "7"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6172969 6173058 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "8"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6181165 6181297 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "9"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6181554 6181633 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "10"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6184008 6184167 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "11"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6184577 6184721 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "12"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6185160 6185293 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "13"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6185584 6185672 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "14"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6185826 6185918 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "15"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6186632 6186806 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "16"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6188106 6188278 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "17"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6188559 6188669 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "18"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6188898 6189129 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "19"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6190208 6190388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "20"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 coding exon 6191691 6191808 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004022"; exon_number "21"; gene_name "CHD5"; oId "uc001alz.1"; nearest_ref "uc001alz.1"; class_code "="; tss_id "TSS2012"; p_id "P3020"; chr1 nearCoding exon 6161853 6165487 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "1"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6166294 6166347 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "2"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6166676 6166839 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "3"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6169855 6170050 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "4"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6170454 6170586 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "5"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6171835 6171943 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "6"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6172200 6172337 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "7"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6172969 6173058 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "8"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6173371 6173476 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "9"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6181165 6181297 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "10"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6181554 6181633 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "11"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6184008 6184167 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "12"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6184577 6184721 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "13"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6185160 6185293 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "14"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6185584 6185672 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "15"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6185826 6185918 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "16"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6186632 6186806 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "17"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6188106 6188278 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "18"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6188559 6188669 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "19"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6188898 6189129 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "20"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6190264 6190388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "21"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6191691 6191808 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "22"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6194188 6194319 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "23"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6194778 6194919 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "24"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6195290 6195463 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "25"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6196577 6196698 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "26"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6196788 6196925 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "27"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6202188 6202388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "28"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6202474 6202665 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "29"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6203883 6203991 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "30"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 nearCoding exon 6204084 6204215 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004023"; exon_number "31"; oId "uc001ama.1"; nearest_ref "uc001ama.1"; class_code "="; tss_id "TSS2013"; chr1 coding exon 6161853 6165487 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "1"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6166294 6166347 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "2"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6166455 6166569 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "3"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6166676 6166839 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "4"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6169855 6170050 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "5"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6170454 6170586 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "6"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6171835 6171943 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "7"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6172200 6172337 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "8"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6172969 6173058 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "9"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6181165 6181297 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "10"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6181554 6181633 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "11"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6184008 6184167 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "12"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6184577 6184721 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "13"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6185160 6185293 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "14"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6185584 6185672 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "15"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6185826 6185918 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "16"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6186632 6186806 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "17"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6188106 6188278 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "18"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6188559 6188669 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "19"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6188898 6189129 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "20"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6190264 6190388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "21"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6191691 6191808 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "22"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6194188 6194319 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "23"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6194778 6194919 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "24"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6195290 6195463 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "25"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6196577 6196698 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "26"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6196788 6196925 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "27"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6202188 6202388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "28"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6202474 6202665 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "29"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6203883 6203991 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "30"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6204084 6204215 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "31"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6206272 6206483 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "32"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6206725 6206931 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "33"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6208914 6209135 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "34"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6209306 6209472 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "35"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6211092 6211215 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "36"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6212472 6212596 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "37"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6214720 6214958 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "38"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6215659 6215777 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "39"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6219396 6219575 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "40"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6228210 6228337 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "41"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 coding exon 6240005 6240183 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004024"; exon_number "42"; gene_name "CHD5"; oId "uc001amb.1"; nearest_ref "uc001amb.1"; class_code "="; tss_id "TSS2014"; p_id "P3019"; chr1 nearCoding exon 6181165 6181297 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "1"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6181554 6181633 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "2"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6184008 6184167 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "3"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6184577 6184721 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "4"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6185198 6185293 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "5"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6185584 6185672 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "6"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6185826 6185918 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "7"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6186632 6186806 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "8"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6188106 6188278 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "9"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6188559 6188669 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "10"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6188898 6189129 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "11"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6190264 6190388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "12"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6191691 6191808 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "13"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6194188 6194319 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "14"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6194778 6194919 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "15"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6195290 6195463 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "16"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6196577 6196698 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "17"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6196788 6196925 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "18"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6202188 6202388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "19"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6202474 6202665 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "20"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6203883 6203991 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "21"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6204084 6204215 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "22"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6206272 6206483 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "23"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6206725 6206931 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004025"; exon_number "24"; oId "uc001amc.1"; nearest_ref "uc001amc.1"; class_code "="; tss_id "TSS2015"; chr1 nearCoding exon 6181554 6181633 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "1"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6184008 6184167 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "2"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6185160 6185293 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "3"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6185584 6185672 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "4"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6185826 6185918 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "5"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6186632 6186806 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "6"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6188106 6188278 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "7"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6188559 6188669 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "8"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6188898 6189129 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "9"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6190264 6190388 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "10"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6191691 6191808 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "11"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6194188 6194319 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "12"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6194778 6194919 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "13"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6195290 6195463 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "14"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6196577 6196698 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "15"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 nearCoding exon 6196788 6196925 . - . gene_id "XLOC_001281"; transcript_id "TCONS_00004026"; exon_number "16"; oId "uc009vlx.1"; nearest_ref "uc009vlx.1"; class_code "="; tss_id "TSS2016"; chr1 coding exon 6245081 6246876 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004028"; exon_number "1"; gene_name "RPL22"; oId "uc001ame.2"; nearest_ref "uc001ame.2"; class_code "="; tss_id "TSS2017"; p_id "P3022"; chr1 coding exon 6253007 6253114 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004028"; exon_number "2"; gene_name "RPL22"; oId "uc001ame.2"; nearest_ref "uc001ame.2"; class_code "="; tss_id "TSS2017"; p_id "P3022"; chr1 coding exon 6257712 6257816 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004028"; exon_number "3"; gene_name "RPL22"; oId "uc001ame.2"; nearest_ref "uc001ame.2"; class_code "="; tss_id "TSS2017"; p_id "P3022"; chr1 coding exon 6259622 6259679 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004028"; exon_number "4"; gene_name "RPL22"; oId "uc001ame.2"; nearest_ref "uc001ame.2"; class_code "="; tss_id "TSS2017"; p_id "P3022"; chr1 coding exon 6245081 6246876 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004027"; exon_number "1"; gene_name "RPL22"; oId "uc001amd.2"; nearest_ref "uc001amd.2"; class_code "="; tss_id "TSS2017"; p_id "P3021"; chr1 coding exon 6252990 6253114 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004027"; exon_number "2"; gene_name "RPL22"; oId "uc001amd.2"; nearest_ref "uc001amd.2"; class_code "="; tss_id "TSS2017"; p_id "P3021"; chr1 coding exon 6257712 6257816 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004027"; exon_number "3"; gene_name "RPL22"; oId "uc001amd.2"; nearest_ref "uc001amd.2"; class_code "="; tss_id "TSS2017"; p_id "P3021"; chr1 coding exon 6259622 6259679 . - . gene_id "XLOC_001282"; transcript_id "TCONS_00004027"; exon_number "4"; gene_name "RPL22"; oId "uc001amd.2"; nearest_ref "uc001amd.2"; class_code "="; tss_id "TSS2017"; p_id "P3021"; chr1 coding exon 6281255 6285322 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004030"; exon_number "1"; oId "uc001aml.2"; nearest_ref "uc001aml.2"; class_code "="; tss_id "TSS2018"; p_id "P3024"; chr1 coding exon 6291962 6292179 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004030"; exon_number "2"; oId "uc001aml.2"; nearest_ref "uc001aml.2"; class_code "="; tss_id "TSS2018"; p_id "P3024"; chr1 coding exon 6293534 6293703 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004030"; exon_number "3"; oId "uc001aml.2"; nearest_ref "uc001aml.2"; class_code "="; tss_id "TSS2018"; p_id "P3024"; chr1 coding exon 6294465 6294571 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004030"; exon_number "4"; oId "uc001aml.2"; nearest_ref "uc001aml.2"; class_code "="; tss_id "TSS2018"; p_id "P3024"; chr1 coding exon 6294946 6295034 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004030"; exon_number "5"; oId "uc001aml.2"; nearest_ref "uc001aml.2"; class_code "="; tss_id "TSS2018"; p_id "P3024"; chr1 coding exon 6295777 6296044 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004030"; exon_number "6"; oId "uc001aml.2"; nearest_ref "uc001aml.2"; class_code "="; tss_id "TSS2018"; p_id "P3024"; chr1 coding exon 6281255 6285322 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004029"; exon_number "1"; gene_name "ICMT"; oId "uc001amk.2"; nearest_ref "uc001amk.2"; class_code "="; tss_id "TSS2018"; p_id "P3023"; chr1 coding exon 6291962 6292179 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004029"; exon_number "2"; gene_name "ICMT"; oId "uc001amk.2"; nearest_ref "uc001amk.2"; class_code "="; tss_id "TSS2018"; p_id "P3023"; chr1 coding exon 6293534 6293703 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004029"; exon_number "3"; gene_name "ICMT"; oId "uc001amk.2"; nearest_ref "uc001amk.2"; class_code "="; tss_id "TSS2018"; p_id "P3023"; chr1 coding exon 6294946 6295034 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004029"; exon_number "4"; gene_name "ICMT"; oId "uc001amk.2"; nearest_ref "uc001amk.2"; class_code "="; tss_id "TSS2018"; p_id "P3023"; chr1 coding exon 6295777 6296044 . - . gene_id "XLOC_001283"; transcript_id "TCONS_00004029"; exon_number "5"; gene_name "ICMT"; oId "uc001amk.2"; nearest_ref "uc001amk.2"; class_code "="; tss_id "TSS2018"; p_id "P3023"; chr1 coding exon 6307414 6310123 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004031"; exon_number "1"; gene_name "GPR153"; oId "uc001amo.1"; nearest_ref "uc001amo.1"; class_code "="; p_id "P3026"; chr1 coding exon 6308856 6310063 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004032"; exon_number "1"; gene_name "GPR153"; oId "uc001amp.1"; nearest_ref "uc001amp.1"; class_code "="; tss_id "TSS2019"; p_id "P3025"; chr1 coding exon 6310500 6310684 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004032"; exon_number "2"; gene_name "GPR153"; oId "uc001amp.1"; nearest_ref "uc001amp.1"; class_code "="; tss_id "TSS2019"; p_id "P3025"; chr1 coding exon 6311398 6311590 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004032"; exon_number "3"; gene_name "GPR153"; oId "uc001amp.1"; nearest_ref "uc001amp.1"; class_code "="; tss_id "TSS2019"; p_id "P3025"; chr1 coding exon 6313778 6314207 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004032"; exon_number "4"; gene_name "GPR153"; oId "uc001amp.1"; nearest_ref "uc001amp.1"; class_code "="; tss_id "TSS2019"; p_id "P3025"; chr1 coding exon 6314610 6315074 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004032"; exon_number "5"; gene_name "GPR153"; oId "uc001amp.1"; nearest_ref "uc001amp.1"; class_code "="; tss_id "TSS2019"; p_id "P3025"; chr1 coding exon 6320885 6321035 . - . gene_id "XLOC_001284"; transcript_id "TCONS_00004032"; exon_number "6"; gene_name "GPR153"; oId "uc001amp.1"; nearest_ref "uc001amp.1"; class_code "="; tss_id "TSS2019"; p_id "P3025"; chr1 coding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "1"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "2"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "3"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6378552 6378638 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "4"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "5"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "6"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "7"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6409809 6409926 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "8"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6418886 6419004 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004033"; exon_number "9"; gene_name "ACOT7"; oId "uc001amq.2"; nearest_ref "uc001amq.2"; class_code "="; tss_id "TSS2020"; p_id "P3031"; chr1 coding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "1"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "2"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "3"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6378552 6378638 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "4"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "5"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "6"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "7"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6409809 6409926 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "8"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6420630 6420764 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004034"; exon_number "9"; gene_name "ACOT7"; oId "uc001amr.2"; nearest_ref "uc001amr.2"; class_code "="; tss_id "TSS2021"; p_id "P3028"; chr1 coding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "1"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "2"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "3"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6378552 6378638 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "4"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "5"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "6"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "7"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6409809 6409926 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "8"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6445554 6445883 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004035"; exon_number "9"; gene_name "ACOT7"; oId "uc001ams.2"; nearest_ref "uc001ams.2"; class_code "="; tss_id "TSS2022"; p_id "P3030"; chr1 coding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "1"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "2"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "3"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6378552 6378638 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "4"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "5"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "6"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "7"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 coding exon 6453321 6453438 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004036"; exon_number "8"; gene_name "ACOT7"; oId "uc010nzq.1"; nearest_ref "uc010nzq.1"; class_code "="; tss_id "TSS2023"; p_id "P3029"; chr1 nearCoding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "1"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "2"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "3"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6378552 6378636 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "4"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "5"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "6"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "7"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6409809 6409926 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "8"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6453317 6453826 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004039"; exon_number "9"; oId "uc001amv.2"; nearest_ref "uc001amv.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "1"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "2"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6342784 6342856 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "3"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "4"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6378552 6378638 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "5"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "6"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "7"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "8"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6409809 6409926 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "9"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 nearCoding exon 6453317 6453826 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004038"; exon_number "10"; oId "uc001amu.2"; nearest_ref "uc001amu.2"; class_code "="; tss_id "TSS2024"; chr1 coding exon 6324333 6324755 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "1"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6341162 6341346 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "2"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6354924 6355040 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "3"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6378552 6378638 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "4"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6387359 6387473 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "5"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6393537 6393628 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "6"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6399493 6399649 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "7"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6409809 6409926 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "8"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6453317 6453826 . - . gene_id "XLOC_001285"; transcript_id "TCONS_00004037"; exon_number "9"; gene_name "ACOT7"; oId "uc001amt.2"; nearest_ref "uc001amt.2"; class_code "="; tss_id "TSS2024"; p_id "P3027"; chr1 coding exon 6472500 6473342 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004040"; exon_number "1"; gene_name "HES2"; oId "uc001amw.2"; nearest_ref "uc001amw.2"; class_code "="; tss_id "TSS2025"; p_id "P3033"; chr1 coding exon 6479667 6479762 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004040"; exon_number "2"; gene_name "HES2"; oId "uc001amw.2"; nearest_ref "uc001amw.2"; class_code "="; tss_id "TSS2025"; p_id "P3033"; chr1 coding exon 6479836 6479903 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004040"; exon_number "3"; gene_name "HES2"; oId "uc001amw.2"; nearest_ref "uc001amw.2"; class_code "="; tss_id "TSS2025"; p_id "P3033"; chr1 coding exon 6484538 6484730 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004040"; exon_number "4"; gene_name "HES2"; oId "uc001amw.2"; nearest_ref "uc001amw.2"; class_code "="; tss_id "TSS2025"; p_id "P3033"; chr1 coding exon 6475295 6479213 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004041"; exon_number "1"; gene_name "HES2"; oId "uc001amx.2"; nearest_ref "uc001amx.2"; class_code "="; tss_id "TSS2026"; p_id "P3032"; chr1 coding exon 6479301 6479400 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004041"; exon_number "2"; gene_name "HES2"; oId "uc001amx.2"; nearest_ref "uc001amx.2"; class_code "="; tss_id "TSS2026"; p_id "P3032"; chr1 coding exon 6479667 6479762 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004041"; exon_number "3"; gene_name "HES2"; oId "uc001amx.2"; nearest_ref "uc001amx.2"; class_code "="; tss_id "TSS2026"; p_id "P3032"; chr1 coding exon 6479836 6479979 . - . gene_id "XLOC_001286"; transcript_id "TCONS_00004041"; exon_number "4"; gene_name "HES2"; oId "uc001amx.2"; nearest_ref "uc001amx.2"; class_code "="; tss_id "TSS2026"; p_id "P3032"; chr1 nearCoding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6522689 6522723 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6525148 6525282 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004044"; exon_number "8"; gene_name "TNFRSF25"; oId "uc001anc.2"; nearest_ref "uc001anc.2"; class_code "="; tss_id "TSS2027"; chr1 coding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6522689 6522726 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6522923 6523030 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6523132 6523187 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6525148 6525282 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "8"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "9"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004046"; exon_number "10"; gene_name "TNFRSF25"; oId "uc001ane.2"; nearest_ref "uc001ane.2"; class_code "="; tss_id "TSS2027"; p_id "P3046"; chr1 coding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6522689 6522726 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6522923 6523030 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6523132 6523187 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "8"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004048"; exon_number "9"; gene_name "TNFRSF25"; oId "uc001ang.2"; nearest_ref "uc001ang.2"; class_code "="; tss_id "TSS2027"; p_id "P3045"; chr1 nearCoding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004050"; exon_number "1"; gene_name "TNFRSF25"; oId "uc009vlz.2"; nearest_ref "uc009vlz.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004050"; exon_number "2"; gene_name "TNFRSF25"; oId "uc009vlz.2"; nearest_ref "uc009vlz.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004050"; exon_number "3"; gene_name "TNFRSF25"; oId "uc009vlz.2"; nearest_ref "uc009vlz.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004050"; exon_number "4"; gene_name "TNFRSF25"; oId "uc009vlz.2"; nearest_ref "uc009vlz.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004050"; exon_number "5"; gene_name "TNFRSF25"; oId "uc009vlz.2"; nearest_ref "uc009vlz.2"; class_code "="; tss_id "TSS2027"; chr1 coding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6522689 6522726 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6522923 6523030 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6523125 6523207 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6525148 6525282 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "8"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "9"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004049"; exon_number "10"; gene_name "TNFRSF25"; oId "uc001anh.2"; nearest_ref "uc001anh.2"; class_code "="; tss_id "TSS2027"; p_id "P3044"; chr1 coding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6522689 6522723 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6523132 6523187 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6525148 6525282 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "8"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004047"; exon_number "9"; gene_name "TNFRSF25"; oId "uc001anf.2"; nearest_ref "uc001anf.2"; class_code "="; tss_id "TSS2027"; p_id "P3043"; chr1 coding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 coding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 coding exon 6522689 6522723 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 coding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 coding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004045"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001and.2"; nearest_ref "uc001and.2"; class_code "="; tss_id "TSS2027"; p_id "P3041"; chr1 nearCoding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6522689 6522726 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6522923 6523030 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6524435 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "6"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6525148 6525282 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "7"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "8"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 nearCoding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004043"; exon_number "9"; gene_name "TNFRSF25"; oId "uc001anb.2"; nearest_ref "uc001anb.2"; class_code "="; tss_id "TSS2027"; chr1 coding exon 6521221 6521822 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004042"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001ana.2"; nearest_ref "uc001ana.2"; class_code "="; tss_id "TSS2027"; p_id "P3042"; chr1 coding exon 6522054 6522234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004042"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001ana.2"; nearest_ref "uc001ana.2"; class_code "="; tss_id "TSS2027"; p_id "P3042"; chr1 coding exon 6522689 6522723 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004042"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001ana.2"; nearest_ref "uc001ana.2"; class_code "="; tss_id "TSS2027"; p_id "P3042"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004042"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001ana.2"; nearest_ref "uc001ana.2"; class_code "="; tss_id "TSS2027"; p_id "P3042"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004042"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001ana.2"; nearest_ref "uc001ana.2"; class_code "="; tss_id "TSS2027"; p_id "P3042"; chr1 coding exon 6524171 6524513 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004051"; exon_number "1"; gene_name "TNFRSF25"; oId "uc001ani.1"; nearest_ref "uc001ani.1"; class_code "="; tss_id "TSS2027"; p_id "P3040"; chr1 coding exon 6524612 6524779 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004051"; exon_number "2"; gene_name "TNFRSF25"; oId "uc001ani.1"; nearest_ref "uc001ani.1"; class_code "="; tss_id "TSS2027"; p_id "P3040"; chr1 coding exon 6525148 6525282 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004051"; exon_number "3"; gene_name "TNFRSF25"; oId "uc001ani.1"; nearest_ref "uc001ani.1"; class_code "="; tss_id "TSS2027"; p_id "P3040"; chr1 coding exon 6525500 6525620 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004051"; exon_number "4"; gene_name "TNFRSF25"; oId "uc001ani.1"; nearest_ref "uc001ani.1"; class_code "="; tss_id "TSS2027"; p_id "P3040"; chr1 coding exon 6526129 6526255 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004051"; exon_number "5"; gene_name "TNFRSF25"; oId "uc001ani.1"; nearest_ref "uc001ani.1"; class_code "="; tss_id "TSS2027"; p_id "P3040"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6531050 6531643 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004052"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001anj.1"; nearest_ref "uc001anj.1"; class_code "="; tss_id "TSS2028"; p_id "P3049"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "1"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "2"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "3"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "4"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "5"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "6"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "7"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "8"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "9"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "10"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "11"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "12"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "13"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "14"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "15"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6534511 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "16"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "17"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "18"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004053"; exon_number "19"; gene_name "PLEKHG5"; oId "uc009vma.1"; nearest_ref "uc009vma.1"; class_code "="; tss_id "TSS2029"; p_id "P3048"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "1"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "2"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "3"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "4"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "5"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "6"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "7"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "8"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "9"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "10"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "11"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "12"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "13"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "14"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "15"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "16"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "17"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "18"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "19"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "20"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6545384 6545529 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004054"; exon_number "21"; gene_name "PLEKHG5"; oId "uc010nzr.1"; nearest_ref "uc010nzr.1"; class_code "="; tss_id "TSS2030"; p_id "P3047"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6545896 6546014 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004055"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001ank.1"; nearest_ref "uc001ank.1"; class_code "="; tss_id "TSS2031"; p_id "P3050"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "1"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6527885 6527958 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "2"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6528159 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "3"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "4"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "5"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "6"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "7"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "8"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "9"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "10"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "11"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "12"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "13"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "14"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "15"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "16"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "17"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "18"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "19"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "20"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "21"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6550505 6550640 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004057"; exon_number "22"; gene_name "PLEKHG5"; oId "uc009vmb.1"; nearest_ref "uc009vmb.1"; class_code "="; tss_id "TSS2032"; p_id "P3034"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6550505 6550640 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004056"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001anl.1"; nearest_ref "uc001anl.1"; class_code "="; tss_id "TSS2032"; p_id "P3050"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6551697 6551760 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004058"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001anm.1"; nearest_ref "uc001anm.1"; class_code "="; tss_id "TSS2033"; p_id "P3050"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6556553 6556756 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004059"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001ann.1"; nearest_ref "uc001ann.1"; class_code "="; tss_id "TSS2034"; p_id "P3036"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6556553 6556629 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6557380 6557484 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004060"; exon_number "22"; gene_name "PLEKHG5"; oId "uc001ano.1"; nearest_ref "uc001ano.1"; class_code "="; tss_id "TSS2035"; p_id "P3035"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6527885 6527953 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6556553 6556629 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6579505 6580069 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004062"; exon_number "22"; gene_name "PLEKHG5"; oId "uc001anq.1"; nearest_ref "uc001anq.1"; class_code "="; tss_id "TSS2036"; p_id "P3037"; chr1 coding exon 6526152 6527632 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "1"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6527885 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "2"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "3"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6529395 6529510 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "4"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6529604 6529736 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "5"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6530296 6530415 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "6"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6530566 6530703 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "7"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6530795 6530944 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "8"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6531050 6531160 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "9"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6531548 6531697 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "10"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6531818 6531868 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "11"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6532587 6532682 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "12"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6533046 6533234 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "13"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6533311 6533514 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "14"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6534073 6534224 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "15"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6534511 6534647 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "16"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6535107 6535198 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "17"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6535522 6535582 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "18"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6535991 6536096 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "19"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6537589 6537718 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "20"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6556553 6556629 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "21"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6579505 6580069 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004061"; exon_number "22"; gene_name "PLEKHG5"; oId "uc001anp.1"; nearest_ref "uc001anp.1"; class_code "="; tss_id "TSS2036"; p_id "P3038"; chr1 coding exon 6527299 6528646 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004063"; exon_number "1"; oId "uc001anr.1"; nearest_ref "uc001anr.1"; class_code "="; tss_id "TSS2037"; p_id "P3039"; chr1 coding exon 6529102 6529301 . - . gene_id "XLOC_001287"; transcript_id "TCONS_00004063"; exon_number "2"; oId "uc001anr.1"; nearest_ref "uc001anr.1"; class_code "="; tss_id "TSS2037"; p_id "P3039"; chr1 nearCoding exon 6585210 6586063 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "1"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6586756 6586921 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "2"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6589054 6589231 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "3"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6592028 6592139 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "4"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6592523 6592820 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "5"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6593340 6593501 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "6"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6601890 6601987 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "7"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6604886 6604982 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "8"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6605105 6605240 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "9"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6609631 6609758 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "10"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6610456 6610675 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "11"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 nearCoding exon 6614167 6614581 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004065"; exon_number "12"; gene_name "NOL9"; oId "uc010nzs.1"; nearest_ref "uc010nzs.1"; class_code "="; tss_id "TSS2038"; chr1 coding exon 6585210 6586063 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "1"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6586756 6586889 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "2"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6589054 6589231 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "3"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6592028 6592139 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "4"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6592523 6592820 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "5"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6593340 6593501 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "6"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6601890 6601987 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "7"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6604886 6604982 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "8"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6605105 6605240 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "9"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6609631 6609758 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "10"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6610456 6610675 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "11"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6614167 6614581 . - . gene_id "XLOC_001288"; transcript_id "TCONS_00004064"; exon_number "12"; gene_name "NOL9"; oId "uc001ans.2"; nearest_ref "uc001ans.2"; class_code "="; tss_id "TSS2038"; p_id "P3051"; chr1 coding exon 6650779 6655617 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004066"; exon_number "1"; gene_name "KLHL21"; oId "uc001anz.1"; nearest_ref "uc001anz.1"; class_code "="; tss_id "TSS2039"; p_id "P3053"; chr1 coding exon 6659107 6659512 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004066"; exon_number "2"; gene_name "KLHL21"; oId "uc001anz.1"; nearest_ref "uc001anz.1"; class_code "="; tss_id "TSS2039"; p_id "P3053"; chr1 coding exon 6661857 6662929 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004066"; exon_number "3"; gene_name "KLHL21"; oId "uc001anz.1"; nearest_ref "uc001anz.1"; class_code "="; tss_id "TSS2039"; p_id "P3053"; chr1 coding exon 6650785 6653718 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004067"; exon_number "1"; gene_name "KLHL21"; oId "uc009vme.2"; nearest_ref "uc009vme.2"; class_code "="; tss_id "TSS2040"; p_id "P3054"; chr1 coding exon 6655545 6655617 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004067"; exon_number "2"; gene_name "KLHL21"; oId "uc009vme.2"; nearest_ref "uc009vme.2"; class_code "="; tss_id "TSS2040"; p_id "P3054"; chr1 coding exon 6659107 6659512 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004067"; exon_number "3"; gene_name "KLHL21"; oId "uc009vme.2"; nearest_ref "uc009vme.2"; class_code "="; tss_id "TSS2040"; p_id "P3054"; chr1 coding exon 6659810 6659871 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004067"; exon_number "4"; gene_name "KLHL21"; oId "uc009vme.2"; nearest_ref "uc009vme.2"; class_code "="; tss_id "TSS2040"; p_id "P3054"; chr1 coding exon 6650785 6653718 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004068"; exon_number "1"; gene_name "KLHL21"; oId "uc001aoa.2"; nearest_ref "uc001aoa.2"; class_code "="; tss_id "TSS2039"; p_id "P3052"; chr1 coding exon 6655545 6655617 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004068"; exon_number "2"; gene_name "KLHL21"; oId "uc001aoa.2"; nearest_ref "uc001aoa.2"; class_code "="; tss_id "TSS2039"; p_id "P3052"; chr1 coding exon 6659107 6659512 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004068"; exon_number "3"; gene_name "KLHL21"; oId "uc001aoa.2"; nearest_ref "uc001aoa.2"; class_code "="; tss_id "TSS2039"; p_id "P3052"; chr1 coding exon 6661857 6662929 . - . gene_id "XLOC_001289"; transcript_id "TCONS_00004068"; exon_number "4"; gene_name "KLHL21"; oId "uc001aoa.2"; nearest_ref "uc001aoa.2"; class_code "="; tss_id "TSS2039"; p_id "P3052"; chr1 coding exon 6694228 6694844 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "1"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6705931 6706038 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "2"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6711589 6711662 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "3"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6712889 6713011 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "4"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6713971 6714099 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "5"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6727769 6727870 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "6"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6738454 6738527 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "7"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6740968 6741097 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004069"; exon_number "8"; gene_name "DNAJC11"; oId "uc010nzt.1"; nearest_ref "uc010nzt.1"; class_code "="; tss_id "TSS2041"; p_id "P3058"; chr1 coding exon 6694228 6695760 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "1"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6696177 6696306 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "2"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6697258 6697400 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "3"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6697507 6697564 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "4"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6698355 6698424 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "5"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6699962 6700117 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "6"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6704618 6704734 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "7"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6705101 6705186 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "8"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6705849 6706038 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "9"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6711589 6711662 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "10"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6712889 6713011 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "11"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6713971 6714099 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "12"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6727769 6727870 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "13"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6740968 6741097 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "14"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6761789 6761966 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004072"; exon_number "15"; oId "uc010nzu.1"; nearest_ref "uc010nzu.1"; class_code "="; tss_id "TSS2042"; p_id "P3057"; chr1 coding exon 6694228 6695760 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "1"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6696177 6696306 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "2"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6697258 6697400 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "3"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6697507 6697564 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "4"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6698355 6698424 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "5"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6704618 6704734 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "6"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6705101 6705186 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "7"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6705849 6706038 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "8"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6711589 6711662 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "9"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6712889 6713011 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "10"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6713971 6714099 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "11"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6727769 6727870 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "12"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6738454 6738527 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "13"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6740968 6741097 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "14"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6761789 6761966 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004071"; exon_number "15"; gene_name "DNAJC11"; oId "uc001aog.2"; nearest_ref "uc001aog.2"; class_code "="; tss_id "TSS2042"; p_id "P3056"; chr1 coding exon 6694228 6695760 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "1"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6696177 6696306 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "2"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6697258 6697400 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "3"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6697507 6697564 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "4"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6698355 6698424 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "5"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6699962 6700117 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "6"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6704618 6704734 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "7"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6705101 6705186 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "8"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6705849 6706038 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "9"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6711589 6711662 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "10"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6712889 6713011 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "11"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6713971 6714099 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "12"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6727769 6727870 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "13"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6738454 6738527 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "14"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6740968 6741097 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "15"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 6761789 6761966 . - . gene_id "XLOC_001290"; transcript_id "TCONS_00004070"; exon_number "16"; gene_name "DNAJC11"; oId "uc001aof.2"; nearest_ref "uc001aof.2"; class_code "="; tss_id "TSS2042"; p_id "P3055"; chr1 coding exon 7903144 7904010 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "1"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7906752 7906826 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "2"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7907864 7907942 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "3"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7909700 7909743 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "4"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7910872 7910982 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "5"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7912961 7913178 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "6"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7913367 7913565 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "7"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7973241 7973294 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004073"; exon_number "8"; gene_name "UTS2"; oId "uc001aoq.2"; nearest_ref "uc001aoq.2"; class_code "="; tss_id "TSS2043"; p_id "P3061"; chr1 coding exon 7907673 7907942 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004074"; exon_number "1"; gene_name "UTS2"; oId "uc001aor.2"; nearest_ref "uc001aor.2"; class_code "="; tss_id "TSS2044"; p_id "P3060"; chr1 coding exon 7909700 7909743 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004074"; exon_number "2"; gene_name "UTS2"; oId "uc001aor.2"; nearest_ref "uc001aor.2"; class_code "="; tss_id "TSS2044"; p_id "P3060"; chr1 coding exon 7910872 7910982 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004074"; exon_number "3"; gene_name "UTS2"; oId "uc001aor.2"; nearest_ref "uc001aor.2"; class_code "="; tss_id "TSS2044"; p_id "P3060"; chr1 coding exon 7912961 7913178 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004074"; exon_number "4"; gene_name "UTS2"; oId "uc001aor.2"; nearest_ref "uc001aor.2"; class_code "="; tss_id "TSS2044"; p_id "P3060"; chr1 coding exon 7907673 7907942 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004075"; exon_number "1"; gene_name "UTS2"; oId "uc001aos.2"; nearest_ref "uc001aos.2"; class_code "="; tss_id "TSS2045"; p_id "P3059"; chr1 coding exon 7909700 7909743 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004075"; exon_number "2"; gene_name "UTS2"; oId "uc001aos.2"; nearest_ref "uc001aos.2"; class_code "="; tss_id "TSS2045"; p_id "P3059"; chr1 coding exon 7910872 7910982 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004075"; exon_number "3"; gene_name "UTS2"; oId "uc001aos.2"; nearest_ref "uc001aos.2"; class_code "="; tss_id "TSS2045"; p_id "P3059"; chr1 coding exon 7912961 7912983 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004075"; exon_number "4"; gene_name "UTS2"; oId "uc001aos.2"; nearest_ref "uc001aos.2"; class_code "="; tss_id "TSS2045"; p_id "P3059"; chr1 coding exon 7913367 7913565 . - . gene_id "XLOC_001291"; transcript_id "TCONS_00004075"; exon_number "5"; gene_name "UTS2"; oId "uc001aos.2"; nearest_ref "uc001aos.2"; class_code "="; tss_id "TSS2045"; p_id "P3059"; chr1 coding exon 7979908 7980983 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "1"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 7993222 7993356 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "2"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 7995073 7995203 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "3"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 7997750 7997816 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "4"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 7998253 7998390 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "5"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 7998781 7998888 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "6"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 7999955 8000138 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "7"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 8000844 8000887 . - . gene_id "XLOC_001292"; transcript_id "TCONS_00004076"; exon_number "8"; gene_name "TNFRSF9"; oId "uc001aot.2"; nearest_ref "uc001aot.2"; class_code "="; tss_id "TSS2046"; p_id "P3062"; chr1 coding exon 8071780 8074456 . - . gene_id "XLOC_001293"; transcript_id "TCONS_00004077"; exon_number "1"; gene_name "ERRFI1"; oId "uc001aoz.2"; nearest_ref "uc001aoz.2"; class_code "="; tss_id "TSS2047"; p_id "P3064"; chr1 coding exon 8075368 8075444 . - . gene_id "XLOC_001293"; transcript_id "TCONS_00004077"; exon_number "2"; gene_name "ERRFI1"; oId "uc001aoz.2"; nearest_ref "uc001aoz.2"; class_code "="; tss_id "TSS2047"; p_id "P3064"; chr1 coding exon 8075555 8075752 . - . gene_id "XLOC_001293"; transcript_id "TCONS_00004077"; exon_number "3"; gene_name "ERRFI1"; oId "uc001aoz.2"; nearest_ref "uc001aoz.2"; class_code "="; tss_id "TSS2047"; p_id "P3064"; chr1 coding exon 8086218 8086393 . - . gene_id "XLOC_001293"; transcript_id "TCONS_00004077"; exon_number "4"; gene_name "ERRFI1"; oId "uc001aoz.2"; nearest_ref "uc001aoz.2"; class_code "="; tss_id "TSS2047"; p_id "P3064"; chr1 coding exon 8073487 8075444 . - . gene_id "XLOC_001293"; transcript_id "TCONS_00004078"; exon_number "1"; gene_name "ERRFI1"; oId "uc001apa.1"; nearest_ref "uc001apa.1"; class_code "="; tss_id "TSS2048"; p_id "P3063"; chr1 coding exon 8075555 8075752 . - . gene_id "XLOC_001293"; transcript_id "TCONS_00004078"; exon_number "2"; gene_name "ERRFI1"; oId "uc001apa.1"; nearest_ref "uc001apa.1"; class_code "="; tss_id "TSS2048"; p_id "P3063"; chr1 coding exon 8412466 8415180 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "1"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8415479 8415659 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "2"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8416160 8416306 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "3"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8418256 8418976 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "4"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8419824 8420046 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "5"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8420172 8421550 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "6"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8421823 8421936 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "7"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8422743 8422904 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "8"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8424116 8424315 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "9"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8424806 8424898 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "10"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8425872 8426034 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "11"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8482787 8482867 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "12"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8483621 8483747 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004079"; exon_number "13"; gene_name "RERE"; oId "uc001apd.2"; nearest_ref "uc001apd.2"; class_code "="; tss_id "TSS2049"; p_id "P3065"; chr1 coding exon 8412466 8415180 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "1"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8415479 8415659 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "2"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8416160 8416306 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "3"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8418256 8418976 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "4"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8419824 8420046 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "5"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8420172 8421550 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "6"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8421823 8421936 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "7"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8422743 8422904 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "8"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8424116 8424315 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "9"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8424806 8424898 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "10"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8425872 8426034 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "11"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8482787 8482867 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "12"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8525985 8526083 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "13"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8555123 8555222 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "14"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8557465 8557589 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "15"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8568686 8568734 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "16"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8601273 8601377 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "17"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8616534 8616630 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "18"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8617477 8617582 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "19"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8674620 8674745 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "20"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8684369 8684439 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "21"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8716032 8716500 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "22"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8877219 8877699 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004081"; exon_number "23"; gene_name "RERE"; oId "uc001apf.2"; nearest_ref "uc001apf.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8412466 8415180 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "1"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8415479 8415659 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "2"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8416160 8416306 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "3"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8418256 8418976 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "4"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8419824 8420046 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "5"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8420172 8421550 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "6"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8421823 8421936 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "7"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8422743 8422904 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "8"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8424116 8424315 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "9"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8424806 8424898 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "10"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8425872 8426034 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "11"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8482787 8482867 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "12"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8525985 8526083 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "13"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8555123 8555222 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "14"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8557465 8557589 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "15"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8568686 8568734 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "16"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8601273 8601377 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "17"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8616534 8616630 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "18"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8617477 8617582 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "19"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8674620 8674745 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "20"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8684369 8684439 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "21"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8716032 8716500 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "22"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8852463 8852647 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "23"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8877219 8877699 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004080"; exon_number "24"; gene_name "RERE"; oId "uc001ape.2"; nearest_ref "uc001ape.2"; class_code "="; tss_id "TSS2050"; p_id "P3068"; chr1 coding exon 8420172 8421550 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "1"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8421823 8421936 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "2"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8422743 8422904 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "3"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8424116 8424315 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "4"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8424806 8424898 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "5"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8425872 8426034 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "6"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8482787 8482867 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "7"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8525985 8526083 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "8"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8555123 8555222 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "9"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8557465 8557589 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "10"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8568686 8568734 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "11"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8585818 8585844 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004082"; exon_number "12"; gene_name "RERE"; oId "uc010nzx.1"; nearest_ref "uc010nzx.1"; class_code "="; tss_id "TSS2051"; p_id "P3066"; chr1 coding exon 8525030 8526083 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "1"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8555123 8555222 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "2"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8557465 8557589 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "3"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8568686 8568734 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "4"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8601273 8601377 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "5"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8616534 8616630 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "6"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8617477 8617582 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "7"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8674620 8674745 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "8"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8684369 8684439 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "9"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8716032 8716500 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "10"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8813490 8813897 . - . gene_id "XLOC_001294"; transcript_id "TCONS_00004084"; exon_number "11"; oId "uc001aph.1"; nearest_ref "uc001aph.1"; class_code "="; tss_id "TSS2052"; p_id "P3067"; chr1 coding exon 8440652 8441235 . - . gene_id "XLOC_001295"; transcript_id "TCONS_00004083"; exon_number "1"; oId "uc001apg.1"; nearest_ref "uc001apg.1"; class_code "="; p_id "P3069"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "1"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8922946 8923004 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "2"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8923294 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "3"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "4"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "5"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "6"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "7"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8928047 8928116 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "8"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8930511 8931356 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004085"; exon_number "9"; gene_name "ENO1"; oId "uc001api.1"; nearest_ref "uc001api.1"; class_code "="; tss_id "TSS2053"; p_id "P3077"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "1"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8922946 8923004 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "2"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8923294 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "3"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "4"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "5"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "6"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "7"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8931950 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "8"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "9"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004089"; exon_number "10"; gene_name "ENO1"; oId "uc009vmi.1"; nearest_ref "uc009vmi.1"; class_code "="; tss_id "TSS2054"; p_id "P3076"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "1"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8922946 8923004 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "2"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8923294 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "3"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "4"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "5"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "6"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "7"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004091"; exon_number "8"; gene_name "ENO1"; oId "uc009vmk.1"; nearest_ref "uc009vmk.1"; class_code "="; tss_id "TSS2054"; p_id "P3075"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "1"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "2"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "3"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "4"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "5"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8928047 8928116 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "6"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8930511 8930569 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "7"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8931950 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "8"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "9"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004090"; exon_number "10"; gene_name "ENO1"; oId "uc009vmj.1"; nearest_ref "uc009vmj.1"; class_code "="; tss_id "TSS2054"; p_id "P3074"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "1"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8923294 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "2"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "3"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "4"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "5"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "6"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8928047 8928116 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "7"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8930511 8930569 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "8"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8931950 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "9"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "10"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004088"; exon_number "11"; gene_name "ENO1"; oId "uc001apl.1"; nearest_ref "uc001apl.1"; class_code "="; tss_id "TSS2054"; p_id "P3073"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "1"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8922946 8923004 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "2"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8923294 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "3"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "4"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "5"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "6"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "7"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8928047 8928116 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "8"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8930511 8930558 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "9"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8931950 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "10"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "11"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004087"; exon_number "12"; gene_name "ENO1"; oId "uc001apk.1"; nearest_ref "uc001apk.1"; class_code "="; tss_id "TSS2054"; p_id "P3072"; chr1 coding exon 8921063 8921488 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "1"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8922946 8923004 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "2"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8923294 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "3"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "4"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "5"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "6"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "7"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8928047 8928116 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "8"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8930511 8930569 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "9"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8931950 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "10"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "11"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004086"; exon_number "12"; gene_name "ENO1"; oId "uc001apj.1"; nearest_ref "uc001apj.1"; class_code "="; tss_id "TSS2054"; p_id "P3071"; chr1 coding exon 8923173 8923402 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "1"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8923950 8924151 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "2"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8925344 8925541 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "3"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8926338 8926560 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "4"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8927176 8927309 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "5"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8928047 8928116 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "6"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8930511 8930569 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "7"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8931950 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "8"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "9"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 coding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004092"; exon_number "10"; gene_name "ENO1"; oId "uc009vml.1"; nearest_ref "uc009vml.1"; class_code "="; tss_id "TSS2054"; p_id "P3070"; chr1 nearCoding exon 8931006 8932045 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004093"; exon_number "1"; gene_name "ENO1"; oId "uc009vmm.1"; nearest_ref "uc009vmm.1"; class_code "="; tss_id "TSS2054"; chr1 nearCoding exon 8934883 8934976 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004093"; exon_number "2"; gene_name "ENO1"; oId "uc009vmm.1"; nearest_ref "uc009vmm.1"; class_code "="; tss_id "TSS2054"; chr1 nearCoding exon 8938639 8938780 . - . gene_id "XLOC_001296"; transcript_id "TCONS_00004093"; exon_number "3"; gene_name "ENO1"; oId "uc009vmm.1"; nearest_ref "uc009vmm.1"; class_code "="; tss_id "TSS2054"; chr1 coding exon 9063359 9063577 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "1"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9064811 9064938 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "2"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9067369 9067444 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "3"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9070202 9070303 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "4"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9073584 9073694 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "5"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9074740 9074927 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "6"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9075176 9075301 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "7"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9078282 9078434 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "8"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9079268 9079392 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "9"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9082977 9083137 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "10"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9085035 9085133 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "11"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9086354 9086404 . - . gene_id "XLOC_001297"; transcript_id "TCONS_00004094"; exon_number "12"; gene_name "SLC2A7"; oId "uc009vmo.1"; nearest_ref "uc009vmo.1"; class_code "="; tss_id "TSS2055"; p_id "P3078"; chr1 coding exon 9097007 9097848 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "1"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9097956 9098083 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "2"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9098490 9098565 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "3"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9098887 9098988 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "4"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9099611 9099721 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "5"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9099859 9100046 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "6"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9100123 9100248 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "7"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9101844 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "8"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9107669 9107793 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "9"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9109159 9109319 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004095"; exon_number "10"; gene_name "SLC2A5"; oId "uc010nzy.1"; nearest_ref "uc010nzy.1"; class_code "="; tss_id "TSS2056"; p_id "P3083"; chr1 coding exon 9097007 9097848 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "1"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9097956 9098083 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "2"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9098490 9098565 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "3"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9098887 9098988 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "4"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9099611 9099721 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "5"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9099859 9100046 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "6"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9100123 9100248 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "7"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9101844 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "8"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9107669 9107793 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "9"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9129563 9129653 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004096"; exon_number "10"; gene_name "SLC2A5"; oId "uc010nzz.1"; nearest_ref "uc010nzz.1"; class_code "="; tss_id "TSS2057"; p_id "P3080"; chr1 coding exon 9097007 9097848 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "1"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9097956 9098083 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "2"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9098490 9098565 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "3"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9098887 9098988 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "4"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9099611 9099721 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "5"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9099859 9100046 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "6"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9100123 9100248 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "7"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9101844 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "8"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9107669 9107793 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "9"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9117507 9117629 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "10"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9118211 9118309 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "11"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9129563 9129887 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004098"; exon_number "12"; gene_name "SLC2A5"; oId "uc010oaa.1"; nearest_ref "uc010oaa.1"; class_code "="; tss_id "TSS2058"; p_id "P3079"; chr1 coding exon 9097007 9097848 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "1"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9097956 9098083 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "2"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9098490 9098565 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "3"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9098887 9098988 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "4"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9099611 9099721 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "5"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9099859 9100046 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "6"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9100123 9100248 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "7"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9101844 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "8"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9107669 9107793 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "9"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9117507 9117667 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "10"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9118211 9118309 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "11"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9129563 9129887 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004097"; exon_number "12"; gene_name "SLC2A5"; oId "uc001apo.2"; nearest_ref "uc001apo.2"; class_code "="; tss_id "TSS2058"; p_id "P3084"; chr1 coding exon 9097007 9097848 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "1"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9097956 9098083 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "2"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9098490 9098565 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "3"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9098887 9098988 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "4"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9099611 9099721 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "5"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9099859 9100046 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "6"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9100123 9100248 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "7"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9101844 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "8"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9107669 9107793 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "9"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9117507 9117667 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "10"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9118211 9118309 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "11"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9129563 9129653 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "12"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9145073 9145201 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "13"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9148431 9148510 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004099"; exon_number "14"; gene_name "SLC2A5"; oId "uc010oab.1"; nearest_ref "uc010oab.1"; class_code "="; tss_id "TSS2059"; p_id "P3084"; chr1 coding exon 9101428 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004100"; exon_number "1"; gene_name "SLC2A5"; oId "uc010oac.1"; nearest_ref "uc010oac.1"; class_code "="; tss_id "TSS2057"; p_id "P3082"; chr1 coding exon 9117507 9117667 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004100"; exon_number "2"; gene_name "SLC2A5"; oId "uc010oac.1"; nearest_ref "uc010oac.1"; class_code "="; tss_id "TSS2057"; p_id "P3082"; chr1 coding exon 9118211 9118309 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004100"; exon_number "3"; gene_name "SLC2A5"; oId "uc010oac.1"; nearest_ref "uc010oac.1"; class_code "="; tss_id "TSS2057"; p_id "P3082"; chr1 coding exon 9129563 9129653 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004100"; exon_number "4"; gene_name "SLC2A5"; oId "uc010oac.1"; nearest_ref "uc010oac.1"; class_code "="; tss_id "TSS2057"; p_id "P3082"; chr1 coding exon 9101428 9101996 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004101"; exon_number "1"; gene_name "SLC2A5"; oId "uc001app.3"; nearest_ref "uc001app.3"; class_code "="; tss_id "TSS2058"; p_id "P3081"; chr1 coding exon 9107669 9107793 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004101"; exon_number "2"; gene_name "SLC2A5"; oId "uc001app.3"; nearest_ref "uc001app.3"; class_code "="; tss_id "TSS2058"; p_id "P3081"; chr1 coding exon 9117507 9117667 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004101"; exon_number "3"; gene_name "SLC2A5"; oId "uc001app.3"; nearest_ref "uc001app.3"; class_code "="; tss_id "TSS2058"; p_id "P3081"; chr1 coding exon 9118211 9118309 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004101"; exon_number "4"; gene_name "SLC2A5"; oId "uc001app.3"; nearest_ref "uc001app.3"; class_code "="; tss_id "TSS2058"; p_id "P3081"; chr1 coding exon 9129563 9129887 . - . gene_id "XLOC_001298"; transcript_id "TCONS_00004101"; exon_number "5"; gene_name "SLC2A5"; oId "uc001app.3"; nearest_ref "uc001app.3"; class_code "="; tss_id "TSS2058"; p_id "P3081"; chr1 coding exon 9164476 9164693 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004103"; exon_number "1"; gene_name "GPR157"; oId "uc010oad.1"; nearest_ref "uc010oad.1"; class_code "="; tss_id "TSS2060"; p_id "P3088"; chr1 coding exon 9171335 9171548 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004103"; exon_number "2"; gene_name "GPR157"; oId "uc010oad.1"; nearest_ref "uc010oad.1"; class_code "="; tss_id "TSS2060"; p_id "P3088"; chr1 coding exon 9188704 9189229 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004103"; exon_number "3"; gene_name "GPR157"; oId "uc010oad.1"; nearest_ref "uc010oad.1"; class_code "="; tss_id "TSS2060"; p_id "P3088"; chr1 coding exon 9164476 9164693 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004102"; exon_number "1"; gene_name "GPR157"; oId "uc001apq.1"; nearest_ref "uc001apq.1"; class_code "="; tss_id "TSS2060"; p_id "P3087"; chr1 coding exon 9165545 9165739 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004102"; exon_number "2"; gene_name "GPR157"; oId "uc001apq.1"; nearest_ref "uc001apq.1"; class_code "="; tss_id "TSS2060"; p_id "P3087"; chr1 coding exon 9171335 9171548 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004102"; exon_number "3"; gene_name "GPR157"; oId "uc001apq.1"; nearest_ref "uc001apq.1"; class_code "="; tss_id "TSS2060"; p_id "P3087"; chr1 coding exon 9188704 9189229 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004102"; exon_number "4"; gene_name "GPR157"; oId "uc001apq.1"; nearest_ref "uc001apq.1"; class_code "="; tss_id "TSS2060"; p_id "P3087"; chr1 coding exon 9169162 9171548 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004104"; exon_number "1"; gene_name "GPR157"; oId "uc001apr.2"; nearest_ref "uc001apr.2"; class_code "="; tss_id "TSS2060"; p_id "P3086"; chr1 coding exon 9188704 9189229 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004104"; exon_number "2"; gene_name "GPR157"; oId "uc001apr.2"; nearest_ref "uc001apr.2"; class_code "="; tss_id "TSS2060"; p_id "P3086"; chr1 coding exon 9186961 9189356 . - . gene_id "XLOC_001299"; transcript_id "TCONS_00004105"; exon_number "1"; oId "uc001aps.2"; nearest_ref "uc001aps.2"; class_code "="; p_id "P3085"; chr1 coding exon 9208347 9211894 . - . gene_id "XLOC_001300"; transcript_id "TCONS_00004106"; exon_number "1"; oId "uc009vmq.2"; nearest_ref "uc009vmq.2"; class_code "="; tss_id "TSS2061"; p_id "P3089"; chr1 coding exon 9242066 9242451 . - . gene_id "XLOC_001300"; transcript_id "TCONS_00004106"; exon_number "2"; oId "uc009vmq.2"; nearest_ref "uc009vmq.2"; class_code "="; tss_id "TSS2061"; p_id "P3089"; chr1 coding exon 9712669 9714101 . - . gene_id "XLOC_001301"; transcript_id "TCONS_00004107"; exon_number "1"; gene_name "C1orf200"; oId "uc001aqc.3"; nearest_ref "uc001aqc.3"; class_code "="; tss_id "TSS2062"; p_id "P3090"; chr1 coding exon 9714256 9714644 . - . gene_id "XLOC_001301"; transcript_id "TCONS_00004107"; exon_number "2"; gene_name "C1orf200"; oId "uc001aqc.3"; nearest_ref "uc001aqc.3"; class_code "="; tss_id "TSS2062"; p_id "P3090"; chr1 noncoding exon 9732486 9732777 . - . gene_id "XLOC_001302"; transcript_id "TCONS_00004108"; exon_number "1"; oId "uc001aqd.2"; nearest_ref "uc001aqd.2"; class_code "="; tss_id "TSS2063"; chr1 noncoding exon 9740770 9741193 . - . gene_id "XLOC_001302"; transcript_id "TCONS_00004108"; exon_number "2"; oId "uc001aqd.2"; nearest_ref "uc001aqd.2"; class_code "="; tss_id "TSS2063"; chr1 noncoding exon 9747393 9747627 . - . gene_id "XLOC_001302"; transcript_id "TCONS_00004108"; exon_number "3"; oId "uc001aqd.2"; nearest_ref "uc001aqd.2"; class_code "="; tss_id "TSS2063"; chr1 coding exon 9789080 9790763 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004109"; exon_number "1"; oId "uc001aqf.2"; nearest_ref "uc001aqf.2"; class_code "="; tss_id "TSS2064"; p_id "P3092"; chr1 coding exon 9791180 9791448 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004109"; exon_number "2"; oId "uc001aqf.2"; nearest_ref "uc001aqf.2"; class_code "="; tss_id "TSS2064"; p_id "P3092"; chr1 coding exon 9791819 9791954 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004109"; exon_number "3"; oId "uc001aqf.2"; nearest_ref "uc001aqf.2"; class_code "="; tss_id "TSS2064"; p_id "P3092"; chr1 coding exon 9793459 9793604 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004109"; exon_number "4"; oId "uc001aqf.2"; nearest_ref "uc001aqf.2"; class_code "="; tss_id "TSS2064"; p_id "P3092"; chr1 coding exon 9789080 9790763 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "1"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9791264 9791448 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "2"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9791819 9791954 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "3"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9793459 9793604 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "4"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9794030 9794200 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "5"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9795006 9795232 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "6"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9795525 9795673 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "7"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9795943 9796100 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "8"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9801152 9801314 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "9"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9803942 9804063 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "10"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9804453 9804701 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "11"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9809519 9809704 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "12"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9809822 9809971 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "13"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9811531 9811739 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "14"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9815172 9815367 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "15"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9816539 9816568 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "16"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9833330 9833452 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "17"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9883701 9884550 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004112"; exon_number "18"; gene_name "CLSTN1"; oId "uc010oag.1"; nearest_ref "uc010oag.1"; class_code "="; tss_id "TSS2065"; p_id "P3093"; chr1 coding exon 9789080 9790763 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "1"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9791264 9791448 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "2"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9791819 9791954 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "3"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9793459 9793604 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "4"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9794030 9794200 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "5"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9795006 9795232 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "6"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9795525 9795673 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "7"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9795943 9796100 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "8"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9797556 9797612 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "9"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9801152 9801314 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "10"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9803942 9804063 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "11"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9804453 9804701 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "12"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9809519 9809704 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "13"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9809822 9809971 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "14"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9811531 9811739 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "15"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9815172 9815367 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "16"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9833330 9833452 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "17"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9883701 9884550 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004111"; exon_number "18"; gene_name "CLSTN1"; oId "uc001aqi.2"; nearest_ref "uc001aqi.2"; class_code "="; tss_id "TSS2065"; p_id "P3091"; chr1 coding exon 9789080 9790763 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "1"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9791264 9791448 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "2"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9791819 9791954 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "3"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9793459 9793604 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "4"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9794030 9794200 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "5"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9795006 9795232 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "6"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9795525 9795673 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "7"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9795943 9796100 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "8"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9797556 9797612 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "9"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9801152 9801314 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "10"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9803942 9804063 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "11"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9804453 9804701 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "12"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9809519 9809704 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "13"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9809822 9809971 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "14"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9811531 9811739 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "15"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9815172 9815367 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "16"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9816539 9816568 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "17"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9833330 9833452 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "18"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9883701 9884550 . - . gene_id "XLOC_001303"; transcript_id "TCONS_00004110"; exon_number "19"; gene_name "CLSTN1"; oId "uc001aqh.2"; nearest_ref "uc001aqh.2"; class_code "="; tss_id "TSS2065"; p_id "P3094"; chr1 coding exon 9908334 9910834 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004114"; exon_number "1"; gene_name "CTNNBIP1"; oId "uc001aql.1"; nearest_ref "uc001aql.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9931245 9931335 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004114"; exon_number "2"; gene_name "CTNNBIP1"; oId "uc001aql.1"; nearest_ref "uc001aql.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9932027 9932146 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004114"; exon_number "3"; gene_name "CTNNBIP1"; oId "uc001aql.1"; nearest_ref "uc001aql.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9937963 9938047 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004114"; exon_number "4"; gene_name "CTNNBIP1"; oId "uc001aql.1"; nearest_ref "uc001aql.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9970153 9970316 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004114"; exon_number "5"; gene_name "CTNNBIP1"; oId "uc001aql.1"; nearest_ref "uc001aql.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9908334 9910834 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004113"; exon_number "1"; gene_name "CTNNBIP1"; oId "uc001aqk.1"; nearest_ref "uc001aqk.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9931245 9931335 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004113"; exon_number "2"; gene_name "CTNNBIP1"; oId "uc001aqk.1"; nearest_ref "uc001aqk.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9932027 9932146 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004113"; exon_number "3"; gene_name "CTNNBIP1"; oId "uc001aqk.1"; nearest_ref "uc001aqk.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9937963 9938047 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004113"; exon_number "4"; gene_name "CTNNBIP1"; oId "uc001aqk.1"; nearest_ref "uc001aqk.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9943763 9943796 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004113"; exon_number "5"; gene_name "CTNNBIP1"; oId "uc001aqk.1"; nearest_ref "uc001aqk.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9970153 9970316 . - . gene_id "XLOC_001304"; transcript_id "TCONS_00004113"; exon_number "6"; gene_name "CTNNBIP1"; oId "uc001aqk.1"; nearest_ref "uc001aqk.1"; class_code "="; tss_id "TSS2066"; p_id "P3095"; chr1 coding exon 9989778 9990515 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004115"; exon_number "1"; gene_name "LZIC"; oId "uc001aqn.2"; nearest_ref "uc001aqn.2"; class_code "="; tss_id "TSS2067"; p_id "P3098"; chr1 coding exon 9995550 9995685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004115"; exon_number "2"; gene_name "LZIC"; oId "uc001aqn.2"; nearest_ref "uc001aqn.2"; class_code "="; tss_id "TSS2067"; p_id "P3098"; chr1 coding exon 9996577 9996685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004115"; exon_number "3"; gene_name "LZIC"; oId "uc001aqn.2"; nearest_ref "uc001aqn.2"; class_code "="; tss_id "TSS2067"; p_id "P3098"; chr1 coding exon 10001225 10001427 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004115"; exon_number "4"; gene_name "LZIC"; oId "uc001aqn.2"; nearest_ref "uc001aqn.2"; class_code "="; tss_id "TSS2067"; p_id "P3098"; chr1 coding exon 10002682 10002840 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004115"; exon_number "5"; gene_name "LZIC"; oId "uc001aqn.2"; nearest_ref "uc001aqn.2"; class_code "="; tss_id "TSS2067"; p_id "P3098"; chr1 coding exon 9989778 9990515 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "1"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9991949 9992030 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "2"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9992861 9992956 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "3"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9994820 9994918 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "4"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9995550 9995685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "5"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9996577 9996685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "6"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 10002682 10002840 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "7"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 10003307 10003387 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004116"; exon_number "8"; gene_name "LZIC"; oId "uc001aqo.2"; nearest_ref "uc001aqo.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9989778 9990515 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "1"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 9991949 9992030 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "2"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 9992861 9992956 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "3"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 9994820 9994918 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "4"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 9995550 9995685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "5"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 9996577 9996685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "6"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 10002739 10002840 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "7"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 10003407 10003427 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004118"; exon_number "8"; gene_name "LZIC"; oId "uc010oah.1"; nearest_ref "uc010oah.1"; class_code "="; tss_id "TSS2068"; p_id "P3096"; chr1 coding exon 9989778 9990515 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "1"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9991949 9992030 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "2"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9992861 9992956 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "3"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9994820 9994918 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "4"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9995550 9995685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "5"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 9996577 9996685 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "6"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 10002682 10002840 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "7"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 10003407 10003427 . - . gene_id "XLOC_001305"; transcript_id "TCONS_00004117"; exon_number "8"; gene_name "LZIC"; oId "uc009vmr.2"; nearest_ref "uc009vmr.2"; class_code "="; tss_id "TSS2068"; p_id "P3097"; chr1 coding exon 10520605 10523266 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004120"; exon_number "1"; gene_name "DFFA"; oId "uc001ark.2"; nearest_ref "uc001ark.2"; class_code "="; tss_id "TSS2069"; p_id "P3099"; chr1 coding exon 10523488 10523677 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004120"; exon_number "2"; gene_name "DFFA"; oId "uc001ark.2"; nearest_ref "uc001ark.2"; class_code "="; tss_id "TSS2069"; p_id "P3099"; chr1 coding exon 10527247 10527389 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004120"; exon_number "3"; gene_name "DFFA"; oId "uc001ark.2"; nearest_ref "uc001ark.2"; class_code "="; tss_id "TSS2069"; p_id "P3099"; chr1 coding exon 10529234 10529395 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004120"; exon_number "4"; gene_name "DFFA"; oId "uc001ark.2"; nearest_ref "uc001ark.2"; class_code "="; tss_id "TSS2069"; p_id "P3099"; chr1 coding exon 10532380 10532613 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004120"; exon_number "5"; gene_name "DFFA"; oId "uc001ark.2"; nearest_ref "uc001ark.2"; class_code "="; tss_id "TSS2069"; p_id "P3099"; chr1 coding exon 10520605 10521759 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004119"; exon_number "1"; gene_name "DFFA"; oId "uc001arj.2"; nearest_ref "uc001arj.2"; class_code "="; tss_id "TSS2069"; p_id "P3100"; chr1 coding exon 10523115 10523266 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004119"; exon_number "2"; gene_name "DFFA"; oId "uc001arj.2"; nearest_ref "uc001arj.2"; class_code "="; tss_id "TSS2069"; p_id "P3100"; chr1 coding exon 10523488 10523677 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004119"; exon_number "3"; gene_name "DFFA"; oId "uc001arj.2"; nearest_ref "uc001arj.2"; class_code "="; tss_id "TSS2069"; p_id "P3100"; chr1 coding exon 10527247 10527389 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004119"; exon_number "4"; gene_name "DFFA"; oId "uc001arj.2"; nearest_ref "uc001arj.2"; class_code "="; tss_id "TSS2069"; p_id "P3100"; chr1 coding exon 10529234 10529395 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004119"; exon_number "5"; gene_name "DFFA"; oId "uc001arj.2"; nearest_ref "uc001arj.2"; class_code "="; tss_id "TSS2069"; p_id "P3100"; chr1 coding exon 10532380 10532613 . - . gene_id "XLOC_001306"; transcript_id "TCONS_00004119"; exon_number "6"; gene_name "DFFA"; oId "uc001arj.2"; nearest_ref "uc001arj.2"; class_code "="; tss_id "TSS2069"; p_id "P3100"; chr1 coding exon 10696668 10700116 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "1"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10702916 10703057 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "2"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10703217 10703368 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "3"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10704974 10705145 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "4"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10706185 10706383 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "5"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10707858 10708196 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "6"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10709127 10709249 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "7"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10709340 10709494 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "8"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10710749 10710812 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "9"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10710998 10711133 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "10"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10713434 10714275 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "11"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10714476 10714648 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "12"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10715706 10715870 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "13"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10716703 10716793 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "14"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10718565 10718633 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "15"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10719759 10720593 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "16"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10725140 10725628 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "17"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10753931 10753969 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "18"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10765549 10765601 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "19"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10820758 10820914 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "20"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10856621 10856707 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004121"; exon_number "21"; gene_name "CASZ1"; oId "uc001aro.2"; nearest_ref "uc001aro.2"; class_code "="; tss_id "TSS2070"; p_id "P3104"; chr1 coding exon 10707270 10708196 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "1"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10709127 10709249 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "2"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10709340 10709494 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "3"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10710749 10710812 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "4"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10710998 10711133 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "5"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10713434 10714275 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "6"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10714476 10714648 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "7"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10715706 10715870 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "8"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10716703 10716793 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "9"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10718565 10718633 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "10"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10719759 10720593 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "11"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10725140 10725628 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "12"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10753931 10753969 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "13"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10765549 10765601 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "14"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10820758 10820914 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "15"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10856621 10856707 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004122"; exon_number "16"; gene_name "CASZ1"; oId "uc001arp.1"; nearest_ref "uc001arp.1"; class_code "="; tss_id "TSS2070"; p_id "P3103"; chr1 coding exon 10713041 10714275 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "1"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10714476 10714648 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "2"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10715706 10715870 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "3"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10716703 10716793 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "4"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10718565 10718633 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "5"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10719759 10720593 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "6"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10725140 10725628 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "7"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10753931 10753969 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "8"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10754354 10754507 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004123"; exon_number "9"; gene_name "CASZ1"; oId "uc009vmx.2"; nearest_ref "uc009vmx.2"; class_code "="; tss_id "TSS2071"; p_id "P3102"; chr1 coding exon 10718064 10718633 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004124"; exon_number "1"; oId "uc001arq.1"; nearest_ref "uc001arq.1"; class_code "="; tss_id "TSS2072"; p_id "P3101"; chr1 coding exon 10719759 10721455 . - . gene_id "XLOC_001307"; transcript_id "TCONS_00004124"; exon_number "2"; oId "uc001arq.1"; nearest_ref "uc001arq.1"; class_code "="; tss_id "TSS2072"; p_id "P3101"; chr1 coding exon 11006533 11006798 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "1"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11007700 11008901 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "2"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11009681 11009871 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "3"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11014076 11014199 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "4"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11015047 11015243 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "5"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11017080 11017164 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "6"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11017673 11017810 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "7"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11018771 11018809 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "8"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11024185 11024258 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004127"; exon_number "9"; gene_name "C1orf127"; oId "uc010oao.1"; nearest_ref "uc010oao.1"; class_code "="; tss_id "TSS2073"; p_id "P3107"; chr1 coding exon 11006533 11006798 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "1"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11007700 11008901 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "2"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11009759 11009871 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "3"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11014076 11014199 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "4"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11015047 11015243 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "5"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11017080 11017164 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "6"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11017673 11017810 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "7"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11018771 11018809 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "8"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11024185 11024258 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004126"; exon_number "9"; gene_name "C1orf127"; oId "uc001ars.1"; nearest_ref "uc001ars.1"; class_code "="; tss_id "TSS2073"; p_id "P3106"; chr1 coding exon 11006533 11006798 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "1"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11007700 11008901 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "2"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11009681 11009871 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "3"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11014076 11014199 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "4"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11015047 11015243 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "5"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11017642 11017810 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "6"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11018771 11018809 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "7"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11024185 11024258 . - . gene_id "XLOC_001308"; transcript_id "TCONS_00004125"; exon_number "8"; gene_name "C1orf127"; oId "uc001arr.1"; nearest_ref "uc001arr.1"; class_code "="; tss_id "TSS2073"; p_id "P3105"; chr1 coding exon 11086581 11087705 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "1"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11090233 11090307 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "2"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11090805 11090939 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "3"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11094885 11094963 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "4"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11097750 11097868 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "5"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11102932 11103079 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "6"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11103396 11103592 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "7"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11105465 11105596 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "8"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11106613 11106790 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "9"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11106948 11107176 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "10"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11107260 11107285 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004128"; exon_number "11"; gene_name "MASP2"; oId "uc001aru.2"; nearest_ref "uc001aru.2"; class_code "="; tss_id "TSS2074"; p_id "P3108"; chr1 coding exon 11104856 11106790 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004130"; exon_number "1"; gene_name "MASP2"; oId "uc001arw.2"; nearest_ref "uc001arw.2"; class_code "="; tss_id "TSS2074"; p_id "P3111"; chr1 coding exon 11106948 11107176 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004130"; exon_number "2"; gene_name "MASP2"; oId "uc001arw.2"; nearest_ref "uc001arw.2"; class_code "="; tss_id "TSS2074"; p_id "P3111"; chr1 coding exon 11107260 11107285 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004130"; exon_number "3"; gene_name "MASP2"; oId "uc001arw.2"; nearest_ref "uc001arw.2"; class_code "="; tss_id "TSS2074"; p_id "P3111"; chr1 coding exon 11104856 11105010 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004129"; exon_number "1"; gene_name "MASP2"; oId "uc001arv.2"; nearest_ref "uc001arv.2"; class_code "="; tss_id "TSS2074"; p_id "P3110"; chr1 coding exon 11105465 11105596 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004129"; exon_number "2"; gene_name "MASP2"; oId "uc001arv.2"; nearest_ref "uc001arv.2"; class_code "="; tss_id "TSS2074"; p_id "P3110"; chr1 coding exon 11106613 11106790 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004129"; exon_number "3"; gene_name "MASP2"; oId "uc001arv.2"; nearest_ref "uc001arv.2"; class_code "="; tss_id "TSS2074"; p_id "P3110"; chr1 coding exon 11106948 11107176 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004129"; exon_number "4"; gene_name "MASP2"; oId "uc001arv.2"; nearest_ref "uc001arv.2"; class_code "="; tss_id "TSS2074"; p_id "P3110"; chr1 coding exon 11107260 11107285 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004129"; exon_number "5"; gene_name "MASP2"; oId "uc001arv.2"; nearest_ref "uc001arv.2"; class_code "="; tss_id "TSS2074"; p_id "P3110"; chr1 coding exon 11105156 11105596 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004131"; exon_number "1"; gene_name "MASP2"; oId "uc001arx.1"; nearest_ref "uc001arx.1"; class_code "="; tss_id "TSS2074"; p_id "P3109"; chr1 coding exon 11106613 11106790 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004131"; exon_number "2"; gene_name "MASP2"; oId "uc001arx.1"; nearest_ref "uc001arx.1"; class_code "="; tss_id "TSS2074"; p_id "P3109"; chr1 coding exon 11106948 11107176 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004131"; exon_number "3"; gene_name "MASP2"; oId "uc001arx.1"; nearest_ref "uc001arx.1"; class_code "="; tss_id "TSS2074"; p_id "P3109"; chr1 coding exon 11107260 11107285 . - . gene_id "XLOC_001309"; transcript_id "TCONS_00004131"; exon_number "4"; gene_name "MASP2"; oId "uc001arx.1"; nearest_ref "uc001arx.1"; class_code "="; tss_id "TSS2074"; p_id "P3109"; chr1 coding exon 11114649 11114942 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004132"; exon_number "1"; gene_name "SRM"; oId "uc001ary.1"; nearest_ref "uc001ary.1"; class_code "="; tss_id "TSS2075"; p_id "P3113"; chr1 coding exon 11115019 11115141 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004132"; exon_number "2"; gene_name "SRM"; oId "uc001ary.1"; nearest_ref "uc001ary.1"; class_code "="; tss_id "TSS2075"; p_id "P3113"; chr1 coding exon 11115838 11115983 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004132"; exon_number "3"; gene_name "SRM"; oId "uc001ary.1"; nearest_ref "uc001ary.1"; class_code "="; tss_id "TSS2075"; p_id "P3113"; chr1 coding exon 11116068 11116151 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004132"; exon_number "4"; gene_name "SRM"; oId "uc001ary.1"; nearest_ref "uc001ary.1"; class_code "="; tss_id "TSS2075"; p_id "P3113"; chr1 coding exon 11116661 11116841 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004132"; exon_number "5"; gene_name "SRM"; oId "uc001ary.1"; nearest_ref "uc001ary.1"; class_code "="; tss_id "TSS2075"; p_id "P3113"; chr1 coding exon 11114649 11114942 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "1"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11115019 11115141 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "2"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11115838 11115983 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "3"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11116068 11116151 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "4"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11116661 11116814 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "5"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11118857 11118949 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "6"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11119282 11119402 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "7"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11119834 11120091 . - . gene_id "XLOC_001310"; transcript_id "TCONS_00004133"; exon_number "8"; gene_name "SRM"; oId "uc001arz.1"; nearest_ref "uc001arz.1"; class_code "="; tss_id "TSS2076"; p_id "P3112"; chr1 coding exon 11126678 11126805 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "1"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11128065 11128141 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "2"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11128702 11128763 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "3"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11129616 11129787 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "4"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11130957 11131030 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "5"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11132144 11132228 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "6"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11134288 11134383 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "7"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11136899 11137005 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "8"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11137422 11137500 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "9"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11137658 11137708 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "10"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11139768 11139879 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "11"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11140556 11140606 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "12"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11140821 11140969 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "13"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11141139 11141295 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "14"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11142745 11142935 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "15"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11147505 11147648 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "16"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11147857 11147967 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "17"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11148180 11148255 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "18"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11150611 11150725 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "19"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11151071 11151236 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "20"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11151550 11151654 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "21"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11155815 11155938 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "22"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11158077 11158213 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "23"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11159778 11159938 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004135"; exon_number "24"; gene_name "EXOSC10"; oId "uc001asb.2"; nearest_ref "uc001asb.2"; class_code "="; tss_id "TSS2077"; p_id "P3114"; chr1 coding exon 11126678 11126805 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "1"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11128065 11128141 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "2"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11128702 11128763 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "3"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11129616 11129787 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "4"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11130957 11131030 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "5"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11132144 11132228 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "6"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11133991 11134065 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "7"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11134288 11134383 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "8"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11136899 11137005 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "9"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11137422 11137500 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "10"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11137658 11137708 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "11"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11139768 11139879 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "12"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11140556 11140606 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "13"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11140821 11140969 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "14"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11141139 11141295 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "15"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11142745 11142935 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "16"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11147505 11147648 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "17"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11147857 11147967 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "18"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11148180 11148255 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "19"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11150611 11150725 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "20"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11151071 11151236 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "21"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11151550 11151654 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "22"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11155815 11155938 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "23"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11158077 11158213 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "24"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11159778 11159938 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004134"; exon_number "25"; gene_name "EXOSC10"; oId "uc001asa.2"; nearest_ref "uc001asa.2"; class_code "="; tss_id "TSS2077"; p_id "P3116"; chr1 coding exon 11139768 11140969 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "1"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11141139 11141295 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "2"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11142745 11142935 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "3"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11147505 11147648 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "4"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11147857 11147967 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "5"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11148180 11148255 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "6"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11150611 11150725 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "7"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11151071 11151236 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "8"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11151550 11151654 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "9"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11155815 11155938 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "10"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11158077 11158213 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "11"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11159778 11159938 . - . gene_id "XLOC_001311"; transcript_id "TCONS_00004136"; exon_number "12"; gene_name "EXOSC10"; oId "uc009vmy.1"; nearest_ref "uc009vmy.1"; class_code "="; tss_id "TSS2077"; p_id "P3115"; chr1 coding exon 11166589 11167557 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "1"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11168238 11168343 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "2"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11169347 11169427 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "3"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11169706 11169786 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "4"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11172909 11172974 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "5"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11174375 11174510 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "6"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11174870 11174944 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "7"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11175453 11175525 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "8"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11177061 11177143 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "9"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11181303 11181425 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "10"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11182036 11182183 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "11"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11184555 11184690 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "12"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11186679 11186853 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "13"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11187067 11187201 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "14"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11187681 11187863 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "15"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11188061 11188183 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "16"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11188511 11188609 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "17"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11188912 11189008 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "18"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11189795 11189895 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "19"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11190586 11191615 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004137"; exon_number "20"; oId "uc001asc.2"; nearest_ref "uc001asc.2"; class_code "="; tss_id "TSS2078"; p_id "P3118"; chr1 coding exon 11166589 11167557 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "1"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11168238 11168343 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "2"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11169347 11169427 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "3"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11169706 11169786 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "4"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11172909 11172974 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "5"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11174375 11174510 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "6"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11174870 11174944 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "7"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11175453 11175525 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "8"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11177061 11177143 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "9"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11181303 11181425 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "10"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11182036 11182183 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "11"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11184555 11184690 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "12"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11186679 11186853 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "13"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11187067 11187201 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "14"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11187681 11187863 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "15"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11188061 11188183 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "16"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11188511 11188609 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "17"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11188912 11189008 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "18"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11189795 11189895 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "19"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11190586 11190834 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "20"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11193137 11193254 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "21"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11194408 11194523 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "22"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11199361 11199492 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "23"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11199590 11199715 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "24"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11204705 11204812 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "25"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11205025 11205102 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "26"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11206733 11206848 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "27"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11210183 11210283 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "28"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11217209 11217348 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "29"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11227499 11227574 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "30"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11259315 11259460 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "31"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11259598 11259760 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "32"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11264618 11264760 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "33"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11269369 11269515 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "34"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11270871 11270963 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "35"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11272369 11272531 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "36"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11272853 11272965 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "37"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11273456 11273623 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "38"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11276205 11276291 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "39"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11288725 11288975 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "40"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11290982 11291111 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "41"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11291357 11291491 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "42"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11292493 11292585 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "43"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11293455 11293544 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "44"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11294200 11294322 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "45"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11297900 11298105 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "46"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11298459 11298674 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "47"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11300360 11300604 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "48"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11301610 11301738 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "49"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11303171 11303357 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "50"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11307682 11307790 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "51"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11307876 11308151 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "52"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11313896 11314030 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "53"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11316049 11316249 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "54"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11316990 11317222 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "55"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11318542 11318650 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "56"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11319305 11319480 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "57"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11322502 11322608 . - . gene_id "XLOC_001312"; transcript_id "TCONS_00004138"; exon_number "58"; gene_name "MTOR"; oId "uc001asd.2"; nearest_ref "uc001asd.2"; class_code "="; tss_id "TSS2079"; p_id "P3117"; chr1 coding exon 11708450 11708885 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004140"; exon_number "1"; gene_name "FBXO2"; oId "uc009vna.2"; nearest_ref "uc009vna.2"; class_code "="; tss_id "TSS2080"; p_id "P3120"; chr1 coding exon 11709144 11709282 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004140"; exon_number "2"; gene_name "FBXO2"; oId "uc009vna.2"; nearest_ref "uc009vna.2"; class_code "="; tss_id "TSS2080"; p_id "P3120"; chr1 coding exon 11709836 11709940 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004140"; exon_number "3"; gene_name "FBXO2"; oId "uc009vna.2"; nearest_ref "uc009vna.2"; class_code "="; tss_id "TSS2080"; p_id "P3120"; chr1 coding exon 11710002 11710131 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004140"; exon_number "4"; gene_name "FBXO2"; oId "uc009vna.2"; nearest_ref "uc009vna.2"; class_code "="; tss_id "TSS2080"; p_id "P3120"; chr1 coding exon 11710523 11710891 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004140"; exon_number "5"; gene_name "FBXO2"; oId "uc009vna.2"; nearest_ref "uc009vna.2"; class_code "="; tss_id "TSS2080"; p_id "P3120"; chr1 coding exon 11714376 11714739 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004140"; exon_number "6"; gene_name "FBXO2"; oId "uc009vna.2"; nearest_ref "uc009vna.2"; class_code "="; tss_id "TSS2080"; p_id "P3120"; chr1 coding exon 11708450 11708885 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004139"; exon_number "1"; gene_name "FBXO2"; oId "uc001asj.2"; nearest_ref "uc001asj.2"; class_code "="; tss_id "TSS2080"; p_id "P3119"; chr1 coding exon 11709144 11709282 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004139"; exon_number "2"; gene_name "FBXO2"; oId "uc001asj.2"; nearest_ref "uc001asj.2"; class_code "="; tss_id "TSS2080"; p_id "P3119"; chr1 coding exon 11709836 11709931 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004139"; exon_number "3"; gene_name "FBXO2"; oId "uc001asj.2"; nearest_ref "uc001asj.2"; class_code "="; tss_id "TSS2080"; p_id "P3119"; chr1 coding exon 11710002 11710131 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004139"; exon_number "4"; gene_name "FBXO2"; oId "uc001asj.2"; nearest_ref "uc001asj.2"; class_code "="; tss_id "TSS2080"; p_id "P3119"; chr1 coding exon 11710523 11710891 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004139"; exon_number "5"; gene_name "FBXO2"; oId "uc001asj.2"; nearest_ref "uc001asj.2"; class_code "="; tss_id "TSS2080"; p_id "P3119"; chr1 coding exon 11714376 11714739 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004139"; exon_number "6"; gene_name "FBXO2"; oId "uc001asj.2"; nearest_ref "uc001asj.2"; class_code "="; tss_id "TSS2080"; p_id "P3119"; chr1 nearCoding exon 11709144 11709282 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004141"; exon_number "1"; gene_name "FBXO2"; oId "uc009vnb.1"; nearest_ref "uc009vnb.1"; class_code "="; tss_id "TSS2081"; chr1 nearCoding exon 11709836 11709931 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004141"; exon_number "2"; gene_name "FBXO2"; oId "uc009vnb.1"; nearest_ref "uc009vnb.1"; class_code "="; tss_id "TSS2081"; chr1 nearCoding exon 11710002 11710131 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004141"; exon_number "3"; gene_name "FBXO2"; oId "uc009vnb.1"; nearest_ref "uc009vnb.1"; class_code "="; tss_id "TSS2081"; chr1 nearCoding exon 11710523 11710891 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004141"; exon_number "4"; gene_name "FBXO2"; oId "uc009vnb.1"; nearest_ref "uc009vnb.1"; class_code "="; tss_id "TSS2081"; chr1 nearCoding exon 11713448 11713582 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004141"; exon_number "5"; gene_name "FBXO2"; oId "uc009vnb.1"; nearest_ref "uc009vnb.1"; class_code "="; tss_id "TSS2081"; chr1 nearCoding exon 11714088 11714401 . - . gene_id "XLOC_001313"; transcript_id "TCONS_00004141"; exon_number "6"; gene_name "FBXO2"; oId "uc009vnb.1"; nearest_ref "uc009vnb.1"; class_code "="; tss_id "TSS2081"; chr1 coding exon 11734538 11734873 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "1"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11735139 11735231 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "2"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11735715 11735788 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "3"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11736103 11736197 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "4"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11736905 11737005 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "5"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11737600 11737671 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "6"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11740410 11740528 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "7"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11740619 11740670 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "8"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11751470 11751678 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004143"; exon_number "9"; gene_name "MAD2L2"; oId "uc009vnc.2"; nearest_ref "uc009vnc.2"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11734538 11734873 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "1"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11735139 11735231 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "2"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11735715 11735788 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "3"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11736103 11736197 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "4"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11736905 11737005 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "5"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11737600 11737671 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "6"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11740410 11740528 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "7"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11740619 11740670 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "8"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11741096 11741495 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "9"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11741795 11742073 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "10"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11751470 11751678 . - . gene_id "XLOC_001314"; transcript_id "TCONS_00004142"; exon_number "11"; gene_name "MAD2L2"; oId "uc001asq.3"; nearest_ref "uc001asq.3"; class_code "="; tss_id "TSS2082"; p_id "P3121"; chr1 coding exon 11845787 11850955 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "1"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11851264 11851383 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "2"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11852335 11852436 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "3"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11853964 11854146 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "4"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11854415 11854595 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "5"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11854786 11854920 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "6"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11855155 11855405 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "7"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11856263 11856456 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "8"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11860269 11860379 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "9"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11861218 11861456 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "10"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11862938 11863440 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004144"; exon_number "11"; gene_name "MTHFR"; oId "uc001atb.1"; nearest_ref "uc001atb.1"; class_code "="; tss_id "TSS2083"; p_id "P3122"; chr1 coding exon 11845787 11850955 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "1"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11851264 11851383 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "2"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11852335 11852436 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "3"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11853964 11854146 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "4"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11854415 11854595 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "5"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11854786 11854920 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "6"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11855155 11855405 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "7"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11856263 11856456 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "8"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11860269 11860379 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "9"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11861218 11861456 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "10"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11862938 11863186 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "11"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 coding exon 11865945 11866115 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004145"; exon_number "12"; gene_name "MTHFR"; oId "uc001atc.1"; nearest_ref "uc001atc.1"; class_code "="; tss_id "TSS2084"; p_id "P3123"; chr1 nearCoding exon 11862938 11863186 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004147"; exon_number "1"; gene_name "MTHFR"; oId "uc009vnd.1"; nearest_ref "uc009vnd.1"; class_code "="; tss_id "TSS2085"; chr1 nearCoding exon 11863856 11864589 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004147"; exon_number "2"; gene_name "MTHFR"; oId "uc009vnd.1"; nearest_ref "uc009vnd.1"; class_code "="; tss_id "TSS2085"; chr1 nearCoding exon 11865437 11865470 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004147"; exon_number "3"; gene_name "MTHFR"; oId "uc009vnd.1"; nearest_ref "uc009vnd.1"; class_code "="; tss_id "TSS2085"; chr1 nearCoding exon 11862938 11863186 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004146"; exon_number "1"; gene_name "MTHFR"; oId "uc001atd.1"; nearest_ref "uc001atd.1"; class_code "="; tss_id "TSS2085"; chr1 nearCoding exon 11863462 11864589 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004146"; exon_number "2"; gene_name "MTHFR"; oId "uc001atd.1"; nearest_ref "uc001atd.1"; class_code "="; tss_id "TSS2085"; chr1 nearCoding exon 11865437 11865470 . - . gene_id "XLOC_001315"; transcript_id "TCONS_00004146"; exon_number "3"; gene_name "MTHFR"; oId "uc001atd.1"; nearest_ref "uc001atd.1"; class_code "="; tss_id "TSS2085"; chr1 coding exon 11905769 11906071 . - . gene_id "XLOC_001316"; transcript_id "TCONS_00004148"; exon_number "1"; gene_name "NPPA"; oId "uc001ati.2"; nearest_ref "uc001ati.2"; class_code "="; tss_id "TSS2086"; p_id "P3124"; chr1 coding exon 11907170 11907496 . - . gene_id "XLOC_001316"; transcript_id "TCONS_00004148"; exon_number "2"; gene_name "NPPA"; oId "uc001ati.2"; nearest_ref "uc001ati.2"; class_code "="; tss_id "TSS2086"; p_id "P3124"; chr1 coding exon 11907619 11907840 . - . gene_id "XLOC_001316"; transcript_id "TCONS_00004148"; exon_number "3"; gene_name "NPPA"; oId "uc001ati.2"; nearest_ref "uc001ati.2"; class_code "="; tss_id "TSS2086"; p_id "P3124"; chr1 coding exon 11917522 11917728 . - . gene_id "XLOC_001317"; transcript_id "TCONS_00004149"; exon_number "1"; gene_name "NPPB"; oId "uc001atj.2"; nearest_ref "uc001atj.2"; class_code "="; tss_id "TSS2087"; p_id "P3125"; chr1 coding exon 11918271 11918526 . - . gene_id "XLOC_001317"; transcript_id "TCONS_00004149"; exon_number "2"; gene_name "NPPB"; oId "uc001atj.2"; nearest_ref "uc001atj.2"; class_code "="; tss_id "TSS2087"; p_id "P3125"; chr1 coding exon 11918759 11918992 . - . gene_id "XLOC_001317"; transcript_id "TCONS_00004149"; exon_number "3"; gene_name "NPPB"; oId "uc001atj.2"; nearest_ref "uc001atj.2"; class_code "="; tss_id "TSS2087"; p_id "P3125"; chr1 coding exon 11980124 11980389 . - . gene_id "XLOC_001318"; transcript_id "TCONS_00004150"; exon_number "1"; gene_name "KIAA2013"; oId "uc001atk.2"; nearest_ref "uc001atk.2"; class_code "="; tss_id "TSS2088"; p_id "P3127"; chr1 coding exon 11982693 11983546 . - . gene_id "XLOC_001318"; transcript_id "TCONS_00004150"; exon_number "2"; gene_name "KIAA2013"; oId "uc001atk.2"; nearest_ref "uc001atk.2"; class_code "="; tss_id "TSS2088"; p_id "P3127"; chr1 coding exon 11985262 11986480 . - . gene_id "XLOC_001318"; transcript_id "TCONS_00004150"; exon_number "3"; gene_name "KIAA2013"; oId "uc001atk.2"; nearest_ref "uc001atk.2"; class_code "="; tss_id "TSS2088"; p_id "P3127"; chr1 coding exon 11982232 11983546 . - . gene_id "XLOC_001318"; transcript_id "TCONS_00004151"; exon_number "1"; gene_name "KIAA2013"; oId "uc001atl.1"; nearest_ref "uc001atl.1"; class_code "="; tss_id "TSS2088"; p_id "P3126"; chr1 coding exon 11985262 11986480 . - . gene_id "XLOC_001318"; transcript_id "TCONS_00004151"; exon_number "2"; gene_name "KIAA2013"; oId "uc001atl.1"; nearest_ref "uc001atl.1"; class_code "="; tss_id "TSS2088"; p_id "P3126"; chr1 coding exon 12627940 12628453 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004152"; exon_number "1"; gene_name "DHRS3"; oId "uc001aub.2"; nearest_ref "uc001aub.2"; class_code "="; tss_id "TSS2089"; p_id "P3130"; chr1 coding exon 12632756 12632881 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004152"; exon_number "2"; gene_name "DHRS3"; oId "uc001aub.2"; nearest_ref "uc001aub.2"; class_code "="; tss_id "TSS2089"; p_id "P3130"; chr1 coding exon 12638746 12638984 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004152"; exon_number "3"; gene_name "DHRS3"; oId "uc001aub.2"; nearest_ref "uc001aub.2"; class_code "="; tss_id "TSS2089"; p_id "P3130"; chr1 coding exon 12639321 12639440 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004152"; exon_number "4"; gene_name "DHRS3"; oId "uc001aub.2"; nearest_ref "uc001aub.2"; class_code "="; tss_id "TSS2089"; p_id "P3130"; chr1 coding exon 12640551 12640694 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004152"; exon_number "5"; gene_name "DHRS3"; oId "uc001aub.2"; nearest_ref "uc001aub.2"; class_code "="; tss_id "TSS2089"; p_id "P3130"; chr1 coding exon 12676564 12676788 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004152"; exon_number "6"; gene_name "DHRS3"; oId "uc001aub.2"; nearest_ref "uc001aub.2"; class_code "="; tss_id "TSS2089"; p_id "P3130"; chr1 coding exon 12627940 12628453 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004153"; exon_number "1"; gene_name "DHRS3"; oId "uc001auc.2"; nearest_ref "uc001auc.2"; class_code "="; tss_id "TSS2090"; p_id "P3128"; chr1 coding exon 12632756 12632881 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004153"; exon_number "2"; gene_name "DHRS3"; oId "uc001auc.2"; nearest_ref "uc001auc.2"; class_code "="; tss_id "TSS2090"; p_id "P3128"; chr1 coding exon 12638746 12638984 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004153"; exon_number "3"; gene_name "DHRS3"; oId "uc001auc.2"; nearest_ref "uc001auc.2"; class_code "="; tss_id "TSS2090"; p_id "P3128"; chr1 coding exon 12639321 12639440 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004153"; exon_number "4"; gene_name "DHRS3"; oId "uc001auc.2"; nearest_ref "uc001auc.2"; class_code "="; tss_id "TSS2090"; p_id "P3128"; chr1 coding exon 12640551 12640694 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004153"; exon_number "5"; gene_name "DHRS3"; oId "uc001auc.2"; nearest_ref "uc001auc.2"; class_code "="; tss_id "TSS2090"; p_id "P3128"; chr1 coding exon 12677159 12677820 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004153"; exon_number "6"; gene_name "DHRS3"; oId "uc001auc.2"; nearest_ref "uc001auc.2"; class_code "="; tss_id "TSS2090"; p_id "P3128"; chr1 coding exon 12638985 12639440 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004154"; exon_number "1"; gene_name "DHRS3"; oId "uc009vnm.2"; nearest_ref "uc009vnm.2"; class_code "="; tss_id "TSS2090"; p_id "P3131"; chr1 coding exon 12640551 12640694 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004154"; exon_number "2"; gene_name "DHRS3"; oId "uc009vnm.2"; nearest_ref "uc009vnm.2"; class_code "="; tss_id "TSS2090"; p_id "P3131"; chr1 coding exon 12677159 12677820 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004154"; exon_number "3"; gene_name "DHRS3"; oId "uc009vnm.2"; nearest_ref "uc009vnm.2"; class_code "="; tss_id "TSS2090"; p_id "P3131"; chr1 coding exon 12640135 12640694 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004155"; exon_number "1"; gene_name "DHRS3"; oId "uc001aud.3"; nearest_ref "uc001aud.3"; class_code "="; tss_id "TSS2090"; p_id "P3129"; chr1 coding exon 12677159 12677820 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004155"; exon_number "2"; gene_name "DHRS3"; oId "uc001aud.3"; nearest_ref "uc001aud.3"; class_code "="; tss_id "TSS2090"; p_id "P3129"; chr1 nearCoding exon 12640551 12640694 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004156"; exon_number "1"; gene_name "DHRS3"; oId "uc001aue.1"; nearest_ref "uc001aue.1"; class_code "="; tss_id "TSS2091"; chr1 nearCoding exon 12655999 12656106 . - . gene_id "XLOC_001319"; transcript_id "TCONS_00004156"; exon_number "2"; gene_name "DHRS3"; oId "uc001aue.1"; nearest_ref "uc001aue.1"; class_code "="; tss_id "TSS2091"; chr1 coding exon 12884468 12885361 . - . gene_id "XLOC_001320"; transcript_id "TCONS_00004157"; exon_number "1"; gene_name "PRAMEF11"; oId "uc001auk.2"; nearest_ref "uc001auk.2"; class_code "="; tss_id "TSS2092"; p_id "P3132"; chr1 coding exon 12887108 12887689 . - . gene_id "XLOC_001320"; transcript_id "TCONS_00004157"; exon_number "2"; gene_name "PRAMEF11"; oId "uc001auk.2"; nearest_ref "uc001auk.2"; class_code "="; tss_id "TSS2092"; p_id "P3132"; chr1 coding exon 12888357 12888664 . - . gene_id "XLOC_001320"; transcript_id "TCONS_00004157"; exon_number "3"; gene_name "PRAMEF11"; oId "uc001auk.2"; nearest_ref "uc001auk.2"; class_code "="; tss_id "TSS2092"; p_id "P3132"; chr1 coding exon 12891210 12891264 . - . gene_id "XLOC_001320"; transcript_id "TCONS_00004157"; exon_number "4"; gene_name "PRAMEF11"; oId "uc001auk.2"; nearest_ref "uc001auk.2"; class_code "="; tss_id "TSS2092"; p_id "P3132"; chr1 coding exon 12907236 12908237 . - . gene_id "XLOC_001321"; transcript_id "TCONS_00004158"; exon_number "1"; oId "uc009vno.2"; nearest_ref "uc009vno.2"; class_code "="; p_id "P3133"; chr1 coding exon 12907263 12908323 . - . gene_id "XLOC_001321"; transcript_id "TCONS_00004159"; exon_number "1"; gene_name "HNRNPCL1"; oId "uc010obf.1"; nearest_ref "uc010obf.1"; class_code "="; tss_id "TSS2093"; p_id "P3133"; chr1 coding exon 12908534 12908578 . - . gene_id "XLOC_001321"; transcript_id "TCONS_00004159"; exon_number "2"; gene_name "HNRNPCL1"; oId "uc010obf.1"; nearest_ref "uc010obf.1"; class_code "="; tss_id "TSS2093"; p_id "P3133"; chr1 coding exon 12939033 12939926 . - . gene_id "XLOC_001322"; transcript_id "TCONS_00004160"; exon_number "1"; gene_name "PRAMEF4"; oId "uc001aun.2"; nearest_ref "uc001aun.2"; class_code "="; tss_id "TSS2094"; p_id "P3134"; chr1 coding exon 12941675 12942256 . - . gene_id "XLOC_001322"; transcript_id "TCONS_00004160"; exon_number "2"; gene_name "PRAMEF4"; oId "uc001aun.2"; nearest_ref "uc001aun.2"; class_code "="; tss_id "TSS2094"; p_id "P3134"; chr1 coding exon 12942923 12943231 . - . gene_id "XLOC_001322"; transcript_id "TCONS_00004160"; exon_number "3"; gene_name "PRAMEF4"; oId "uc001aun.2"; nearest_ref "uc001aun.2"; class_code "="; tss_id "TSS2094"; p_id "P3134"; chr1 coding exon 12945971 12946025 . - . gene_id "XLOC_001322"; transcript_id "TCONS_00004160"; exon_number "4"; gene_name "PRAMEF4"; oId "uc001aun.2"; nearest_ref "uc001aun.2"; class_code "="; tss_id "TSS2094"; p_id "P3134"; chr1 coding exon 12952728 12953305 . - . gene_id "XLOC_001323"; transcript_id "TCONS_00004161"; exon_number "1"; gene_name "PRAMEF10"; oId "uc001auo.2"; nearest_ref "uc001auo.2"; class_code "="; tss_id "TSS2095"; p_id "P3135"; chr1 coding exon 12954417 12954995 . - . gene_id "XLOC_001323"; transcript_id "TCONS_00004161"; exon_number "2"; gene_name "PRAMEF10"; oId "uc001auo.2"; nearest_ref "uc001auo.2"; class_code "="; tss_id "TSS2095"; p_id "P3135"; chr1 coding exon 12955392 12955703 . - . gene_id "XLOC_001323"; transcript_id "TCONS_00004161"; exon_number "3"; gene_name "PRAMEF10"; oId "uc001auo.2"; nearest_ref "uc001auo.2"; class_code "="; tss_id "TSS2095"; p_id "P3135"; chr1 coding exon 12958047 12958094 . - . gene_id "XLOC_001323"; transcript_id "TCONS_00004161"; exon_number "4"; gene_name "PRAMEF10"; oId "uc001auo.2"; nearest_ref "uc001auo.2"; class_code "="; tss_id "TSS2095"; p_id "P3135"; chr1 coding exon 12998302 12999066 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004162"; exon_number "1"; gene_name "PRAMEF6"; oId "uc001auq.2"; nearest_ref "uc001auq.2"; class_code "="; tss_id "TSS2096"; p_id "P3137"; chr1 coding exon 13000814 13001395 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004162"; exon_number "2"; gene_name "PRAMEF6"; oId "uc001auq.2"; nearest_ref "uc001auq.2"; class_code "="; tss_id "TSS2096"; p_id "P3137"; chr1 coding exon 13002062 13002370 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004162"; exon_number "3"; gene_name "PRAMEF6"; oId "uc001auq.2"; nearest_ref "uc001auq.2"; class_code "="; tss_id "TSS2096"; p_id "P3137"; chr1 coding exon 13007343 13007406 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004162"; exon_number "4"; gene_name "PRAMEF6"; oId "uc001auq.2"; nearest_ref "uc001auq.2"; class_code "="; tss_id "TSS2096"; p_id "P3137"; chr1 coding exon 12998302 12999066 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004163"; exon_number "1"; gene_name "PRAMEF5"; oId "uc001aur.2"; nearest_ref "uc001aur.2"; class_code "="; tss_id "TSS2097"; p_id "P3138"; chr1 coding exon 13111146 13111727 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004163"; exon_number "2"; gene_name "PRAMEF5"; oId "uc001aur.2"; nearest_ref "uc001aur.2"; class_code "="; tss_id "TSS2097"; p_id "P3138"; chr1 coding exon 13112394 13112702 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004163"; exon_number "3"; gene_name "PRAMEF5"; oId "uc001aur.2"; nearest_ref "uc001aur.2"; class_code "="; tss_id "TSS2097"; p_id "P3138"; chr1 coding exon 13117674 13117751 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004163"; exon_number "4"; gene_name "PRAMEF5"; oId "uc001aur.2"; nearest_ref "uc001aur.2"; class_code "="; tss_id "TSS2097"; p_id "P3138"; chr1 coding exon 13108514 13109399 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004164"; exon_number "1"; gene_name "PRAMEF5"; oId "uc001aus.1"; nearest_ref "uc001aus.1"; class_code "="; tss_id "TSS2097"; p_id "P3136"; chr1 coding exon 13111146 13111727 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004164"; exon_number "2"; gene_name "PRAMEF5"; oId "uc001aus.1"; nearest_ref "uc001aus.1"; class_code "="; tss_id "TSS2097"; p_id "P3136"; chr1 coding exon 13112394 13112702 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004164"; exon_number "3"; gene_name "PRAMEF5"; oId "uc001aus.1"; nearest_ref "uc001aus.1"; class_code "="; tss_id "TSS2097"; p_id "P3136"; chr1 coding exon 13117674 13117751 . - . gene_id "XLOC_001324"; transcript_id "TCONS_00004164"; exon_number "4"; gene_name "PRAMEF5"; oId "uc001aus.1"; nearest_ref "uc001aus.1"; class_code "="; tss_id "TSS2097"; p_id "P3136"; chr1 coding exon 13182961 13183967 . - . gene_id "XLOC_001325"; transcript_id "TCONS_00004165"; exon_number "1"; oId "uc010obg.1"; nearest_ref "uc010obg.1"; class_code "="; p_id "P3139"; chr1 coding exon 13328196 13329406 . - . gene_id "XLOC_001326"; transcript_id "TCONS_00004166"; exon_number "1"; gene_name "PRAMEF22"; oId "uc001aut.1"; nearest_ref "uc001aut.1"; class_code "="; tss_id "TSS2098"; p_id "P3140"; chr1 coding exon 13330414 13330992 . - . gene_id "XLOC_001326"; transcript_id "TCONS_00004166"; exon_number "2"; gene_name "PRAMEF22"; oId "uc001aut.1"; nearest_ref "uc001aut.1"; class_code "="; tss_id "TSS2098"; p_id "P3140"; chr1 coding exon 13331379 13331692 . - . gene_id "XLOC_001326"; transcript_id "TCONS_00004166"; exon_number "3"; gene_name "PRAMEF22"; oId "uc001aut.1"; nearest_ref "uc001aut.1"; class_code "="; tss_id "TSS2098"; p_id "P3140"; chr1 coding exon 13386649 13387543 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004167"; exon_number "1"; gene_name "PRAMEF8"; oId "uc010obh.1"; nearest_ref "uc010obh.1"; class_code "="; tss_id "TSS2099"; p_id "P3141"; chr1 coding exon 13388458 13389033 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004167"; exon_number "2"; gene_name "PRAMEF8"; oId "uc010obh.1"; nearest_ref "uc010obh.1"; class_code "="; tss_id "TSS2099"; p_id "P3141"; chr1 coding exon 13389416 13389770 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004167"; exon_number "3"; gene_name "PRAMEF8"; oId "uc010obh.1"; nearest_ref "uc010obh.1"; class_code "="; tss_id "TSS2099"; p_id "P3141"; chr1 coding exon 13386649 13387543 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004168"; exon_number "1"; gene_name "PRAMEF8"; oId "uc001auv.2"; nearest_ref "uc001auv.2"; class_code "="; tss_id "TSS2100"; p_id "P3141"; chr1 coding exon 13388458 13389033 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004168"; exon_number "2"; gene_name "PRAMEF8"; oId "uc001auv.2"; nearest_ref "uc001auv.2"; class_code "="; tss_id "TSS2100"; p_id "P3141"; chr1 coding exon 13389416 13389727 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004168"; exon_number "3"; gene_name "PRAMEF8"; oId "uc001auv.2"; nearest_ref "uc001auv.2"; class_code "="; tss_id "TSS2100"; p_id "P3141"; chr1 coding exon 13390708 13390765 . - . gene_id "XLOC_001327"; transcript_id "TCONS_00004168"; exon_number "4"; gene_name "PRAMEF8"; oId "uc001auv.2"; nearest_ref "uc001auv.2"; class_code "="; tss_id "TSS2100"; p_id "P3141"; chr1 coding exon 13447414 13448608 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004170"; exon_number "1"; gene_name "PRAMEF13"; oId "uc010obi.1"; nearest_ref "uc010obi.1"; class_code "="; tss_id "TSS2101"; p_id "P3143"; chr1 coding exon 13449560 13450138 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004170"; exon_number "2"; gene_name "PRAMEF13"; oId "uc010obi.1"; nearest_ref "uc010obi.1"; class_code "="; tss_id "TSS2101"; p_id "P3143"; chr1 coding exon 13450550 13450861 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004170"; exon_number "3"; gene_name "PRAMEF13"; oId "uc010obi.1"; nearest_ref "uc010obi.1"; class_code "="; tss_id "TSS2101"; p_id "P3143"; chr1 coding exon 13452579 13452656 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004170"; exon_number "4"; gene_name "PRAMEF13"; oId "uc010obi.1"; nearest_ref "uc010obi.1"; class_code "="; tss_id "TSS2101"; p_id "P3143"; chr1 coding exon 13447414 13448608 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004169"; exon_number "1"; gene_name "PRAMEF14"; oId "uc009vnt.1"; nearest_ref "uc009vnt.1"; class_code "="; tss_id "TSS2101"; p_id "P3142"; chr1 coding exon 13449704 13450138 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004169"; exon_number "2"; gene_name "PRAMEF14"; oId "uc009vnt.1"; nearest_ref "uc009vnt.1"; class_code "="; tss_id "TSS2101"; p_id "P3142"; chr1 coding exon 13450550 13450941 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004169"; exon_number "3"; gene_name "PRAMEF14"; oId "uc009vnt.1"; nearest_ref "uc009vnt.1"; class_code "="; tss_id "TSS2101"; p_id "P3142"; chr1 coding exon 13452579 13452656 . - . gene_id "XLOC_001328"; transcript_id "TCONS_00004169"; exon_number "4"; gene_name "PRAMEF14"; oId "uc009vnt.1"; nearest_ref "uc009vnt.1"; class_code "="; tss_id "TSS2101"; p_id "P3142"; chr1 coding exon 13474053 13475262 . - . gene_id "XLOC_001329"; transcript_id "TCONS_00004171"; exon_number "1"; gene_name "PRAMEF18"; oId "uc009vnu.1"; nearest_ref "uc009vnu.1"; class_code "="; tss_id "TSS2102"; p_id "P3144"; chr1 coding exon 13476271 13476849 . - . gene_id "XLOC_001329"; transcript_id "TCONS_00004171"; exon_number "2"; gene_name "PRAMEF18"; oId "uc009vnu.1"; nearest_ref "uc009vnu.1"; class_code "="; tss_id "TSS2102"; p_id "P3144"; chr1 coding exon 13477236 13477569 . - . gene_id "XLOC_001329"; transcript_id "TCONS_00004171"; exon_number "3"; gene_name "PRAMEF18"; oId "uc009vnu.1"; nearest_ref "uc009vnu.1"; class_code "="; tss_id "TSS2102"; p_id "P3144"; chr1 coding exon 13607431 13608328 . - . gene_id "XLOC_001330"; transcript_id "TCONS_00004172"; exon_number "1"; gene_name "PRAMEF8"; oId "uc001auy.2"; nearest_ref "uc001auy.2"; class_code "="; tss_id "TSS2103"; p_id "P3145"; chr1 coding exon 13609243 13609818 . - . gene_id "XLOC_001330"; transcript_id "TCONS_00004172"; exon_number "2"; gene_name "PRAMEF8"; oId "uc001auy.2"; nearest_ref "uc001auy.2"; class_code "="; tss_id "TSS2103"; p_id "P3145"; chr1 coding exon 13610201 13610512 . - . gene_id "XLOC_001330"; transcript_id "TCONS_00004172"; exon_number "3"; gene_name "PRAMEF8"; oId "uc001auy.2"; nearest_ref "uc001auy.2"; class_code "="; tss_id "TSS2103"; p_id "P3145"; chr1 coding exon 13611493 13611550 . - . gene_id "XLOC_001330"; transcript_id "TCONS_00004172"; exon_number "4"; gene_name "PRAMEF8"; oId "uc001auy.2"; nearest_ref "uc001auy.2"; class_code "="; tss_id "TSS2103"; p_id "P3145"; chr1 coding exon 13668269 13669463 . - . gene_id "XLOC_001331"; transcript_id "TCONS_00004173"; exon_number "1"; gene_name "PRAMEF14"; oId "uc009vnw.1"; nearest_ref "uc009vnw.1"; class_code "="; tss_id "TSS2104"; p_id "P3146"; chr1 coding exon 13670559 13670993 . - . gene_id "XLOC_001331"; transcript_id "TCONS_00004173"; exon_number "2"; gene_name "PRAMEF14"; oId "uc009vnw.1"; nearest_ref "uc009vnw.1"; class_code "="; tss_id "TSS2104"; p_id "P3146"; chr1 coding exon 13671405 13671796 . - . gene_id "XLOC_001331"; transcript_id "TCONS_00004173"; exon_number "3"; gene_name "PRAMEF14"; oId "uc009vnw.1"; nearest_ref "uc009vnw.1"; class_code "="; tss_id "TSS2104"; p_id "P3146"; chr1 coding exon 13673434 13673511 . - . gene_id "XLOC_001331"; transcript_id "TCONS_00004173"; exon_number "4"; gene_name "PRAMEF14"; oId "uc009vnw.1"; nearest_ref "uc009vnw.1"; class_code "="; tss_id "TSS2104"; p_id "P3146"; chr1 coding exon 13694889 13696098 . - . gene_id "XLOC_001332"; transcript_id "TCONS_00004174"; exon_number "1"; gene_name "PRAMEF18"; oId "uc009vny.1"; nearest_ref "uc009vny.1"; class_code "="; tss_id "TSS2105"; p_id "P3147"; chr1 coding exon 13697107 13697685 . - . gene_id "XLOC_001332"; transcript_id "TCONS_00004174"; exon_number "2"; gene_name "PRAMEF18"; oId "uc009vny.1"; nearest_ref "uc009vny.1"; class_code "="; tss_id "TSS2105"; p_id "P3147"; chr1 coding exon 13698072 13698405 . - . gene_id "XLOC_001332"; transcript_id "TCONS_00004174"; exon_number "3"; gene_name "PRAMEF18"; oId "uc009vny.1"; nearest_ref "uc009vny.1"; class_code "="; tss_id "TSS2105"; p_id "P3147"; chr1 coding exon 13801447 13802567 . - . gene_id "XLOC_001333"; transcript_id "TCONS_00004175"; exon_number "1"; gene_name "LRRC38"; oId "uc001avb.2"; nearest_ref "uc001avb.2"; class_code "="; tss_id "TSS2106"; p_id "P3148"; chr1 coding exon 13839458 13840242 . - . gene_id "XLOC_001333"; transcript_id "TCONS_00004175"; exon_number "2"; gene_name "LRRC38"; oId "uc001avb.2"; nearest_ref "uc001avb.2"; class_code "="; tss_id "TSS2106"; p_id "P3148"; chr1 antisense exon 15438312 15444303 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004177"; exon_number "1"; gene_name "C1orf126"; oId "uc009voh.2"; nearest_ref "uc009voh.2"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15444823 15445400 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004177"; exon_number "2"; gene_name "C1orf126"; oId "uc009voh.2"; nearest_ref "uc009voh.2"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15447073 15447193 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004177"; exon_number "3"; gene_name "C1orf126"; oId "uc009voh.2"; nearest_ref "uc009voh.2"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15447468 15447555 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004177"; exon_number "4"; gene_name "C1orf126"; oId "uc009voh.2"; nearest_ref "uc009voh.2"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15450724 15450869 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004177"; exon_number "5"; gene_name "C1orf126"; oId "uc009voh.2"; nearest_ref "uc009voh.2"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15478787 15478960 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004177"; exon_number "6"; gene_name "C1orf126"; oId "uc009voh.2"; nearest_ref "uc009voh.2"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15438312 15444303 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004176"; exon_number "1"; gene_name "C1orf126"; oId "uc001avv.3"; nearest_ref "uc001avv.3"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15444823 15445400 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004176"; exon_number "2"; gene_name "C1orf126"; oId "uc001avv.3"; nearest_ref "uc001avv.3"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15447468 15447555 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004176"; exon_number "3"; gene_name "C1orf126"; oId "uc001avv.3"; nearest_ref "uc001avv.3"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15450724 15450869 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004176"; exon_number "4"; gene_name "C1orf126"; oId "uc001avv.3"; nearest_ref "uc001avv.3"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15478787 15478960 . - . gene_id "XLOC_001334"; transcript_id "TCONS_00004176"; exon_number "5"; gene_name "C1orf126"; oId "uc001avv.3"; nearest_ref "uc001avv.3"; class_code "="; tss_id "TSS2107"; chr1 antisense exon 15653176 15656179 . - . gene_id "XLOC_001335"; transcript_id "TCONS_00004178"; exon_number "1"; oId "uc001awc.1"; nearest_ref "uc001awc.1"; class_code "="; tss_id "TSS2108"; chr1 antisense exon 15670272 15670372 . - . gene_id "XLOC_001335"; transcript_id "TCONS_00004178"; exon_number "2"; oId "uc001awc.1"; nearest_ref "uc001awc.1"; class_code "="; tss_id "TSS2108"; chr1 coding exon 15817324 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "1"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "2"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15831106 15831253 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "3"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15832485 15832574 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "4"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15833394 15833570 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "5"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15834368 15834402 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "6"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15844605 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "7"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15850564 15850790 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004179"; exon_number "8"; gene_name "CASP9"; oId "uc001awm.1"; nearest_ref "uc001awm.1"; class_code "="; tss_id "TSS2109"; p_id "P3151"; chr1 coding exon 15818797 15819530 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "1"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15820387 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "2"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "3"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15831106 15831253 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "4"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15832485 15832574 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "5"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15833394 15833570 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "6"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15834368 15834402 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "7"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15844745 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "8"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15850564 15850790 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004183"; exon_number "9"; gene_name "CASP9"; oId "uc009voi.2"; nearest_ref "uc009voi.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15818797 15819530 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "1"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15820387 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "2"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "3"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15831106 15831253 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "4"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15832485 15832574 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "5"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15833394 15833628 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "6"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15834368 15834402 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "7"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15844605 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "8"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15850564 15850790 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004182"; exon_number "9"; gene_name "CASP9"; oId "uc001awp.2"; nearest_ref "uc001awp.2"; class_code "="; tss_id "TSS2109"; p_id "P3153"; chr1 coding exon 15818797 15819530 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004181"; exon_number "1"; gene_name "CASP9"; oId "uc001awo.2"; nearest_ref "uc001awo.2"; class_code "="; tss_id "TSS2109"; p_id "P3150"; chr1 coding exon 15820387 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004181"; exon_number "2"; gene_name "CASP9"; oId "uc001awo.2"; nearest_ref "uc001awo.2"; class_code "="; tss_id "TSS2109"; p_id "P3150"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004181"; exon_number "3"; gene_name "CASP9"; oId "uc001awo.2"; nearest_ref "uc001awo.2"; class_code "="; tss_id "TSS2109"; p_id "P3150"; chr1 coding exon 15844605 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004181"; exon_number "4"; gene_name "CASP9"; oId "uc001awo.2"; nearest_ref "uc001awo.2"; class_code "="; tss_id "TSS2109"; p_id "P3150"; chr1 coding exon 15850564 15850790 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004181"; exon_number "5"; gene_name "CASP9"; oId "uc001awo.2"; nearest_ref "uc001awo.2"; class_code "="; tss_id "TSS2109"; p_id "P3150"; chr1 coding exon 15818797 15819530 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "1"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15820387 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "2"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "3"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15831106 15831253 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "4"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15832485 15832574 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "5"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15833394 15833570 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "6"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15834368 15834402 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "7"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15844605 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "8"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15850564 15850790 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004180"; exon_number "9"; gene_name "CASP9"; oId "uc001awn.2"; nearest_ref "uc001awn.2"; class_code "="; tss_id "TSS2109"; p_id "P3149"; chr1 coding exon 15818797 15819530 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "1"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15820387 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "2"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "3"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15831106 15831253 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "4"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15832485 15832574 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "5"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15833394 15833570 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "6"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15834368 15834402 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "7"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15844605 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "8"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15851078 15851221 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004184"; exon_number "9"; gene_name "CASP9"; oId "uc010obm.1"; nearest_ref "uc010obm.1"; class_code "="; tss_id "TSS2110"; p_id "P3152"; chr1 coding exon 15818797 15819530 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "1"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15820387 15820496 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "2"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15821768 15821947 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "3"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15831106 15831253 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "4"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15832485 15832574 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "5"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15833394 15833570 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "6"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15834368 15834402 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "7"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15844605 15844890 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "8"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15851347 15851384 . - . gene_id "XLOC_001336"; transcript_id "TCONS_00004185"; exon_number "9"; gene_name "CASP9"; oId "uc001awq.2"; nearest_ref "uc001awq.2"; class_code "="; tss_id "TSS2111"; p_id "P3152"; chr1 coding exon 15899152 15900219 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "1"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 15901252 15901336 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "2"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 15904180 15904359 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "3"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 15905354 15905549 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "4"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 15906589 15906637 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "5"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 15909688 15909890 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "6"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 15911191 15911605 . - . gene_id "XLOC_001337"; transcript_id "TCONS_00004186"; exon_number "7"; gene_name "AGMAT"; oId "uc001awv.1"; nearest_ref "uc001awv.1"; class_code "="; tss_id "TSS2112"; p_id "P3154"; chr1 coding exon 16133657 16134194 . - . gene_id "XLOC_001338"; transcript_id "TCONS_00004187"; exon_number "1"; oId "uc009vol.1"; nearest_ref "uc009vol.1"; class_code "="; p_id "P3155"; chr1 antisense exon 16160710 16163401 . - . gene_id "XLOC_001339"; transcript_id "TCONS_00004188"; exon_number "1"; oId "uc001axj.2"; nearest_ref "uc001axj.2"; class_code "="; tss_id "TSS2113"; chr1 antisense exon 16174603 16174642 . - . gene_id "XLOC_001339"; transcript_id "TCONS_00004188"; exon_number "2"; oId "uc001axj.2"; nearest_ref "uc001axj.2"; class_code "="; tss_id "TSS2113"; chr1 coding exon 16268366 16268747 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "1"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16268826 16268936 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "2"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16269024 16269233 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "3"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16269559 16269689 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "4"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16269894 16270014 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "5"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16270094 16270210 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "6"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16270303 16270390 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "7"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16270795 16271095 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "8"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16271192 16271334 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "9"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "10"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "11"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16272649 16272789 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "12"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16273430 16273618 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "13"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16274786 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "14"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "15"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004191"; exon_number "16"; gene_name "ZBTB17"; oId "uc010obr.1"; nearest_ref "uc010obr.1"; class_code "="; tss_id "TSS2114"; p_id "P3159"; chr1 coding exon 16268366 16268747 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "1"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16268826 16268915 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "2"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16269024 16269233 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "3"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16269559 16269689 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "4"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16269894 16270014 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "5"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16270094 16270210 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "6"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16270303 16270390 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "7"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16270795 16271095 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "8"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16271192 16271334 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "9"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "10"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "11"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16272649 16272789 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "12"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16273430 16273618 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "13"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16274790 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "14"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "15"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004192"; exon_number "16"; gene_name "ZBTB17"; oId "uc010obs.1"; nearest_ref "uc010obs.1"; class_code "="; tss_id "TSS2114"; p_id "P3160"; chr1 coding exon 16268366 16268747 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "1"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16268826 16268915 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "2"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16269024 16269233 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "3"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16269559 16269689 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "4"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16269894 16270014 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "5"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16270094 16270210 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "6"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16270303 16270390 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "7"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16270795 16271095 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "8"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16271192 16271334 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "9"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "10"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "11"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16272649 16272811 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "12"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16273430 16273618 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "13"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "14"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004190"; exon_number "15"; gene_name "ZBTB17"; oId "uc010obq.1"; nearest_ref "uc010obq.1"; class_code "="; tss_id "TSS2114"; p_id "P3158"; chr1 coding exon 16268366 16268747 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "1"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16268826 16268915 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "2"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16269024 16269233 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "3"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16269559 16269689 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "4"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16269894 16270014 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "5"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16270094 16270210 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "6"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16270303 16270390 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "7"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16270795 16271095 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "8"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16271192 16271334 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "9"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "10"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "11"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16272649 16272789 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "12"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16273430 16273618 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "13"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16274786 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "14"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "15"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004189"; exon_number "16"; gene_name "ZBTB17"; oId "uc001axl.3"; nearest_ref "uc001axl.3"; class_code "="; tss_id "TSS2114"; p_id "P3157"; chr1 coding exon 16270322 16271095 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "1"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16271192 16271334 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "2"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "3"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "4"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16272649 16272789 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "5"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16274786 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "6"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "7"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004193"; exon_number "8"; gene_name "ZBTB17"; oId "uc010obt.1"; nearest_ref "uc010obt.1"; class_code "="; tss_id "TSS2114"; p_id "P3163"; chr1 coding exon 16270366 16271334 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "1"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "2"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "3"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16272649 16272789 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "4"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16273430 16273618 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "5"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "6"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004194"; exon_number "7"; gene_name "ZBTB17"; oId "uc010obu.1"; nearest_ref "uc010obu.1"; class_code "="; tss_id "TSS2114"; p_id "P3162"; chr1 coding exon 16271432 16271697 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004195"; exon_number "1"; gene_name "ZBTB17"; oId "uc009vom.1"; nearest_ref "uc009vom.1"; class_code "="; tss_id "TSS2114"; p_id "P3161"; chr1 coding exon 16272210 16272335 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004195"; exon_number "2"; gene_name "ZBTB17"; oId "uc009vom.1"; nearest_ref "uc009vom.1"; class_code "="; tss_id "TSS2114"; p_id "P3161"; chr1 coding exon 16272649 16272811 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004195"; exon_number "3"; gene_name "ZBTB17"; oId "uc009vom.1"; nearest_ref "uc009vom.1"; class_code "="; tss_id "TSS2114"; p_id "P3161"; chr1 coding exon 16274790 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004195"; exon_number "4"; gene_name "ZBTB17"; oId "uc009vom.1"; nearest_ref "uc009vom.1"; class_code "="; tss_id "TSS2114"; p_id "P3161"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004195"; exon_number "5"; gene_name "ZBTB17"; oId "uc009vom.1"; nearest_ref "uc009vom.1"; class_code "="; tss_id "TSS2114"; p_id "P3161"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004195"; exon_number "6"; gene_name "ZBTB17"; oId "uc009vom.1"; nearest_ref "uc009vom.1"; class_code "="; tss_id "TSS2114"; p_id "P3161"; chr1 coding exon 16272257 16272789 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004196"; exon_number "1"; gene_name "ZBTB17"; oId "uc010obv.1"; nearest_ref "uc010obv.1"; class_code "="; tss_id "TSS2114"; p_id "P3164"; chr1 coding exon 16273430 16273618 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004196"; exon_number "2"; gene_name "ZBTB17"; oId "uc010obv.1"; nearest_ref "uc010obv.1"; class_code "="; tss_id "TSS2114"; p_id "P3164"; chr1 coding exon 16274786 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004196"; exon_number "3"; gene_name "ZBTB17"; oId "uc010obv.1"; nearest_ref "uc010obv.1"; class_code "="; tss_id "TSS2114"; p_id "P3164"; chr1 coding exon 16299534 16299620 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004196"; exon_number "4"; gene_name "ZBTB17"; oId "uc010obv.1"; nearest_ref "uc010obv.1"; class_code "="; tss_id "TSS2114"; p_id "P3164"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004196"; exon_number "5"; gene_name "ZBTB17"; oId "uc010obv.1"; nearest_ref "uc010obv.1"; class_code "="; tss_id "TSS2114"; p_id "P3164"; chr1 coding exon 16274238 16274992 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004197"; exon_number "1"; gene_name "ZBTB17"; oId "uc009von.1"; nearest_ref "uc009von.1"; class_code "="; tss_id "TSS2114"; p_id "P3156"; chr1 coding exon 16302478 16302627 . - . gene_id "XLOC_001340"; transcript_id "TCONS_00004197"; exon_number "2"; gene_name "ZBTB17"; oId "uc009von.1"; nearest_ref "uc009von.1"; class_code "="; tss_id "TSS2114"; p_id "P3156"; chr1 noncoding exon 16317619 16317647 . - . gene_id "XLOC_001341"; transcript_id "TCONS_00004198"; exon_number "1"; oId "uc001axm.1"; nearest_ref "uc001axm.1"; class_code "="; chr1 coding exon 16340523 16342254 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004201"; exon_number "1"; gene_name "HSPB7"; oId "uc001axq.2"; nearest_ref "uc001axq.2"; class_code "="; tss_id "TSS2115"; p_id "P3166"; chr1 coding exon 16343569 16343714 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004201"; exon_number "2"; gene_name "HSPB7"; oId "uc001axq.2"; nearest_ref "uc001axq.2"; class_code "="; tss_id "TSS2115"; p_id "P3166"; chr1 coding exon 16344260 16345285 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004201"; exon_number "3"; gene_name "HSPB7"; oId "uc001axq.2"; nearest_ref "uc001axq.2"; class_code "="; tss_id "TSS2115"; p_id "P3166"; chr1 coding exon 16340523 16342254 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004202"; exon_number "1"; gene_name "HSPB7"; oId "uc001axr.2"; nearest_ref "uc001axr.2"; class_code "="; tss_id "TSS2115"; p_id "P3169"; chr1 coding exon 16343569 16343717 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004202"; exon_number "2"; gene_name "HSPB7"; oId "uc001axr.2"; nearest_ref "uc001axr.2"; class_code "="; tss_id "TSS2115"; p_id "P3169"; chr1 coding exon 16344260 16345285 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004202"; exon_number "3"; gene_name "HSPB7"; oId "uc001axr.2"; nearest_ref "uc001axr.2"; class_code "="; tss_id "TSS2115"; p_id "P3169"; chr1 coding exon 16340523 16342254 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004200"; exon_number "1"; gene_name "HSPB7"; oId "uc001axp.2"; nearest_ref "uc001axp.2"; class_code "="; tss_id "TSS2115"; p_id "P3165"; chr1 coding exon 16343584 16343702 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004200"; exon_number "2"; gene_name "HSPB7"; oId "uc001axp.2"; nearest_ref "uc001axp.2"; class_code "="; tss_id "TSS2115"; p_id "P3165"; chr1 coding exon 16344260 16345285 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004200"; exon_number "3"; gene_name "HSPB7"; oId "uc001axp.2"; nearest_ref "uc001axp.2"; class_code "="; tss_id "TSS2115"; p_id "P3165"; chr1 coding exon 16340523 16342254 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004199"; exon_number "1"; gene_name "HSPB7"; oId "uc001axo.2"; nearest_ref "uc001axo.2"; class_code "="; tss_id "TSS2115"; p_id "P3167"; chr1 coding exon 16343569 16343702 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004199"; exon_number "2"; gene_name "HSPB7"; oId "uc001axo.2"; nearest_ref "uc001axo.2"; class_code "="; tss_id "TSS2115"; p_id "P3167"; chr1 coding exon 16344260 16345285 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004199"; exon_number "3"; gene_name "HSPB7"; oId "uc001axo.2"; nearest_ref "uc001axo.2"; class_code "="; tss_id "TSS2115"; p_id "P3167"; chr1 coding exon 16340523 16342254 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004203"; exon_number "1"; gene_name "HSPB7"; oId "uc001axs.2"; nearest_ref "uc001axs.2"; class_code "="; tss_id "TSS2116"; p_id "P3168"; chr1 coding exon 16343569 16343702 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004203"; exon_number "2"; gene_name "HSPB7"; oId "uc001axs.2"; nearest_ref "uc001axs.2"; class_code "="; tss_id "TSS2116"; p_id "P3168"; chr1 coding exon 16344260 16344347 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004203"; exon_number "3"; gene_name "HSPB7"; oId "uc001axs.2"; nearest_ref "uc001axs.2"; class_code "="; tss_id "TSS2116"; p_id "P3168"; chr1 coding exon 16345629 16346089 . - . gene_id "XLOC_001342"; transcript_id "TCONS_00004203"; exon_number "4"; gene_name "HSPB7"; oId "uc001axs.2"; nearest_ref "uc001axs.2"; class_code "="; tss_id "TSS2116"; p_id "P3168"; chr1 coding exon 16361814 16361953 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "1"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16362731 16362841 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "2"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16386364 16386546 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "3"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16388594 16388687 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "4"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16388994 16389029 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "5"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16390016 16390131 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "6"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16399916 16400127 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004204"; exon_number "7"; gene_name "FAM131C"; oId "uc010obz.1"; nearest_ref "uc010obz.1"; class_code "="; tss_id "TSS2117"; p_id "P3171"; chr1 coding exon 16384265 16385212 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "1"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16385989 16386099 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "2"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16386364 16386546 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "3"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16388594 16388687 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "4"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16388994 16389029 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "5"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16390016 16390131 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "6"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16399916 16400127 . - . gene_id "XLOC_001343"; transcript_id "TCONS_00004205"; exon_number "7"; gene_name "FAM131C"; oId "uc001axz.3"; nearest_ref "uc001axz.3"; class_code "="; tss_id "TSS2117"; p_id "P3170"; chr1 coding exon 16450832 16451815 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "1"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16455929 16456084 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "2"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16456721 16456914 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "3"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16458216 16458365 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "4"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16458559 16458768 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "5"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16458873 16458934 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "6"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16459675 16459863 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "7"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16459976 16460101 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "8"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16460355 16460410 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "9"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16460963 16461062 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "10"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16461531 16461684 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "11"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16462150 16462265 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "12"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16464348 16464680 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "13"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16464770 16464925 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "14"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16474873 16475542 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "15"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16477391 16477458 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "16"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16482343 16482564 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004206"; exon_number "17"; gene_name "EPHA2"; oId "uc001aya.1"; nearest_ref "uc001aya.1"; class_code "="; tss_id "TSS2118"; p_id "P3173"; chr1 coding exon 16462084 16462265 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004207"; exon_number "1"; gene_name "EPHA2"; oId "uc010oca.1"; nearest_ref "uc010oca.1"; class_code "="; tss_id "TSS2118"; p_id "P3172"; chr1 coding exon 16464348 16464680 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004207"; exon_number "2"; gene_name "EPHA2"; oId "uc010oca.1"; nearest_ref "uc010oca.1"; class_code "="; tss_id "TSS2118"; p_id "P3172"; chr1 coding exon 16464770 16464925 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004207"; exon_number "3"; gene_name "EPHA2"; oId "uc010oca.1"; nearest_ref "uc010oca.1"; class_code "="; tss_id "TSS2118"; p_id "P3172"; chr1 coding exon 16474873 16475542 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004207"; exon_number "4"; gene_name "EPHA2"; oId "uc010oca.1"; nearest_ref "uc010oca.1"; class_code "="; tss_id "TSS2118"; p_id "P3172"; chr1 coding exon 16477391 16477458 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004207"; exon_number "5"; gene_name "EPHA2"; oId "uc010oca.1"; nearest_ref "uc010oca.1"; class_code "="; tss_id "TSS2118"; p_id "P3172"; chr1 coding exon 16482343 16482564 . - . gene_id "XLOC_001344"; transcript_id "TCONS_00004207"; exon_number "6"; gene_name "EPHA2"; oId "uc010oca.1"; nearest_ref "uc010oca.1"; class_code "="; tss_id "TSS2118"; p_id "P3172"; chr1 coding exon 16524599 16525239 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "1"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16525645 16525749 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "2"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16528277 16528356 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "3"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16528911 16529035 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "4"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16531254 16531414 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "5"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16531582 16531671 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "6"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16531846 16531920 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "7"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16532033 16532162 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "8"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16532426 16532578 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "9"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16532675 16532835 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "10"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16533443 16533705 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004209"; exon_number "11"; gene_name "ARHGEF19"; oId "uc009voo.1"; nearest_ref "uc009voo.1"; class_code "="; tss_id "TSS2119"; p_id "P3175"; chr1 coding exon 16524599 16525239 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "1"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16525645 16525749 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "2"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16528277 16528356 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "3"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16528911 16529069 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "4"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16531254 16531414 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "5"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16531582 16531671 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "6"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16531846 16531920 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "7"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16532033 16532162 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "8"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16532426 16532568 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "9"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16532675 16532835 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "10"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16533443 16533705 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004208"; exon_number "11"; gene_name "ARHGEF19"; oId "uc001ayb.1"; nearest_ref "uc001ayb.1"; class_code "="; tss_id "TSS2119"; p_id "P3174"; chr1 coding exon 16524599 16525239 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "1"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16525645 16525749 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "2"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16528277 16528356 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "3"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16528911 16529069 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "4"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16531254 16531414 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "5"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16531582 16531671 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "6"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16531846 16531920 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "7"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16532033 16532162 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "8"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16532426 16532578 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "9"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16532675 16532835 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "10"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16533443 16533705 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "11"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16534017 16534093 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "12"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16534170 16534272 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "13"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16534439 16534720 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "14"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16535138 16535578 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "15"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16538997 16539104 . - . gene_id "XLOC_001345"; transcript_id "TCONS_00004210"; exon_number "16"; gene_name "ARHGEF19"; oId "uc001ayc.1"; nearest_ref "uc001ayc.1"; class_code "="; tss_id "TSS2120"; p_id "P3176"; chr1 coding exon 16558183 16558792 . - . gene_id "XLOC_001346"; transcript_id "TCONS_00004211"; exon_number "1"; gene_name "C1orf89"; oId "uc001ayd.2"; nearest_ref "uc001ayd.2"; class_code "="; tss_id "TSS2121"; p_id "P3177"; chr1 coding exon 16559005 16559141 . - . gene_id "XLOC_001346"; transcript_id "TCONS_00004211"; exon_number "2"; gene_name "C1orf89"; oId "uc001ayd.2"; nearest_ref "uc001ayd.2"; class_code "="; tss_id "TSS2121"; p_id "P3177"; chr1 coding exon 16559388 16559512 . - . gene_id "XLOC_001346"; transcript_id "TCONS_00004211"; exon_number "3"; gene_name "C1orf89"; oId "uc001ayd.2"; nearest_ref "uc001ayd.2"; class_code "="; tss_id "TSS2121"; p_id "P3177"; chr1 coding exon 16560107 16560259 . - . gene_id "XLOC_001346"; transcript_id "TCONS_00004211"; exon_number "4"; gene_name "C1orf89"; oId "uc001ayd.2"; nearest_ref "uc001ayd.2"; class_code "="; tss_id "TSS2121"; p_id "P3177"; chr1 coding exon 16563126 16563659 . - . gene_id "XLOC_001346"; transcript_id "TCONS_00004211"; exon_number "5"; gene_name "C1orf89"; oId "uc001ayd.2"; nearest_ref "uc001ayd.2"; class_code "="; tss_id "TSS2121"; p_id "P3177"; chr1 coding exon 16576560 16578280 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004212"; exon_number "1"; gene_name "FBXO42"; oId "uc001aye.3"; nearest_ref "uc001aye.3"; class_code "="; tss_id "TSS2122"; p_id "P3178"; chr1 coding exon 16578783 16578899 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004212"; exon_number "2"; gene_name "FBXO42"; oId "uc001aye.3"; nearest_ref "uc001aye.3"; class_code "="; tss_id "TSS2122"; p_id "P3178"; chr1 coding exon 16579591 16580226 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004212"; exon_number "3"; gene_name "FBXO42"; oId "uc001aye.3"; nearest_ref "uc001aye.3"; class_code "="; tss_id "TSS2122"; p_id "P3178"; chr1 coding exon 16576560 16578280 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "1"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16578783 16578899 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "2"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16579591 16579647 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "3"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16580130 16580226 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "4"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16582206 16582316 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "5"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16583101 16583254 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "6"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16621278 16621412 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "7"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16632298 16632414 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "8"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16636731 16636852 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "9"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16641664 16641930 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "10"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16642932 16643088 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004213"; exon_number "11"; gene_name "FBXO42"; oId "uc001ayf.2"; nearest_ref "uc001ayf.2"; class_code "="; tss_id "TSS2123"; p_id "P3180"; chr1 coding exon 16576560 16578280 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "1"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16578783 16578899 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "2"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16579591 16579647 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "3"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16580130 16580226 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "4"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16582206 16582316 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "5"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16583101 16583254 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "6"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16621278 16621412 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "7"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16632298 16632414 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "8"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16641664 16641930 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "9"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16678750 16678948 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004214"; exon_number "10"; gene_name "FBXO42"; oId "uc001ayg.2"; nearest_ref "uc001ayg.2"; class_code "="; tss_id "TSS2124"; p_id "P3179"; chr1 coding exon 16618834 16621412 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004215"; exon_number "1"; oId "uc001ayh.2"; nearest_ref "uc001ayh.2"; class_code "="; tss_id "TSS2125"; p_id "P3181"; chr1 coding exon 16632298 16632414 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004215"; exon_number "2"; oId "uc001ayh.2"; nearest_ref "uc001ayh.2"; class_code "="; tss_id "TSS2125"; p_id "P3181"; chr1 coding exon 16641664 16641930 . - . gene_id "XLOC_001347"; transcript_id "TCONS_00004215"; exon_number "3"; oId "uc001ayh.2"; nearest_ref "uc001ayh.2"; class_code "="; tss_id "TSS2125"; p_id "P3181"; chr1 nearCoding exon 16722176 16722807 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "1"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16723053 16723241 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "2"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16725839 16726016 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "3"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16726977 16727130 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "4"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16727215 16727387 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "5"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16730222 16730339 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "6"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16730463 16730534 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "7"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16731462 16731599 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "8"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16734993 16735200 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "9"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16735613 16735698 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "10"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16736096 16736538 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "11"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16737273 16737410 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "12"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16748406 16748689 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "13"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16752019 16752226 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "14"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16754359 16754510 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "15"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16757738 16757917 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "16"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 nearCoding exon 16763623 16763919 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004216"; exon_number "17"; gene_name "SPATA21"; oId "uc001ayl.1"; nearest_ref "uc001ayl.1"; class_code "="; tss_id "TSS2126"; chr1 coding exon 16725139 16725317 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "1"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16725839 16726016 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "2"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16727215 16727387 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "3"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16730222 16730339 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "4"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16730463 16730534 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "5"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16731462 16731599 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "6"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16735613 16735698 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "7"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16736096 16736538 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "8"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16737273 16737410 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "9"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16752019 16752226 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "10"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16763623 16763919 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004218"; exon_number "11"; gene_name "SPATA21"; oId "uc010occ.1"; nearest_ref "uc010occ.1"; class_code "="; tss_id "TSS2126"; p_id "P3183"; chr1 coding exon 16725139 16725317 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "1"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16725839 16726016 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "2"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16727215 16727387 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "3"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16730222 16730339 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "4"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16730463 16730534 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "5"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16731462 16731599 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "6"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16735613 16735698 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "7"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16736096 16736538 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "8"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16748004 16748052 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "9"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16748406 16748466 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "10"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16757833 16757917 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "11"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16759285 16759419 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "12"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 coding exon 16763623 16763919 . - . gene_id "XLOC_001348"; transcript_id "TCONS_00004217"; exon_number "13"; gene_name "SPATA21"; oId "uc001ayn.2"; nearest_ref "uc001ayn.2"; class_code "="; tss_id "TSS2126"; p_id "P3182"; chr1 nearCoding exon 16793931 16796622 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "1"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16802320 16802557 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "2"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16802894 16802999 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "3"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16803425 16803569 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "4"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16804750 16804932 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "5"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16809782 16809981 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "6"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16810728 16810959 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "7"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16811318 16811401 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "8"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16812064 16812160 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "9"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16812921 16813156 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "10"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16817113 16817278 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "11"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16817360 16817421 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "12"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16817505 16817579 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "13"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16817681 16817811 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "14"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 nearCoding exon 16818476 16819196 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004219"; exon_number "15"; oId "uc001ayt.2"; nearest_ref "uc001ayt.2"; class_code "="; tss_id "TSS2127"; chr1 coding exon 16795418 16795502 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004220"; exon_number "1"; oId "uc001ayr.3"; nearest_ref "uc001ayr.3"; class_code "="; tss_id "TSS2128"; p_id "P3184"; chr1 coding exon 16802320 16802557 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004220"; exon_number "2"; oId "uc001ayr.3"; nearest_ref "uc001ayr.3"; class_code "="; tss_id "TSS2128"; p_id "P3184"; chr1 coding exon 16802894 16802999 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004220"; exon_number "3"; oId "uc001ayr.3"; nearest_ref "uc001ayr.3"; class_code "="; tss_id "TSS2128"; p_id "P3184"; chr1 coding exon 16803425 16803569 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004220"; exon_number "4"; oId "uc001ayr.3"; nearest_ref "uc001ayr.3"; class_code "="; tss_id "TSS2128"; p_id "P3184"; chr1 noncoding exon 16804750 16804932 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "1"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16809782 16809981 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "2"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16810728 16810959 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "3"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16812064 16812160 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "4"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16816180 16816286 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "5"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16817113 16817278 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "6"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16817360 16817421 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "7"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16817505 16817579 . - . gene_id "XLOC_001349"; transcript_id "TCONS_00004221"; exon_number "8"; oId "uc001ays.2"; nearest_ref "uc001ays.2"; class_code "="; tss_id "TSS2129"; chr1 noncoding exon 16860386 16860704 . - . gene_id "XLOC_001350"; transcript_id "TCONS_00004222"; exon_number "1"; oId "uc009voq.1"; nearest_ref "uc009voq.1"; class_code "="; tss_id "TSS2130"; chr1 noncoding exon 16861321 16863483 . - . gene_id "XLOC_001350"; transcript_id "TCONS_00004222"; exon_number "2"; oId "uc009voq.1"; nearest_ref "uc009voq.1"; class_code "="; tss_id "TSS2130"; chr1 noncoding exon 16888923 16890082 . - . gene_id "XLOC_001351"; transcript_id "TCONS_00004223"; exon_number "1"; oId "uc001ayw.2"; nearest_ref "uc001ayw.2"; class_code "="; chr1 coding exon 16890412 16890681 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "1"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16891302 16891336 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "2"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16891403 16891413 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "3"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16892128 16892300 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "4"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16892903 16892954 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "5"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16893674 16893846 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "6"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16894474 16894525 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "7"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16895568 16895731 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "8"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16899637 16899688 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "9"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16900982 16901187 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "10"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16901652 16901724 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "11"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16902762 16902976 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "12"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16903812 16903914 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "13"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16905688 16905897 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "14"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16907240 16907451 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "15"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16907915 16907987 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "16"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16909039 16909253 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "17"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16910089 16910191 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "18"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16911984 16912193 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "19"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16913545 16913756 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "20"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16914220 16914292 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "21"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16915344 16915558 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "22"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16916394 16916496 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "23"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16918342 16918551 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "24"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16918654 16918808 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "25"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16919936 16920062 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "26"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16921087 16921156 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "27"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16921426 16921504 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "28"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16935003 16935274 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "29"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16939833 16939982 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004224"; exon_number "30"; gene_name "NBPF1"; oId "uc009vos.1"; nearest_ref "uc009vos.1"; class_code "="; tss_id "TSS2131"; p_id "P3188"; chr1 coding exon 16892903 16892954 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "1"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16893674 16893846 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "2"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16894474 16894525 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "3"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16895568 16895731 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "4"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16899637 16899688 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "5"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16900982 16901187 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "6"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16901652 16901724 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "7"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16909039 16909253 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "8"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16910089 16910191 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "9"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16911984 16912193 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "10"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16913545 16913756 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004226"; exon_number "11"; gene_name "NBPF1"; oId "uc009vot.1"; nearest_ref "uc009vot.1"; class_code "="; tss_id "TSS2132"; p_id "P3186"; chr1 coding exon 16892903 16892954 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "1"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16893674 16893846 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "2"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16894474 16894525 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "3"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16895568 16895731 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "4"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16899637 16899688 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "5"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16900982 16901187 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "6"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16901652 16901724 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "7"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16902762 16902976 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "8"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16903812 16903914 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "9"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16911984 16912193 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "10"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16913545 16913756 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004225"; exon_number "11"; gene_name "NBPF1"; oId "uc001ayz.1"; nearest_ref "uc001ayz.1"; class_code "="; tss_id "TSS2132"; p_id "P3185"; chr1 coding exon 16893674 16893846 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "1"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16894474 16894525 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "2"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16895568 16895731 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "3"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16899637 16899688 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "4"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16900982 16901187 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "5"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16901652 16901724 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "6"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16902762 16902976 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "7"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16903812 16903914 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "8"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16905688 16905897 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "9"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16907240 16907451 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "10"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16907915 16907987 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "11"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16909039 16909253 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "12"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16910089 16910191 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "13"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16911984 16912193 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "14"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 coding exon 16918654 16918808 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004227"; exon_number "15"; gene_name "NBPF1"; oId "uc010oce.1"; nearest_ref "uc010oce.1"; class_code "="; tss_id "TSS2133"; p_id "P3187"; chr1 nearCoding exon 16926098 16928338 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004228"; exon_number "1"; gene_name "NBPF1"; oId "uc001aza.3"; nearest_ref "uc001aza.3"; class_code "="; tss_id "TSS2131"; chr1 nearCoding exon 16935003 16935274 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004228"; exon_number "2"; gene_name "NBPF1"; oId "uc001aza.3"; nearest_ref "uc001aza.3"; class_code "="; tss_id "TSS2131"; chr1 nearCoding exon 16939833 16939982 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004228"; exon_number "3"; gene_name "NBPF1"; oId "uc001aza.3"; nearest_ref "uc001aza.3"; class_code "="; tss_id "TSS2131"; chr1 nearCoding exon 16931913 16934186 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004229"; exon_number "1"; gene_name "NBPF1"; oId "uc001azb.1"; nearest_ref "uc001azb.1"; class_code "="; tss_id "TSS2134"; chr1 nearCoding exon 16935003 16935274 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004229"; exon_number "2"; gene_name "NBPF1"; oId "uc001azb.1"; nearest_ref "uc001azb.1"; class_code "="; tss_id "TSS2134"; chr1 nearCoding exon 16939273 16939752 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004229"; exon_number "3"; gene_name "NBPF1"; oId "uc001azb.1"; nearest_ref "uc001azb.1"; class_code "="; tss_id "TSS2134"; chr1 nearCoding exon 16931913 16934186 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004230"; exon_number "1"; gene_name "NBPF1"; oId "uc001azc.1"; nearest_ref "uc001azc.1"; class_code "="; tss_id "TSS2131"; chr1 nearCoding exon 16935003 16935274 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004230"; exon_number "2"; gene_name "NBPF1"; oId "uc001azc.1"; nearest_ref "uc001azc.1"; class_code "="; tss_id "TSS2131"; chr1 nearCoding exon 16939833 16939982 . - . gene_id "XLOC_001352"; transcript_id "TCONS_00004230"; exon_number "3"; gene_name "NBPF1"; oId "uc001azc.1"; nearest_ref "uc001azc.1"; class_code "="; tss_id "TSS2131"; chr1 noncoding exon 16944753 16945598 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004231"; exon_number "1"; oId "uc010ocf.1"; nearest_ref "uc010ocf.1"; class_code "="; tss_id "TSS2135"; chr1 noncoding exon 16946340 16946519 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004231"; exon_number "2"; oId "uc010ocf.1"; nearest_ref "uc010ocf.1"; class_code "="; tss_id "TSS2135"; chr1 noncoding exon 16952270 16952500 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004231"; exon_number "3"; oId "uc010ocf.1"; nearest_ref "uc010ocf.1"; class_code "="; tss_id "TSS2135"; chr1 noncoding exon 16952848 16952994 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004231"; exon_number "4"; oId "uc010ocf.1"; nearest_ref "uc010ocf.1"; class_code "="; tss_id "TSS2135"; chr1 noncoding exon 16944753 16945598 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "1"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16946340 16946533 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "2"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16952270 16952500 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "3"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16952848 16952994 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "4"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16953640 16953784 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "5"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16954963 16955145 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "6"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16957385 16957604 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004233"; exon_number "7"; oId "uc009vov.1"; nearest_ref "uc009vov.1"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16944753 16945598 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "1"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16946340 16946740 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "2"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16952270 16952500 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "3"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16952848 16952994 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "4"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16953640 16953784 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "5"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16954963 16955145 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "6"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16957385 16957604 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004232"; exon_number "7"; oId "uc001aze.2"; nearest_ref "uc001aze.2"; class_code "="; tss_id "TSS2136"; chr1 noncoding exon 16944758 16946519 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "1"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16952270 16952500 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "2"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16952848 16952994 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "3"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16953640 16953784 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "4"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16954963 16955145 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "5"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16957385 16957604 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "6"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16959784 16959841 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004234"; exon_number "7"; oId "uc001azf.2"; nearest_ref "uc001azf.2"; class_code "="; tss_id "TSS2137"; chr1 noncoding exon 16951873 16952500 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "1"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16952848 16952994 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "2"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16953640 16953784 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "3"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16954963 16955145 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "4"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16957385 16957604 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "5"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16958025 16958108 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "6"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16958770 16958866 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "7"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16959590 16959841 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "8"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16969523 16969640 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "9"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16971141 16971178 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004235"; exon_number "10"; oId "uc001azg.1"; nearest_ref "uc001azg.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16956165 16957604 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004236"; exon_number "1"; oId "uc001azi.1"; nearest_ref "uc001azi.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16958025 16958108 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004236"; exon_number "2"; oId "uc001azi.1"; nearest_ref "uc001azi.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16958770 16958866 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004236"; exon_number "3"; oId "uc001azi.1"; nearest_ref "uc001azi.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16959590 16959841 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004236"; exon_number "4"; oId "uc001azi.1"; nearest_ref "uc001azi.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16969523 16969640 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004236"; exon_number "5"; oId "uc001azi.1"; nearest_ref "uc001azi.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16971141 16971178 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004236"; exon_number "6"; oId "uc001azi.1"; nearest_ref "uc001azi.1"; class_code "="; tss_id "TSS2138"; chr1 noncoding exon 16959590 16959841 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004237"; exon_number "1"; oId "uc001azj.1"; nearest_ref "uc001azj.1"; class_code "="; tss_id "TSS2139"; chr1 noncoding exon 16961522 16961663 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004237"; exon_number "2"; oId "uc001azj.1"; nearest_ref "uc001azj.1"; class_code "="; tss_id "TSS2139"; chr1 noncoding exon 16969262 16969345 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004237"; exon_number "3"; oId "uc001azj.1"; nearest_ref "uc001azj.1"; class_code "="; tss_id "TSS2139"; chr1 noncoding exon 16969523 16969640 . - . gene_id "XLOC_001353"; transcript_id "TCONS_00004237"; exon_number "4"; oId "uc001azj.1"; nearest_ref "uc001azj.1"; class_code "="; tss_id "TSS2139"; chr1 coding exon 17017713 17017789 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "1"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17022926 17023189 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "2"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17023274 17023419 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "3"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17025921 17026116 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "4"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17026354 17026515 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "5"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17029196 17029467 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "6"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17030438 17030639 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "7"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17033783 17033914 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "8"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17034040 17034222 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "9"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17034387 17034573 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "10"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17046459 17046652 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004238"; exon_number "11"; gene_name "ESPN"; oId "uc001azn.1"; nearest_ref "uc001azn.1"; class_code "="; tss_id "TSS2140"; p_id "P3190"; chr1 coding exon 17033419 17034222 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004239"; exon_number "1"; gene_name "ESPNP"; oId "uc010ocj.1"; nearest_ref "uc010ocj.1"; class_code "="; tss_id "TSS2141"; p_id "P3189"; chr1 coding exon 17034387 17034573 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004239"; exon_number "2"; gene_name "ESPNP"; oId "uc010ocj.1"; nearest_ref "uc010ocj.1"; class_code "="; tss_id "TSS2141"; p_id "P3189"; chr1 coding exon 17036935 17037114 . - . gene_id "XLOC_001354"; transcript_id "TCONS_00004239"; exon_number "3"; gene_name "ESPNP"; oId "uc010ocj.1"; nearest_ref "uc010ocj.1"; class_code "="; tss_id "TSS2141"; p_id "P3189"; chr1 coding exon 17081402 17083888 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "1"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17084013 17084152 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "2"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17084249 17084355 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "3"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17084437 17084583 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "4"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17084711 17084788 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "5"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17084961 17085081 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "6"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17085170 17085206 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "7"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17085298 17086181 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "8"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17086384 17086552 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004240"; exon_number "9"; gene_name "MSTP9"; oId "uc001azp.3"; nearest_ref "uc001azp.3"; class_code "="; tss_id "TSS2142"; p_id "P3192"; chr1 coding exon 17081402 17083888 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "1"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17084013 17084152 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "2"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17084249 17084355 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "3"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17084437 17084583 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "4"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17084961 17085081 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "5"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17085298 17085530 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "6"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17085561 17085663 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "7"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17085764 17085894 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "8"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17085971 17086181 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "9"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17086384 17086502 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "10"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17086647 17086767 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "11"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17086849 17086985 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "12"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17087246 17087368 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "13"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17087450 17087597 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "14"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 coding exon 17090909 17090975 . - . gene_id "XLOC_001355"; transcript_id "TCONS_00004241"; exon_number "15"; gene_name "MSTP9"; oId "uc010ock.1"; nearest_ref "uc010ock.1"; class_code "="; tss_id "TSS2143"; p_id "P3191"; chr1 noncoding exon 17215041 17215280 . - . gene_id "XLOC_001356"; transcript_id "TCONS_00004242"; exon_number "1"; oId "uc001azs.1"; nearest_ref "uc001azs.1"; class_code "="; tss_id "TSS2144"; chr1 noncoding exon 17216043 17216161 . - . gene_id "XLOC_001356"; transcript_id "TCONS_00004242"; exon_number "2"; oId "uc001azs.1"; nearest_ref "uc001azs.1"; class_code "="; tss_id "TSS2144"; chr1 coding exon 17301000 17301518 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "1"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17301764 17301837 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "2"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17302138 17302225 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "3"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17302996 17303040 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "4"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17303203 17303289 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "5"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17303392 17303418 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "6"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17303604 17303690 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "7"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17304732 17304809 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "8"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17307082 17307173 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004244"; exon_number "9"; gene_name "MFAP2"; oId "uc001azx.2"; nearest_ref "uc001azx.2"; class_code "="; tss_id "TSS2145"; p_id "P3194"; chr1 coding exon 17301000 17301518 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "1"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17301764 17301837 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "2"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17302138 17302225 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "3"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17302996 17303040 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "4"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17303203 17303289 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "5"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17303392 17303418 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "6"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17303604 17303693 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "7"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17304732 17304809 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "8"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17307082 17307173 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004243"; exon_number "9"; gene_name "MFAP2"; oId "uc001azw.2"; nearest_ref "uc001azw.2"; class_code "="; tss_id "TSS2145"; p_id "P3193"; chr1 coding exon 17301000 17301518 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "1"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17301764 17301837 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "2"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17302138 17302225 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "3"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17302996 17303040 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "4"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17303203 17303289 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "5"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17303392 17303418 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "6"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17303604 17303690 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "7"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17304732 17304809 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "8"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17308009 17308081 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004246"; exon_number "9"; gene_name "MFAP2"; oId "uc010ocl.1"; nearest_ref "uc010ocl.1"; class_code "="; tss_id "TSS2146"; p_id "P3194"; chr1 coding exon 17301000 17301518 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "1"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17301764 17301837 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "2"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17302138 17302225 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "3"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17302996 17303040 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "4"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17303203 17303289 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "5"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17303392 17303418 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "6"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17303604 17303693 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "7"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17304732 17304809 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "8"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17308009 17308081 . - . gene_id "XLOC_001357"; transcript_id "TCONS_00004245"; exon_number "9"; gene_name "MFAP2"; oId "uc001azy.2"; nearest_ref "uc001azy.2"; class_code "="; tss_id "TSS2146"; p_id "P3193"; chr1 coding exon 17312453 17312853 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "1"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17313300 17313451 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "2"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17313541 17313764 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "3"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17314633 17314729 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "4"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17314817 17314969 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "5"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17316186 17316265 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "6"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17316382 17316498 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004247"; exon_number "7"; gene_name "ATP13A2"; oId "uc001azz.1"; nearest_ref "uc001azz.1"; class_code "="; tss_id "TSS2147"; p_id "P3200"; chr1 coding exon 17312453 17312853 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "1"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17313300 17313451 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "2"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17313541 17313764 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "3"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17314633 17314729 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "4"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17314817 17314969 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "5"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17316186 17316265 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "6"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17316622 17316782 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "7"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17318229 17318353 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "8"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17318504 17318624 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "9"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17318738 17318897 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "10"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17318981 17319076 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "11"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17320124 17320330 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "12"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17322471 17322659 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "13"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17322749 17322795 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "14"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17322881 17322991 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "15"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17323515 17323670 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "16"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17326506 17326637 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "17"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17326741 17326807 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "18"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17326895 17327029 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "19"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17328529 17328598 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "20"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17328791 17328868 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "21"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17330827 17330906 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "22"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17331202 17331316 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "23"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17331509 17331567 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "24"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17331869 17332051 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "25"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17332179 17332273 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "26"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17338224 17338423 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004250"; exon_number "27"; gene_name "ATP13A2"; oId "uc001bac.2"; nearest_ref "uc001bac.2"; class_code "="; tss_id "TSS2148"; p_id "P3196"; chr1 coding exon 17312453 17312853 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "1"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17312958 17313127 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "2"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17313300 17313451 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "3"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17313541 17313764 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "4"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17314633 17314729 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "5"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17314817 17314969 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "6"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17316186 17316265 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "7"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17316382 17316498 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "8"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17316622 17316782 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "9"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17318229 17318353 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "10"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17318504 17318624 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "11"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17318738 17318897 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "12"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17318981 17319076 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "13"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17320124 17320330 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "14"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17322471 17322659 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "15"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17322749 17322795 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "16"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17322881 17322991 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "17"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17323515 17323670 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "18"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17326506 17326637 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "19"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17326741 17326807 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "20"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17326895 17327029 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "21"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17328529 17328598 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "22"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17328791 17328868 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "23"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17330827 17330906 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "24"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17331202 17331316 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "25"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17331509 17331567 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "26"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17331869 17332051 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "27"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17332179 17332273 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "28"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17338224 17338423 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004249"; exon_number "29"; gene_name "ATP13A2"; oId "uc001bab.2"; nearest_ref "uc001bab.2"; class_code "="; tss_id "TSS2148"; p_id "P3199"; chr1 coding exon 17312453 17312853 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "1"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17312958 17313127 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "2"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17313300 17313451 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "3"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17313541 17313764 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "4"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17314633 17314729 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "5"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17314817 17314969 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "6"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17316186 17316265 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "7"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17316382 17316498 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "8"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17316622 17316782 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "9"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17318229 17318353 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "10"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17318504 17318624 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "11"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17318738 17318897 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "12"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17318981 17319076 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "13"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17320124 17320330 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "14"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17322471 17322659 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "15"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17322749 17322795 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "16"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17322881 17322991 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "17"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17323515 17323670 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "18"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17326506 17326637 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "19"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17326741 17326807 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "20"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17326895 17327029 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "21"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17328529 17328598 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "22"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17328791 17328868 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "23"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17330827 17330906 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "24"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17331187 17331316 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "25"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17331509 17331567 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "26"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17331869 17332051 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "27"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17332179 17332273 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "28"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17338224 17338423 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004248"; exon_number "29"; gene_name "ATP13A2"; oId "uc001baa.2"; nearest_ref "uc001baa.2"; class_code "="; tss_id "TSS2148"; p_id "P3198"; chr1 coding exon 17321982 17322659 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004251"; exon_number "1"; gene_name "ATP13A2"; oId "uc009vpa.1"; nearest_ref "uc009vpa.1"; class_code "="; tss_id "TSS2149"; p_id "P3197"; chr1 coding exon 17322749 17322795 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004251"; exon_number "2"; gene_name "ATP13A2"; oId "uc009vpa.1"; nearest_ref "uc009vpa.1"; class_code "="; tss_id "TSS2149"; p_id "P3197"; chr1 coding exon 17323515 17323670 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004251"; exon_number "3"; gene_name "ATP13A2"; oId "uc009vpa.1"; nearest_ref "uc009vpa.1"; class_code "="; tss_id "TSS2149"; p_id "P3197"; chr1 coding exon 17326506 17326637 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004251"; exon_number "4"; gene_name "ATP13A2"; oId "uc009vpa.1"; nearest_ref "uc009vpa.1"; class_code "="; tss_id "TSS2149"; p_id "P3197"; chr1 coding exon 17326741 17326807 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004251"; exon_number "5"; gene_name "ATP13A2"; oId "uc009vpa.1"; nearest_ref "uc009vpa.1"; class_code "="; tss_id "TSS2149"; p_id "P3197"; chr1 coding exon 17321982 17322659 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "1"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17322749 17322795 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "2"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17322881 17322991 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "3"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17323515 17323670 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "4"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17326506 17326637 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "5"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17326741 17326807 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "6"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17326895 17327342 . - . gene_id "XLOC_001358"; transcript_id "TCONS_00004252"; exon_number "7"; gene_name "ATP13A2"; oId "uc001bad.1"; nearest_ref "uc001bad.1"; class_code "="; tss_id "TSS2150"; p_id "P3195"; chr1 coding exon 17345227 17345453 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "1"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17349103 17349225 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "2"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17350468 17350569 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "3"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17354244 17354360 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "4"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17355095 17355231 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "5"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17359555 17359640 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "6"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17371256 17371383 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "7"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17380443 17380665 . - . gene_id "XLOC_001359"; transcript_id "TCONS_00004253"; exon_number "8"; gene_name "SDHB"; oId "uc001bae.2"; nearest_ref "uc001bae.2"; class_code "="; tss_id "TSS2151"; p_id "P3201"; chr1 coding exon 17393257 17395772 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "1"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17396583 17396711 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "2"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17397901 17397986 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "3"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17401351 17401444 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "4"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17402174 17402318 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "5"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17405759 17405910 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "6"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17409040 17409147 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "7"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17410221 17410332 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "8"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17413016 17413194 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "9"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17422404 17422465 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "10"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17429482 17429554 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "11"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17431373 17431556 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "12"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17445775 17445948 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004255"; exon_number "13"; oId "uc010ocm.1"; nearest_ref "uc010ocm.1"; class_code "="; tss_id "TSS2152"; p_id "P3204"; chr1 coding exon 17393257 17395772 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "1"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17396583 17396711 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "2"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17397901 17397986 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "3"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17401351 17401444 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "4"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17402174 17402318 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "5"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17405759 17405910 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "6"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17409040 17409147 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "7"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17410221 17410332 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "8"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17411094 17411197 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "9"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17413016 17413194 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "10"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17418903 17419028 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "11"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17420062 17420179 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "12"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17422404 17422465 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "13"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17429482 17429554 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "14"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17431373 17431556 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "15"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17445775 17445948 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004254"; exon_number "16"; gene_name "PADI2"; oId "uc001baf.2"; nearest_ref "uc001baf.2"; class_code "="; tss_id "TSS2152"; p_id "P3203"; chr1 coding exon 17405526 17405910 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "1"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17409040 17409147 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "2"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17410221 17410332 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "3"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17411094 17411197 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "4"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17413016 17413194 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "5"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17418903 17419028 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "6"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17420062 17420179 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "7"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17422404 17422465 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "8"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17429482 17429554 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "9"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17431373 17431556 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "10"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 coding exon 17445775 17445948 . - . gene_id "XLOC_001360"; transcript_id "TCONS_00004256"; exon_number "11"; gene_name "PADI2"; oId "uc001bag.1"; nearest_ref "uc001bag.1"; class_code "="; tss_id "TSS2152"; p_id "P3202"; chr1 noncoding exon 17439787 17439808 . - . gene_id "XLOC_001361"; transcript_id "TCONS_00004257"; exon_number "1"; oId "uc010ocn.1"; nearest_ref "uc010ocn.1"; class_code "="; chr1 coding exon 17733252 17735690 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "1"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17736470 17736547 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "2"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17738618 17738690 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "3"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17739569 17739674 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "4"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17740033 17740213 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "5"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17742976 17743142 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "6"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17747210 17747324 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "7"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17748699 17748787 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "8"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17749201 17749332 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "9"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17752037 17752180 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "10"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17755602 17755695 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "11"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17764726 17765057 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004258"; exon_number "12"; gene_name "RCC2"; oId "uc001bal.2"; nearest_ref "uc001bal.2"; class_code "="; tss_id "TSS2153"; p_id "P3205"; chr1 coding exon 17733252 17735690 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "1"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17736470 17736547 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "2"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17738618 17738690 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "3"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17739569 17739674 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "4"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17740033 17740213 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "5"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17742976 17743142 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "6"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17747210 17747324 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "7"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17748699 17748787 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "8"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17749201 17749332 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "9"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17752037 17752180 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "10"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17755602 17755695 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "11"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17764726 17765018 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "12"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 17766041 17766220 . - . gene_id "XLOC_001362"; transcript_id "TCONS_00004259"; exon_number "13"; gene_name "RCC2"; oId "uc001bam.2"; nearest_ref "uc001bam.2"; class_code "="; tss_id "TSS2154"; p_id "P3205"; chr1 coding exon 19166093 19167021 . - . gene_id "XLOC_001363"; transcript_id "TCONS_00004260"; exon_number "1"; gene_name "TAS1R2"; oId "uc001bba.1"; nearest_ref "uc001bba.1"; class_code "="; tss_id "TSS2155"; p_id "P3206"; chr1 coding exon 19168223 19168346 . - . gene_id "XLOC_001363"; transcript_id "TCONS_00004260"; exon_number "2"; gene_name "TAS1R2"; oId "uc001bba.1"; nearest_ref "uc001bba.1"; class_code "="; tss_id "TSS2155"; p_id "P3206"; chr1 coding exon 19175835 19176044 . - . gene_id "XLOC_001363"; transcript_id "TCONS_00004260"; exon_number "3"; gene_name "TAS1R2"; oId "uc001bba.1"; nearest_ref "uc001bba.1"; class_code "="; tss_id "TSS2155"; p_id "P3206"; chr1 coding exon 19180707 19181480 . - . gene_id "XLOC_001363"; transcript_id "TCONS_00004260"; exon_number "4"; gene_name "TAS1R2"; oId "uc001bba.1"; nearest_ref "uc001bba.1"; class_code "="; tss_id "TSS2155"; p_id "P3206"; chr1 coding exon 19183825 19184125 . - . gene_id "XLOC_001363"; transcript_id "TCONS_00004260"; exon_number "5"; gene_name "TAS1R2"; oId "uc001bba.1"; nearest_ref "uc001bba.1"; class_code "="; tss_id "TSS2155"; p_id "P3206"; chr1 coding exon 19185973 19186155 . - . gene_id "XLOC_001363"; transcript_id "TCONS_00004260"; exon_number "6"; gene_name "TAS1R2"; oId "uc001bba.1"; nearest_ref "uc001bba.1"; class_code "="; tss_id "TSS2155"; p_id "P3206"; chr1 coding exon 19197926 19199451 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "1"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19200957 19201075 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "2"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19201876 19201997 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "3"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19202809 19202961 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "4"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19203702 19203749 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "5"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19203910 19204106 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "6"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19205794 19205867 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "7"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19208194 19208381 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "8"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19209618 19209692 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "9"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19209773 19209922 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "10"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19211967 19212122 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "11"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19212958 19213005 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "12"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19215856 19215948 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "13"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19216506 19216599 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "14"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19217188 19217385 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004261"; exon_number "15"; gene_name "ALDH4A1"; oId "uc010ocu.1"; nearest_ref "uc010ocu.1"; class_code "="; tss_id "TSS2156"; p_id "P3208"; chr1 coding exon 19197926 19199451 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "1"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19200957 19201075 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "2"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19201876 19201997 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "3"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19202809 19202961 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "4"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19203702 19203749 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "5"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19203910 19204106 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "6"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19205794 19205867 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "7"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19208194 19208381 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "8"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19209618 19209692 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "9"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19209773 19209922 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "10"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19211967 19212122 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "11"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19212958 19213005 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "12"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19215856 19215948 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "13"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19216506 19216599 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "14"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19228956 19229293 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004263"; exon_number "15"; gene_name "ALDH4A1"; oId "uc001bbc.2"; nearest_ref "uc001bbc.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19197926 19198284 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "1"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19199298 19199451 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "2"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19200957 19201075 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "3"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19201876 19201997 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "4"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19202809 19202961 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "5"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19203702 19203749 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "6"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19203910 19204106 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "7"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19205794 19205867 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "8"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19208194 19208381 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "9"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19209618 19209692 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "10"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19209773 19209922 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "11"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19211967 19212122 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "12"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19212958 19213005 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "13"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19215856 19215948 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "14"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19216506 19216599 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "15"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19228956 19229293 . - . gene_id "XLOC_001364"; transcript_id "TCONS_00004262"; exon_number "16"; gene_name "ALDH4A1"; oId "uc001bbb.2"; nearest_ref "uc001bbb.2"; class_code "="; tss_id "TSS2157"; p_id "P3207"; chr1 coding exon 19230774 19235160 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "1"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19236836 19236966 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "2"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19237878 19237970 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "3"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19238457 19238577 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "4"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19243397 19243536 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "5"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19244856 19244996 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "6"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19246172 19246267 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "7"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19247555 19247615 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "8"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 coding exon 19282162 19282826 . - . gene_id "XLOC_001365"; transcript_id "TCONS_00004264"; exon_number "9"; gene_name "IFFO2"; oId "uc001bbd.2"; nearest_ref "uc001bbd.2"; class_code "="; tss_id "TSS2158"; p_id "P3209"; chr1 nearCoding exon 19398604 19402005 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004265"; exon_number "1"; oId "uc001bbe.1"; nearest_ref "uc001bbe.1"; class_code "="; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004266"; exon_number "1"; oId "uc001bbf.2"; nearest_ref "uc001bbf.2"; class_code "="; tss_id "TSS2159"; p_id "P3218"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004266"; exon_number "2"; oId "uc001bbf.2"; nearest_ref "uc001bbf.2"; class_code "="; tss_id "TSS2159"; p_id "P3218"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004266"; exon_number "3"; oId "uc001bbf.2"; nearest_ref "uc001bbf.2"; class_code "="; tss_id "TSS2159"; p_id "P3218"; chr1 coding exon 19407843 19408140 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004266"; exon_number "4"; oId "uc001bbf.2"; nearest_ref "uc001bbf.2"; class_code "="; tss_id "TSS2159"; p_id "P3218"; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "1"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "2"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "3"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19407843 19408067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "4"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19410998 19411192 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "5"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19412639 19412764 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "6"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19413173 19413315 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "7"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19414310 19414423 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "8"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19415253 19415471 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "9"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19419313 19419412 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "10"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19419807 19419980 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "11"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19420443 19420633 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "12"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19422039 19422146 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "13"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19423017 19423144 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "14"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19423687 19423774 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "15"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19426091 19426171 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004267"; exon_number "16"; oId "uc010ocv.1"; nearest_ref "uc010ocv.1"; class_code "="; tss_id "TSS2160"; p_id "P3217"; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "1"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "2"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19404279 19404341 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "3"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "4"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19407843 19408067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "5"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19410998 19411192 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "6"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19412639 19412764 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "7"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19413173 19413315 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "8"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19414310 19414423 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "9"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19415253 19415471 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "10"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19419313 19419412 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "11"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19419807 19419980 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "12"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19420443 19420633 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "13"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19421400 19421519 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "14"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19422039 19422146 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "15"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19423017 19423144 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "16"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19423687 19423774 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "17"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19426091 19426171 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "18"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19426870 19427067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004268"; exon_number "19"; gene_name "UBR4"; oId "uc009vph.2"; nearest_ref "uc009vph.2"; class_code "="; tss_id "TSS2161"; p_id "P3216"; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "1"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "2"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "3"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19407843 19408067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "4"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19410998 19411192 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "5"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19412639 19412764 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "6"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19413173 19413315 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "7"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19414310 19414423 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "8"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19415253 19415471 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "9"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19419313 19419412 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "10"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19419807 19419980 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "11"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19420443 19420633 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "12"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19421400 19421519 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "13"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19422039 19422146 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "14"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19423017 19423144 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "15"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19423687 19423774 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "16"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19426870 19427067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "17"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19428014 19428129 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004269"; exon_number "18"; oId "uc010ocw.1"; nearest_ref "uc010ocw.1"; class_code "="; tss_id "TSS2162"; p_id "P3214"; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "1"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "2"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "3"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19407843 19408067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "4"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19410998 19411192 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "5"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19412639 19412764 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "6"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19413173 19413315 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "7"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19414310 19414423 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "8"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19415253 19415471 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "9"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19419313 19419412 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "10"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19419807 19419980 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "11"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19420443 19420633 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "12"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19421400 19421519 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "13"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19422039 19422146 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "14"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19423017 19423144 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "15"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19423687 19423774 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "16"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19426091 19426171 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "17"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19426870 19427067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "18"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19428014 19428135 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "19"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19430578 19430751 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "20"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19431079 19431410 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004270"; exon_number "21"; oId "uc001bbg.2"; nearest_ref "uc001bbg.2"; class_code "="; tss_id "TSS2163"; p_id "P3211"; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "1"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "2"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "3"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19407843 19408067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "4"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19410998 19411192 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "5"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19412639 19412764 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "6"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19413173 19413315 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "7"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19414310 19414423 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "8"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19415253 19415471 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "9"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19419313 19419412 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "10"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19419807 19419980 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "11"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19420443 19420633 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "12"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19421400 19421519 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "13"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19422039 19422146 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "14"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19423017 19423144 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "15"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19423687 19423774 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "16"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19426091 19426171 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "17"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19426870 19427067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "18"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19428014 19428129 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "19"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19430578 19430751 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "20"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19431079 19431160 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "21"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19431542 19431683 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "22"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19432227 19432336 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004271"; exon_number "23"; oId "uc001bbh.2"; nearest_ref "uc001bbh.2"; class_code "="; tss_id "TSS2164"; p_id "P3210"; chr1 coding exon 19401002 19401390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "1"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19403234 19403396 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "2"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19404470 19404560 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "3"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19407843 19408067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "4"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19410998 19411192 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "5"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19412639 19412764 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "6"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19413173 19413315 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "7"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19414310 19414423 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "8"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19415253 19415471 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "9"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19419313 19419412 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "10"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19419807 19419980 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "11"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19420443 19420633 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "12"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19421400 19421519 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "13"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19422039 19422146 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "14"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19423017 19423144 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "15"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19423687 19423774 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "16"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19426091 19426171 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "17"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19426870 19427067 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "18"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19428014 19428135 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "19"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19430578 19430751 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "20"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19431079 19431160 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "21"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19431542 19431683 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "22"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19432227 19432336 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "23"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19433063 19433220 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "24"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19433331 19433460 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "25"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19436590 19436717 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "26"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19436874 19436958 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "27"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19437236 19437326 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "28"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19439018 19439361 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "29"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19440193 19440321 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "30"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19440439 19440564 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "31"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19441305 19441443 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "32"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19441892 19442131 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "33"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19443715 19443908 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "34"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19444317 19444404 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "35"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19445366 19445451 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "36"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19446051 19446195 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "37"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19446674 19446842 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "38"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19447683 19447928 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "39"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19448428 19448506 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "40"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19449327 19449554 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "41"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19451035 19451184 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "42"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19452940 19453149 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "43"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19454117 19454233 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "44"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19454705 19454812 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "45"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19455472 19455568 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "46"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19464501 19464675 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "47"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19465577 19465714 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "48"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19467282 19467386 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "49"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19467841 19468018 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "50"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19468141 19468271 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "51"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19470474 19470585 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "52"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19471280 19471401 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "53"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19472287 19472427 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "54"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19473320 19473494 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "55"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19474487 19474621 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "56"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19475057 19475120 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "57"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19477071 19477287 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "58"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19478137 19478353 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "59"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19478807 19478970 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "60"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19479795 19479996 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "61"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19480262 19480433 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "62"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19481412 19481569 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "63"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19481935 19482162 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "64"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19482765 19482917 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "65"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19483261 19483419 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "66"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19484309 19484491 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "67"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19486605 19486775 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "68"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19487411 19487641 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "69"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19488083 19488230 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "70"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19488321 19488391 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "71"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19488914 19489105 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "72"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19490258 19490321 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "73"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19490747 19490935 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "74"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19491293 19491491 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "75"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19491743 19491843 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "76"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19492150 19492251 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "77"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19493516 19493725 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "78"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19494521 19494678 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "79"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19495929 19496026 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "80"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19497256 19497377 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "81"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19499358 19499587 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "82"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19499675 19499800 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "83"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19499933 19500115 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "84"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19500813 19500941 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "85"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19501448 19501527 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "86"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19503086 19503221 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "87"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19503955 19504237 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "88"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19505545 19505714 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "89"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19510305 19510390 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "90"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19510510 19510669 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "91"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19511593 19511780 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "92"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19513034 19513151 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "93"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19513658 19513795 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "94"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19513935 19514034 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "95"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19518682 19518872 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "96"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19518975 19519034 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "97"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19519927 19520051 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "98"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19523635 19523759 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "99"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19524164 19524305 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "100"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19524441 19524543 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "101"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19525035 19525174 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "102"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19525293 19525422 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "103"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19526145 19526248 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "104"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19528212 19528309 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "105"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19536567 19536746 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004272"; exon_number "106"; gene_name "UBR4"; oId "uc001bbi.2"; nearest_ref "uc001bbi.2"; class_code "="; tss_id "TSS2165"; p_id "P3219"; chr1 coding exon 19438134 19440564 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004273"; exon_number "1"; gene_name "UBR4"; oId "uc001bbj.1"; nearest_ref "uc001bbj.1"; class_code "="; tss_id "TSS2166"; p_id "P3220"; chr1 coding exon 19441305 19441443 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004273"; exon_number "2"; gene_name "UBR4"; oId "uc001bbj.1"; nearest_ref "uc001bbj.1"; class_code "="; tss_id "TSS2166"; p_id "P3220"; chr1 coding exon 19441892 19442131 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004273"; exon_number "3"; gene_name "UBR4"; oId "uc001bbj.1"; nearest_ref "uc001bbj.1"; class_code "="; tss_id "TSS2166"; p_id "P3220"; chr1 coding exon 19443715 19443908 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004273"; exon_number "4"; gene_name "UBR4"; oId "uc001bbj.1"; nearest_ref "uc001bbj.1"; class_code "="; tss_id "TSS2166"; p_id "P3220"; chr1 coding exon 19444317 19444474 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004273"; exon_number "5"; gene_name "UBR4"; oId "uc001bbj.1"; nearest_ref "uc001bbj.1"; class_code "="; tss_id "TSS2166"; p_id "P3220"; chr1 coding exon 19447683 19447928 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "1"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19448428 19448506 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "2"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19449327 19449554 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "3"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19451035 19451184 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "4"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19452940 19453149 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "5"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19454117 19454233 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "6"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19454705 19454812 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "7"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19455472 19455568 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "8"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19464501 19464675 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "9"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19465577 19465714 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "10"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19467841 19468018 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "11"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19468141 19468271 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "12"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19470474 19470585 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "13"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19471280 19471401 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "14"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19472287 19472427 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "15"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19472517 19472600 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "16"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19473320 19473494 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "17"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19474487 19474621 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "18"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19475057 19475120 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "19"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19477071 19477287 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "20"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19478137 19478353 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004274"; exon_number "21"; gene_name "UBR4"; oId "uc001bbk.1"; nearest_ref "uc001bbk.1"; class_code "="; tss_id "TSS2167"; p_id "P3215"; chr1 coding exon 19477418 19478353 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "1"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19478807 19478970 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "2"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19479795 19479996 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "3"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19480262 19480433 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "4"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19481412 19481569 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "5"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19481935 19482162 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "6"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19482765 19482917 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "7"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19483261 19483419 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004275"; exon_number "8"; oId "uc001bbl.1"; nearest_ref "uc001bbl.1"; class_code "="; tss_id "TSS2168"; p_id "P3213"; chr1 coding exon 19477418 19478353 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "1"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19478807 19478970 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "2"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19479795 19479996 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "3"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19480262 19480433 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "4"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19481412 19481572 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "5"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19481935 19482162 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "6"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19482765 19482917 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "7"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19483261 19483419 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "8"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19484309 19484491 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "9"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19486605 19486775 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "10"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19487411 19487641 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "11"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19488083 19488230 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "12"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19488321 19488391 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "13"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19488914 19489105 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "14"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19490258 19490321 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "15"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19490747 19490935 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "16"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19491293 19491491 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "17"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19491743 19491843 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "18"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19492150 19492251 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "19"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19493516 19493725 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "20"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19494521 19494678 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "21"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19495929 19496026 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "22"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19497256 19497377 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "23"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19499358 19499587 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "24"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19499675 19499800 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "25"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19499933 19500115 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "26"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19500813 19500941 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "27"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19501448 19501527 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "28"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19503086 19503221 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "29"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19503955 19504237 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "30"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 coding exon 19505545 19505714 . - . gene_id "XLOC_001366"; transcript_id "TCONS_00004276"; exon_number "31"; gene_name "UBR4"; oId "uc001bbm.1"; nearest_ref "uc001bbm.1"; class_code "="; tss_id "TSS2169"; p_id "P3212"; chr1 nearCoding exon 19544585 19545976 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004277"; exon_number "1"; gene_name "KIAA0090"; oId "uc001bbn.2"; nearest_ref "uc001bbn.2"; class_code "="; tss_id "TSS2170"; chr1 nearCoding exon 19546063 19546192 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004277"; exon_number "2"; gene_name "KIAA0090"; oId "uc001bbn.2"; nearest_ref "uc001bbn.2"; class_code "="; tss_id "TSS2170"; chr1 nearCoding exon 19547258 19548410 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004277"; exon_number "3"; gene_name "KIAA0090"; oId "uc001bbn.2"; nearest_ref "uc001bbn.2"; class_code "="; tss_id "TSS2170"; chr1 coding exon 19544585 19545976 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "1"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19546063 19546192 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "2"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19547258 19547342 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "3"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19549118 19549328 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "4"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19549890 19550063 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "5"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19553807 19553944 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "6"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19557338 19557457 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "7"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19557755 19557916 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "8"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19559118 19559267 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "9"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19559430 19559629 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "10"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19561624 19561746 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "11"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19563636 19563732 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "12"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19564511 19564633 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "13"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19565289 19565351 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "14"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19565725 19565796 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "15"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19566312 19566479 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "16"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19566791 19566940 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "17"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19567510 19567636 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "18"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19568839 19568967 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "19"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19570108 19570201 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "20"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19571400 19571524 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "21"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19577909 19578046 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004281"; exon_number "22"; gene_name "KIAA0090"; oId "uc001bbr.2"; nearest_ref "uc001bbr.2"; class_code "="; tss_id "TSS2171"; p_id "P3224"; chr1 coding exon 19544585 19545976 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "1"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19546063 19546192 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "2"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19547258 19547342 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "3"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19549118 19549328 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "4"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19549890 19550063 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "5"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19553807 19553944 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "6"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19557338 19557457 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "7"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19557755 19557916 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "8"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19559118 19559267 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "9"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19559430 19559629 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "10"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19561624 19561746 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "11"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19563636 19563732 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "12"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19564511 19564633 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "13"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19565289 19565348 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "14"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19565725 19565796 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "15"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19566312 19566479 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "16"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19566791 19566940 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "17"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19567510 19567636 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "18"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19568839 19568967 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "19"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19570108 19570201 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "20"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19570444 19570509 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "21"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19571400 19571524 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "22"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19577909 19578046 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004280"; exon_number "23"; gene_name "KIAA0090"; oId "uc001bbq.2"; nearest_ref "uc001bbq.2"; class_code "="; tss_id "TSS2171"; p_id "P3221"; chr1 coding exon 19544585 19545976 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "1"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19546063 19546192 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "2"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19547258 19547342 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "3"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19549118 19549328 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "4"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19549890 19550063 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "5"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19553807 19553944 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "6"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19557338 19557457 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "7"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19557755 19557916 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "8"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19559118 19559267 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "9"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19559430 19559629 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "10"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19561624 19561743 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "11"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19563636 19563732 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "12"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19564511 19564633 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "13"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19565289 19565351 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "14"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19565725 19565796 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "15"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19566312 19566479 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "16"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19566791 19566940 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "17"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19567510 19567636 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "18"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19568839 19568967 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "19"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19570108 19570201 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "20"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19570444 19570509 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "21"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19571400 19571524 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "22"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19577909 19578046 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004279"; exon_number "23"; gene_name "KIAA0090"; oId "uc001bbp.2"; nearest_ref "uc001bbp.2"; class_code "="; tss_id "TSS2171"; p_id "P3223"; chr1 coding exon 19544585 19545976 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "1"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19546063 19546192 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "2"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19547258 19547342 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "3"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19549118 19549328 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "4"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19549890 19550063 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "5"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19553807 19553944 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "6"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19557338 19557457 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "7"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19557755 19557916 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "8"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19559118 19559267 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "9"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19559430 19559629 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "10"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19561624 19561746 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "11"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19563636 19563732 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "12"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19564511 19564633 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "13"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19565289 19565351 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "14"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19565725 19565796 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "15"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19566312 19566479 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "16"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19566791 19566940 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "17"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19567510 19567636 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "18"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19568839 19568967 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "19"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19570108 19570201 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "20"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19570444 19570509 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "21"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19571400 19571524 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "22"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19577909 19578046 . - . gene_id "XLOC_001367"; transcript_id "TCONS_00004278"; exon_number "23"; gene_name "KIAA0090"; oId "uc001bbo.2"; nearest_ref "uc001bbo.2"; class_code "="; tss_id "TSS2171"; p_id "P3222"; chr1 coding exon 19592476 19593955 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004283"; exon_number "1"; gene_name "AKR7L"; oId "uc010ocy.1"; nearest_ref "uc010ocy.1"; class_code "="; tss_id "TSS2172"; p_id "P3226"; chr1 coding exon 19595066 19595195 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004283"; exon_number "2"; gene_name "AKR7L"; oId "uc010ocy.1"; nearest_ref "uc010ocy.1"; class_code "="; tss_id "TSS2172"; p_id "P3226"; chr1 coding exon 19596945 19597049 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004283"; exon_number "3"; gene_name "AKR7L"; oId "uc010ocy.1"; nearest_ref "uc010ocy.1"; class_code "="; tss_id "TSS2172"; p_id "P3226"; chr1 coding exon 19597242 19597429 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004283"; exon_number "4"; gene_name "AKR7L"; oId "uc010ocy.1"; nearest_ref "uc010ocy.1"; class_code "="; tss_id "TSS2172"; p_id "P3226"; chr1 coding exon 19600355 19600568 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004283"; exon_number "5"; gene_name "AKR7L"; oId "uc010ocy.1"; nearest_ref "uc010ocy.1"; class_code "="; tss_id "TSS2172"; p_id "P3226"; chr1 coding exon 19592476 19593955 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "1"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19595066 19595195 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "2"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19595766 19595865 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "3"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19596077 19596173 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "4"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19596945 19597049 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "5"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19597242 19597429 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "6"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19600355 19600568 . - . gene_id "XLOC_001368"; transcript_id "TCONS_00004282"; exon_number "7"; gene_name "AKR7L"; oId "uc010ocx.1"; nearest_ref "uc010ocx.1"; class_code "="; tss_id "TSS2172"; p_id "P3225"; chr1 coding exon 19609057 19609386 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "1"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19610490 19610619 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "2"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19611180 19611279 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "3"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19611512 19611608 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "4"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19612382 19612486 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "5"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19612679 19612866 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "6"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19614990 19615280 . - . gene_id "XLOC_001369"; transcript_id "TCONS_00004284"; exon_number "7"; gene_name "AKR7A3"; oId "uc001bbv.1"; nearest_ref "uc001bbv.1"; class_code "="; tss_id "TSS2173"; p_id "P3227"; chr1 coding exon 19630459 19630880 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004286"; exon_number "1"; gene_name "AKR7A2"; oId "uc001bbx.2"; nearest_ref "uc001bbx.2"; class_code "="; tss_id "TSS2174"; p_id "P3230"; chr1 coding exon 19632512 19632641 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004286"; exon_number "2"; gene_name "AKR7A2"; oId "uc001bbx.2"; nearest_ref "uc001bbx.2"; class_code "="; tss_id "TSS2174"; p_id "P3230"; chr1 coding exon 19633496 19633595 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004286"; exon_number "3"; gene_name "AKR7A2"; oId "uc001bbx.2"; nearest_ref "uc001bbx.2"; class_code "="; tss_id "TSS2174"; p_id "P3230"; chr1 coding exon 19633808 19633904 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004286"; exon_number "4"; gene_name "AKR7A2"; oId "uc001bbx.2"; nearest_ref "uc001bbx.2"; class_code "="; tss_id "TSS2174"; p_id "P3230"; chr1 coding exon 19634949 19635136 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004286"; exon_number "5"; gene_name "AKR7A2"; oId "uc001bbx.2"; nearest_ref "uc001bbx.2"; class_code "="; tss_id "TSS2174"; p_id "P3230"; chr1 coding exon 19638321 19638640 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004286"; exon_number "6"; gene_name "AKR7A2"; oId "uc001bbx.2"; nearest_ref "uc001bbx.2"; class_code "="; tss_id "TSS2174"; p_id "P3230"; chr1 coding exon 19630459 19630880 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "1"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19632512 19632641 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "2"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19633496 19633595 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "3"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19633808 19633904 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "4"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19634652 19634756 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "5"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19634949 19635136 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "6"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19638321 19638640 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004285"; exon_number "7"; gene_name "AKR7A2"; oId "uc001bbw.2"; nearest_ref "uc001bbw.2"; class_code "="; tss_id "TSS2174"; p_id "P3229"; chr1 coding exon 19634233 19634756 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004287"; exon_number "1"; gene_name "AKR7A2"; oId "uc009vpi.1"; nearest_ref "uc009vpi.1"; class_code "="; tss_id "TSS2174"; p_id "P3228"; chr1 coding exon 19634949 19635136 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004287"; exon_number "2"; gene_name "AKR7A2"; oId "uc009vpi.1"; nearest_ref "uc009vpi.1"; class_code "="; tss_id "TSS2174"; p_id "P3228"; chr1 coding exon 19638321 19638640 . - . gene_id "XLOC_001370"; transcript_id "TCONS_00004287"; exon_number "3"; gene_name "AKR7A2"; oId "uc009vpi.1"; nearest_ref "uc009vpi.1"; class_code "="; tss_id "TSS2174"; p_id "P3228"; chr1 coding exon 19665274 19666111 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "1"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19670852 19670928 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "2"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19671681 19671746 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "3"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19683129 19683245 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "4"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19683916 19684057 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "5"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19705034 19705147 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "6"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19711999 19712120 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "7"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19746155 19746253 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004288"; exon_number "8"; gene_name "CAPZB"; oId "uc001bcd.2"; nearest_ref "uc001bcd.2"; class_code "="; tss_id "TSS2175"; p_id "P3234"; chr1 coding exon 19665274 19666111 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "1"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19670852 19670928 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "2"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19671681 19671746 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "3"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19683129 19683245 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "4"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19683916 19684057 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "5"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19705034 19705147 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "6"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19711999 19712120 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "7"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19746155 19746244 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "8"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19810684 19811201 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004289"; exon_number "9"; gene_name "CAPZB"; oId "uc010ocz.1"; nearest_ref "uc010ocz.1"; class_code "="; tss_id "TSS2176"; p_id "P3233"; chr1 coding exon 19665274 19666111 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "1"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19671681 19671746 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "2"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19683129 19683245 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "3"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19683916 19684057 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "4"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19705034 19705147 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "5"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19711999 19712120 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "6"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19746155 19746244 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "7"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19775328 19775824 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "8"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19811930 19811992 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004291"; exon_number "9"; gene_name "CAPZB"; oId "uc009vpk.2"; nearest_ref "uc009vpk.2"; class_code "="; tss_id "TSS2177"; p_id "P3232"; chr1 coding exon 19665274 19666111 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "1"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19670852 19670928 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "2"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19671681 19671746 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "3"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19683129 19683245 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "4"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19683916 19684057 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "5"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19705034 19705147 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "6"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19711999 19712120 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "7"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19746155 19746244 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "8"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 coding exon 19811930 19811992 . - . gene_id "XLOC_001371"; transcript_id "TCONS_00004290"; exon_number "9"; gene_name "CAPZB"; oId "uc001bce.2"; nearest_ref "uc001bce.2"; class_code "="; tss_id "TSS2177"; p_id "P3231"; chr1 noncoding exon 19673335 19675427 . - . gene_id "XLOC_001372"; transcript_id "TCONS_00004292"; exon_number "1"; oId "uc001bcf.1"; nearest_ref "uc001bcf.1"; class_code "="; chr1 coding exon 20008707 20009937 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "1"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20020927 20021044 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "2"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20027261 20027378 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "3"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20072949 20073092 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "4"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20073656 20073753 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "5"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20082127 20082259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "6"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20097035 20097062 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "7"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20097801 20097975 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "8"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20107073 20107259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004293"; exon_number "9"; gene_name "TMCO4"; oId "uc001bcm.2"; nearest_ref "uc001bcm.2"; class_code "="; tss_id "TSS2178"; p_id "P3235"; chr1 coding exon 20008707 20009937 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "1"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20020927 20021044 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "2"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20027261 20027378 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "3"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20063865 20063949 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "4"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20066317 20066453 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "5"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20067270 20067434 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "6"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20072025 20072144 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "7"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20072949 20073092 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "8"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20073656 20073753 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "9"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20082127 20082259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "10"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20097035 20097062 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "11"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20097801 20097975 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "12"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20107073 20107259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "13"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20113519 20113610 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "14"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20124630 20124708 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "15"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20126348 20126410 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004294"; exon_number "16"; gene_name "TMCO4"; oId "uc001bcn.2"; nearest_ref "uc001bcn.2"; class_code "="; tss_id "TSS2179"; p_id "P3240"; chr1 coding exon 20008735 20009207 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "1"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20009781 20009937 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "2"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20020927 20021044 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "3"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20027261 20027378 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "4"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20063865 20063949 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "5"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20066317 20066453 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "6"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20067270 20067434 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "7"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20072949 20073092 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "8"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20073656 20073753 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "9"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20082127 20082259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "10"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20097035 20097062 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "11"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20097801 20097975 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "12"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20107073 20107259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "13"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20113519 20113610 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "14"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20125667 20125837 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004296"; exon_number "15"; gene_name "TMCO4"; oId "uc001bcp.1"; nearest_ref "uc001bcp.1"; class_code "="; tss_id "TSS2180"; p_id "P3239"; chr1 coding exon 20008735 20009207 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "1"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20009781 20009937 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "2"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20020927 20021044 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "3"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20027261 20027378 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "4"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20063865 20063949 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "5"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20066317 20066453 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "6"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20067270 20067434 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "7"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20072025 20072144 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "8"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20072949 20073092 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "9"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20073656 20073753 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "10"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20082127 20082259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "11"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20097035 20097062 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "12"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20097801 20097975 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "13"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20107073 20107259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "14"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20113519 20113610 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "15"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20125667 20125837 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004295"; exon_number "16"; gene_name "TMCO4"; oId "uc001bco.1"; nearest_ref "uc001bco.1"; class_code "="; tss_id "TSS2180"; p_id "P3238"; chr1 coding exon 20071537 20072144 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "1"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20072949 20073092 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "2"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20073656 20073753 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "3"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20082127 20082259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "4"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20097035 20097062 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "5"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20097801 20097975 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "6"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20107073 20107259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "7"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20113519 20113610 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "8"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20124630 20124708 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "9"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20125667 20125837 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004297"; exon_number "10"; gene_name "TMCO4"; oId "uc009vpn.1"; nearest_ref "uc009vpn.1"; class_code "="; tss_id "TSS2180"; p_id "P3236"; chr1 coding exon 20072025 20072144 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "1"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20072949 20073092 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "2"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20073656 20073753 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "3"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20082127 20082259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "4"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20097035 20097062 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "5"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20097801 20097975 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "6"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20107073 20107259 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "7"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20113519 20113610 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "8"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20126691 20126758 . - . gene_id "XLOC_001373"; transcript_id "TCONS_00004298"; exon_number "9"; gene_name "TMCO4"; oId "uc001bcq.1"; nearest_ref "uc001bcq.1"; class_code "="; tss_id "TSS2181"; p_id "P3237"; chr1 coding exon 20140523 20141771 . - . gene_id "XLOC_001374"; transcript_id "TCONS_00004299"; exon_number "1"; gene_name "RNF186"; oId "uc001bcr.2"; nearest_ref "uc001bcr.2"; class_code "="; p_id "P3241"; chr1 coding exon 20246800 20246942 . - . gene_id "XLOC_001375"; transcript_id "TCONS_00004300"; exon_number "1"; gene_name "PLA2G2E"; oId "uc001bct.1"; nearest_ref "uc001bct.1"; class_code "="; tss_id "TSS2182"; p_id "P3242"; chr1 coding exon 20248791 20248897 . - . gene_id "XLOC_001375"; transcript_id "TCONS_00004300"; exon_number "2"; gene_name "PLA2G2E"; oId "uc001bct.1"; nearest_ref "uc001bct.1"; class_code "="; tss_id "TSS2182"; p_id "P3242"; chr1 coding exon 20249110 20249248 . - . gene_id "XLOC_001375"; transcript_id "TCONS_00004300"; exon_number "3"; gene_name "PLA2G2E"; oId "uc001bct.1"; nearest_ref "uc001bct.1"; class_code "="; tss_id "TSS2182"; p_id "P3242"; chr1 coding exon 20250013 20250110 . - . gene_id "XLOC_001375"; transcript_id "TCONS_00004300"; exon_number "4"; gene_name "PLA2G2E"; oId "uc001bct.1"; nearest_ref "uc001bct.1"; class_code "="; tss_id "TSS2182"; p_id "P3242"; chr1 coding exon 20301925 20302336 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004301"; exon_number "1"; gene_name "PLA2G2A"; oId "uc001bcu.2"; nearest_ref "uc001bcu.2"; class_code "="; tss_id "TSS2183"; p_id "P3243"; chr1 coding exon 20304508 20304614 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004301"; exon_number "2"; gene_name "PLA2G2A"; oId "uc001bcu.2"; nearest_ref "uc001bcu.2"; class_code "="; tss_id "TSS2183"; p_id "P3243"; chr1 coding exon 20304873 20305017 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004301"; exon_number "3"; gene_name "PLA2G2A"; oId "uc001bcu.2"; nearest_ref "uc001bcu.2"; class_code "="; tss_id "TSS2183"; p_id "P3243"; chr1 coding exon 20305227 20305404 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004301"; exon_number "4"; gene_name "PLA2G2A"; oId "uc001bcu.2"; nearest_ref "uc001bcu.2"; class_code "="; tss_id "TSS2183"; p_id "P3243"; chr1 coding exon 20306073 20306152 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004301"; exon_number "5"; gene_name "PLA2G2A"; oId "uc001bcu.2"; nearest_ref "uc001bcu.2"; class_code "="; tss_id "TSS2183"; p_id "P3243"; chr1 coding exon 20301925 20302336 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004304"; exon_number "1"; gene_name "PLA2G2A"; oId "uc010odb.1"; nearest_ref "uc010odb.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20304508 20304614 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004304"; exon_number "2"; gene_name "PLA2G2A"; oId "uc010odb.1"; nearest_ref "uc010odb.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20304873 20305017 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004304"; exon_number "3"; gene_name "PLA2G2A"; oId "uc010odb.1"; nearest_ref "uc010odb.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20305227 20305372 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004304"; exon_number "4"; gene_name "PLA2G2A"; oId "uc010odb.1"; nearest_ref "uc010odb.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20306855 20306932 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004304"; exon_number "5"; gene_name "PLA2G2A"; oId "uc010odb.1"; nearest_ref "uc010odb.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20301925 20302336 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004303"; exon_number "1"; gene_name "PLA2G2A"; oId "uc010oda.1"; nearest_ref "uc010oda.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20304508 20304614 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004303"; exon_number "2"; gene_name "PLA2G2A"; oId "uc010oda.1"; nearest_ref "uc010oda.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20304873 20305017 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004303"; exon_number "3"; gene_name "PLA2G2A"; oId "uc010oda.1"; nearest_ref "uc010oda.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20305227 20305372 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004303"; exon_number "4"; gene_name "PLA2G2A"; oId "uc010oda.1"; nearest_ref "uc010oda.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20306073 20306152 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004303"; exon_number "5"; gene_name "PLA2G2A"; oId "uc010oda.1"; nearest_ref "uc010oda.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20306855 20306932 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004303"; exon_number "6"; gene_name "PLA2G2A"; oId "uc010oda.1"; nearest_ref "uc010oda.1"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20301925 20302336 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004302"; exon_number "1"; gene_name "PLA2G2A"; oId "uc001bcv.2"; nearest_ref "uc001bcv.2"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20304508 20304614 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004302"; exon_number "2"; gene_name "PLA2G2A"; oId "uc001bcv.2"; nearest_ref "uc001bcv.2"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20304873 20305017 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004302"; exon_number "3"; gene_name "PLA2G2A"; oId "uc001bcv.2"; nearest_ref "uc001bcv.2"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20305227 20305372 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004302"; exon_number "4"; gene_name "PLA2G2A"; oId "uc001bcv.2"; nearest_ref "uc001bcv.2"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20306073 20306183 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004302"; exon_number "5"; gene_name "PLA2G2A"; oId "uc001bcv.2"; nearest_ref "uc001bcv.2"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 coding exon 20306855 20306932 . - . gene_id "XLOC_001376"; transcript_id "TCONS_00004302"; exon_number "6"; gene_name "PLA2G2A"; oId "uc001bcv.2"; nearest_ref "uc001bcv.2"; class_code "="; tss_id "TSS2184"; p_id "P3243"; chr1 nearCoding exon 20438441 20440752 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004306"; exon_number "1"; oId "uc009vpo.2"; nearest_ref "uc009vpo.2"; class_code "="; tss_id "TSS2185"; chr1 nearCoding exon 20442826 20442970 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004306"; exon_number "2"; oId "uc009vpo.2"; nearest_ref "uc009vpo.2"; class_code "="; tss_id "TSS2185"; chr1 nearCoding exon 20445952 20446008 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004306"; exon_number "3"; oId "uc009vpo.2"; nearest_ref "uc009vpo.2"; class_code "="; tss_id "TSS2185"; chr1 coding exon 20438441 20440752 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004305"; exon_number "1"; gene_name "PLA2G2D"; oId "uc001bcz.2"; nearest_ref "uc001bcz.2"; class_code "="; tss_id "TSS2185"; p_id "P3244"; chr1 coding exon 20442000 20442106 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004305"; exon_number "2"; gene_name "PLA2G2D"; oId "uc001bcz.2"; nearest_ref "uc001bcz.2"; class_code "="; tss_id "TSS2185"; p_id "P3244"; chr1 coding exon 20442826 20442970 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004305"; exon_number "3"; gene_name "PLA2G2D"; oId "uc001bcz.2"; nearest_ref "uc001bcz.2"; class_code "="; tss_id "TSS2185"; p_id "P3244"; chr1 coding exon 20445952 20446008 . - . gene_id "XLOC_001377"; transcript_id "TCONS_00004305"; exon_number "4"; gene_name "PLA2G2D"; oId "uc001bcz.2"; nearest_ref "uc001bcz.2"; class_code "="; tss_id "TSS2185"; p_id "P3244"; chr1 coding exon 20490484 20490650 . - . gene_id "XLOC_001378"; transcript_id "TCONS_00004307"; exon_number "1"; gene_name "PLA2G2C"; oId "uc009vpq.1"; nearest_ref "uc009vpq.1"; class_code "="; tss_id "TSS2186"; p_id "P3245"; chr1 coding exon 20499287 20499384 . - . gene_id "XLOC_001378"; transcript_id "TCONS_00004307"; exon_number "2"; gene_name "PLA2G2C"; oId "uc009vpq.1"; nearest_ref "uc009vpq.1"; class_code "="; tss_id "TSS2186"; p_id "P3245"; chr1 coding exon 20501500 20501687 . - . gene_id "XLOC_001378"; transcript_id "TCONS_00004307"; exon_number "3"; gene_name "PLA2G2C"; oId "uc009vpq.1"; nearest_ref "uc009vpq.1"; class_code "="; tss_id "TSS2186"; p_id "P3245"; chr1 noncoding exon 20687598 20688534 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004308"; exon_number "1"; oId "uc009vpu.1"; nearest_ref "uc009vpu.1"; class_code "="; tss_id "TSS2187"; chr1 noncoding exon 20688637 20688887 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004308"; exon_number "2"; oId "uc009vpu.1"; nearest_ref "uc009vpu.1"; class_code "="; tss_id "TSS2187"; chr1 noncoding exon 20700088 20700231 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004308"; exon_number "3"; oId "uc009vpu.1"; nearest_ref "uc009vpu.1"; class_code "="; tss_id "TSS2187"; chr1 noncoding exon 20732068 20732187 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004308"; exon_number "4"; oId "uc009vpu.1"; nearest_ref "uc009vpu.1"; class_code "="; tss_id "TSS2187"; chr1 noncoding exon 20687598 20688534 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "1"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20688637 20688887 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "2"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20700088 20700231 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "3"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20703874 20704002 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "4"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20704804 20704925 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "5"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20705466 20705519 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "6"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20724976 20725280 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "7"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20725973 20726042 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "8"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20727428 20727480 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "9"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20732068 20732187 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "10"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20732680 20732762 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "11"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 noncoding exon 20755077 20755275 . - . gene_id "XLOC_001379"; transcript_id "TCONS_00004309"; exon_number "12"; oId "uc001bdf.1"; nearest_ref "uc001bdf.1"; class_code "="; tss_id "TSS2188"; chr1 nearCoding exon 20808885 20810212 . - . gene_id "XLOC_001380"; transcript_id "TCONS_00004310"; exon_number "1"; gene_name "CAMK2N1"; oId "uc001bdg.2"; nearest_ref "uc001bdg.2"; class_code "="; tss_id "TSS2189"; chr1 nearCoding exon 20810860 20811138 . - . gene_id "XLOC_001380"; transcript_id "TCONS_00004310"; exon_number "2"; gene_name "CAMK2N1"; oId "uc001bdg.2"; nearest_ref "uc001bdg.2"; class_code "="; tss_id "TSS2189"; chr1 coding exon 20808885 20810212 . - . gene_id "XLOC_001380"; transcript_id "TCONS_00004311"; exon_number "1"; gene_name "CAMK2N1"; oId "uc001bdh.2"; nearest_ref "uc001bdh.2"; class_code "="; tss_id "TSS2190"; p_id "P3246"; chr1 coding exon 20811707 20812728 . - . gene_id "XLOC_001380"; transcript_id "TCONS_00004311"; exon_number "2"; gene_name "CAMK2N1"; oId "uc001bdh.2"; nearest_ref "uc001bdh.2"; class_code "="; tss_id "TSS2190"; p_id "P3246"; chr1 coding exon 20825943 20827912 . - . gene_id "XLOC_001381"; transcript_id "TCONS_00004312"; exon_number "1"; gene_name "MUL1"; oId "uc001bdi.3"; nearest_ref "uc001bdi.3"; class_code "="; tss_id "TSS2191"; p_id "P3247"; chr1 coding exon 20828562 20828682 . - . gene_id "XLOC_001381"; transcript_id "TCONS_00004312"; exon_number "2"; gene_name "MUL1"; oId "uc001bdi.3"; nearest_ref "uc001bdi.3"; class_code "="; tss_id "TSS2191"; p_id "P3247"; chr1 coding exon 20829715 20829802 . - . gene_id "XLOC_001381"; transcript_id "TCONS_00004312"; exon_number "3"; gene_name "MUL1"; oId "uc001bdi.3"; nearest_ref "uc001bdi.3"; class_code "="; tss_id "TSS2191"; p_id "P3247"; chr1 coding exon 20834398 20834674 . - . gene_id "XLOC_001381"; transcript_id "TCONS_00004312"; exon_number "4"; gene_name "MUL1"; oId "uc001bdi.3"; nearest_ref "uc001bdi.3"; class_code "="; tss_id "TSS2191"; p_id "P3247"; chr1 coding exon 20978260 20979021 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "1"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20979114 20979220 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "2"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20979344 20979464 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "3"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20980120 20980267 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "4"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20980716 20980864 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "5"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20981107 20981200 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "6"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20981933 20982027 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "7"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20982169 20982247 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "8"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20982622 20982680 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "9"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20987374 20987484 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "10"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20987690 20988037 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004315"; exon_number "11"; oId "uc010odd.1"; nearest_ref "uc010odd.1"; class_code "="; tss_id "TSS2192"; p_id "P3251"; chr1 coding exon 20978260 20979021 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "1"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20979114 20979220 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "2"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20979344 20979464 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "3"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20980120 20980267 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "4"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20980716 20980864 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "5"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20981107 20981200 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "6"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20981933 20982027 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "7"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20982169 20982272 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "8"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20982594 20982680 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "9"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20987690 20988037 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004316"; exon_number "10"; gene_name "DDOST"; oId "uc010ode.1"; nearest_ref "uc010ode.1"; class_code "="; tss_id "TSS2192"; p_id "P3250"; chr1 coding exon 20978260 20979021 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "1"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20979114 20979220 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "2"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20979335 20979464 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "3"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20980120 20980267 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "4"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20980716 20980864 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "5"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20981107 20981200 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "6"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20981933 20982027 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "7"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20982169 20982272 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "8"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20982594 20982680 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "9"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20987374 20987484 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "10"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20987690 20988037 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004314"; exon_number "11"; gene_name "DDOST"; oId "uc009vpw.1"; nearest_ref "uc009vpw.1"; class_code "="; tss_id "TSS2192"; p_id "P3249"; chr1 coding exon 20978260 20979021 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "1"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20979114 20979220 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "2"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20979344 20979464 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "3"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20980120 20980267 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "4"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20980716 20980864 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "5"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20981107 20981200 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "6"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20981933 20982027 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "7"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20982169 20982272 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "8"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20982594 20982680 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "9"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20987374 20987484 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "10"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20987690 20988037 . - . gene_id "XLOC_001382"; transcript_id "TCONS_00004313"; exon_number "11"; gene_name "DDOST"; oId "uc001bdo.1"; nearest_ref "uc001bdo.1"; class_code "="; tss_id "TSS2192"; p_id "P3248"; chr1 coding exon 20990509 20991255 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004317"; exon_number "1"; gene_name "KIF17"; oId "uc001bdp.3"; nearest_ref "uc001bdp.3"; class_code "="; tss_id "TSS2193"; p_id "P3255"; chr1 coding exon 20992707 20992824 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004317"; exon_number "2"; gene_name "KIF17"; oId "uc001bdp.3"; nearest_ref "uc001bdp.3"; class_code "="; tss_id "TSS2193"; p_id "P3255"; chr1 coding exon 20996914 20996981 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004317"; exon_number "3"; gene_name "KIF17"; oId "uc001bdp.3"; nearest_ref "uc001bdp.3"; class_code "="; tss_id "TSS2193"; p_id "P3255"; chr1 coding exon 20998431 20998689 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004317"; exon_number "4"; gene_name "KIF17"; oId "uc001bdp.3"; nearest_ref "uc001bdp.3"; class_code "="; tss_id "TSS2193"; p_id "P3255"; chr1 coding exon 21009146 21009377 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004317"; exon_number "5"; gene_name "KIF17"; oId "uc001bdp.3"; nearest_ref "uc001bdp.3"; class_code "="; tss_id "TSS2193"; p_id "P3255"; chr1 coding exon 21011302 21011689 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004317"; exon_number "6"; gene_name "KIF17"; oId "uc001bdp.3"; nearest_ref "uc001bdp.3"; class_code "="; tss_id "TSS2193"; p_id "P3255"; chr1 coding exon 20990509 20991255 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "1"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 20992707 20992824 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "2"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 20996914 20996984 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "3"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 20998431 20998689 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "4"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 21009146 21009377 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "5"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 21011302 21011513 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "6"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 21011745 21011776 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004318"; exon_number "7"; gene_name "KIF17"; oId "uc001bdq.3"; nearest_ref "uc001bdq.3"; class_code "="; tss_id "TSS2193"; p_id "P3256"; chr1 coding exon 20990509 20991255 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "1"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 20992707 20992824 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "2"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 20996914 20996984 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "3"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 20998431 20998689 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "4"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 21009146 21009377 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "5"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 21011302 21011513 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "6"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 21012539 21012619 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "7"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 21016681 21016828 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "8"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 21024872 21024981 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004319"; exon_number "9"; gene_name "KIF17"; oId "uc009vpx.2"; nearest_ref "uc009vpx.2"; class_code "="; tss_id "TSS2194"; p_id "P3254"; chr1 coding exon 20990509 20991255 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "1"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 20992707 20992824 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "2"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 20996914 20996981 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "3"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 20998431 20998689 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "4"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21009146 21009377 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "5"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21011302 21011513 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "6"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21012539 21012619 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "7"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21013881 21014437 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "8"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21016681 21016828 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "9"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21024872 21024981 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "10"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21030940 21031392 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "11"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21036132 21036321 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "12"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21039947 21040048 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "13"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21041986 21042132 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "14"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 21043969 21044317 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004321"; exon_number "15"; gene_name "KIF17"; oId "uc001bds.3"; nearest_ref "uc001bds.3"; class_code "="; tss_id "TSS2195"; p_id "P3253"; chr1 coding exon 20990509 20991255 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "1"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 20992707 20992824 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "2"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 20996914 20996984 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "3"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 20998431 20998689 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "4"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21009146 21009377 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "5"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21011302 21011513 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "6"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21012539 21012619 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "7"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21013881 21014437 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "8"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21016681 21016828 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "9"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21024872 21024981 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "10"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21030940 21031392 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "11"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21036132 21036321 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "12"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21039947 21040048 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "13"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21041986 21042132 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "14"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21043969 21044317 . - . gene_id "XLOC_001383"; transcript_id "TCONS_00004320"; exon_number "15"; gene_name "KIF17"; oId "uc001bdr.3"; nearest_ref "uc001bdr.3"; class_code "="; tss_id "TSS2195"; p_id "P3252"; chr1 coding exon 21046225 21048488 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "1"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21049249 21049408 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "2"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21050119 21050227 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "3"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21050576 21050744 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "4"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21050889 21051128 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "5"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21052413 21052559 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "6"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21053494 21053568 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "7"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21054016 21054096 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "8"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21054451 21054579 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "9"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21058674 21059133 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004323"; exon_number "10"; gene_name "SH2D5"; oId "uc009vpy.1"; nearest_ref "uc009vpy.1"; class_code "="; tss_id "TSS2196"; p_id "P3258"; chr1 coding exon 21046225 21048488 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "1"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21049249 21049408 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "2"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21050119 21050227 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "3"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21050576 21050744 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "4"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21050889 21051128 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "5"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21052413 21052559 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "6"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21053494 21053568 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "7"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21054016 21054096 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "8"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 coding exon 21058674 21059133 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004322"; exon_number "9"; gene_name "SH2D5"; oId "uc001bdt.1"; nearest_ref "uc001bdt.1"; class_code "="; tss_id "TSS2196"; p_id "P3257"; chr1 nearCoding exon 21046225 21048488 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004324"; exon_number "1"; gene_name "SH2D5"; oId "uc001bdu.1"; nearest_ref "uc001bdu.1"; class_code "="; tss_id "TSS2197"; chr1 nearCoding exon 21049249 21049408 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004324"; exon_number "2"; gene_name "SH2D5"; oId "uc001bdu.1"; nearest_ref "uc001bdu.1"; class_code "="; tss_id "TSS2197"; chr1 nearCoding exon 21050119 21050227 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004324"; exon_number "3"; gene_name "SH2D5"; oId "uc001bdu.1"; nearest_ref "uc001bdu.1"; class_code "="; tss_id "TSS2197"; chr1 nearCoding exon 21050576 21050744 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004324"; exon_number "4"; gene_name "SH2D5"; oId "uc001bdu.1"; nearest_ref "uc001bdu.1"; class_code "="; tss_id "TSS2197"; chr1 nearCoding exon 21050842 21051128 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004324"; exon_number "5"; gene_name "SH2D5"; oId "uc001bdu.1"; nearest_ref "uc001bdu.1"; class_code "="; tss_id "TSS2197"; chr1 nearCoding exon 21059257 21059330 . - . gene_id "XLOC_001384"; transcript_id "TCONS_00004324"; exon_number "6"; gene_name "SH2D5"; oId "uc001bdu.1"; nearest_ref "uc001bdu.1"; class_code "="; tss_id "TSS2197"; chr1 coding exon 21069171 21071584 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004325"; exon_number "1"; gene_name "HP1BP3"; oId "uc010odf.1"; nearest_ref "uc010odf.1"; class_code "="; tss_id "TSS2198"; p_id "P3262"; chr1 coding exon 21072036 21072149 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004325"; exon_number "2"; gene_name "HP1BP3"; oId "uc010odf.1"; nearest_ref "uc010odf.1"; class_code "="; tss_id "TSS2198"; p_id "P3262"; chr1 coding exon 21074037 21074148 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004325"; exon_number "3"; gene_name "HP1BP3"; oId "uc010odf.1"; nearest_ref "uc010odf.1"; class_code "="; tss_id "TSS2198"; p_id "P3262"; chr1 coding exon 21076216 21076468 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004325"; exon_number "4"; gene_name "HP1BP3"; oId "uc010odf.1"; nearest_ref "uc010odf.1"; class_code "="; tss_id "TSS2198"; p_id "P3262"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004325"; exon_number "5"; gene_name "HP1BP3"; oId "uc010odf.1"; nearest_ref "uc010odf.1"; class_code "="; tss_id "TSS2198"; p_id "P3262"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004325"; exon_number "6"; gene_name "HP1BP3"; oId "uc010odf.1"; nearest_ref "uc010odf.1"; class_code "="; tss_id "TSS2198"; p_id "P3262"; chr1 coding exon 21069171 21071584 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "1"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21072036 21072149 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "2"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21074037 21074148 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "3"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21076216 21076375 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "4"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "5"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "6"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "7"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "8"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21099944 21101447 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004326"; exon_number "9"; gene_name "HP1BP3"; oId "uc010odg.1"; nearest_ref "uc010odg.1"; class_code "="; tss_id "TSS2199"; p_id "P3261"; chr1 coding exon 21069171 21071584 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "1"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21072036 21072149 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "2"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21074037 21074148 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "3"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21076216 21076375 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "4"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "5"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "6"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "7"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "8"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21099944 21100103 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "9"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "10"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21106305 21106404 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "11"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21106848 21107033 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "12"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21112679 21113124 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004327"; exon_number "13"; gene_name "HP1BP3"; oId "uc001bdv.1"; nearest_ref "uc001bdv.1"; class_code "="; tss_id "TSS2200"; p_id "P3260"; chr1 coding exon 21069171 21071584 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "1"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21072036 21072149 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "2"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21074037 21074148 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "3"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21076216 21076375 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "4"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "5"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "6"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "7"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "8"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21099944 21100103 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "9"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "10"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21106305 21106404 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "11"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21106838 21107033 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "12"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21113142 21113181 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004328"; exon_number "13"; gene_name "HP1BP3"; oId "uc001bdw.1"; nearest_ref "uc001bdw.1"; class_code "="; tss_id "TSS2200"; p_id "P3259"; chr1 coding exon 21069171 21071584 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "1"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21072036 21072149 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "2"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21074037 21074148 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "3"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21076216 21076375 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "4"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "5"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "6"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "7"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "8"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21099944 21100103 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "9"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "10"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21106305 21106404 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "11"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21113688 21113799 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004329"; exon_number "12"; gene_name "HP1BP3"; oId "uc010odh.1"; nearest_ref "uc010odh.1"; class_code "="; tss_id "TSS2201"; p_id "P3260"; chr1 coding exon 21069623 21069667 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "1"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21071237 21071584 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "2"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21072036 21072149 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "3"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21074037 21074148 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "4"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21076216 21076375 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "5"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "6"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "7"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "8"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "9"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21099944 21100103 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "10"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "11"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21106305 21106404 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "12"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21106838 21107033 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004330"; exon_number "13"; gene_name "HP1BP3"; oId "uc001bdy.1"; nearest_ref "uc001bdy.1"; class_code "="; tss_id "TSS2202"; p_id "P3259"; chr1 coding exon 21080551 21081897 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "1"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "2"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "3"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "4"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "5"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21099944 21100103 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "6"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "7"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21106305 21106401 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "8"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21106838 21107033 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "9"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 coding exon 21113688 21113799 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004332"; exon_number "10"; gene_name "HP1BP3"; oId "uc001bea.2"; nearest_ref "uc001bea.2"; class_code "="; tss_id "TSS2201"; p_id "P3264"; chr1 nearCoding exon 21080551 21081897 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "1"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21083659 21083749 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "2"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21091870 21092024 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "3"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21094077 21094157 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "4"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21097423 21097566 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "5"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21099940 21100103 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "6"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "7"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21106305 21106404 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "8"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21106838 21107033 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "9"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 nearCoding exon 21113688 21113799 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004331"; exon_number "10"; oId "uc001bdz.2"; nearest_ref "uc001bdz.2"; class_code "="; tss_id "TSS2201"; chr1 coding exon 21102149 21102498 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004333"; exon_number "1"; gene_name "HP1BP3"; oId "uc001beb.2"; nearest_ref "uc001beb.2"; class_code "="; tss_id "TSS2200"; p_id "P3263"; chr1 coding exon 21103090 21103243 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004333"; exon_number "2"; gene_name "HP1BP3"; oId "uc001beb.2"; nearest_ref "uc001beb.2"; class_code "="; tss_id "TSS2200"; p_id "P3263"; chr1 coding exon 21106305 21106404 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004333"; exon_number "3"; gene_name "HP1BP3"; oId "uc001beb.2"; nearest_ref "uc001beb.2"; class_code "="; tss_id "TSS2200"; p_id "P3263"; chr1 coding exon 21106838 21107033 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004333"; exon_number "4"; gene_name "HP1BP3"; oId "uc001beb.2"; nearest_ref "uc001beb.2"; class_code "="; tss_id "TSS2200"; p_id "P3263"; chr1 coding exon 21113007 21113133 . - . gene_id "XLOC_001385"; transcript_id "TCONS_00004333"; exon_number "5"; gene_name "HP1BP3"; oId "uc001beb.2"; nearest_ref "uc001beb.2"; class_code "="; tss_id "TSS2200"; p_id "P3263"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "1"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "2"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "3"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "4"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "5"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "6"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "7"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "8"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "9"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "10"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "11"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "12"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "13"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "14"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "15"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "16"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "17"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "18"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "19"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "20"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "21"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "22"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "23"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "24"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "25"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004334"; exon_number "26"; gene_name "EIF4G3"; oId "uc010odi.1"; nearest_ref "uc010odi.1"; class_code "="; tss_id "TSS2203"; p_id "P3271"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "1"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "2"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "3"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "4"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "5"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "6"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "7"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "8"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "9"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "10"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "11"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "12"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "13"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "14"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "15"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "16"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "17"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "18"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "19"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "20"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "21"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "22"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "23"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "24"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21276496 21276601 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "25"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "26"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "27"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "28"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "29"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "30"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004336"; exon_number "31"; gene_name "EIF4G3"; oId "uc010odj.1"; nearest_ref "uc010odj.1"; class_code "="; tss_id "TSS2204"; p_id "P3270"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "1"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "2"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "3"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "4"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "5"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "6"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "7"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "8"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "9"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "10"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "11"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "12"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "13"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "14"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "15"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "16"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "17"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "18"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "19"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "20"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "21"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "22"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "23"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21276496 21276604 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "24"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "25"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "26"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "27"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "28"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "29"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004335"; exon_number "30"; gene_name "EIF4G3"; oId "uc009vpz.2"; nearest_ref "uc009vpz.2"; class_code "="; tss_id "TSS2204"; p_id "P3269"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "1"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "2"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "3"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "4"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "5"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "6"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "7"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "8"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "9"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "10"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "11"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "12"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "13"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "14"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "15"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "16"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "17"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "18"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "19"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "20"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "21"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "22"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "23"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "24"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21276496 21276604 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "25"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "26"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "27"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "28"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "29"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "30"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "31"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21437816 21437876 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004337"; exon_number "32"; gene_name "EIF4G3"; oId "uc001bec.2"; nearest_ref "uc001bec.2"; class_code "="; tss_id "TSS2205"; p_id "P3268"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "1"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "2"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "3"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "4"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "5"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "6"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "7"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "8"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "9"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "10"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "11"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "12"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "13"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "14"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "15"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "16"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "17"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "18"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "19"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21219112 21219222 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "20"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "21"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "22"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "23"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "24"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "25"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21276496 21276601 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "26"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "27"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "28"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "29"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "30"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "31"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "32"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21415631 21415706 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "33"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21502668 21502851 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "34"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21503215 21503340 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004340"; exon_number "35"; gene_name "EIF4G3"; oId "uc001bef.2"; nearest_ref "uc001bef.2"; class_code "="; tss_id "TSS2206"; p_id "P3267"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "1"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "2"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "3"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "4"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "5"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "6"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "7"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "8"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "9"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "10"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "11"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "12"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "13"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "14"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "15"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "16"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "17"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "18"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "19"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "20"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "21"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "22"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "23"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "24"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21276496 21276601 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "25"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "26"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "27"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "28"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "29"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21308881 21308901 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "30"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "31"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "32"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21415631 21415706 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "33"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21502668 21502851 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "34"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21503215 21503340 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004339"; exon_number "35"; gene_name "EIF4G3"; oId "uc001bee.2"; nearest_ref "uc001bee.2"; class_code "="; tss_id "TSS2206"; p_id "P3272"; chr1 coding exon 21132976 21133993 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "1"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21137231 21137377 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "2"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21139651 21139732 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "3"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21143885 21144031 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "4"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21151593 21151691 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "5"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21154110 21154191 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "6"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21155640 21155765 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "7"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21167349 21167521 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "8"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21175908 21176023 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "9"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21177751 21177971 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "10"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21180053 21180170 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "11"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21181471 21181564 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "12"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21183896 21183990 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "13"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21186878 21187010 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "14"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21188721 21188825 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "15"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21190969 21191205 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "16"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21191609 21191755 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "17"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21205816 21206013 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "18"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21212694 21212864 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "19"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21220010 21220129 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "20"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21221861 21221994 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "21"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21226190 21226436 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "22"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21231376 21231464 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "23"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "24"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21276496 21276604 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "25"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "26"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "27"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "28"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "29"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "30"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "31"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21415631 21415706 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "32"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21502668 21502851 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "33"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21503215 21503340 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004338"; exon_number "34"; gene_name "EIF4G3"; oId "uc001bed.2"; nearest_ref "uc001bed.2"; class_code "="; tss_id "TSS2206"; p_id "P3268"; chr1 coding exon 21267740 21267888 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "1"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "2"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21276496 21276601 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "3"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "4"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "5"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "6"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "7"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "8"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004341"; exon_number "9"; gene_name "EIF4G3"; oId "uc001beg.2"; nearest_ref "uc001beg.2"; class_code "="; tss_id "TSS2204"; p_id "P3273"; chr1 coding exon 21267740 21267888 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "1"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "2"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21276496 21276604 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "3"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "4"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "5"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "6"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "7"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "8"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "9"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21415631 21415706 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004342"; exon_number "10"; gene_name "EIF4G3"; oId "uc010odk.1"; nearest_ref "uc010odk.1"; class_code "="; tss_id "TSS2207"; p_id "P3266"; chr1 coding exon 21267740 21267888 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "1"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21267984 21268823 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "2"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21276496 21276604 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "3"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21295967 21296089 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "4"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21299495 21299592 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "5"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21306827 21306941 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "6"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21307541 21307720 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "7"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21324094 21324126 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "8"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21329206 21329301 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "9"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21377359 21377487 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "10"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21415631 21415706 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "11"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21437816 21437876 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "12"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21494454 21494532 . - . gene_id "XLOC_001386"; transcript_id "TCONS_00004343"; exon_number "13"; gene_name "EIF4G3"; oId "uc001beh.2"; nearest_ref "uc001beh.2"; class_code "="; tss_id "TSS2208"; p_id "P3265"; chr1 coding exon 21543740 21546624 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "1"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21548240 21548335 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "2"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21551743 21551933 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "3"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21553652 21553719 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "4"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21554424 21554534 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "5"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21560051 21560154 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "6"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21562343 21562420 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "7"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21563239 21563337 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "8"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21564627 21564737 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "9"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21571482 21571596 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "10"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21573714 21573856 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "11"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21582440 21582631 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "12"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21584018 21584083 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "13"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21585186 21585332 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "14"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21586764 21586885 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "15"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21599192 21599404 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "16"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21605684 21606183 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004344"; exon_number "17"; gene_name "ECE1"; oId "uc001bej.2"; nearest_ref "uc001bej.2"; class_code "="; tss_id "TSS2209"; p_id "P3275"; chr1 coding exon 21543740 21546624 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "1"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21548240 21548335 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "2"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21551743 21551933 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "3"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21553652 21553719 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "4"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21554424 21554534 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "5"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21560051 21560154 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "6"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21562343 21562420 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "7"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21563239 21563337 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "8"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21564627 21564737 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "9"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21571482 21571596 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "10"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21573714 21573856 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "11"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21582440 21582631 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "12"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21584018 21584083 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "13"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21585186 21585332 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "14"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21586764 21586885 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "15"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21599192 21599404 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "16"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21605684 21605825 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "17"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21616563 21616766 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004345"; exon_number "18"; gene_name "ECE1"; oId "uc001bei.2"; nearest_ref "uc001bei.2"; class_code "="; tss_id "TSS2210"; p_id "P3274"; chr1 coding exon 21543740 21546624 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "1"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21551743 21551933 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "2"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21553652 21553719 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "3"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21554424 21554534 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "4"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21560051 21560154 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "5"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21562343 21562420 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "6"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21563239 21563337 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "7"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21564627 21564737 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "8"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21571482 21571596 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "9"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21573714 21573856 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "10"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21582440 21582631 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "11"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21584018 21584083 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "12"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21585186 21585332 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "13"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21586764 21586885 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "14"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21599192 21599404 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "15"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21605684 21605825 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "16"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21616563 21616649 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "17"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21616857 21616982 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004347"; exon_number "18"; gene_name "ECE1"; oId "uc010odl.1"; nearest_ref "uc010odl.1"; class_code "="; tss_id "TSS2211"; p_id "P3279"; chr1 coding exon 21543740 21546624 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "1"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21548240 21548335 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "2"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21551743 21551933 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "3"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21553652 21553719 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "4"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21554424 21554534 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "5"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21560051 21560154 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "6"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21562343 21562420 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "7"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21563239 21563337 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "8"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21564627 21564737 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "9"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21571482 21571596 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "10"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21573714 21573856 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "11"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21582440 21582631 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "12"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21584018 21584083 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "13"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21585186 21585332 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "14"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21586764 21586885 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "15"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21599192 21599404 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "16"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21605684 21605825 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "17"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21616563 21616649 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "18"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21616857 21616982 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004346"; exon_number "19"; gene_name "ECE1"; oId "uc001bek.2"; nearest_ref "uc001bek.2"; class_code "="; tss_id "TSS2211"; p_id "P3278"; chr1 coding exon 21543740 21546624 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "1"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21548240 21548335 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "2"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21551743 21551933 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "3"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21553652 21553719 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "4"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21554424 21554534 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "5"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21560051 21560154 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "6"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21562343 21562420 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "7"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21563239 21563337 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "8"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21564627 21564737 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "9"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21571482 21571596 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "10"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21573714 21573856 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "11"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21582440 21582631 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "12"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21584018 21584083 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "13"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21585186 21585332 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "14"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21586764 21586885 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "15"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21599192 21599404 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "16"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21605684 21605825 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "17"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21616563 21616649 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "18"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21671869 21672034 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004348"; exon_number "19"; gene_name "ECE1"; oId "uc001bem.2"; nearest_ref "uc001bem.2"; class_code "="; tss_id "TSS2212"; p_id "P3277"; chr1 coding exon 21559598 21560154 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "1"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21562343 21562420 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "2"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21563239 21563337 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "3"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21564627 21564737 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "4"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21571482 21571596 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "5"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21573714 21573856 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "6"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21582440 21582631 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "7"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21584018 21584083 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "8"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21585186 21585332 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "9"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21586764 21586885 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "10"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21599192 21599404 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "11"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21605684 21605825 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "12"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21616563 21616649 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "13"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 coding exon 21616857 21616982 . - . gene_id "XLOC_001387"; transcript_id "TCONS_00004349"; exon_number "14"; gene_name "ECE1"; oId "uc009vqa.1"; nearest_ref "uc009vqa.1"; class_code "="; tss_id "TSS2211"; p_id "P3276"; chr1 noncoding exon 21602543 21604868 . - . gene_id "XLOC_001388"; transcript_id "TCONS_00004350"; exon_number "1"; oId "uc001ben.1"; nearest_ref "uc001ben.1"; class_code "="; chr1 noncoding exon 21749601 21751356 . - . gene_id "XLOC_001389"; transcript_id "TCONS_00004351"; exon_number "1"; oId "uc001bep.1"; nearest_ref "uc001bep.1"; class_code "="; tss_id "TSS2213"; chr1 noncoding exon 21751961 21752012 . - . gene_id "XLOC_001389"; transcript_id "TCONS_00004351"; exon_number "2"; oId "uc001bep.1"; nearest_ref "uc001bep.1"; class_code "="; tss_id "TSS2213"; chr1 noncoding exon 21752727 21752899 . - . gene_id "XLOC_001389"; transcript_id "TCONS_00004351"; exon_number "3"; oId "uc001bep.1"; nearest_ref "uc001bep.1"; class_code "="; tss_id "TSS2213"; chr1 noncoding exon 21753515 21753566 . - . gene_id "XLOC_001389"; transcript_id "TCONS_00004351"; exon_number "4"; oId "uc001bep.1"; nearest_ref "uc001bep.1"; class_code "="; tss_id "TSS2213"; chr1 noncoding exon 21754277 21754300 . - . gene_id "XLOC_001389"; transcript_id "TCONS_00004351"; exon_number "5"; oId "uc001bep.1"; nearest_ref "uc001bep.1"; class_code "="; tss_id "TSS2213"; chr1 coding exon 21922709 21923757 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "1"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21924179 21924221 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "2"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21924454 21924557 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "3"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21924893 21924995 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "4"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21925987 21926110 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "5"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21928177 21928290 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "6"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21929297 21929406 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "7"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21930151 21930405 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "8"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21932559 21932690 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "9"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21934706 21934843 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "10"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21935343 21935429 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "11"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21936068 21936139 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "12"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21936613 21936768 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "13"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21937945 21938074 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "14"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21938209 21938309 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "15"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21938519 21938602 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "16"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21939669 21939722 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "17"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21940121 21940199 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "18"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21940479 21940582 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "19"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21943799 21943984 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "20"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21944427 21944465 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "21"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21945518 21945565 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "22"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21946508 21946543 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004352"; exon_number "23"; gene_name "RAP1GAP"; oId "uc001bev.2"; nearest_ref "uc001bev.2"; class_code "="; tss_id "TSS2214"; p_id "P3283"; chr1 coding exon 21922709 21923757 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "1"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21924179 21924221 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "2"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21924454 21924557 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "3"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21924893 21924995 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "4"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21925987 21926110 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "5"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21928177 21928290 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "6"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21929297 21929406 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "7"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21932559 21932690 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "8"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21934706 21934843 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "9"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21935343 21935429 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "10"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21936068 21936139 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "11"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21936613 21936768 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "12"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21937945 21938074 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "13"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21938209 21938309 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "14"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21938519 21938602 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "15"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21939669 21939722 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "16"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21940121 21940199 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "17"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21940479 21940582 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "18"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21943799 21943984 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "19"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21944427 21944465 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "20"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21945518 21945565 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "21"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21946508 21946543 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "22"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21952797 21952890 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "23"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21976254 21976289 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "24"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21978272 21978348 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004353"; exon_number "25"; gene_name "RAP1GAP"; oId "uc001bew.2"; nearest_ref "uc001bew.2"; class_code "="; tss_id "TSS2215"; p_id "P3280"; chr1 coding exon 21922709 21923757 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "1"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21924179 21924221 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "2"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21924454 21924533 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "3"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21924893 21924995 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "4"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21925987 21926110 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "5"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21928177 21928290 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "6"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21929297 21929406 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "7"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21930328 21930405 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "8"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21932559 21932690 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "9"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21934706 21934843 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "10"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21935343 21935429 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "11"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21936068 21936139 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "12"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21936613 21936768 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "13"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21937945 21938074 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "14"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21938209 21938309 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "15"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21938519 21938602 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "16"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21939669 21939722 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "17"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21940121 21940199 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "18"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21940479 21940582 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "19"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21943799 21943984 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "20"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21944427 21944465 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "21"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21945518 21945565 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "22"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21946508 21946543 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "23"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21952797 21952890 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "24"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21976254 21976289 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "25"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21991704 21991810 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "26"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21995747 21995856 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004355"; exon_number "27"; gene_name "RAP1GAP"; oId "uc001bey.2"; nearest_ref "uc001bey.2"; class_code "="; tss_id "TSS2216"; p_id "P3282"; chr1 coding exon 21922709 21923757 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "1"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21924179 21924221 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "2"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21924454 21924557 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "3"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21924893 21924995 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "4"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21925987 21926110 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "5"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21928177 21928290 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "6"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21929297 21929406 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "7"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21932559 21932690 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "8"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21934706 21934843 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "9"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21935343 21935429 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "10"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21936068 21936139 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "11"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21936613 21936768 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "12"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21937945 21938074 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "13"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21938209 21938309 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "14"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21938519 21938602 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "15"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21939669 21939722 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "16"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21940121 21940199 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "17"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21940479 21940582 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "18"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21943799 21943984 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "19"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21944427 21944465 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "20"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21945518 21945565 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "21"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21946508 21946543 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "22"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21952797 21952890 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "23"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21976254 21976289 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "24"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 21995747 21995856 . - . gene_id "XLOC_001390"; transcript_id "TCONS_00004354"; exon_number "25"; gene_name "RAP1GAP"; oId "uc001bex.2"; nearest_ref "uc001bex.2"; class_code "="; tss_id "TSS2216"; p_id "P3281"; chr1 coding exon 22004794 22005932 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "1"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22007301 22007327 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "2"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22013684 22013732 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "3"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22016467 22016592 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "4"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22027991 22028095 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "5"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22030005 22030111 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "6"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22030755 22030885 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "7"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22032220 22032330 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "8"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22032619 22032680 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "9"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22032960 22033082 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "10"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22033237 22033361 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "11"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22041882 22041950 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "12"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22047529 22047656 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "13"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22048143 22048257 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "14"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22050391 22051612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004356"; exon_number "15"; gene_name "USP48"; oId "uc001bfa.2"; nearest_ref "uc001bfa.2"; class_code "="; tss_id "TSS2217"; p_id "P3287"; chr1 coding exon 22004794 22005932 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "1"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22007301 22007327 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "2"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22013684 22013732 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "3"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22016467 22016592 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "4"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22021559 22021714 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "5"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22027991 22028095 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "6"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22030005 22030111 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "7"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22030755 22030885 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "8"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22032220 22032330 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "9"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22032619 22032680 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "10"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22032960 22033082 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "11"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22033237 22033400 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "12"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22041882 22041950 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "13"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22047529 22047659 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "14"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22048143 22048257 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "15"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22050391 22050588 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "16"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22055063 22055212 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "17"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22056197 22056322 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "18"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22062939 22063118 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "19"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22073560 22073642 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "20"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22074631 22074764 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "21"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22078000 22078108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "22"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22079020 22079144 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "23"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22079485 22079612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "24"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22083039 22083195 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "25"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22084156 22084276 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "26"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22109317 22109688 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004360"; exon_number "27"; gene_name "USP48"; oId "uc010odq.1"; nearest_ref "uc010odq.1"; class_code "="; tss_id "TSS2218"; p_id "P3285"; chr1 coding exon 22004794 22005932 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "1"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22007301 22007327 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "2"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22013684 22013732 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "3"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22016467 22016592 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "4"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22021559 22021714 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "5"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22027991 22028095 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "6"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22030005 22030111 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "7"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22030755 22030885 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "8"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22032220 22032330 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "9"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22032619 22032680 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "10"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22032960 22033082 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "11"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22033237 22033361 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "12"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22041882 22041950 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "13"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22047529 22047659 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "14"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22048143 22048257 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "15"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22055063 22055212 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "16"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22056197 22056325 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "17"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22062939 22063118 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "18"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22073560 22073642 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "19"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22074631 22074764 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "20"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22078000 22078108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "21"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22079020 22079144 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "22"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22079485 22079612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "23"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22083039 22083195 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "24"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22084156 22084276 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "25"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22109317 22109688 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004359"; exon_number "26"; gene_name "USP48"; oId "uc009vqc.2"; nearest_ref "uc009vqc.2"; class_code "="; tss_id "TSS2218"; p_id "P3291"; chr1 coding exon 22004794 22005932 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "1"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22007301 22007327 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "2"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22013684 22013732 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "3"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22016467 22016592 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "4"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22027991 22028095 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "5"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22030005 22030111 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "6"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22030755 22030885 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "7"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22032220 22032330 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "8"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22032619 22032680 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "9"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22032960 22033082 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "10"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22033237 22033361 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "11"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22041882 22041950 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "12"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22047529 22047659 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "13"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22048143 22048257 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "14"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22050391 22050588 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "15"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22055063 22055212 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "16"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22056197 22056325 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "17"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22062939 22063118 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "18"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22073560 22073642 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "19"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22074631 22074764 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "20"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22078000 22078108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "21"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22079020 22079144 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "22"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22079485 22079612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "23"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22083039 22083195 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "24"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22084156 22084276 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "25"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22109317 22109688 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004358"; exon_number "26"; gene_name "USP48"; oId "uc001bfc.2"; nearest_ref "uc001bfc.2"; class_code "="; tss_id "TSS2218"; p_id "P3290"; chr1 coding exon 22004794 22005932 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "1"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22007301 22007327 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "2"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22013684 22013732 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "3"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22016467 22016592 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "4"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22021559 22021714 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "5"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22027991 22028095 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "6"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22030005 22030111 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "7"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22030755 22030885 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "8"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22032220 22032330 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "9"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22032619 22032680 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "10"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22032960 22033082 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "11"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22033237 22033361 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "12"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22041882 22041950 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "13"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22047529 22047659 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "14"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22048143 22048257 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "15"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22050391 22050588 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "16"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22055063 22055212 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "17"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22056197 22056325 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "18"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22062939 22063118 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "19"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22073560 22073642 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "20"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22074631 22074764 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "21"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22078000 22078108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "22"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22079020 22079144 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "23"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22079485 22079612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "24"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22083039 22083195 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "25"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22084156 22084276 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "26"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22109317 22109688 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004357"; exon_number "27"; gene_name "USP48"; oId "uc001bfb.2"; nearest_ref "uc001bfb.2"; class_code "="; tss_id "TSS2218"; p_id "P3289"; chr1 coding exon 22012385 22013732 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004361"; exon_number "1"; gene_name "USP48"; oId "uc001bfd.1"; nearest_ref "uc001bfd.1"; class_code "="; tss_id "TSS2219"; p_id "P3286"; chr1 coding exon 22016467 22016592 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004361"; exon_number "2"; gene_name "USP48"; oId "uc001bfd.1"; nearest_ref "uc001bfd.1"; class_code "="; tss_id "TSS2219"; p_id "P3286"; chr1 coding exon 22021559 22021714 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004361"; exon_number "3"; gene_name "USP48"; oId "uc001bfd.1"; nearest_ref "uc001bfd.1"; class_code "="; tss_id "TSS2219"; p_id "P3286"; chr1 coding exon 22027991 22028095 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004361"; exon_number "4"; gene_name "USP48"; oId "uc001bfd.1"; nearest_ref "uc001bfd.1"; class_code "="; tss_id "TSS2219"; p_id "P3286"; chr1 coding exon 22030755 22031108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004361"; exon_number "5"; gene_name "USP48"; oId "uc001bfd.1"; nearest_ref "uc001bfd.1"; class_code "="; tss_id "TSS2219"; p_id "P3286"; chr1 coding exon 22047529 22047656 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "1"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22048143 22048257 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "2"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22050391 22050588 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "3"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22055063 22055212 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "4"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22056197 22056322 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "5"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22062939 22063118 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "6"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22073560 22073642 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "7"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22074631 22074764 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "8"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22078000 22078108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "9"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22079020 22079144 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "10"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22079485 22079612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "11"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22083039 22083195 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "12"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22084156 22084276 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "13"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22109317 22109688 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004362"; exon_number "14"; gene_name "USP48"; oId "uc001bfe.1"; nearest_ref "uc001bfe.1"; class_code "="; tss_id "TSS2218"; p_id "P3284"; chr1 coding exon 22054340 22055212 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "1"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22056197 22056325 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "2"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22062939 22063118 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "3"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22073560 22073642 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "4"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22074631 22074764 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "5"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22078000 22078108 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "6"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22079020 22079144 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "7"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22079485 22079612 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "8"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22083039 22083195 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "9"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22084156 22084276 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "10"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22109317 22109688 . - . gene_id "XLOC_001391"; transcript_id "TCONS_00004363"; exon_number "11"; gene_name "USP48"; oId "uc001bff.2"; nearest_ref "uc001bff.2"; class_code "="; tss_id "TSS2218"; p_id "P3288"; chr1 coding exon 22148738 22149981 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "1"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22150109 22150212 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "2"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22150614 22150697 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "3"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22150799 22150869 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "4"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22151030 22151108 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "5"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22151197 22151272 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "6"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22154356 22154412 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "7"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22154523 22154645 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "8"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22154748 22154919 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "9"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22155328 22155572 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "10"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22155876 22157206 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004364"; exon_number "11"; gene_name "HSPG2"; oId "uc001bfi.2"; nearest_ref "uc001bfi.2"; class_code "="; tss_id "TSS2220"; p_id "P3294"; chr1 coding exon 22148738 22149981 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "1"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22150109 22150212 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "2"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22150614 22150697 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "3"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22150799 22150869 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "4"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22151030 22151108 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "5"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22151197 22151272 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "6"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22154356 22154412 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "7"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22154523 22154645 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "8"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22154748 22154919 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "9"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22155328 22155572 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "10"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22155876 22156097 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "11"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22156486 22156584 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "12"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22157475 22157583 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "13"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22157708 22157817 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "14"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22157956 22158055 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "15"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22158145 22158289 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "16"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22158988 22159099 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "17"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22159761 22159877 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "18"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22159960 22160107 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "19"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22160309 22160418 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "20"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22161172 22161438 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "21"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22162033 22162130 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "22"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22163295 22163499 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "23"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22165318 22165578 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "24"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22165864 22166043 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "25"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22166315 22166510 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "26"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22167594 22167778 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "27"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22168032 22168166 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "28"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22168495 22168635 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "29"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22168732 22168873 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "30"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22169263 22169414 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "31"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22169790 22169931 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "32"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22170641 22170792 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "33"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22172601 22172748 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "34"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22172941 22173092 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "35"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22173847 22173985 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "36"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22174182 22174333 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "37"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22174451 22174586 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "38"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22175136 22175287 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "39"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22175386 22175524 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "40"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22176534 22176685 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "41"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22176856 22176991 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "42"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22178039 22178190 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "43"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22178284 22178419 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "44"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22178581 22178726 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "45"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22179193 22179325 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "46"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22179412 22179563 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "47"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22180686 22180836 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "48"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22181104 22181258 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "49"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22181341 22181476 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "50"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22181797 22181939 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "51"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22182016 22182168 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "52"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22182280 22182405 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "53"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22183508 22183688 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "54"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22183778 22183878 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "55"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22186059 22186169 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "56"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22186328 22186495 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "57"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22186670 22186728 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "58"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22188250 22188336 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "59"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22188481 22188608 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "60"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22190593 22190706 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "61"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22191336 22191566 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "62"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22191778 22191858 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "63"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22192210 22192302 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "64"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22198679 22198870 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "65"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22199113 22199253 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "66"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22199490 22199584 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "67"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22199868 22199917 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "68"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22200418 22200504 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "69"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22200899 22201026 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "70"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22201109 22201222 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "71"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22201384 22201495 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "72"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22202122 22202240 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "73"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22202356 22202535 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "74"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22202722 22202898 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "75"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22203005 22203145 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "76"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22204679 22204746 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "77"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22204926 22204984 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "78"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22205070 22205156 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "79"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22205487 22205614 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "80"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22206600 22206747 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "81"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22206856 22207052 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "82"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22207149 22207328 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "83"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22207832 22207995 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "84"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22211021 22211170 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "85"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22211260 22211411 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "86"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22211506 22211650 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "87"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22211813 22211944 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "88"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22213708 22213827 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "89"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22213913 22214167 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "90"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22214431 22214559 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "91"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22216474 22216634 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "92"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22216920 22216978 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "93"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22217078 22217187 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "94"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22222415 22222459 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "95"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22222668 22222803 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "96"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22263648 22263750 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004366"; exon_number "97"; gene_name "HSPG2"; oId "uc009vqd.2"; nearest_ref "uc009vqd.2"; class_code "="; tss_id "TSS2221"; p_id "P3293"; chr1 coding exon 22148738 22149981 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "1"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22150109 22150212 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "2"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22150614 22150697 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "3"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22150799 22150869 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "4"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22151030 22151108 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "5"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22151197 22151272 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "6"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22154356 22154412 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "7"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22154523 22154645 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "8"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22154748 22154919 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "9"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22155328 22155572 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "10"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22155876 22156097 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "11"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22156486 22156584 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "12"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22157475 22157583 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "13"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22157708 22157817 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "14"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22157956 22158055 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "15"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22158145 22158289 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "16"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22158988 22159099 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "17"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22159761 22159877 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "18"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22159960 22160107 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "19"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22160309 22160418 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "20"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22161172 22161438 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "21"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22162033 22162130 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "22"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22163295 22163499 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "23"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22165318 22165578 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "24"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22165864 22166043 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "25"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22166315 22166510 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "26"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22167594 22167778 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "27"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22168032 22168166 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "28"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22168495 22168635 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "29"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22168732 22168873 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "30"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22169263 22169414 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "31"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22169790 22169931 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "32"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22170641 22170792 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "33"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22172601 22172748 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "34"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22172941 22173092 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "35"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22173847 22173985 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "36"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22174182 22174333 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "37"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22174451 22174586 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "38"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22175136 22175287 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "39"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22175386 22175524 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "40"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22176534 22176685 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "41"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22176856 22176991 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "42"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22178039 22178190 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "43"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22178284 22178419 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "44"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22178581 22178726 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "45"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22179193 22179325 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "46"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22179412 22179563 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "47"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22180686 22180836 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "48"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22181104 22181258 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "49"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22181341 22181476 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "50"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22181797 22181939 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "51"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22182016 22182168 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "52"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22182280 22182405 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "53"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22183508 22183688 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "54"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22183778 22183878 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "55"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22186059 22186169 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "56"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22186328 22186495 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "57"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22186670 22186728 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "58"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22188250 22188336 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "59"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22188481 22188608 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "60"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22190593 22190706 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "61"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22191336 22191566 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "62"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22191778 22191858 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "63"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22192210 22192302 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "64"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22198679 22198870 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "65"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22199113 22199253 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "66"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22199490 22199584 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "67"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22199868 22199917 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "68"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22200418 22200504 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "69"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22200899 22201026 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "70"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22201109 22201222 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "71"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22201384 22201495 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "72"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22202122 22202240 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "73"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22202356 22202535 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "74"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22202722 22202898 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "75"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22203005 22203145 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "76"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22204679 22204746 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "77"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22204926 22204984 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "78"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22205070 22205156 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "79"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22205487 22205614 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "80"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22206600 22206747 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "81"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22206856 22207052 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "82"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22207149 22207328 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "83"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22207832 22207995 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "84"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22211021 22211167 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "85"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22211260 22211411 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "86"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22211506 22211650 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "87"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22211813 22211944 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "88"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22213708 22213827 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "89"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22213913 22214167 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "90"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22214431 22214559 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "91"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22216474 22216634 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "92"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22216920 22216978 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "93"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22217078 22217187 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "94"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22222415 22222459 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "95"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22222668 22222803 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "96"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22263648 22263750 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004365"; exon_number "97"; gene_name "HSPG2"; oId "uc001bfj.2"; nearest_ref "uc001bfj.2"; class_code "="; tss_id "TSS2221"; p_id "P3292"; chr1 coding exon 22213708 22213827 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004367"; exon_number "1"; gene_name "HSPG2"; oId "uc009vqe.1"; nearest_ref "uc009vqe.1"; class_code "="; tss_id "TSS2222"; p_id "P3295"; chr1 coding exon 22213913 22214167 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004367"; exon_number "2"; gene_name "HSPG2"; oId "uc009vqe.1"; nearest_ref "uc009vqe.1"; class_code "="; tss_id "TSS2222"; p_id "P3295"; chr1 coding exon 22214431 22214559 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004367"; exon_number "3"; gene_name "HSPG2"; oId "uc009vqe.1"; nearest_ref "uc009vqe.1"; class_code "="; tss_id "TSS2222"; p_id "P3295"; chr1 coding exon 22216474 22216634 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004367"; exon_number "4"; gene_name "HSPG2"; oId "uc009vqe.1"; nearest_ref "uc009vqe.1"; class_code "="; tss_id "TSS2222"; p_id "P3295"; chr1 coding exon 22222415 22222459 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004367"; exon_number "5"; gene_name "HSPG2"; oId "uc009vqe.1"; nearest_ref "uc009vqe.1"; class_code "="; tss_id "TSS2222"; p_id "P3295"; chr1 coding exon 22222668 22222803 . - . gene_id "XLOC_001392"; transcript_id "TCONS_00004367"; exon_number "6"; gene_name "HSPG2"; oId "uc009vqe.1"; nearest_ref "uc009vqe.1"; class_code "="; tss_id "TSS2222"; p_id "P3295"; chr1 coding exon 22443800 22447010 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004368"; exon_number "1"; gene_name "WNT4"; oId "uc001bfs.3"; nearest_ref "uc001bfs.3"; class_code "="; tss_id "TSS2223"; p_id "P3296"; chr1 coding exon 22447704 22447846 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004368"; exon_number "2"; gene_name "WNT4"; oId "uc001bfs.3"; nearest_ref "uc001bfs.3"; class_code "="; tss_id "TSS2223"; p_id "P3296"; chr1 coding exon 22447938 22448069 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004368"; exon_number "3"; gene_name "WNT4"; oId "uc001bfs.3"; nearest_ref "uc001bfs.3"; class_code "="; tss_id "TSS2223"; p_id "P3296"; chr1 coding exon 22456109 22456344 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004368"; exon_number "4"; gene_name "WNT4"; oId "uc001bfs.3"; nearest_ref "uc001bfs.3"; class_code "="; tss_id "TSS2223"; p_id "P3296"; chr1 coding exon 22469339 22469519 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004368"; exon_number "5"; gene_name "WNT4"; oId "uc001bfs.3"; nearest_ref "uc001bfs.3"; class_code "="; tss_id "TSS2223"; p_id "P3296"; chr1 coding exon 22443800 22447010 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004369"; exon_number "1"; gene_name "WNT4"; oId "uc010odt.1"; nearest_ref "uc010odt.1"; class_code "="; tss_id "TSS2224"; p_id "P3297"; chr1 coding exon 22447704 22447846 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004369"; exon_number "2"; gene_name "WNT4"; oId "uc010odt.1"; nearest_ref "uc010odt.1"; class_code "="; tss_id "TSS2224"; p_id "P3297"; chr1 coding exon 22447938 22448069 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004369"; exon_number "3"; gene_name "WNT4"; oId "uc010odt.1"; nearest_ref "uc010odt.1"; class_code "="; tss_id "TSS2224"; p_id "P3297"; chr1 coding exon 22456109 22456344 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004369"; exon_number "4"; gene_name "WNT4"; oId "uc010odt.1"; nearest_ref "uc010odt.1"; class_code "="; tss_id "TSS2224"; p_id "P3297"; chr1 coding exon 22470225 22470385 . - . gene_id "XLOC_001393"; transcript_id "TCONS_00004369"; exon_number "5"; gene_name "WNT4"; oId "uc010odt.1"; nearest_ref "uc010odt.1"; class_code "="; tss_id "TSS2224"; p_id "P3297"; chr1 coding exon 23337327 23337594 . - . gene_id "XLOC_001394"; transcript_id "TCONS_00004370"; exon_number "1"; oId "uc001bgh.1"; nearest_ref "uc001bgh.1"; class_code "="; tss_id "TSS2225"; p_id "P3298"; chr1 coding exon 23340376 23340538 . - . gene_id "XLOC_001394"; transcript_id "TCONS_00004370"; exon_number "2"; oId "uc001bgh.1"; nearest_ref "uc001bgh.1"; class_code "="; tss_id "TSS2225"; p_id "P3298"; chr1 coding exon 23342265 23342343 . - . gene_id "XLOC_001394"; transcript_id "TCONS_00004370"; exon_number "3"; oId "uc001bgh.1"; nearest_ref "uc001bgh.1"; class_code "="; tss_id "TSS2225"; p_id "P3298"; chr1 coding exon 23410516 23415546 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004372"; exon_number "1"; gene_name "LUZP1"; oId "uc010odv.1"; nearest_ref "uc010odv.1"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23417683 23420873 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004372"; exon_number "2"; gene_name "LUZP1"; oId "uc010odv.1"; nearest_ref "uc010odv.1"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23435515 23435620 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004372"; exon_number "3"; gene_name "LUZP1"; oId "uc010odv.1"; nearest_ref "uc010odv.1"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23495259 23495517 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004372"; exon_number "4"; gene_name "LUZP1"; oId "uc010odv.1"; nearest_ref "uc010odv.1"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23410516 23415546 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004371"; exon_number "1"; gene_name "LUZP1"; oId "uc001bgk.2"; nearest_ref "uc001bgk.2"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23417683 23420873 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004371"; exon_number "2"; gene_name "LUZP1"; oId "uc001bgk.2"; nearest_ref "uc001bgk.2"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23435515 23435620 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004371"; exon_number "3"; gene_name "LUZP1"; oId "uc001bgk.2"; nearest_ref "uc001bgk.2"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23436078 23436143 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004371"; exon_number "4"; gene_name "LUZP1"; oId "uc001bgk.2"; nearest_ref "uc001bgk.2"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23495259 23495517 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004371"; exon_number "5"; gene_name "LUZP1"; oId "uc001bgk.2"; nearest_ref "uc001bgk.2"; class_code "="; tss_id "TSS2226"; p_id "P3300"; chr1 coding exon 23416921 23417391 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004373"; exon_number "1"; gene_name "LUZP1"; oId "uc001bgl.2"; nearest_ref "uc001bgl.2"; class_code "="; tss_id "TSS2226"; p_id "P3299"; chr1 coding exon 23417683 23420873 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004373"; exon_number "2"; gene_name "LUZP1"; oId "uc001bgl.2"; nearest_ref "uc001bgl.2"; class_code "="; tss_id "TSS2226"; p_id "P3299"; chr1 coding exon 23495259 23495517 . - . gene_id "XLOC_001395"; transcript_id "TCONS_00004373"; exon_number "3"; gene_name "LUZP1"; oId "uc001bgl.2"; nearest_ref "uc001bgl.2"; class_code "="; tss_id "TSS2226"; p_id "P3299"; chr1 coding exon 23518389 23521222 . - . gene_id "XLOC_001396"; transcript_id "TCONS_00004374"; exon_number "1"; gene_name "HTR1D"; oId "uc001bgn.2"; nearest_ref "uc001bgn.2"; class_code "="; p_id "P3301"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004375"; exon_number "1"; gene_name "HNRNPR"; oId "uc001bgo.2"; nearest_ref "uc001bgo.2"; class_code "="; tss_id "TSS2227"; p_id "P3309"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004375"; exon_number "2"; gene_name "HNRNPR"; oId "uc001bgo.2"; nearest_ref "uc001bgo.2"; class_code "="; tss_id "TSS2227"; p_id "P3309"; chr1 coding exon 23638155 23638386 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004375"; exon_number "3"; gene_name "HNRNPR"; oId "uc001bgo.2"; nearest_ref "uc001bgo.2"; class_code "="; tss_id "TSS2227"; p_id "P3309"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "1"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "2"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "3"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23644976 23645190 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "4"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "5"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23650049 23650225 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "6"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23660011 23660124 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "7"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "8"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "9"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004379"; exon_number "10"; gene_name "HNRNPR"; oId "uc009vqk.2"; nearest_ref "uc009vqk.2"; class_code "="; tss_id "TSS2228"; p_id "P3308"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "1"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "2"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "3"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23644976 23645181 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "4"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "5"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23650049 23650225 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "6"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "7"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "8"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23667345 23667510 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "9"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004381"; exon_number "10"; gene_name "HNRNPR"; oId "uc010odw.1"; nearest_ref "uc010odw.1"; class_code "="; tss_id "TSS2228"; p_id "P3305"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "1"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "2"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "3"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23644976 23645181 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "4"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "5"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23660011 23660124 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "6"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "7"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "8"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004382"; exon_number "9"; gene_name "HNRNPR"; oId "uc010odx.1"; nearest_ref "uc010odx.1"; class_code "="; tss_id "TSS2228"; p_id "P3304"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "1"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "2"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "3"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23644976 23645181 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "4"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "5"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23650049 23650225 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "6"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "7"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "8"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004380"; exon_number "9"; gene_name "HNRNPR"; oId "uc009vql.2"; nearest_ref "uc009vql.2"; class_code "="; tss_id "TSS2228"; p_id "P3302"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "1"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "2"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "3"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23644976 23645181 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "4"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "5"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23650049 23650225 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "6"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23660011 23660124 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "7"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "8"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "9"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004378"; exon_number "10"; gene_name "HNRNPR"; oId "uc001bgs.3"; nearest_ref "uc001bgs.3"; class_code "="; tss_id "TSS2228"; p_id "P3307"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "1"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "2"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "3"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23644976 23645181 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "4"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "5"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23650049 23650225 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "6"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23660011 23660124 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "7"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "8"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "9"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23667345 23667510 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "10"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004377"; exon_number "11"; gene_name "HNRNPR"; oId "uc001bgr.3"; nearest_ref "uc001bgr.3"; class_code "="; tss_id "TSS2228"; p_id "P3306"; chr1 coding exon 23636277 23637559 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "1"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23637694 23637815 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "2"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23640046 23640195 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "3"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23644976 23645190 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "4"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23648021 23648156 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "5"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23650049 23650225 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "6"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23660011 23660124 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "7"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23664247 23664354 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "8"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23664983 23665101 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "9"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23667345 23667510 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "10"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23670704 23670853 . - . gene_id "XLOC_001397"; transcript_id "TCONS_00004376"; exon_number "11"; gene_name "HNRNPR"; oId "uc001bgp.3"; nearest_ref "uc001bgp.3"; class_code "="; tss_id "TSS2228"; p_id "P3303"; chr1 coding exon 23685942 23689714 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004383"; exon_number "1"; gene_name "ZNF436"; oId "uc001bgt.2"; nearest_ref "uc001bgt.2"; class_code "="; tss_id "TSS2229"; p_id "P3310"; chr1 coding exon 23693535 23693661 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004383"; exon_number "2"; gene_name "ZNF436"; oId "uc001bgt.2"; nearest_ref "uc001bgt.2"; class_code "="; tss_id "TSS2229"; p_id "P3310"; chr1 coding exon 23694466 23694879 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004383"; exon_number "3"; gene_name "ZNF436"; oId "uc001bgt.2"; nearest_ref "uc001bgt.2"; class_code "="; tss_id "TSS2229"; p_id "P3310"; chr1 coding exon 23685942 23689714 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004384"; exon_number "1"; gene_name "ZNF436"; oId "uc001bgu.2"; nearest_ref "uc001bgu.2"; class_code "="; tss_id "TSS2230"; p_id "P3310"; chr1 coding exon 23693535 23693661 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004384"; exon_number "2"; gene_name "ZNF436"; oId "uc001bgu.2"; nearest_ref "uc001bgu.2"; class_code "="; tss_id "TSS2230"; p_id "P3310"; chr1 coding exon 23694466 23694558 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004384"; exon_number "3"; gene_name "ZNF436"; oId "uc001bgu.2"; nearest_ref "uc001bgu.2"; class_code "="; tss_id "TSS2230"; p_id "P3310"; chr1 coding exon 23695859 23696357 . - . gene_id "XLOC_001398"; transcript_id "TCONS_00004384"; exon_number "4"; gene_name "ZNF436"; oId "uc001bgu.2"; nearest_ref "uc001bgu.2"; class_code "="; tss_id "TSS2230"; p_id "P3310"; chr1 coding exon 23707555 23707967 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "1"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23710839 23710910 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "2"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23713766 23713912 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "3"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23720372 23720524 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "4"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23724036 23724094 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "5"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23724285 23724448 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "6"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23735157 23735219 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "7"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23743742 23743883 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "8"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23744397 23744502 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "9"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23745570 23745632 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "10"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23751058 23751261 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004385"; exon_number "11"; gene_name "TCEA3"; oId "uc001bgx.1"; nearest_ref "uc001bgx.1"; class_code "="; tss_id "TSS2231"; p_id "P3314"; chr1 coding exon 23710671 23710910 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004386"; exon_number "1"; gene_name "TCEA3"; oId "uc009vqm.1"; nearest_ref "uc009vqm.1"; class_code "="; tss_id "TSS2232"; p_id "P3313"; chr1 coding exon 23713766 23713912 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004386"; exon_number "2"; gene_name "TCEA3"; oId "uc009vqm.1"; nearest_ref "uc009vqm.1"; class_code "="; tss_id "TSS2232"; p_id "P3313"; chr1 coding exon 23720372 23720524 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004386"; exon_number "3"; gene_name "TCEA3"; oId "uc009vqm.1"; nearest_ref "uc009vqm.1"; class_code "="; tss_id "TSS2232"; p_id "P3313"; chr1 coding exon 23724036 23724094 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004387"; exon_number "1"; gene_name "TCEA3"; oId "uc009vqn.1"; nearest_ref "uc009vqn.1"; class_code "="; tss_id "TSS2231"; p_id "P3312"; chr1 coding exon 23724285 23724448 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004387"; exon_number "2"; gene_name "TCEA3"; oId "uc009vqn.1"; nearest_ref "uc009vqn.1"; class_code "="; tss_id "TSS2231"; p_id "P3312"; chr1 coding exon 23735157 23735219 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004387"; exon_number "3"; gene_name "TCEA3"; oId "uc009vqn.1"; nearest_ref "uc009vqn.1"; class_code "="; tss_id "TSS2231"; p_id "P3312"; chr1 coding exon 23743742 23743883 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004387"; exon_number "4"; gene_name "TCEA3"; oId "uc009vqn.1"; nearest_ref "uc009vqn.1"; class_code "="; tss_id "TSS2231"; p_id "P3312"; chr1 coding exon 23744397 23744502 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004387"; exon_number "5"; gene_name "TCEA3"; oId "uc009vqn.1"; nearest_ref "uc009vqn.1"; class_code "="; tss_id "TSS2231"; p_id "P3312"; chr1 coding exon 23751058 23751261 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004387"; exon_number "6"; gene_name "TCEA3"; oId "uc009vqn.1"; nearest_ref "uc009vqn.1"; class_code "="; tss_id "TSS2231"; p_id "P3312"; chr1 coding exon 23735157 23735219 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004388"; exon_number "1"; gene_name "TCEA3"; oId "uc010ody.1"; nearest_ref "uc010ody.1"; class_code "="; tss_id "TSS2231"; p_id "P3311"; chr1 coding exon 23743742 23743883 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004388"; exon_number "2"; gene_name "TCEA3"; oId "uc010ody.1"; nearest_ref "uc010ody.1"; class_code "="; tss_id "TSS2231"; p_id "P3311"; chr1 coding exon 23744397 23744502 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004388"; exon_number "3"; gene_name "TCEA3"; oId "uc010ody.1"; nearest_ref "uc010ody.1"; class_code "="; tss_id "TSS2231"; p_id "P3311"; chr1 coding exon 23745570 23745700 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004388"; exon_number "4"; gene_name "TCEA3"; oId "uc010ody.1"; nearest_ref "uc010ody.1"; class_code "="; tss_id "TSS2231"; p_id "P3311"; chr1 coding exon 23751058 23751261 . - . gene_id "XLOC_001399"; transcript_id "TCONS_00004388"; exon_number "5"; gene_name "TCEA3"; oId "uc010ody.1"; nearest_ref "uc010ody.1"; class_code "="; tss_id "TSS2231"; p_id "P3311"; chr1 coding exon 23755056 23756423 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "1"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23757528 23757618 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "2"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23758189 23758411 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "3"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23759570 23759765 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "4"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23759918 23760025 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "5"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23760119 23760186 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "6"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23760747 23760862 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "7"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23761026 23761111 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "8"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23762344 23762521 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "9"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 coding exon 23763053 23763170 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004389"; exon_number "10"; gene_name "ASAP3"; oId "uc001bgy.1"; nearest_ref "uc001bgy.1"; class_code "="; tss_id "TSS2233"; p_id "P3320"; chr1 nearCoding exon 23755056 23756423 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "1"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23757528 23757618 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "2"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23758189 23758411 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "3"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23759570 23759765 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "4"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23759918 23760025 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "5"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23760119 23760186 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "6"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23760747 23760862 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "7"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23761026 23761111 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "8"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23762216 23762521 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "9"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23763053 23763147 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "10"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 nearCoding exon 23763404 23763537 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004390"; exon_number "11"; oId "uc001bgz.1"; nearest_ref "uc001bgz.1"; class_code "="; tss_id "TSS2234"; chr1 coding exon 23755056 23756423 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "1"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23757528 23757618 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "2"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23758189 23758411 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "3"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23759570 23759765 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "4"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23759855 23760025 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "5"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23760119 23760186 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "6"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23760747 23760862 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "7"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23761026 23761111 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "8"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23762344 23762521 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "9"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23763053 23763147 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "10"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23763404 23763537 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "11"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23763623 23763813 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "12"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23763917 23763965 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "13"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23765240 23765327 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "14"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23765654 23765723 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "15"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23767595 23767704 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "16"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23767880 23767966 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "17"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23768148 23768223 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "18"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23768679 23768764 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "19"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23768994 23769105 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "20"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23777972 23778021 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "21"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23779190 23779264 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "22"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23782374 23782519 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "23"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23782615 23782687 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "24"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23810529 23810677 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004391"; exon_number "25"; oId "uc010odz.1"; nearest_ref "uc010odz.1"; class_code "="; tss_id "TSS2235"; p_id "P3319"; chr1 coding exon 23755056 23756423 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "1"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23757528 23757618 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "2"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23758189 23758411 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "3"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23759570 23759765 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "4"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23759918 23760025 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "5"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23760119 23760186 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "6"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23760747 23760862 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "7"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23761026 23761111 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "8"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23762344 23762521 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "9"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23763053 23763147 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "10"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23763404 23763537 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "11"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23763623 23763813 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "12"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23763917 23763965 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "13"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23765240 23765327 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "14"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23765654 23765723 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "15"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23767595 23767704 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "16"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23767880 23767966 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "17"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23768148 23768223 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "18"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23768679 23768764 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "19"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23768994 23769128 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "20"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23779190 23779264 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "21"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23782374 23782519 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "22"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23782615 23782687 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "23"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23810498 23810750 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004393"; exon_number "24"; gene_name "ASAP3"; oId "uc010oea.1"; nearest_ref "uc010oea.1"; class_code "="; tss_id "TSS2235"; p_id "P3318"; chr1 coding exon 23755056 23756423 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "1"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23757528 23757618 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "2"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23758189 23758411 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "3"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23759570 23759765 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "4"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23759918 23760025 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "5"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23760119 23760186 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "6"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23760747 23760862 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "7"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23761026 23761111 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "8"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23762344 23762521 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "9"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23763053 23763147 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "10"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23763404 23763537 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "11"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23763623 23763813 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "12"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23763917 23763965 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "13"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23765240 23765327 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "14"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23765654 23765723 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "15"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23767595 23767704 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "16"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23767880 23767966 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "17"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23768148 23768223 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "18"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23768679 23768764 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "19"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23768994 23769105 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "20"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23777972 23778021 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "21"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23779190 23779264 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "22"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23782374 23782519 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "23"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23782615 23782687 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "24"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23810498 23810750 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004392"; exon_number "25"; gene_name "ASAP3"; oId "uc001bha.2"; nearest_ref "uc001bha.2"; class_code "="; tss_id "TSS2235"; p_id "P3317"; chr1 coding exon 23755060 23755437 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "1"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23758401 23758411 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "2"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23759570 23759765 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "3"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23759918 23760025 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "4"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23760119 23760186 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "5"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23760747 23760862 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "6"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23761026 23761111 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "7"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23762344 23762521 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "8"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23763053 23763147 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "9"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23763404 23763537 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "10"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23763623 23763813 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "11"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23763917 23763965 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "12"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23765240 23765327 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "13"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23765654 23765723 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004394"; exon_number "14"; gene_name "ASAP3"; oId "uc001bhb.2"; nearest_ref "uc001bhb.2"; class_code "="; tss_id "TSS2236"; p_id "P3316"; chr1 coding exon 23768994 23769105 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "1"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 coding exon 23777972 23778021 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "2"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 coding exon 23779190 23779264 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "3"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 coding exon 23782374 23782519 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "4"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 coding exon 23782615 23782687 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "5"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 coding exon 23810498 23810645 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "6"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 coding exon 23810965 23811057 . - . gene_id "XLOC_001400"; transcript_id "TCONS_00004395"; exon_number "7"; gene_name "ASAP3"; oId "uc001bhc.1"; nearest_ref "uc001bhc.1"; class_code "="; tss_id "TSS2237"; p_id "P3315"; chr1 noncoding exon 23801095 23803135 . - . gene_id "XLOC_001401"; transcript_id "TCONS_00004396"; exon_number "1"; oId "uc001bhd.2"; nearest_ref "uc001bhd.2"; class_code "="; chr1 coding exon 23832922 23836640 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "1"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23842827 23843019 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "2"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23845508 23845622 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "3"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23847405 23847563 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "4"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23848329 23848548 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "5"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23850875 23850980 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "6"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23857034 23857713 . - . gene_id "XLOC_001402"; transcript_id "TCONS_00004397"; exon_number "7"; gene_name "E2F2"; oId "uc001bhe.1"; nearest_ref "uc001bhe.1"; class_code "="; tss_id "TSS2238"; p_id "P3321"; chr1 coding exon 23884410 23884906 . - . gene_id "XLOC_001403"; transcript_id "TCONS_00004398"; exon_number "1"; gene_name "ID3"; oId "uc001bhh.3"; nearest_ref "uc001bhh.3"; class_code "="; tss_id "TSS2239"; p_id "P3323"; chr1 coding exon 23885426 23885510 . - . gene_id "XLOC_001403"; transcript_id "TCONS_00004398"; exon_number "2"; gene_name "ID3"; oId "uc001bhh.3"; nearest_ref "uc001bhh.3"; class_code "="; tss_id "TSS2239"; p_id "P3323"; chr1 coding exon 23885618 23886322 . - . gene_id "XLOC_001403"; transcript_id "TCONS_00004398"; exon_number "3"; gene_name "ID3"; oId "uc001bhh.3"; nearest_ref "uc001bhh.3"; class_code "="; tss_id "TSS2239"; p_id "P3323"; chr1 coding exon 23884432 23885978 . - . gene_id "XLOC_001403"; transcript_id "TCONS_00004399"; exon_number "1"; gene_name "ID3"; oId "uc001bhg.1"; nearest_ref "uc001bhg.1"; class_code "="; p_id "P3322"; chr1 antisense exon 24086872 24087641 . - . gene_id "XLOC_001404"; transcript_id "TCONS_00004400"; exon_number "1"; oId "uc001bhp.1"; nearest_ref "uc001bhp.1"; class_code "="; tss_id "TSS2240"; chr1 antisense exon 24098601 24098656 . - . gene_id "XLOC_001404"; transcript_id "TCONS_00004400"; exon_number "2"; oId "uc001bhp.1"; nearest_ref "uc001bhp.1"; class_code "="; tss_id "TSS2240"; chr1 antisense exon 24098758 24098916 . - . gene_id "XLOC_001404"; transcript_id "TCONS_00004400"; exon_number "3"; oId "uc001bhp.1"; nearest_ref "uc001bhp.1"; class_code "="; tss_id "TSS2240"; chr1 antisense exon 24104689 24104777 . - . gene_id "XLOC_001404"; transcript_id "TCONS_00004400"; exon_number "4"; oId "uc001bhp.1"; nearest_ref "uc001bhp.1"; class_code "="; tss_id "TSS2240"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "1"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "2"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24122999 24123076 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "3"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24123187 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "4"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "5"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "6"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "7"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24124607 24124720 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "8"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24125105 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "9"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "10"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24125856 24126060 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004401"; exon_number "11"; gene_name "GALE"; oId "uc009vqo.1"; nearest_ref "uc009vqo.1"; class_code "="; tss_id "TSS2241"; p_id "P3329"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "1"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "2"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24123187 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "3"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "4"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "5"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "6"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24124607 24124720 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "7"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24125105 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "8"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "9"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24125856 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "10"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24126877 24127034 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004403"; exon_number "11"; gene_name "GALE"; oId "uc001bhw.1"; nearest_ref "uc001bhw.1"; class_code "="; tss_id "TSS2242"; p_id "P3328"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "1"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "2"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24122999 24123076 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "3"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24123187 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "4"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "5"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "6"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "7"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24124607 24124720 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "8"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24125105 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "9"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "10"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24125856 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "11"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24126877 24127034 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004402"; exon_number "12"; gene_name "GALE"; oId "uc001bhv.1"; nearest_ref "uc001bhv.1"; class_code "="; tss_id "TSS2242"; p_id "P3329"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "1"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "2"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24122999 24123076 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "3"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24123187 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "4"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "5"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "6"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "7"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24124607 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "8"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24125856 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "9"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24127202 24127294 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004406"; exon_number "10"; gene_name "GALE"; oId "uc001bhz.1"; nearest_ref "uc001bhz.1"; class_code "="; tss_id "TSS2243"; p_id "P3327"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "1"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "2"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24122999 24123076 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "3"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24123187 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "4"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "5"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "6"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "7"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24124607 24124720 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "8"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24125105 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "9"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "10"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24125852 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "11"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24127202 24127294 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004407"; exon_number "12"; gene_name "GALE"; oId "uc009vqp.1"; nearest_ref "uc009vqp.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "1"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "2"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24122999 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "3"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "4"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "5"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "6"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24124607 24124720 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "7"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24125105 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "8"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "9"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24125856 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "10"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24127202 24127294 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004405"; exon_number "11"; gene_name "GALE"; oId "uc001bhy.1"; nearest_ref "uc001bhy.1"; class_code "="; tss_id "TSS2243"; p_id "P3326"; chr1 coding exon 24122089 24122497 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "1"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24122641 24122755 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "2"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24122999 24123076 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "3"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24123187 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "4"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "5"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "6"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24124185 24124361 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "7"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24124607 24124720 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "8"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24125105 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "9"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "10"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24125856 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "11"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24127202 24127294 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004404"; exon_number "12"; gene_name "GALE"; oId "uc001bhx.1"; nearest_ref "uc001bhx.1"; class_code "="; tss_id "TSS2243"; p_id "P3329"; chr1 coding exon 24122210 24123272 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004408"; exon_number "1"; gene_name "GALE"; oId "uc001bia.2"; nearest_ref "uc001bia.2"; class_code "="; tss_id "TSS2244"; p_id "P3325"; chr1 coding exon 24123366 24123432 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004408"; exon_number "2"; gene_name "GALE"; oId "uc001bia.2"; nearest_ref "uc001bia.2"; class_code "="; tss_id "TSS2244"; p_id "P3325"; chr1 coding exon 24123524 24123637 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004408"; exon_number "3"; gene_name "GALE"; oId "uc001bia.2"; nearest_ref "uc001bia.2"; class_code "="; tss_id "TSS2244"; p_id "P3325"; chr1 coding exon 24124577 24125220 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004409"; exon_number "1"; gene_name "GALE"; oId "uc009vqq.1"; nearest_ref "uc009vqq.1"; class_code "="; tss_id "TSS2243"; p_id "P3324"; chr1 coding exon 24125377 24125502 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004409"; exon_number "2"; gene_name "GALE"; oId "uc009vqq.1"; nearest_ref "uc009vqq.1"; class_code "="; tss_id "TSS2243"; p_id "P3324"; chr1 coding exon 24125856 24125926 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004409"; exon_number "3"; gene_name "GALE"; oId "uc009vqq.1"; nearest_ref "uc009vqq.1"; class_code "="; tss_id "TSS2243"; p_id "P3324"; chr1 coding exon 24127202 24127294 . - . gene_id "XLOC_001405"; transcript_id "TCONS_00004409"; exon_number "4"; gene_name "GALE"; oId "uc009vqq.1"; nearest_ref "uc009vqq.1"; class_code "="; tss_id "TSS2243"; p_id "P3324"; chr1 coding exon 24128368 24129054 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "1"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24130890 24131015 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "2"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24134625 24134813 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "3"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24143165 24143260 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "4"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24143966 24144073 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "5"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24147000 24147083 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "6"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24151846 24151949 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004412"; exon_number "7"; gene_name "HMGCL"; oId "uc010oec.1"; nearest_ref "uc010oec.1"; class_code "="; tss_id "TSS2245"; p_id "P3335"; chr1 coding exon 24128368 24129054 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004411"; exon_number "1"; gene_name "HMGCL"; oId "uc009vqr.2"; nearest_ref "uc009vqr.2"; class_code "="; tss_id "TSS2245"; p_id "P3334"; chr1 coding exon 24130890 24131015 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004411"; exon_number "2"; gene_name "HMGCL"; oId "uc009vqr.2"; nearest_ref "uc009vqr.2"; class_code "="; tss_id "TSS2245"; p_id "P3334"; chr1 coding exon 24134625 24134813 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004411"; exon_number "3"; gene_name "HMGCL"; oId "uc009vqr.2"; nearest_ref "uc009vqr.2"; class_code "="; tss_id "TSS2245"; p_id "P3334"; chr1 coding exon 24147000 24147083 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004411"; exon_number "4"; gene_name "HMGCL"; oId "uc009vqr.2"; nearest_ref "uc009vqr.2"; class_code "="; tss_id "TSS2245"; p_id "P3334"; chr1 coding exon 24151846 24151949 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004411"; exon_number "5"; gene_name "HMGCL"; oId "uc009vqr.2"; nearest_ref "uc009vqr.2"; class_code "="; tss_id "TSS2245"; p_id "P3334"; chr1 coding exon 24128368 24129054 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "1"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24130890 24131015 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "2"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24134625 24134813 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "3"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24137226 24137289 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "4"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24140680 24140828 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "5"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24143165 24143260 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "6"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24143966 24144073 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "7"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24147000 24147083 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "8"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24151846 24151949 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004410"; exon_number "9"; gene_name "HMGCL"; oId "uc001bib.2"; nearest_ref "uc001bib.2"; class_code "="; tss_id "TSS2245"; p_id "P3333"; chr1 coding exon 24128368 24129054 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "1"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24130890 24131015 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "2"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24134625 24134813 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "3"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24137226 24137289 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "4"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24140680 24140828 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "5"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24143165 24143260 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "6"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24143966 24144073 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "7"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24147000 24147083 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "8"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24152574 24152673 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "9"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24164554 24165110 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004413"; exon_number "10"; gene_name "HMGCL"; oId "uc001bic.2"; nearest_ref "uc001bic.2"; class_code "="; tss_id "TSS2246"; p_id "P3332"; chr1 coding exon 24130078 24131015 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004414"; exon_number "1"; gene_name "HMGCL"; oId "uc009vqs.1"; nearest_ref "uc009vqs.1"; class_code "="; tss_id "TSS2245"; p_id "P3331"; chr1 coding exon 24134625 24134705 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004414"; exon_number "2"; gene_name "HMGCL"; oId "uc009vqs.1"; nearest_ref "uc009vqs.1"; class_code "="; tss_id "TSS2245"; p_id "P3331"; chr1 coding exon 24143165 24143260 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004414"; exon_number "3"; gene_name "HMGCL"; oId "uc009vqs.1"; nearest_ref "uc009vqs.1"; class_code "="; tss_id "TSS2245"; p_id "P3331"; chr1 coding exon 24143966 24144073 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004414"; exon_number "4"; gene_name "HMGCL"; oId "uc009vqs.1"; nearest_ref "uc009vqs.1"; class_code "="; tss_id "TSS2245"; p_id "P3331"; chr1 coding exon 24147000 24147083 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004414"; exon_number "5"; gene_name "HMGCL"; oId "uc009vqs.1"; nearest_ref "uc009vqs.1"; class_code "="; tss_id "TSS2245"; p_id "P3331"; chr1 coding exon 24151846 24151949 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004414"; exon_number "6"; gene_name "HMGCL"; oId "uc009vqs.1"; nearest_ref "uc009vqs.1"; class_code "="; tss_id "TSS2245"; p_id "P3331"; chr1 coding exon 24135777 24137289 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004415"; exon_number "1"; gene_name "HMGCL"; oId "uc001bid.1"; nearest_ref "uc001bid.1"; class_code "="; tss_id "TSS2245"; p_id "P3330"; chr1 coding exon 24140680 24140828 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004415"; exon_number "2"; gene_name "HMGCL"; oId "uc001bid.1"; nearest_ref "uc001bid.1"; class_code "="; tss_id "TSS2245"; p_id "P3330"; chr1 coding exon 24143165 24143260 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004415"; exon_number "3"; gene_name "HMGCL"; oId "uc001bid.1"; nearest_ref "uc001bid.1"; class_code "="; tss_id "TSS2245"; p_id "P3330"; chr1 coding exon 24143966 24144073 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004415"; exon_number "4"; gene_name "HMGCL"; oId "uc001bid.1"; nearest_ref "uc001bid.1"; class_code "="; tss_id "TSS2245"; p_id "P3330"; chr1 coding exon 24147000 24147083 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004415"; exon_number "5"; gene_name "HMGCL"; oId "uc001bid.1"; nearest_ref "uc001bid.1"; class_code "="; tss_id "TSS2245"; p_id "P3330"; chr1 coding exon 24151846 24151949 . - . gene_id "XLOC_001406"; transcript_id "TCONS_00004415"; exon_number "6"; gene_name "HMGCL"; oId "uc001bid.1"; nearest_ref "uc001bid.1"; class_code "="; tss_id "TSS2245"; p_id "P3330"; chr1 coding exon 24171574 24172345 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "1"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24172564 24172663 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "2"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24175139 24175329 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "3"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24180850 24181050 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "4"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24186288 24186393 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "5"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24189624 24189761 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "6"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24191981 24192115 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "7"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 coding exon 24194388 24194821 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004416"; exon_number "8"; gene_name "FUCA1"; oId "uc001bie.2"; nearest_ref "uc001bie.2"; class_code "="; tss_id "TSS2247"; p_id "P3336"; chr1 nearCoding exon 24180850 24181050 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004417"; exon_number "1"; oId "uc009vqt.1"; nearest_ref "uc009vqt.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24186288 24186393 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004417"; exon_number "2"; oId "uc009vqt.1"; nearest_ref "uc009vqt.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24189624 24189761 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004417"; exon_number "3"; oId "uc009vqt.1"; nearest_ref "uc009vqt.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24191981 24192115 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004417"; exon_number "4"; oId "uc009vqt.1"; nearest_ref "uc009vqt.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24192400 24192461 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004417"; exon_number "5"; oId "uc009vqt.1"; nearest_ref "uc009vqt.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24194388 24194821 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004417"; exon_number "6"; oId "uc009vqt.1"; nearest_ref "uc009vqt.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24186288 24186393 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004418"; exon_number "1"; oId "uc010oed.1"; nearest_ref "uc010oed.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24189624 24189761 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004418"; exon_number "2"; oId "uc010oed.1"; nearest_ref "uc010oed.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24191981 24192115 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004418"; exon_number "3"; oId "uc010oed.1"; nearest_ref "uc010oed.1"; class_code "="; tss_id "TSS2247"; chr1 nearCoding exon 24194214 24194787 . - . gene_id "XLOC_001407"; transcript_id "TCONS_00004418"; exon_number "4"; oId "uc010oed.1"; nearest_ref "uc010oed.1"; class_code "="; tss_id "TSS2247"; chr1 coding exon 24200461 24202152 . - . gene_id "XLOC_001408"; transcript_id "TCONS_00004419"; exon_number "1"; gene_name "CNR2"; oId "uc001bif.2"; nearest_ref "uc001bif.2"; class_code "="; tss_id "TSS2248"; p_id "P3337"; chr1 coding exon 24239736 24239817 . - . gene_id "XLOC_001408"; transcript_id "TCONS_00004419"; exon_number "2"; gene_name "CNR2"; oId "uc001bif.2"; nearest_ref "uc001bif.2"; class_code "="; tss_id "TSS2248"; p_id "P3337"; chr1 coding exon 24292939 24294213 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004421"; exon_number "1"; gene_name "SFRS13A"; oId "uc010oee.1"; nearest_ref "uc010oee.1"; class_code "="; tss_id "TSS2249"; p_id "P3338"; chr1 coding exon 24298063 24298116 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004421"; exon_number "2"; gene_name "SFRS13A"; oId "uc010oee.1"; nearest_ref "uc010oee.1"; class_code "="; tss_id "TSS2249"; p_id "P3338"; chr1 coding exon 24298340 24298502 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004421"; exon_number "3"; gene_name "SFRS13A"; oId "uc010oee.1"; nearest_ref "uc010oee.1"; class_code "="; tss_id "TSS2249"; p_id "P3338"; chr1 coding exon 24301464 24301566 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004421"; exon_number "4"; gene_name "SFRS13A"; oId "uc010oee.1"; nearest_ref "uc010oee.1"; class_code "="; tss_id "TSS2249"; p_id "P3338"; chr1 coding exon 24305202 24305307 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004421"; exon_number "5"; gene_name "SFRS13A"; oId "uc010oee.1"; nearest_ref "uc010oee.1"; class_code "="; tss_id "TSS2249"; p_id "P3338"; chr1 coding exon 24306681 24306821 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004421"; exon_number "6"; gene_name "SFRS13A"; oId "uc010oee.1"; nearest_ref "uc010oee.1"; class_code "="; tss_id "TSS2249"; p_id "P3338"; chr1 nearCoding exon 24292939 24294213 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "1"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 nearCoding exon 24298063 24298116 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "2"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 nearCoding exon 24298340 24298502 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "3"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 nearCoding exon 24301464 24301541 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "4"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 nearCoding exon 24304401 24304763 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "5"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 nearCoding exon 24305143 24305307 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "6"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 nearCoding exon 24306681 24306821 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004420"; exon_number "7"; oId "uc001bij.1"; nearest_ref "uc001bij.1"; class_code "="; tss_id "TSS2249"; chr1 coding exon 24295573 24297929 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004422"; exon_number "1"; gene_name "SFRS13A"; oId "uc010oef.1"; nearest_ref "uc010oef.1"; class_code "="; tss_id "TSS2249"; p_id "P3339"; chr1 coding exon 24298063 24298116 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004422"; exon_number "2"; gene_name "SFRS13A"; oId "uc010oef.1"; nearest_ref "uc010oef.1"; class_code "="; tss_id "TSS2249"; p_id "P3339"; chr1 coding exon 24298340 24298502 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004422"; exon_number "3"; gene_name "SFRS13A"; oId "uc010oef.1"; nearest_ref "uc010oef.1"; class_code "="; tss_id "TSS2249"; p_id "P3339"; chr1 coding exon 24301464 24301566 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004422"; exon_number "4"; gene_name "SFRS13A"; oId "uc010oef.1"; nearest_ref "uc010oef.1"; class_code "="; tss_id "TSS2249"; p_id "P3339"; chr1 coding exon 24305202 24305307 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004422"; exon_number "5"; gene_name "SFRS13A"; oId "uc010oef.1"; nearest_ref "uc010oef.1"; class_code "="; tss_id "TSS2249"; p_id "P3339"; chr1 coding exon 24306681 24306821 . - . gene_id "XLOC_001409"; transcript_id "TCONS_00004422"; exon_number "6"; gene_name "SFRS13A"; oId "uc010oef.1"; nearest_ref "uc010oef.1"; class_code "="; tss_id "TSS2249"; p_id "P3339"; chr1 coding exon 24382532 24384117 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "1"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24385414 24385469 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "2"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24387550 24387572 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "3"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24387763 24387799 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "4"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24388436 24388599 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "5"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24389616 24389724 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "6"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24389982 24390020 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "7"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24390562 24390649 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "8"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24392381 24392491 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "9"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24392597 24393069 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004423"; exon_number "10"; gene_name "MYOM3"; oId "uc001bil.3"; nearest_ref "uc001bil.3"; class_code "="; tss_id "TSS2250"; p_id "P3343"; chr1 coding exon 24382532 24384117 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "1"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24385414 24385469 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "2"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24387550 24387572 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "3"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24387763 24387799 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "4"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24388436 24388599 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "5"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24389616 24389724 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "6"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24389982 24390020 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "7"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24390562 24390649 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "8"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24392381 24392491 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "9"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24393511 24393578 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "10"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24394460 24394519 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "11"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24394713 24394857 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "12"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24397607 24397743 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "13"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24398459 24398503 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "14"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24400650 24400759 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "15"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24401809 24401965 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "16"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24402649 24402763 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "17"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24406506 24406684 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "18"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24407820 24407946 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "19"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24408491 24408678 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "20"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24409083 24409204 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "21"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24410958 24411129 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "22"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24413134 24413317 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "23"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24416028 24416155 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "24"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24416555 24416608 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "25"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24417287 24417486 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "26"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24418664 24418805 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "27"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24419437 24419598 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "28"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24421343 24421493 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004424"; exon_number "29"; gene_name "MYOM3"; oId "uc001bim.3"; nearest_ref "uc001bim.3"; class_code "="; tss_id "TSS2251"; p_id "P3342"; chr1 coding exon 24382532 24384117 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "1"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24385414 24385469 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "2"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24387550 24387572 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "3"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24387763 24387799 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "4"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24388436 24388599 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "5"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24389616 24389724 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "6"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24389982 24390020 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "7"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24390562 24390649 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "8"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24392381 24392491 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "9"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24393511 24393578 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "10"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24394460 24394519 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "11"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24394713 24394857 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "12"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24397607 24397743 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "13"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24398459 24398503 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "14"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24400650 24400759 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "15"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24401809 24401965 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "16"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24402649 24402763 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "17"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24406506 24406684 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "18"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24407820 24407946 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "19"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24408491 24408678 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "20"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24409083 24409204 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "21"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24410958 24411129 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "22"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24413134 24413317 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "23"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24416028 24416155 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "24"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24416555 24416608 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "25"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24417287 24417486 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "26"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24418664 24418805 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "27"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24419437 24419598 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "28"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24421343 24421480 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "29"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24421932 24421976 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "30"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24424413 24424501 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "31"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24426170 24426265 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "32"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24432410 24432567 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "33"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24433563 24433722 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "34"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24434483 24434563 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "35"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24434966 24435144 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "36"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24438521 24438665 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004425"; exon_number "37"; gene_name "MYOM3"; oId "uc001bin.3"; nearest_ref "uc001bin.3"; class_code "="; tss_id "TSS2252"; p_id "P3341"; chr1 coding exon 24392138 24392491 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "1"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24393511 24393578 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "2"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24394460 24394519 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "3"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24394713 24394857 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "4"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24397607 24397743 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "5"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24398459 24398503 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "6"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24400650 24400759 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "7"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24401809 24401965 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "8"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24402649 24402763 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "9"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24406506 24406684 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "10"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24407820 24407946 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "11"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24408491 24408678 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "12"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24409083 24409204 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "13"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24410958 24411129 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "14"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24413134 24413317 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "15"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24416028 24416155 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "16"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24416555 24416608 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "17"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24417287 24417486 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "18"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24418664 24418805 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "19"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24419437 24419598 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "20"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24421343 24421480 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "21"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24421932 24421976 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "22"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24424413 24424501 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "23"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24426170 24426265 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "24"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24432410 24432567 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "25"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24433563 24433722 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "26"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24434483 24434563 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "27"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24434966 24435144 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "28"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24438521 24438665 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004426"; exon_number "29"; gene_name "MYOM3"; oId "uc001bio.2"; nearest_ref "uc001bio.2"; class_code "="; tss_id "TSS2252"; p_id "P3340"; chr1 coding exon 24408039 24411129 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "1"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24413134 24413317 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "2"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24416028 24416155 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "3"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24416555 24416608 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "4"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24417287 24417486 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "5"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24418664 24418805 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "6"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24419437 24419598 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "7"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24421343 24421480 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "8"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24421932 24421976 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "9"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24424413 24424501 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "10"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24426170 24426265 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "11"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24432410 24432567 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "12"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24433563 24433722 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "13"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24434483 24434929 . - . gene_id "XLOC_001410"; transcript_id "TCONS_00004427"; exon_number "14"; gene_name "MYOM3"; oId "uc001bip.1"; nearest_ref "uc001bip.1"; class_code "="; tss_id "TSS2253"; p_id "P3344"; chr1 coding exon 24446261 24448227 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004428"; exon_number "1"; gene_name "IL22RA1"; oId "uc010oeg.1"; nearest_ref "uc010oeg.1"; class_code "="; tss_id "TSS2254"; p_id "P3348"; chr1 coding exon 24449792 24450033 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004428"; exon_number "2"; gene_name "IL22RA1"; oId "uc010oeg.1"; nearest_ref "uc010oeg.1"; class_code "="; tss_id "TSS2254"; p_id "P3348"; chr1 coding exon 24454631 24454769 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004428"; exon_number "3"; gene_name "IL22RA1"; oId "uc010oeg.1"; nearest_ref "uc010oeg.1"; class_code "="; tss_id "TSS2254"; p_id "P3348"; chr1 coding exon 24460701 24460876 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004428"; exon_number "4"; gene_name "IL22RA1"; oId "uc010oeg.1"; nearest_ref "uc010oeg.1"; class_code "="; tss_id "TSS2254"; p_id "P3348"; chr1 coding exon 24463621 24463799 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004428"; exon_number "5"; gene_name "IL22RA1"; oId "uc010oeg.1"; nearest_ref "uc010oeg.1"; class_code "="; tss_id "TSS2254"; p_id "P3348"; chr1 coding exon 24446261 24447794 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "1"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24447868 24448227 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "2"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24449792 24449913 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "3"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24454631 24454769 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "4"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24460701 24460876 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "5"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24463621 24463799 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "6"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24465072 24465204 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "7"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24469530 24469611 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004431"; exon_number "8"; gene_name "IL22RA1"; oId "uc010oeh.1"; nearest_ref "uc010oeh.1"; class_code "="; tss_id "TSS2255"; p_id "P3347"; chr1 coding exon 24446261 24448227 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "1"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24449792 24449913 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "2"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24454631 24454769 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "3"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24460701 24460876 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "4"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24461372 24461426 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "5"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24463621 24463799 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "6"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24465072 24465204 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "7"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24469530 24469611 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004430"; exon_number "8"; gene_name "IL22RA1"; oId "uc009vrb.1"; nearest_ref "uc009vrb.1"; class_code "="; tss_id "TSS2255"; p_id "P3346"; chr1 coding exon 24446261 24448227 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "1"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24449792 24449913 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "2"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24454631 24454769 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "3"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24460701 24460876 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "4"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24463621 24463799 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "5"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24465072 24465204 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "6"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24469530 24469611 . - . gene_id "XLOC_001411"; transcript_id "TCONS_00004429"; exon_number "7"; gene_name "IL22RA1"; oId "uc001biq.1"; nearest_ref "uc001biq.1"; class_code "="; tss_id "TSS2255"; p_id "P3345"; chr1 coding exon 24480648 24484381 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004434"; exon_number "1"; gene_name "IL28RA"; oId "uc001bit.2"; nearest_ref "uc001bit.2"; class_code "="; tss_id "TSS2256"; p_id "P3353"; chr1 coding exon 24485964 24486123 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004434"; exon_number "2"; gene_name "IL28RA"; oId "uc001bit.2"; nearest_ref "uc001bit.2"; class_code "="; tss_id "TSS2256"; p_id "P3353"; chr1 coding exon 24488032 24488174 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004434"; exon_number "3"; gene_name "IL28RA"; oId "uc001bit.2"; nearest_ref "uc001bit.2"; class_code "="; tss_id "TSS2256"; p_id "P3353"; chr1 coding exon 24495907 24496091 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004434"; exon_number "4"; gene_name "IL28RA"; oId "uc001bit.2"; nearest_ref "uc001bit.2"; class_code "="; tss_id "TSS2256"; p_id "P3353"; chr1 coding exon 24507221 24507344 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004434"; exon_number "5"; gene_name "IL28RA"; oId "uc001bit.2"; nearest_ref "uc001bit.2"; class_code "="; tss_id "TSS2256"; p_id "P3353"; chr1 coding exon 24513681 24513751 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004434"; exon_number "6"; gene_name "IL28RA"; oId "uc001bit.2"; nearest_ref "uc001bit.2"; class_code "="; tss_id "TSS2256"; p_id "P3353"; chr1 coding exon 24480648 24484381 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004435"; exon_number "1"; gene_name "IL28RA"; oId "uc001biu.2"; nearest_ref "uc001biu.2"; class_code "="; tss_id "TSS2256"; p_id "P3352"; chr1 coding exon 24485542 24485672 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004435"; exon_number "2"; gene_name "IL28RA"; oId "uc001biu.2"; nearest_ref "uc001biu.2"; class_code "="; tss_id "TSS2256"; p_id "P3352"; chr1 coding exon 24485964 24486123 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004435"; exon_number "3"; gene_name "IL28RA"; oId "uc001biu.2"; nearest_ref "uc001biu.2"; class_code "="; tss_id "TSS2256"; p_id "P3352"; chr1 coding exon 24488032 24488174 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004435"; exon_number "4"; gene_name "IL28RA"; oId "uc001biu.2"; nearest_ref "uc001biu.2"; class_code "="; tss_id "TSS2256"; p_id "P3352"; chr1 coding exon 24495907 24496091 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004435"; exon_number "5"; gene_name "IL28RA"; oId "uc001biu.2"; nearest_ref "uc001biu.2"; class_code "="; tss_id "TSS2256"; p_id "P3352"; chr1 coding exon 24513681 24513751 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004435"; exon_number "6"; gene_name "IL28RA"; oId "uc001biu.2"; nearest_ref "uc001biu.2"; class_code "="; tss_id "TSS2256"; p_id "P3352"; chr1 coding exon 24480648 24484381 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "1"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24485542 24485672 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "2"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24485964 24486123 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "3"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24488032 24488174 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "4"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24495907 24496091 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "5"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24507221 24507344 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "6"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24513681 24513751 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004433"; exon_number "7"; gene_name "IL28RA"; oId "uc001bis.2"; nearest_ref "uc001bis.2"; class_code "="; tss_id "TSS2256"; p_id "P3349"; chr1 coding exon 24480648 24484294 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "1"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24485542 24485672 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "2"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24485964 24486123 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "3"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24488032 24488174 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "4"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24495907 24496091 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "5"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24507221 24507344 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "6"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24513681 24513751 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004432"; exon_number "7"; gene_name "IL28RA"; oId "uc001bir.2"; nearest_ref "uc001bir.2"; class_code "="; tss_id "TSS2256"; p_id "P3350"; chr1 coding exon 24487869 24488174 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004436"; exon_number "1"; gene_name "IL28RA"; oId "uc001biv.2"; nearest_ref "uc001biv.2"; class_code "="; tss_id "TSS2256"; p_id "P3351"; chr1 coding exon 24495907 24496091 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004436"; exon_number "2"; gene_name "IL28RA"; oId "uc001biv.2"; nearest_ref "uc001biv.2"; class_code "="; tss_id "TSS2256"; p_id "P3351"; chr1 coding exon 24507221 24507344 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004436"; exon_number "3"; gene_name "IL28RA"; oId "uc001biv.2"; nearest_ref "uc001biv.2"; class_code "="; tss_id "TSS2256"; p_id "P3351"; chr1 coding exon 24513681 24513751 . - . gene_id "XLOC_001412"; transcript_id "TCONS_00004436"; exon_number "4"; gene_name "IL28RA"; oId "uc001biv.2"; nearest_ref "uc001biv.2"; class_code "="; tss_id "TSS2256"; p_id "P3351"; chr1 noncoding exon 24580830 24580859 . - . gene_id "XLOC_001413"; transcript_id "TCONS_00004437"; exon_number "1"; oId "uc001biw.2"; nearest_ref "uc001biw.2"; class_code "="; chr1 coding exon 24683490 24685109 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004438"; exon_number "1"; gene_name "C1orf201"; oId "uc010oej.1"; nearest_ref "uc010oej.1"; class_code "="; tss_id "TSS2257"; p_id "P3358"; chr1 coding exon 24687341 24687355 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004438"; exon_number "2"; gene_name "C1orf201"; oId "uc010oej.1"; nearest_ref "uc010oej.1"; class_code "="; tss_id "TSS2257"; p_id "P3358"; chr1 coding exon 24687481 24687531 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004438"; exon_number "3"; gene_name "C1orf201"; oId "uc010oej.1"; nearest_ref "uc010oej.1"; class_code "="; tss_id "TSS2257"; p_id "P3358"; chr1 coding exon 24696164 24696329 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004438"; exon_number "4"; gene_name "C1orf201"; oId "uc010oej.1"; nearest_ref "uc010oej.1"; class_code "="; tss_id "TSS2257"; p_id "P3358"; chr1 coding exon 24700192 24700300 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004438"; exon_number "5"; gene_name "C1orf201"; oId "uc010oej.1"; nearest_ref "uc010oej.1"; class_code "="; tss_id "TSS2257"; p_id "P3358"; chr1 coding exon 24683490 24685109 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "1"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24687341 24687531 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "2"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24696164 24696329 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "3"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24700192 24700300 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "4"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24706143 24706313 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "5"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24710392 24710493 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "6"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24727809 24727946 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004439"; exon_number "7"; gene_name "C1orf201"; oId "uc001bja.2"; nearest_ref "uc001bja.2"; class_code "="; tss_id "TSS2258"; p_id "P3357"; chr1 coding exon 24683490 24685109 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "1"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24687341 24687531 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "2"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24696164 24696329 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "3"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24700192 24700300 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "4"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24706143 24706313 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "5"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24710392 24710493 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "6"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24718051 24718169 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "7"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24727809 24727946 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "8"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24740164 24740230 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004441"; exon_number "9"; gene_name "C1orf201"; oId "uc001bjc.2"; nearest_ref "uc001bjc.2"; class_code "="; tss_id "TSS2259"; p_id "P3356"; chr1 coding exon 24683490 24685109 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "1"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24687341 24687531 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "2"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24696164 24696329 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "3"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24700192 24700300 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "4"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24706143 24706313 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "5"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24710392 24710493 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "6"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24718051 24718169 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "7"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24718414 24718557 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "8"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24727809 24727946 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "9"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24740164 24740230 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004440"; exon_number "10"; gene_name "C1orf201"; oId "uc001bjb.2"; nearest_ref "uc001bjb.2"; class_code "="; tss_id "TSS2259"; p_id "P3355"; chr1 coding exon 24683490 24685109 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "1"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24687341 24687531 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "2"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24696164 24696329 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "3"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24700192 24700300 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "4"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24706143 24706313 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "5"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24710392 24710493 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "6"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24718051 24718169 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "7"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24727809 24727946 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "8"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24741401 24741587 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004442"; exon_number "9"; gene_name "C1orf201"; oId "uc001bjd.2"; nearest_ref "uc001bjd.2"; class_code "="; tss_id "TSS2260"; p_id "P3356"; chr1 coding exon 24695213 24696329 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004443"; exon_number "1"; gene_name "C1orf201"; oId "uc001bjf.2"; nearest_ref "uc001bjf.2"; class_code "="; tss_id "TSS2261"; p_id "P3354"; chr1 coding exon 24700192 24700300 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004443"; exon_number "2"; gene_name "C1orf201"; oId "uc001bjf.2"; nearest_ref "uc001bjf.2"; class_code "="; tss_id "TSS2261"; p_id "P3354"; chr1 coding exon 24706143 24706313 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004443"; exon_number "3"; gene_name "C1orf201"; oId "uc001bjf.2"; nearest_ref "uc001bjf.2"; class_code "="; tss_id "TSS2261"; p_id "P3354"; chr1 coding exon 24710357 24710493 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004443"; exon_number "4"; gene_name "C1orf201"; oId "uc001bjf.2"; nearest_ref "uc001bjf.2"; class_code "="; tss_id "TSS2261"; p_id "P3354"; chr1 coding exon 24718051 24718169 . - . gene_id "XLOC_001414"; transcript_id "TCONS_00004443"; exon_number "5"; gene_name "C1orf201"; oId "uc001bjf.2"; nearest_ref "uc001bjf.2"; class_code "="; tss_id "TSS2261"; p_id "P3354"; cummeRbund/inst/extdata/cuffData_schema.sql0000644000175200017520000005243514516004263022074 0ustar00biocbuildbiocbuild-- Creator: MySQL Workbench 5.2.33/ExportSQLite plugin 2009.12.02 -- Author: Loyal Goff -- Caption: New Model -- Project: Name of the project -- Changed: 2012-05-01 15:20 -- Created: 2011-05-02 12:52 PRAGMA foreign_keys = OFF; -- Schema: cuffData BEGIN; CREATE TABLE "genes"( "gene_id" VARCHAR(45) PRIMARY KEY NOT NULL, "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "gene_short_name" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT ); CREATE INDEX "genes.gsn_index" ON "genes"("gene_short_name"); CREATE INDEX "genes.cc_index" ON "genes"("class_code"); CREATE TABLE "biasData"( "biasData_id" INTEGER PRIMARY KEY NOT NULL ); CREATE TABLE "samples"( "sample_index" INTEGER NOT NULL, "sample_name" VARCHAR(45) PRIMARY KEY NOT NULL ); CREATE TABLE "TSS"( "TSS_group_id" VARCHAR(45) PRIMARY KEY NOT NULL, "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "gene_id" VARCHAR(45) NOT NULL, "gene_short_name" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT, CONSTRAINT "fk_TSS_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); CREATE INDEX "TSS.fk_TSS_genes1" ON "TSS"("gene_id"); CREATE TABLE "TSSData"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_TSSData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "TSSData.fk_TSSData_TSS1" ON "TSSData"("TSS_group_id"); CREATE INDEX "TSSData.fk_TSSData_samples1" ON "TSSData"("sample_name"); CREATE TABLE "CDS"( "CDS_id" VARCHAR(45) PRIMARY KEY NOT NULL, "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "gene_id" VARCHAR(45), "TSS_group_id" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT, "gene_short_name" VARCHAR(45), CONSTRAINT "fk_CDS_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_CDS_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id") ); CREATE INDEX "CDS.fk_CDS_genes1" ON "CDS"("gene_id"); CREATE INDEX "CDS.fk_CDS_TSS1" ON "CDS"("TSS_group_id"); CREATE TABLE "CDSData"( "CDS_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_CDSData_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "CDSData.fk_CDSData_CDS1" ON "CDSData"("CDS_id"); CREATE INDEX "CDSData.fk_CDSData_samples1" ON "CDSData"("sample_name"); CREATE TABLE "splicingDiffData"( "TSS_group_id" VARCHAR(45) NOT NULL, "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "JS_dist" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_splicingDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_splicingDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_splicingDiffData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_splicingDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); CREATE INDEX "splicingDiffData.fk_splicingDiffData_samples1" ON "splicingDiffData"("sample_1"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_samples2" ON "splicingDiffData"("sample_2"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_TSS1" ON "splicingDiffData"("TSS_group_id"); CREATE INDEX "splicingDiffData.fk_splicingDiffData_genes1" ON "splicingDiffData"("gene_id"); CREATE TABLE "TSSExpDiffData"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "ln_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_TSSExpDiffData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_TSSExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_TSS1" ON "TSSExpDiffData"("TSS_group_id"); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_samples1" ON "TSSExpDiffData"("sample_1"); CREATE INDEX "TSSExpDiffData.fk_TSSExpDiffData_samples2" ON "TSSExpDiffData"("sample_2"); CREATE INDEX "TSSExpDiffData.TSSExpDiffData_sig_index" ON "TSSExpDiffData"("test_stat","p_value","q_value","significant"); CREATE TABLE "CDSDiffData"( "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "JS_dist" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_CDSDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_CDSDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_CDSDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); CREATE INDEX "CDSDiffData.fk_CDSDiffData_samples1" ON "CDSDiffData"("sample_1"); CREATE INDEX "CDSDiffData.fk_CDSDiffData_samples2" ON "CDSDiffData"("sample_2"); CREATE INDEX "CDSDiffData.fk_CDSDiffData_genes1" ON "CDSDiffData"("gene_id"); CREATE TABLE "CDSExpDiffData"( "CDS_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "ln_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_CDSExpDiffData_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_CDSExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_CDS1" ON "CDSExpDiffData"("CDS_id"); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_samples1" ON "CDSExpDiffData"("sample_1"); CREATE INDEX "CDSExpDiffData.fk_CDSExpDiffData_samples2" ON "CDSExpDiffData"("sample_2"); CREATE INDEX "CDSExpDiffData.CDSExpDiffData_sig_index" ON "CDSExpDiffData"("test_stat","p_value","q_value","significant"); CREATE TABLE "promoterDiffData"( "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "JS_dist" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_promoterDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_promoterDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_promoterDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); CREATE INDEX "promoterDiffData.fk_promoterDiffData_genes1" ON "promoterDiffData"("gene_id"); CREATE INDEX "promoterDiffData.fk_promoterDiffData_samples1" ON "promoterDiffData"("sample_1"); CREATE INDEX "promoterDiffData.fk_promoterDiffData_samples2" ON "promoterDiffData"("sample_2"); CREATE TABLE "geneFeatures"( "gene_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_geneFeatures_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); CREATE INDEX "geneFeatures.fk_geneFeatures_genes1" ON "geneFeatures"("gene_id"); CREATE TABLE "TSSFeatures"( "TSS_group_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_TSSFeatures_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id") ); CREATE INDEX "TSSFeatures.fk_TSSFeatures_TSS1" ON "TSSFeatures"("TSS_group_id"); CREATE TABLE "CDSFeatures"( "CDS_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_CDSFeatures_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id") ); CREATE INDEX "CDSFeatures.fk_CDSFeatures_CDS1" ON "CDSFeatures"("CDS_id"); CREATE TABLE "model_transcripts"( "model_transcript_id" INTEGER PRIMARY KEY AUTOINCREMENT NOT NULL ); CREATE TABLE "geneCount"( "gene_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_geneCount_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); CREATE INDEX "geneCount.fk_geneCount_samples1" ON "geneCount"("sample_name"); CREATE INDEX "geneCount.fk_geneCount_genes1" ON "geneCount"("gene_id"); CREATE TABLE "CDSCount"( "CDS_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_CDSCount_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "CDSCount.fk_CDSCount_CDS1" ON "CDSCount"("CDS_id"); CREATE INDEX "CDSCount.fk_CDSCount_samples1" ON "CDSCount"("sample_name"); CREATE TABLE "TSSCount"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_TSSCount_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "TSSCount.fk_TSSCount_TSS1" ON "TSSCount"("TSS_group_id"); CREATE INDEX "TSSCount.fk_TSSCount_samples1" ON "TSSCount"("sample_name"); CREATE TABLE "replicates"( "file" INTEGER NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" VARCHAR(45), "rep_name" VARCHAR(45) PRIMARY KEY NOT NULL, "total_mass" FLOAT, "norm_mass" FLOAT, "internal_scale" FLOAT, "external_scale" FLOAT, CONSTRAINT "fk_replicates_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "replicates.fk_replicates_samples1" ON "replicates"("sample_name"); CREATE TABLE "geneReplicateData"( "gene_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INTEGER, "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneData_genes10" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_geneReplicateData_replicates1" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_geneReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "geneReplicateData.fk_geneReplicateData_genes1" ON "geneReplicateData"("gene_id"); CREATE INDEX "geneReplicateData.fk_geneReplicateData_replicates1" ON "geneReplicateData"("rep_name"); CREATE INDEX "geneReplicateData.fk_geneReplicateData_samples1" ON "geneReplicateData"("sample_name"); CREATE TABLE "CDSReplicateData"( "CDS_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INTEGER, "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneReplicateData_replicates100" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_CDSReplicateData_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_CDSReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "CDSReplicateData.fk_CDSReplicateData_replicates1" ON "CDSReplicateData"("rep_name"); CREATE INDEX "CDSReplicateData.fk_CDSReplicateData_CDS1" ON "CDSReplicateData"("CDS_id"); CREATE INDEX "CDSReplicateData.fk_CDSReplicateData_samples1" ON "CDSReplicateData"("sample_name"); CREATE TABLE "TSSReplicateData"( "TSS_group_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" VARCHAR(45), "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneReplicateData_replicates10000" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_TSSReplicateData_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_TSSReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "TSSReplicateData.fk_TSSReplicateData_replicates1" ON "TSSReplicateData"("rep_name"); CREATE INDEX "TSSReplicateData.fk_TSSReplicateData_TSS1" ON "TSSReplicateData"("TSS_group_id"); CREATE INDEX "TSSReplicateData.fk_TSSReplicateData_samples1" ON "TSSReplicateData"("sample_name"); CREATE TABLE "runInfo"( "param" VARCHAR(45), "value" TEXT ); CREATE TABLE "geneData"( "gene_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_geneData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_geneData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "geneData.fk_geneData_genes1" ON "geneData"("gene_id"); CREATE INDEX "geneData.fk_geneData_samples1" ON "geneData"("sample_name"); CREATE TABLE "phenoData"( "sample_name" VARCHAR(45) NOT NULL, "parameter" VARCHAR(45) NOT NULL, "value" VARCHAR(45), CONSTRAINT "fk_phenoData_samples" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "phenoData.fk_phenoData_samples" ON "phenoData"("sample_name"); CREATE TABLE "geneExpDiffData"( "gene_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "ln_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_geneExpDiffData_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_geneExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_geneExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_genes1" ON "geneExpDiffData"("gene_id"); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_samples1" ON "geneExpDiffData"("sample_1"); CREATE INDEX "geneExpDiffData.fk_geneExpDiffData_samples2" ON "geneExpDiffData"("sample_2"); CREATE INDEX "geneExpDiffData.geneExpDiff_status_index" ON "geneExpDiffData"("status"); CREATE INDEX "geneExpDiffData.geneExpDiff_sig_index" ON "geneExpDiffData"("significant","p_value","q_value","test_stat"); CREATE TABLE "isoforms"( "isoform_id" VARCHAR(45) PRIMARY KEY NOT NULL, "gene_id" VARCHAR(45), "CDS_id" VARCHAR(45), "gene_short_name" VARCHAR(45), "TSS_group_id" VARCHAR(45), "class_code" VARCHAR(45), "nearest_ref_id" VARCHAR(45), "locus" VARCHAR(45), "length" INTEGER, "coverage" FLOAT, CONSTRAINT "fk_isoforms_TSS1" FOREIGN KEY("TSS_group_id") REFERENCES "TSS"("TSS_group_id"), CONSTRAINT "fk_isoforms_CDS1" FOREIGN KEY("CDS_id") REFERENCES "CDS"("CDS_id"), CONSTRAINT "fk_isoforms_genes1" FOREIGN KEY("gene_id") REFERENCES "genes"("gene_id") ); CREATE INDEX "isoforms.fk_isoforms_TSS1" ON "isoforms"("TSS_group_id"); CREATE INDEX "isoforms.fk_isoforms_CDS1" ON "isoforms"("CDS_id"); CREATE INDEX "isoforms.fk_isoforms_genes1" ON "isoforms"("gene_id"); CREATE TABLE "isoformData"( "isoform_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "fpkm" FLOAT NOT NULL, "conf_hi" FLOAT, "conf_lo" FLOAT, "quant_status" VARCHAR(45), CONSTRAINT "fk_isoformData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_isoformData_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id") ); CREATE INDEX "isoformData.fk_isoformData_samples1" ON "isoformData"("sample_name"); CREATE INDEX "isoformData.fk_isoformData_isoforms1" ON "isoformData"("isoform_id"); CREATE TABLE "isoformExpDiffData"( "isoform_id" VARCHAR(45) NOT NULL, "sample_1" VARCHAR(45) NOT NULL, "sample_2" VARCHAR(45) NOT NULL, "status" VARCHAR(45), "value_1" FLOAT, "value_2" FLOAT, "ln_fold_change" FLOAT, "test_stat" FLOAT, "p_value" FLOAT, "q_value" FLOAT, "significant" VARCHAR(45), CONSTRAINT "fk_isoformExpDiffData_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id"), CONSTRAINT "fk_isoformExpDiffData_samples1" FOREIGN KEY("sample_1") REFERENCES "samples"("sample_name"), CONSTRAINT "fk_isoformExpDiffData_samples2" FOREIGN KEY("sample_2") REFERENCES "samples"("sample_name") ); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_isoforms1" ON "isoformExpDiffData"("isoform_id"); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_samples1" ON "isoformExpDiffData"("sample_1"); CREATE INDEX "isoformExpDiffData.fk_isoformExpDiffData_samples2" ON "isoformExpDiffData"("sample_2"); CREATE INDEX "isoformExpDiffData.isoformExpDiffData_sig_index" ON "isoformExpDiffData"("test_stat","p_value","q_value","significant"); CREATE TABLE "isoformFeatures"( "isoform_id" VARCHAR(45) NOT NULL, CONSTRAINT "fk_isoformFeatures_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id") ); CREATE INDEX "isoformFeatures.fk_isoformFeatures_isoforms1" ON "isoformFeatures"("isoform_id"); CREATE TABLE "features"( -- GTF Features (all lines/records from reference .gtf file) "feature_id" INTEGER PRIMARY KEY AUTOINCREMENT NOT NULL, "genes_gene_id" VARCHAR(45) NOT NULL, "isoforms_isoform_id" VARCHAR(45) NOT NULL, "seqname" VARCHAR(45) NOT NULL, "source" VARCHAR(45) NOT NULL, "type_id" INTEGER, "start" INTEGER, "end" INTEGER, "score" FLOAT, "strand" VARCHAR(45), "frame" VARCHAR(45), CONSTRAINT "fk_features_genes1" FOREIGN KEY("genes_gene_id") REFERENCES "genes"("gene_id"), CONSTRAINT "fk_features_isoforms1" FOREIGN KEY("isoforms_isoform_id") REFERENCES "isoforms"("isoform_id") ); CREATE INDEX "features.features_seqname_index" ON "features"("seqname"); CREATE INDEX "features.features_type_index" ON "features"("type_id"); CREATE INDEX "features.features_strand_index" ON "features"("strand"); CREATE INDEX "features.features_start_end_index" ON "features"("start","end"); CREATE INDEX "features.fk_features_genes1" ON "features"("genes_gene_id"); CREATE INDEX "features.fk_features_isoforms1" ON "features"("isoforms_isoform_id"); CREATE TABLE "attributes"( "attribute_lookup_id" INTEGER PRIMARY KEY AUTOINCREMENT NOT NULL, "feature_id" INTEGER NOT NULL, "attribute" VARCHAR(45) NOT NULL, "value" VARCHAR(45) NOT NULL, CONSTRAINT "fk_attribute_lookup_features1" FOREIGN KEY("feature_id") REFERENCES "features"("feature_id") ); CREATE INDEX "attributes.fk_attributes_feature_id" ON "attributes"("feature_id"); CREATE INDEX "attributes.attributes_attribute_index" ON "attributes"("attribute"); CREATE INDEX "attributes.attributes_value_index" ON "attributes"("value"); CREATE TABLE "isoformCount"( "isoform_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "count" FLOAT, "variance" FLOAT, "uncertainty" FLOAT, "dispersion" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_isoformCount_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id"), CONSTRAINT "fk_isoformCount_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "isoformCount.fk_isoformCount_isoforms1" ON "isoformCount"("isoform_id"); CREATE INDEX "isoformCount.fk_isoformCount_samples1" ON "isoformCount"("sample_name"); CREATE TABLE "isoformReplicateData"( "isoform_id" VARCHAR(45) NOT NULL, "sample_name" VARCHAR(45) NOT NULL, "replicate" INTEGER, "rep_name" VARCHAR(45) NOT NULL, "raw_frags" FLOAT, "internal_scaled_frags" FLOAT, "external_scaled_frags" FLOAT, "fpkm" FLOAT, "effective_length" FLOAT, "status" VARCHAR(45), CONSTRAINT "fk_geneReplicateData_replicates10" FOREIGN KEY("rep_name") REFERENCES "replicates"("rep_name"), CONSTRAINT "fk_isoformReplicateData_isoforms1" FOREIGN KEY("isoform_id") REFERENCES "isoforms"("isoform_id"), CONSTRAINT "fk_isoformReplicateData_samples1" FOREIGN KEY("sample_name") REFERENCES "samples"("sample_name") ); CREATE INDEX "isoformReplicateData.fk_isoformReplicateData_replicates1" ON "isoformReplicateData"("rep_name"); CREATE INDEX "isoformReplicateData.fk_isoformReplicateData_isoforms1" ON "isoformReplicateData"("isoform_id"); CREATE INDEX "isoformReplicateData.fk_isoformReplicateData_samples1" ON "isoformReplicateData"("sample_name"); COMMIT; cummeRbund/inst/extdata/gene_exp.diff0000644000175200017520000043315114516004263020740 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 log2(fold_change) test_stat p_value q_value significant XLOC_000001 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 20.2175 0.347386 -5.86292 0.713525 0.475521 1 no XLOC_000002 XLOC_000002 OR4F5 chr1:69090-70008 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000003 XLOC_000003 - chr1:321083-321114 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000004 XLOC_000004 - chr1:321145-321223 iPS hESC OK 0 697259 1.79769e+308 1.79769e+308 0.00857693 0.0210912 yes XLOC_000005 XLOC_000005 - chr1:322036-328580 iPS hESC OK 355.823 696.704 0.969385 -2.98373 0.00284757 0.00840284 yes XLOC_000006 XLOC_000006 OR4F16 chr1:367658-368595 iPS hESC NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_000007 XLOC_000007 - chr1:420205-421839 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000008 XLOC_000008 - chr1:566461-568045 iPS hESC OK 41712.9 91983.2 1.14088 -113.525 0 0 yes XLOC_000009 XLOC_000009 - chr1:568148-568842 iPS hESC OK 665.127 6464.44 3.28082 -7.79116 6.66134e-15 1.93179e-13 yes XLOC_000010 XLOC_000010 - chr1:568843-568912 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000011 XLOC_000011 - chr1:569326-570349 iPS hESC OK 7343.63 31401.9 2.09628 -9.65264 0 0 yes XLOC_000012 XLOC_000012 - chr1:763063-789740 iPS hESC OK 121.633 182.273 0.583564 -0.686162 0.492611 0.626756 no XLOC_000013 XLOC_000013 - chr1:791897-794579 iPS hESC OK 8.98318 28.2795 1.65446 -2.50677 0.012184 0.0278445 yes XLOC_000014 XLOC_000014 - chr1:846814-850328 iPS hESC OK 8.69571 27.5823 1.66536 -2.60317 0.00923651 0.0225157 yes XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 196.483 6.25295 -4.97373 1.35012 0.176976 0.275192 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 183.535 741.918 2.01521 -3.23717 0.00120722 0.00398147 yes XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC OK 6.18615 22.784 1.8809 -2.43828 0.0147571 0.0325742 yes XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC OK 550.84 987.18 0.84168 -1.85219 0.0639988 0.118292 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 iPS hESC OK 162.844 1857.6 3.51188 -10.5984 0 0 yes XLOC_000020 XLOC_000020 - chr1:995082-1001833 iPS hESC OK 22.5944 32.064 0.504988 -0.666955 0.504801 0.638402 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 iPS hESC NOTEST 0 1.64828 1.79769e+308 1.79769e+308 0.0567344 1 no XLOC_000022 XLOC_000022 - chr1:1102483-1102578 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000023 XLOC_000023 - chr1:1103242-1103332 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000024 XLOC_000024 - chr1:1104384-1104467 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC OK 0 16.6969 1.79769e+308 1.79769e+308 9.65945e-06 5.37987e-05 yes XLOC_000026 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS hESC OK 223.432 276.214 0.305947 -0.778231 0.436433 0.58168 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 8.76465 74.6629 3.09062 -5.0124 5.37559e-07 4.18599e-06 yes XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 356.49 790.008 1.14801 -1.45248 0.146367 0.234913 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC OK 140.404 187.156 0.414652 -0.925142 0.354892 0.492515 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC NOTEST 6.25639 2.57898 -1.27853 1.50397 0.132589 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 iPS hESC OK 252.561 553.309 1.13145 -1.44826 0.147543 0.23635 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 iPS hESC OK 7.20193 59.0363 3.03515 -2.01569 0.0438326 0.0839708 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC OK 228.717 528.289 1.20777 -2.82221 0.00476939 0.0126932 yes XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC OK 12.4598 69.2663 2.47488 -4.24277 2.20774e-05 0.000116044 yes XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 433.345 980.283 1.17768 -2.57232 0.0101018 0.0242041 yes XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC OK 620.789 1412.56 1.18613 -3.29121 0.000997564 0.00339656 yes XLOC_000037 XLOC_000037 - chr1:1535818-1543166 iPS hESC OK 2.79141 10.6728 1.93487 -1.28059 0.200338 0.30303 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 88.0884 576.289 2.70977 -2.47836 0.013199 0.0295221 yes XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC OK 13.4513 67.208 2.32089 -2.51104 0.0120375 0.0277524 yes XLOC_000040 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 19.4885 92.012 2.2392 -0.563224 0.573282 0.693713 no XLOC_000041 XLOC_000041 - chr1:1571099-1677431 iPS hESC OK 65.0308 78.5208 0.271951 -0.146899 0.883212 0.942616 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 iPS hESC NOTEST 4.99201 3.15678 -0.661169 0.445901 0.655669 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC OK 5.39767 26.9908 2.32206 -2.21879 0.0265012 0.0543598 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC OK 12.037 41.7053 1.79275 -2.92395 0.0034562 0.00981981 yes XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 323.37 984.342 1.60597 -2.63722 0.0083588 0.0206757 yes XLOC_000046 XLOC_000046 - chr1:1981908-2139172 iPS hESC OK 66.2174 109.688 0.728127 -0.674534 0.499972 0.633982 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC OK 246.057 740.008 1.58855 -4.88907 1.01312e-06 7.47401e-06 yes XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC OK 833.583 802.47 -0.0548773 0.173586 0.862191 0.93441 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 2.29682 2.31568 0.0117981 -0.00710896 0.994328 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC OK 48.2407 3.76675 -3.67886 2.14897 0.031637 0.0636524 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 438.685 857.758 0.967386 -2.59177 0.00954834 0.0231571 yes XLOC_000052 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 1.00749 5.29478 2.3938 -1.73866 0.0820952 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 166.428 367.393 1.14242 -2.47326 0.0133888 0.0298672 yes XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC OK 546.504 498.776 -0.131839 0.384888 0.700321 0.803506 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC OK 14.6918 75.1453 2.35467 -2.7235 0.00645943 0.0165118 yes XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC NOTEST 0.580625 2.99279 2.36581 -1.09786 0.272267 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 iPS hESC OK 29.1182 76.8718 1.40054 -1.91184 0.0558967 0.104465 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS hESC OK 72.973 120.109 0.718907 -1.2909 0.196737 0.299197 no XLOC_000060 XLOC_000060 - chr1:3816967-3833877 iPS hESC OK 6.8872 24.9595 1.8576 -1.68829 0.0913563 0.160734 no XLOC_000061 XLOC_000061 - chr1:4000676-4015322 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000062 XLOC_000062 - chr1:4472110-4484744 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC OK 104.444 73.9584 -0.497945 0.907909 0.363926 0.504221 no XLOC_000064 XLOC_000064 - chr1:4847557-4852182 iPS hESC OK 37.4079 18.1722 -1.04161 1.94277 0.0520441 0.0976989 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 74.6211 131.769 0.820359 -1.45981 0.144343 0.233447 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 77.5899 76.0702 -0.0285372 0.00869914 0.993059 0.994837 no XLOC_000067 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS hESC OK 56.5093 132.225 1.22643 -2.33032 0.0197893 0.0419214 yes XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC OK 435.49 1431.61 1.71693 -3.72325 0.000196678 0.000806858 yes XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 19 177.686 3.22526 -4.19897 2.68135e-05 0.000138344 yes XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 3.54524 1.25192 -1.50175 0.685297 0.493157 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC OK 181.164 326.257 0.848713 -1.79341 0.0729066 0.132143 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC OK 277.454 660.096 1.25043 -3.53483 0.00040804 0.00154577 yes XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 104.719 233.593 1.15747 -0.589908 0.555253 0.676764 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC OK 1285.68 1467.41 0.190746 -0.476281 0.633874 0.749729 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC OK 1500.64 502.334 -1.57886 5.54278 2.9771e-08 3.05335e-07 yes XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 291.457 117.867 -1.30612 2.4545 0.0141079 0.0313883 yes XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 4703.17 8447.87 0.844954 -2.90306 0.00369538 0.010325 yes XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 11.4332 39.6496 1.79408 -2.51083 0.0120447 0.0277524 yes XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC OK 137.324 93.0165 -0.562028 1.6203 0.105167 0.18124 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC OK 87.8037 86.131 -0.0277493 0.0532772 0.957511 0.979643 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC OK 216.702 229.284 0.0814236 -0.182156 0.85546 0.928312 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC OK 122.735 402.381 1.71301 -3.36739 0.000758831 0.00265907 yes XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 192.442 441.582 1.19826 -2.99778 0.00271956 0.00813933 yes XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC OK 61.6068 39.4422 -0.643349 1.29478 0.195395 0.298235 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC OK 115.178 229.575 0.995102 -1.81996 0.0687653 0.125448 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC OK 710.689 1147.31 0.690967 -1.64436 0.100103 0.17358 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 910.612 637.441 -0.514543 1.34997 0.177026 0.275192 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC OK 1416.9 7183.39 2.34193 -8.10241 4.44089e-16 1.69763e-14 yes XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 iPS hESC OK 284.879 259.775 -0.133086 0.226672 0.820678 0.896351 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS hESC OK 252.617 678.266 1.4249 -2.04944 0.0404188 0.0786856 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC OK 1918.99 2401.2 0.323411 -1.5344 0.124931 0.207717 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC OK 25.3243 0.912846 -4.794 0.836862 0.40267 0.546467 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC OK 358.008 307.383 -0.219953 0.645793 0.518413 0.644949 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC OK 49.6179 74.4396 0.585208 -0.654466 0.512812 0.642489 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 170.98 558.984 1.70898 -1.95982 0.0500163 0.0941023 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC OK 77.8716 25.5712 -1.60658 2.97333 0.00294584 0.00860227 yes XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC OK 200.894 340.257 0.760192 -1.7535 0.079517 0.142285 no XLOC_000099 XLOC_000099 - chr1:11782186-11785914 iPS hESC OK 138.448 209.081 0.594715 -1.45467 0.14576 0.234387 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 747.942 1610.7 1.10669 -2.58047 0.00986669 0.0237762 yes XLOC_000101 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS hESC NOTEST 4.69748 3.47934 -0.433073 0.2486 0.80367 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 1.75837 4.36698 1.3124 -0.199904 0.841556 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC OK 155.934 366.258 1.23193 -1.15552 0.247876 0.364447 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC OK 865.542 956.552 0.144239 -0.492575 0.622313 0.739216 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC OK 647.078 942.066 0.541888 -2.00047 0.0454496 0.0862824 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC OK 504.143 1223.51 1.27913 -3.41913 0.000628221 0.00226753 yes XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC OK 204.322 441.002 1.10994 -2.53971 0.0110944 0.0261355 yes XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC OK 15.3506 33.8648 1.14149 -2.08339 0.0372158 0.0736436 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 387.51 162.839 -1.25079 4.09571 4.20882e-05 0.000203426 yes XLOC_000110 XLOC_000110 SNORA59B chr1:12290112-12572096 iPS hESC OK 452.443 234.664 -0.947137 0.0823227 0.93439 0.966571 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC NOTEST 0.911079 1.34969 0.566981 -0.252834 0.800396 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC OK 56.4313 10.0548 -2.48861 4.5299 5.9011e-06 3.39919e-05 yes XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC NOTEST 1.78177 1.29047 -0.465419 0.106597 0.915109 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC NOTEST 3.60576 0.853096 -2.07952 1.38146 0.167139 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000123 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC NOTEST 0 0.330232 1.79769e+308 1.79769e+308 0.240869 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC OK 1297.74 1703.36 0.392385 -1.28629 0.198341 0.301092 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 243.069 157.143 -0.629293 1.28415 0.19909 0.301685 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 67.1093 159.342 1.24755 -2.04559 0.0407965 0.0792375 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 145.058 232.379 0.679849 -1.11249 0.265929 0.386264 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 5.81037 8.41368 0.534108 -0.6977 0.485365 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC OK 330.754 468.604 0.502608 -1.33415 0.182153 0.28212 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC NOTEST 2.23637 0 -1.79769e+308 -1.79769e+308 0.34141 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC NOTEST 0 1.27477 1.79769e+308 1.79769e+308 0.352721 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC OK 471.651 155.023 -1.60523 4.59816 4.26243e-06 2.56051e-05 yes XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 iPS hESC OK 1019.54 529.844 -0.944279 2.34312 0.0191231 0.0408186 yes XLOC_000138 XLOC_000138 - chr1:15992765-15995535 iPS hESC OK 252.085 304.42 0.27215 -0.705422 0.480548 0.617008 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC OK 363.264 779.207 1.10099 -3.38248 0.000718357 0.00252777 yes XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC NOTEST 8.47075 8.64413 0.0292302 -0.0371371 0.970376 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC OK 11.5611 31.4534 1.44394 -2.25831 0.0239262 0.0496838 yes XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 895.201 959.481 0.100041 -0.285483 0.775274 0.863584 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 185.864 381.608 1.03785 -3.70756 0.00020927 0.000850221 yes XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS hESC OK 24.3959 89.7145 1.8787 -0.617897 0.536643 0.661755 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 1222.98 1363.34 0.156745 -0.595518 0.551497 0.673163 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 574.66 535.864 -0.100841 0.26818 0.788561 0.877222 no XLOC_000148 XLOC_000148 - chr1:16860385-16864669 iPS hESC OK 8.40518 12.2273 0.540753 -0.429524 0.667542 0.77649 no XLOC_000149 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC OK 15.7802 119.12 2.91623 -2.98133 0.00287003 0.00843951 yes XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 158.894 626.539 1.97934 -2.57486 0.010028 0.0240958 yes XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 15.5386 4.12312 -1.91405 1.68927 0.0911682 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC OK 8.59656 12.671 0.559694 -0.832934 0.404882 0.548318 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC NOTEST 4.09774 4.49965 0.134984 -0.124904 0.900599 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC NOTEST 0 0.21117 1.79769e+308 1.79769e+308 0.240869 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 285.209 682.762 1.25936 -2.96445 0.00303223 0.00880275 yes XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC OK 9.62232 17.1125 0.830595 -1.21425 0.224654 0.334397 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC OK 61.0149 401.989 2.71992 -4.81351 1.48302e-06 1.04808e-05 yes XLOC_000158 XLOC_000158 - chr1:18434239-18704976 iPS hESC OK 1.3684 18.0164 3.71875 -0.765114 0.444204 0.586461 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC OK 104.809 217.548 1.05357 -2.52588 0.011541 0.0268864 yes XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 0.594028 0.969331 0.706458 -0.163503 0.870122 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC OK 773.162 961.74 0.314877 -0.996481 0.319017 0.452433 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 186.005 324.654 0.803561 -1.52997 0.126023 0.207717 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS hESC OK 713.47 816.248 0.194155 -0.473124 0.636125 0.750324 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC OK 3.39355 22.3161 2.71722 -2.91074 0.00360573 0.0101419 yes XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC OK 148.118 157.667 0.0901342 -0.250748 0.802009 0.889168 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0.482708 0.847143 0.811456 -0.189365 0.849807 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC NOTEST 0 0.361045 1.79769e+308 1.79769e+308 0.159889 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC OK 12.3177 17.9074 0.539819 -0.901624 0.367257 0.506332 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC OK 3.13664 19.2036 2.61409 -2.67495 0.00747394 0.0187629 yes XLOC_000170 XLOC_000170 FAM43B chr1:20878931-20881512 iPS hESC OK 1.9757 40.5541 4.35941 -4.17581 2.96933e-05 0.000151346 yes XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC OK 240.92 141.154 -0.771289 1.37456 0.169269 0.265094 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 640.208 441.939 -0.534694 1.58737 0.112429 0.191403 no XLOC_000173 XLOC_000173 - chr1:21543739-21672034 iPS hESC NOTEST 2.1975 7.51557 1.77402 -0.351856 0.724946 1 no XLOC_000174 XLOC_000174 - chr1:21761832-21762609 iPS hESC OK 0 12075.7 1.79769e+308 1.79769e+308 0.00556566 0.0145817 yes XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC OK 85.2069 59.4109 -0.520244 0.987282 0.323505 0.456569 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 953.058 5045.41 2.40434 -7.47991 7.43849e-14 1.78736e-12 yes XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC OK 22.7305 32.928 0.534684 -0.0755976 0.939739 0.96853 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 iPS hESC NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no XLOC_000179 XLOC_000179 - chr1:22351706-22357713 iPS hESC OK 497.821 431.878 -0.205005 0.446531 0.655214 0.768529 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 3644.56 1626.45 -1.16402 5.00502 5.58566e-07 4.30967e-06 yes XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC OK 130.91 221.871 0.761151 -1.46524 0.142855 0.231485 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC OK 33.3894 86.3015 1.37 -2.23977 0.0251058 0.0518772 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC OK 58.2137 301.66 2.37349 -5.4047 6.49186e-08 6.13445e-07 yes XLOC_000187 XLOC_000187 - chr1:23243782-23247347 iPS hESC NOTEST 1.74546 8.0467 2.20479 -2.29657 0.0216434 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 iPS hESC OK 2620.79 4034.49 0.622387 -2.50768 0.0121527 0.0278445 yes XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 15.7957 6.98703 -1.17678 0.22343 0.823201 1 no XLOC_000190 XLOC_000190 - chr1:23832921-23857713 iPS hESC NOTEST 7.64299 0.939918 -3.02353 1.15889 0.2465 1 no XLOC_000191 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC NOTEST 0.878724 0 -1.79769e+308 -1.79769e+308 0.349267 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 45081.3 74807 0.730643 -4.26956 1.95858e-05 0.000105587 yes XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC OK 755.461 523.425 -0.529375 2.00618 0.0448371 0.0853122 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC OK 1073.73 1208.06 0.170066 -0.526827 0.598314 0.715764 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 1047.53 2696.47 1.36408 -3.78556 0.000153361 0.000641675 yes XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC OK 2032.12 1015.28 -1.00111 4.04417 5.25091e-05 0.000246705 yes XLOC_000197 XLOC_000197 - chr1:24526729-24538180 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC OK 21.0142 24.5704 0.225562 -0.317454 0.750899 0.84829 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC OK 470.28 146.117 -1.68639 3.60982 0.000306411 0.00120982 yes XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC OK 373.245 131.842 -1.50132 2.94156 0.00326566 0.0093099 yes XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC NOTEST 1.31366 2.35713 0.84344 -0.758715 0.448023 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 1290.56 1796.38 0.477093 -1.54579 0.122154 0.203833 no XLOC_001217 XLOC_001217 - chr1:11873-29961 iPS hESC OK 1078.51 1083.74 0.00698505 -0.0135644 0.989178 0.994837 no XLOC_001218 XLOC_001218 - chr1:34611-36081 iPS hESC OK 13.7184 16.5503 0.270741 -0.371306 0.71041 0.813971 no XLOC_001219 XLOC_001219 - chr1:89294-237877 iPS hESC NOTEST 12.8434 2.45836 -2.38526 1.10269 0.270162 1 no XLOC_001220 XLOC_001220 - chr1:89294-237877 iPS hESC OK 342.399 634.855 0.890746 -2.10741 0.0350822 0.0697497 no XLOC_001221 XLOC_001221 OR4F16 chr1:621097-622034 iPS hESC NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 iPS hESC OK 443.364 1028.56 1.21406 -1.83484 0.0665289 0.122431 no XLOC_001223 XLOC_001223 - chr1:661139-679736 iPS hESC OK 0 697259 1.79769e+308 1.79769e+308 0.25307 0.3695 no XLOC_001224 XLOC_001224 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001225 XLOC_001225 - chr1:661139-679736 iPS hESC OK 0 697259 1.79769e+308 1.79769e+308 0.25307 0.3695 no XLOC_001226 XLOC_001226 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001227 XLOC_001227 - chr1:700236-714006 iPS hESC OK 247.682 235.71 -0.0714796 0.16032 0.872629 0.936801 no XLOC_001228 XLOC_001228 - chr1:761586-762902 iPS hESC OK 29.1742 19.6665 -0.568958 0.935249 0.34966 0.486056 no XLOC_001229 XLOC_001229 FAM41C chr1:803452-812182 iPS hESC NOTEST 17.3524 2.1691 -2.99997 3.22092 0.00127779 1 no XLOC_001230 XLOC_001230 - chr1:852952-854817 iPS hESC NOTEST 0 4.38548 1.79769e+308 1.79769e+308 0.237503 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 664.491 1835.15 1.46558 -3.40374 0.000664702 0.00237879 yes XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC OK 9.49353 15.2361 0.682474 -0.783221 0.433497 0.578684 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 iPS hESC OK 54.1565 37.4229 -0.533214 0.787619 0.43092 0.576158 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 95.4113 179.994 0.915714 -1.6193 0.105383 0.181242 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 iPS hESC NOTEST 0.346272 5.99833 4.11458 -1.36562 0.172057 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 3.83745 35.195 3.19715 -1.54712 0.121834 0.203703 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC NOTEST 1.29516 1.21775 -0.0889168 0.0280886 0.977591 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 961.909 1813.62 0.914904 -2.39634 0.0165595 0.0359859 yes XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC OK 17.131 41.9198 1.29102 -2.02163 0.043215 0.0831666 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 497.959 714.623 0.521154 -1.32801 0.184175 0.284726 no XLOC_001241 XLOC_001241 - chr1:1189293-1209234 iPS hESC OK 17.2606 37.017 1.10071 -0.741718 0.458258 0.599672 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 154.616 551.917 1.83576 -2.34376 0.0190906 0.0408186 yes XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 937.049 2544.24 1.44104 -3.1479 0.00164446 0.00517973 yes XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS hESC OK 275.675 1162.72 2.07646 -5.07011 3.97588e-07 3.21511e-06 yes XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 1079.39 153.319 -2.81562 6.91225 4.77018e-12 8.72114e-11 yes XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 2557.58 3660.17 0.517133 -1.58926 0.112001 0.19106 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 749.182 1238.98 0.725763 -2.16986 0.0300172 0.0608377 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC OK 3133.93 4356.64 0.47524 -1.41917 0.15585 0.247301 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 iPS hESC OK 55.0852 73.1639 0.409468 -0.654196 0.512985 0.642489 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC OK 31.9981 83.1162 1.37714 -2.19185 0.0283903 0.0578117 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 2379.43 3413.53 0.520646 -1.67432 0.0940685 0.164132 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC OK 321.824 2901.12 3.17227 -1.23257 0.217738 0.325832 no XLOC_001253 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS hESC OK 81.9647 251.238 1.61598 -0.407636 0.683541 0.791815 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 439.217 1155.8 1.39589 -2.29215 0.0218972 0.0459241 yes XLOC_001255 XLOC_001255 - chr1:1571099-1677431 iPS hESC OK 251.624 341.44 0.440361 -0.874388 0.381907 0.522916 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 483.898 1157.89 1.25872 -3.17466 0.0015001 0.00481521 yes XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC OK 4287.86 4821.37 0.169186 -0.902592 0.366742 0.506332 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 102.168 291.717 1.51363 -2.35368 0.0185885 0.0400155 yes XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC NOTEST 0 3.06699 1.79769e+308 1.79769e+308 0.0359621 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 1.6663 0.932315 -0.837758 0.453751 0.650008 1 no XLOC_001261 XLOC_001261 - chr1:1944651-1946969 iPS hESC NOTEST 4.28982 8.18597 0.932235 -1.04285 0.297016 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 iPS hESC OK 13.1667 33.574 1.35045 -0.211947 0.832149 0.904182 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC OK 426.51 1874.52 2.13587 -3.04583 0.00232038 0.00701957 yes XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC OK 54.986 109.55 0.994453 -1.01176 0.311655 0.442739 no XLOC_001265 XLOC_001265 - chr1:2252695-2322993 iPS hESC OK 54.2991 912.804 4.07131 -7.05004 1.78857e-12 3.5814e-11 yes XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC OK 290.341 461.866 0.669729 -1.0578 0.290149 0.417834 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC OK 174.785 361.252 1.04742 -2.54966 0.0107829 0.0256169 yes XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC NOTEST 6.35744 2.94754 -1.10894 0.97469 0.329714 1 no XLOC_001269 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 2.01017 1.1242 -0.838422 0.315996 0.752005 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC OK 0.931281 12.7571 3.77594 -0.543818 0.586567 0.705726 no XLOC_001271 XLOC_001271 - chr1:2976182-2980350 iPS hESC NOTEST 0.620738 0 -1.79769e+308 -1.79769e+308 0.23502 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC OK 113.568 219.592 0.951267 -2.00978 0.0444542 0.0847755 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 264.765 597.841 1.17505 -2.43355 0.0149514 0.0329166 yes XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC OK 201.581 433.574 1.10492 -3.30712 0.000942595 0.0032356 yes XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC OK 867.894 1345.43 0.632479 -2.16568 0.0303353 0.0613269 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 266.214 182.207 -0.547009 1.14487 0.252261 0.3695 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC OK 489.179 551.063 0.171855 -0.437761 0.66156 0.773813 no XLOC_001279 XLOC_001279 - chr1:5621768-5728315 iPS hESC NOTEST 0 0.669469 1.79769e+308 1.79769e+308 0.240869 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 61.5073 191.389 1.63768 -2.89935 0.00373936 0.0103789 yes XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC OK 14.4353 27.6918 0.939854 -1.05323 0.292236 0.419404 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC OK 2431.44 4375.01 0.847474 -3.23592 0.00121251 0.00398328 yes XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC OK 1479.52 1334.15 -0.149209 0.651214 0.514908 0.642489 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC OK 117.786 272.008 1.20748 -2.16981 0.030021 0.0608377 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 964.538 3559.21 0 0 1 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 5.92301 8.65963 0.547976 -0.833162 0.404754 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 iPS hESC OK 168.073 737.254 2.13308 -2.58718 0.00967652 0.0233849 yes XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC OK 503.823 189.708 -1.40913 4.12461 3.71357e-05 0.000182638 yes XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 243.714 368.135 0.595045 -1.5153 0.129696 0.211795 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC OK 743.808 1372.27 0.883559 -2.94362 0.00324394 0.00927943 yes XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 2.44962 0.950535 -1.36575 0.10801 0.913987 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC NOTEST 0 0.267901 1.79769e+308 1.79769e+308 0.240869 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 778.659 463.514 -0.748378 2.06607 0.0388215 0.0761045 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 274.268 987.152 1.84769 -4.48356 7.3409e-06 4.17142e-05 yes XLOC_001295 XLOC_001295 - chr1:8412465-8877699 iPS hESC NOTEST 20.7508 0 -1.79769e+308 -1.79769e+308 0.365376 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 22441.8 52641 1.23 -8.57684 0 0 yes XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC NOTEST 0 0.358204 1.79769e+308 1.79769e+308 0.238628 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 5.91022 2.9098 -1.02229 0.787925 0.43074 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC OK 37.0457 62.9264 0.764358 -0.884579 0.376384 0.51722 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 iPS hESC OK 95.9263 212.722 1.14897 -2.69957 0.00694287 0.0175872 yes XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC NOTEST 0 0.589835 1.79769e+308 1.79769e+308 0.430197 1 no XLOC_001302 XLOC_001302 - chr1:9711789-9884550 iPS hESC OK 86.8241 230.865 1.41088 -0.768268 0.442328 0.585231 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC OK 478.354 1730.22 1.85481 -4.78262 1.73023e-06 1.18303e-05 yes XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC OK 479.396 655.696 0.45181 -1.18064 0.237746 0.352014 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC OK 321.49 197.728 -0.701257 1.43635 0.150902 0.240357 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC OK 783.778 1126.41 0.523219 -1.52957 0.126123 0.207717 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 20.9583 109.537 2.38582 -2.52887 0.0114432 0.026807 yes XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 1.66867 4.3281 1.37503 -0.771281 0.440541 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC OK 75.0649 57.5421 -0.383521 0.715264 0.474446 0.612917 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC OK 2174 4914.1 1.17658 -3.30249 0.000958298 0.00327613 yes XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC OK 1430.05 1348.42 -0.0847953 0.321049 0.748173 0.847997 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC OK 637.839 1027.65 0.688089 -2.81068 0.00494365 0.0131155 yes XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC OK 308.762 1499.45 2.27986 -3.83818 0.000123951 0.000537334 yes XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC OK 4485.74 6757.57 0.59116 -2.41689 0.0156539 0.0343733 yes XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC OK 178.062 185.116 0.0560496 -0.0964087 0.923196 0.966377 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC OK 3.4039 10.2838 1.59511 -0.248783 0.803529 0.889168 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC OK 770.486 7.22153 -6.73732 7.91417 2.44249e-15 8.55889e-14 yes XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC OK 673.993 754.447 0.162686 -0.418068 0.675898 0.784041 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 1376.88 675.842 -1.02665 2.52444 0.0115882 0.0269217 yes XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC OK 162.796 2184.6 3.74623 -7.81032 5.77316e-15 1.73401e-13 yes XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 iPS hESC NOTEST 0.672346 0 -1.79769e+308 -1.79769e+308 0.398736 1 no XLOC_001325 XLOC_001325 - chr1:13182960-13183967 iPS hESC OK 22.2793 275.825 3.62998 -6.09934 1.0651e-09 1.31728e-08 yes XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS hESC NOTEST 0.200934 0 -1.79769e+308 -1.79769e+308 0.454078 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC NOTEST 6.96034 8.16584 0.230444 -0.308805 0.75747 1 no XLOC_001334 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS hESC NOTEST 8.04305 9.25388 0.202316 -0.165261 0.868738 1 no XLOC_001335 XLOC_001335 - chr1:15573767-15726776 iPS hESC NOTEST 0.432797 3.71564 3.10185 -1.10753 0.268064 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 394.058 432.032 0.13273 -0.293287 0.769303 0.859208 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC OK 122.09 115.866 -0.0754893 0.0853533 0.931981 0.966571 no XLOC_001338 XLOC_001338 - chr1:16133656-16134194 iPS hESC OK 7916.63 16097 1.02384 -3.79718 0.000146354 0.000616918 yes XLOC_001339 XLOC_001339 - chr1:16160709-16266950 iPS hESC OK 68.8094 58.2932 -0.239277 0.215806 0.829139 0.902831 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 179.279 335.879 0.905738 -1.52027 0.128444 0.210568 no XLOC_001341 XLOC_001341 - chr1:16317618-16317647 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 192.896 7.0982 -4.76423 5.45001 5.03657e-08 4.92529e-07 yes XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC OK 13.6398 25.9588 0.9284 -0.0958703 0.923624 0.966377 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC OK 257.159 575.636 1.16249 -2.40675 0.0160953 0.0351587 yes XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 173.274 1002.4 2.53234 -5.30549 1.12372e-07 1.01151e-06 yes XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC OK 28.2148 53.4824 0.922611 -1.70186 0.088781 0.15653 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC OK 353.356 268.262 -0.397482 0.991497 0.321443 0.455107 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 1.25463 0 -1.79769e+308 -1.79769e+308 0.44193 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 47.0375 173.076 1.87953 -2.20341 0.0275656 0.0564055 no XLOC_001350 XLOC_001350 - chr1:16860385-16864669 iPS hESC OK 23.1603 11.9908 -0.949728 1.38101 0.167277 0.262462 no XLOC_001351 XLOC_001351 - chr1:16888922-16890082 iPS hESC OK 223.564 175.981 -0.345265 0.727455 0.466947 0.60806 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 450.243 375.075 -0.263526 0.517352 0.60491 0.721602 no XLOC_001353 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 404.217 735.986 0.864549 -1.27091 0.203759 0.3071 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 iPS hESC OK 2.07327 14.5824 2.81425 -2.07993 0.0375321 0.0740951 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC OK 16.1249 41.4204 1.36105 -0.646988 0.51764 0.644941 no XLOC_001356 XLOC_001356 - chr1:17066767-17299474 iPS hESC OK 133.893 415.352 1.63325 -0.775952 0.437778 0.582549 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC OK 1947.53 4866.56 1.32126 -4.05307 5.05506e-05 0.000238837 yes XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 347.865 1430.58 2.04 -3.73811 0.000185412 0.00076437 yes XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC OK 1562.94 1548.47 -0.0134229 0.0414128 0.966967 0.982149 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC OK 31.43 66.1047 1.07261 -1.6239 0.104397 0.18058 no XLOC_001361 XLOC_001361 - chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC OK 3342.9 5456.99 0.707003 -3.54447 0.000393406 0.00150388 yes XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 264.069 652.489 1.30504 -3.0342 0.00241171 0.00726971 yes XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC OK 102.06 89.541 -0.188796 0.471554 0.637245 0.750593 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 878.439 2298.71 1.38781 -2.43909 0.0147242 0.0325742 yes XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 353.593 609.245 0.78493 -2.05363 0.0400116 0.0780736 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC OK 8.4734 11.7019 0.465724 -0.687357 0.491858 0.626746 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC OK 16.1619 17.2325 0.0925378 -0.140051 0.88862 0.947185 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC OK 363.217 695.576 0.937377 -2.0313 0.0422246 0.0816343 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 3724.87 5246.78 0.494242 -2.05681 0.0397047 0.0776549 no XLOC_001372 XLOC_001372 - chr1:19665273-19811992 iPS hESC OK 37.4567 15.7099 -1.25355 0.552166 0.580835 0.700835 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC OK 79.6954 67.0477 -0.249309 0.241365 0.809272 0.892174 no XLOC_001374 XLOC_001374 RNF186 chr1:20140522-20141771 iPS hESC NOTEST 1.07721 0.423276 -1.34763 0.461523 0.644423 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC OK 134.324 35.1082 -1.93584 2.65499 0.00793108 0.0197339 yes XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001379 XLOC_001379 - chr1:20687597-20755275 iPS hESC NOTEST 0 0.74001 1.79769e+308 1.79769e+308 0.239739 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC OK 335.378 130.773 -1.35873 2.48125 0.0130922 0.02944 yes XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC OK 392.307 351.837 -0.157076 0.430656 0.666719 0.77649 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC OK 4463.42 4991.33 0.161274 -0.762379 0.445834 0.58769 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC OK 66.5994 171.982 1.36868 -2.27317 0.0230162 0.0480314 yes XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC OK 73.6913 306.55 2.05656 -3.79814 0.000145789 0.000616918 yes XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 1913.33 1065.05 -0.845162 2.53062 0.0113861 0.0267478 yes XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 1166.43 707.133 -0.722053 2.35337 0.0186041 0.0400155 yes XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 228.564 567.103 1.31101 -3.05117 0.00227954 0.00693138 yes XLOC_001388 XLOC_001388 - chr1:21543739-21672034 iPS hESC NOTEST 8.5531 0.863796 -3.30769 0.721023 0.470896 1 no XLOC_001389 XLOC_001389 - chr1:21749600-21754300 iPS hESC OK 100.478 59.716 -0.750686 1.55954 0.118868 0.199936 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 56.0998 178.62 1.67082 -2.74844 0.00598805 0.0154952 yes XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 1144.32 815.156 -0.489343 1.51715 0.12923 0.211444 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 159.269 1050.98 2.7222 -2.31819 0.020439 0.0431889 yes XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC OK 15.9525 73.6692 2.20728 -4.17744 2.94803e-05 0.000151176 yes XLOC_001394 XLOC_001394 - chr1:23337326-23342343 iPS hESC NOTEST 3.40123 1.30651 -1.38034 0.472724 0.63641 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC OK 860.605 435.794 -0.981705 4.10013 4.12911e-05 0.000200727 yes XLOC_001396 XLOC_001396 HTR1D chr1:23518388-23521222 iPS hESC OK 223.865 138.505 -0.692693 1.72089 0.0852712 0.151293 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 3142.27 3020.37 -0.0570851 0.238614 0.811405 0.893183 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC OK 60.989 18.4192 -1.72734 2.62111 0.00876433 0.0214892 yes XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC OK 134.779 6.26106 -4.42804 3.2598 0.00111492 0.00371408 yes XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 303.901 762.709 1.32753 -3.27845 0.00104379 0.0035254 yes XLOC_001401 XLOC_001401 - chr1:23755055-23811057 iPS hESC NOTEST 14.3352 1.51415 -3.24298 0.863087 0.38809 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC OK 17.3678 95.4288 2.45801 -4.53767 5.68796e-06 3.29902e-05 yes XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC OK 2524.02 3183.79 0.335021 -1.07132 0.284027 0.40972 no XLOC_001404 XLOC_001404 - chr1:24069855-24104777 iPS hESC OK 29.788 77.4967 1.37941 -0.241165 0.809427 0.892174 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 309.118 568.398 0.878744 -1.43376 0.15164 0.241076 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 216.788 359.074 0.727995 -1.33645 0.181404 0.281477 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC OK 207.2 132.316 -0.647036 1.48317 0.138028 0.22453 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC OK 2102.35 1582.97 -0.409363 1.38946 0.164691 0.260349 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 3.09627 3.93809 0.346963 -0.268976 0.787948 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 6.64523 7.00921 0.0769314 -0.10749 0.914401 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 99.4363 206.886 1.05699 -0.825469 0.409105 0.553001 no XLOC_001413 XLOC_001413 - chr1:24580829-24580859 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC OK 164.974 152.011 -0.118064 0.226986 0.820435 0.896351 no XLOC_000001 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts OK 20.2175 16.1506 -0.324017 0.0343416 0.972605 0.985785 no XLOC_000002 XLOC_000002 OR4F5 chr1:69090-70008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000003 XLOC_000003 - chr1:321083-321114 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000004 XLOC_000004 - chr1:321145-321223 iPS Fibroblasts OK 0 14237.7 1.79769e+308 1.79769e+308 0.328042 0.460574 no XLOC_000005 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 355.823 48.0566 -2.88836 4.07283 4.64455e-05 0.000220682 yes XLOC_000006 XLOC_000006 OR4F16 chr1:367658-368595 iPS Fibroblasts NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_000007 XLOC_000007 - chr1:420205-421839 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000008 XLOC_000008 - chr1:566461-568045 iPS Fibroblasts OK 41712.9 69492.5 0.736363 -3.15392 0.00161094 0.00509323 yes XLOC_000009 XLOC_000009 - chr1:568148-568842 iPS Fibroblasts OK 665.127 26012.6 5.28944 -8.42916 0 0 yes XLOC_000010 XLOC_000010 - chr1:568843-568912 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000011 XLOC_000011 - chr1:569326-570349 iPS Fibroblasts OK 7343.63 37535.9 2.35371 -4.48577 7.26496e-06 4.15635e-05 yes XLOC_000012 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts OK 121.633 292.077 1.26381 -1.05641 0.290782 0.418031 no XLOC_000013 XLOC_000013 - chr1:791897-794579 iPS Fibroblasts OK 8.98318 74.5004 3.05195 -3.80203 0.000143517 0.000612679 yes XLOC_000014 XLOC_000014 - chr1:846814-850328 iPS Fibroblasts NOTEST 8.69571 0.58031 -3.90541 2.88572 0.00390514 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 196.483 38.7341 -2.34273 0.293642 0.769031 0.859208 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 183.535 347.16 0.919551 -1.10817 0.267787 0.38829 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts OK 6.18615 59.3098 3.26116 -3.26906 0.00107904 0.00361544 yes XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts OK 550.84 3379.09 2.61693 -4.82844 1.37606e-06 9.80735e-06 yes XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts OK 162.844 2553.38 3.97085 -8.29349 0 0 yes XLOC_000020 XLOC_000020 - chr1:995082-1001833 iPS Fibroblasts OK 22.5944 70.3957 1.63952 -1.68346 0.0922859 0.16203 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000022 XLOC_000022 - chr1:1102483-1102578 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000023 XLOC_000023 - chr1:1103242-1103332 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000024 XLOC_000024 - chr1:1104384-1104467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000026 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS Fibroblasts OK 223.432 1068.96 2.25829 -4.69611 2.65164e-06 1.68942e-05 yes XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 8.76465 63.4772 2.85647 -3.2569 0.00112638 0.00372947 yes XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 356.49 871.528 1.28969 -0.76785 0.442577 0.585231 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts OK 140.404 781.158 2.47603 -4.62916 3.67149e-06 2.25381e-05 yes XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts NOTEST 6.25639 4.31837 -0.534842 0.552796 0.580403 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 252.561 567.727 1.16856 -1.04071 0.298009 0.42551 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 7.20193 0 -1.79769e+308 -1.79769e+308 0.163163 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts OK 228.717 473.976 1.05125 -1.90032 0.0573916 0.107021 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts OK 12.4598 15.5201 0.316864 -0.390484 0.696179 0.803136 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 433.345 794.244 0.874065 -1.47426 0.140412 0.227966 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 620.789 2075.75 1.74146 -3.59419 0.000325405 0.00127881 yes XLOC_000037 XLOC_000037 - chr1:1535818-1543166 iPS Fibroblasts NOTEST 2.79141 5.74721 1.04187 -0.592847 0.553283 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 88.0884 593.05 2.75113 -2.40418 0.0162089 0.0353152 yes XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts OK 13.4513 26.2041 0.96205 -0.696882 0.485877 0.621952 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts OK 19.4885 93.5344 2.26288 -0.0514611 0.958958 0.979932 no XLOC_000041 XLOC_000041 - chr1:1571099-1677431 iPS Fibroblasts OK 65.0308 84.1606 0.37202 -0.0435204 0.965287 0.98172 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts NOTEST 4.99201 11.254 1.17274 -0.821142 0.411566 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 5.39767 1.08118 -2.31973 1.23799 0.215719 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 12.037 0.393202 -4.93606 2.5189 0.0117721 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 323.37 90.8985 -1.83086 1.04905 0.294156 0.420723 no XLOC_000046 XLOC_000046 - chr1:1981908-2139172 iPS Fibroblasts OK 66.2174 100.493 0.601808 -0.400478 0.688805 0.796002 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts OK 246.057 1645.91 2.74182 -6.24327 4.28516e-10 5.81262e-09 yes XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts OK 833.583 3941.6 2.24138 -4.84468 1.26815e-06 9.11547e-06 yes XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 2.29682 2.63403 0.197634 -0.084887 0.932351 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 48.2407 887.589 4.20157 -2.94606 0.00321855 0.00926986 yes XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 438.685 1288.7 1.55466 -3.07037 0.00213791 0.00658601 yes XLOC_000052 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 1.00749 8.22698 3.0296 -2.03146 0.0422079 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts OK 166.428 4.78554 -5.12008 3.95396 7.6868e-05 0.000347559 yes XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts OK 546.504 2696.46 2.30276 -5.16021 2.46673e-07 2.11686e-06 yes XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 14.6918 4.39049 -1.74256 1.38378 0.166425 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts NOTEST 0.580625 0.344217 -0.754289 0.269747 0.787355 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts OK 29.1182 58.9016 1.01639 -1.08029 0.280014 0.404625 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS Fibroblasts OK 72.973 116.754 0.678035 -0.948977 0.342632 0.477076 no XLOC_000060 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 6.8872 4.27286 -0.688717 0.457597 0.647242 1 no XLOC_000061 XLOC_000061 - chr1:4000676-4015322 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000062 XLOC_000062 - chr1:4472110-4484744 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts OK 104.444 1.26614 -6.36615 4.75544 1.98018e-06 1.32169e-05 yes XLOC_000064 XLOC_000064 - chr1:4847557-4852182 iPS Fibroblasts OK 37.4079 0.154615 -7.91852 4.08795 4.35194e-05 0.000209142 yes XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 74.6211 103.077 0.466065 -0.628742 0.529518 0.654889 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts OK 77.5899 67.9405 -0.191597 0.0120081 0.990419 0.994837 no XLOC_000067 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS Fibroblasts OK 56.5093 4.35392 -3.6981 3.5032 0.000459696 0.00172591 yes XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts OK 435.49 0 -1.79769e+308 -1.79769e+308 0.000567569 0.00205744 yes XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 19 0.205083 -6.53365 2.57338 0.0100711 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 3.54524 5.4957 0.63242 -0.359075 0.719539 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts OK 181.164 252.631 0.479732 -0.718656 0.472353 0.611152 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts OK 277.454 769.313 1.47132 -3.21767 0.00129234 0.00419638 yes XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 104.719 558.455 2.41491 -1.09593 0.273108 0.395326 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts OK 1285.68 3198.34 1.31479 -2.61586 0.0089002 0.0217589 yes XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts OK 1500.64 7098.44 2.24192 -5.37272 7.75556e-08 7.1675e-07 yes XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 291.457 358.538 0.298842 -0.43031 0.66697 0.77649 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 4703.17 21648.9 2.20259 -4.60207 4.18305e-06 2.53089e-05 yes XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 11.4332 212.078 4.2133 -4.80727 1.53005e-06 1.06345e-05 yes XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts OK 137.324 1112.18 3.01773 -6.69857 2.10465e-11 3.40387e-10 yes XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts OK 87.8037 876.41 3.31925 -5.5439 2.95804e-08 3.05335e-07 yes XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts OK 216.702 266.339 0.297552 -0.460364 0.645255 0.757904 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts OK 122.735 330.695 1.42995 -2.23236 0.025591 0.05275 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 192.442 175.884 -0.129794 0.0339821 0.972891 0.985785 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts OK 61.6068 319.369 2.37406 -4.08642 4.38084e-05 0.000209335 yes XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts OK 115.178 19.7819 -2.54161 2.84301 0.00446892 0.012046 yes XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts OK 710.689 1440.88 1.01966 -1.56275 0.118112 0.199062 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 910.612 1046.38 0.200493 -0.285745 0.775073 0.863584 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts OK 1416.9 13970.1 3.30153 -6.65003 2.93028e-11 4.40065e-10 yes XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 iPS Fibroblasts OK 284.879 663.444 1.21962 -1.67467 0.0939998 0.164132 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS Fibroblasts OK 252.617 1632.34 2.69192 -2.63313 0.00846012 0.020865 yes XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts OK 1918.99 2744.34 0.516115 -1.38416 0.16631 0.261433 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts OK 25.3243 10.571 -1.26041 0.228828 0.819003 0.896351 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts OK 358.008 332.294 -0.10753 0.227893 0.81973 0.896351 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts OK 49.6179 0.546311 -6.505 3.45961 0.000540964 0.00197805 yes XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 170.98 425.638 1.3158 -1.30949 0.190367 0.292863 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts OK 77.8716 363.317 2.22206 -3.49068 0.000481788 0.00178961 yes XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts OK 200.894 11.5677 -4.11826 4.62994 3.65767e-06 2.25381e-05 yes XLOC_000099 XLOC_000099 - chr1:11782186-11785914 iPS Fibroblasts OK 138.448 6.38178 -4.43925 5.28305 1.27049e-07 1.12471e-06 yes XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 747.942 1911.82 1.35395 -2.52663 0.0115162 0.0268864 yes XLOC_000101 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS Fibroblasts NOTEST 4.69748 1.86471 -1.33293 0.629152 0.529249 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 1.75837 8.96806 2.35056 -0.118497 0.905674 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts OK 155.934 585.495 1.90872 -1.29865 0.194065 0.296744 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts OK 865.542 10441.6 3.5926 -6.85911 6.9289e-12 1.23983e-10 yes XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts OK 647.078 2871.51 2.1498 -5.10134 3.3726e-07 2.75374e-06 yes XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts OK 504.143 575.01 0.189755 -0.366506 0.713987 0.816957 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts OK 204.322 8.49796 -4.58758 3.39196 0.000693942 0.00245259 yes XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts OK 15.3506 1395.94 6.5068 -10.8043 0 0 yes XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 387.51 354.401 -0.128853 0.249172 0.803228 0.889168 no XLOC_000110 XLOC_000110 SNORA59B chr1:12290112-12572096 iPS Fibroblasts OK 452.443 63.6142 -2.83031 0.0878811 0.929971 0.966571 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts NOTEST 0.911079 0 -1.79769e+308 -1.79769e+308 0.23502 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts OK 56.4313 0 -1.79769e+308 -1.79769e+308 0.00123708 0.00403251 yes XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts NOTEST 1.78177 0 -1.79769e+308 -1.79769e+308 0.345744 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts NOTEST 3.60576 0 -1.79769e+308 -1.79769e+308 0.0603368 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000123 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts OK 1297.74 111.012 -3.54721 6.16629 6.99114e-10 9.18679e-09 yes XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 243.069 476.725 0.971791 -1.52811 0.126485 0.207761 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 67.1093 477.168 2.82991 -4.04128 5.3161e-05 0.00024838 yes XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 145.058 714.037 2.29937 -3.25919 0.00111732 0.00371408 yes XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 5.81037 3.72788 -0.640273 0.482642 0.62935 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts OK 330.754 2197 2.7317 -5.82153 5.83102e-09 6.62688e-08 yes XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts NOTEST 2.23637 5.61806 1.32891 -0.360035 0.718821 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 471.651 378.574 -0.317145 0.610035 0.541839 0.666208 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 iPS Fibroblasts OK 1019.54 687.356 -0.568791 0.987166 0.323561 0.456569 no XLOC_000138 XLOC_000138 - chr1:15992765-15995535 iPS Fibroblasts OK 252.085 236.84 -0.0899987 0.166835 0.8675 0.936801 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts OK 363.264 2346.33 2.69132 -6.1413 8.18468e-10 1.04293e-08 yes XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts OK 8.47075 13.9977 0.724627 -0.612628 0.540122 0.66507 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 11.5611 0 -1.79769e+308 -1.79769e+308 0.00828204 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 895.201 2443.99 1.44896 -2.77977 0.00543971 0.0142962 yes XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 185.864 461.983 1.31359 -2.99631 0.00273265 0.00814951 yes XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS Fibroblasts OK 24.3959 2.11931 -3.52497 0.475082 0.634729 0.749729 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 1222.98 5311.2 2.11864 -4.591 4.41137e-06 2.63118e-05 yes XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 574.66 3729.9 2.69836 -5.62585 1.84596e-08 1.99032e-07 yes XLOC_000148 XLOC_000148 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 8.40518 1.32866 -2.66131 1.60784 0.107871 1 no XLOC_000149 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts OK 15.7802 14.8477 -0.0878734 0.0645698 0.948517 0.975186 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 158.894 169.437 0.0926811 -0.100538 0.919917 0.966377 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 15.5386 0.513942 -4.91811 2.02159 0.0432185 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 8.59656 0.32407 -4.72938 2.78066 0.00542479 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts NOTEST 4.09774 0 -1.79769e+308 -1.79769e+308 0.0386699 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 285.209 673.972 1.24067 -2.129 0.0332545 0.0664301 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 9.62232 6.95204 -0.468948 0.497417 0.618895 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts OK 61.0149 0 -1.79769e+308 -1.79769e+308 0.00438279 0.0118519 yes XLOC_000158 XLOC_000158 - chr1:18434239-18704976 iPS Fibroblasts NOTEST 1.3684 0 -1.79769e+308 -1.79769e+308 0.381589 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts OK 104.809 0.745204 -7.13591 5.84916 4.94056e-09 5.6918e-08 yes XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 0.594028 0 -1.79769e+308 -1.79769e+308 0.366238 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts OK 773.162 1651.61 1.09504 -2.54218 0.0110164 0.0260247 yes XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 186.005 587.782 1.65994 -2.4794 0.0131605 0.0295147 yes XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 713.47 12629.3 4.14578 -6.58719 4.48224e-11 6.38909e-10 yes XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 3.39355 0 -1.79769e+308 -1.79769e+308 0.0558829 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts OK 148.118 87.3998 -0.761045 1.44569 0.148264 0.236604 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts OK 0.482708 149.334 8.27318 -2.01592 0.0438088 0.0839708 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 12.3177 0.492177 -4.64542 3.23168 0.00123066 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 3.13664 0.572911 -2.45283 1.46863 0.141933 1 no XLOC_000170 XLOC_000170 FAM43B chr1:20878931-20881512 iPS Fibroblasts NOTEST 1.9757 1.55058 -0.349553 0.253507 0.799876 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts OK 240.92 232.113 -0.0537261 0.076991 0.938631 0.96853 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 640.208 3045.93 2.25027 -4.80789 1.52532e-06 1.06345e-05 yes XLOC_000173 XLOC_000173 - chr1:21543739-21672034 iPS Fibroblasts NOTEST 2.1975 3.33508 0.601856 -0.0238642 0.980961 1 no XLOC_000174 XLOC_000174 - chr1:21761832-21762609 iPS Fibroblasts OK 0 7652.6 1.79769e+308 1.79769e+308 0.0471877 0.0891794 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 85.2069 528.734 2.6335 -4.2785 1.88156e-05 0.00010209 yes XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts OK 953.058 66.8214 -3.83418 4.73638 2.17566e-06 1.44073e-05 yes XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts OK 22.7305 183.25 3.01111 -0.0254501 0.979696 0.991485 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 iPS Fibroblasts NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no XLOC_000179 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts OK 497.821 533.595 0.100116 -0.161086 0.872026 0.936801 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 3644.56 9892.47 1.44059 -3.31548 0.000914851 0.00316621 yes XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts OK 130.91 230.381 0.815449 -1.22544 0.22041 0.329245 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts OK 33.3894 0 -1.79769e+308 -1.79769e+308 0.00598229 0.0154952 yes XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts OK 58.2137 947.084 4.02406 -6.96535 3.27582e-12 6.4069e-11 yes XLOC_000187 XLOC_000187 - chr1:23243782-23247347 iPS Fibroblasts OK 1.74546 18.4428 3.40138 -3.11295 0.00185227 0.00572706 yes XLOC_000188 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts OK 2620.79 2352.33 -0.155907 0.384916 0.700299 0.803506 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts OK 15.7957 100.398 2.66813 -0.481427 0.630213 0.747545 no XLOC_000190 XLOC_000190 - chr1:23832921-23857713 iPS Fibroblasts NOTEST 7.64299 0 -1.79769e+308 -1.79769e+308 0.127318 1 no XLOC_000191 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts NOTEST 0.878724 0 -1.79769e+308 -1.79769e+308 0.349267 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 45081.3 122735 1.44495 -2.82934 0.00466435 0.0124531 yes XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts OK 755.461 1232.52 0.706187 -1.80674 0.0708034 0.128608 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts OK 1073.73 1716.37 0.676735 -1.55782 0.119275 0.20022 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 1047.53 1186.4 0.179594 -0.354128 0.723243 0.824184 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts OK 2032.12 1795.17 -0.178866 0.476805 0.633501 0.749729 no XLOC_000197 XLOC_000197 - chr1:24526729-24538180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 21.0142 0.713283 -4.88074 2.65542 0.00792089 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts OK 470.28 1640.18 1.80227 -2.76943 0.00561551 0.0146666 yes XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 373.245 403.561 0.112667 -0.154766 0.877006 0.937181 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts NOTEST 1.31366 0.128844 -3.34989 1.36696 0.171638 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 1290.56 1626.98 0.334194 -0.6943 0.487494 0.622129 no XLOC_001217 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 1078.51 1418.98 0.395819 -0.581717 0.560758 0.680515 no XLOC_001218 XLOC_001218 - chr1:34611-36081 iPS Fibroblasts NOTEST 13.7184 4.32826 -1.66426 1.37047 0.17054 1 no XLOC_001219 XLOC_001219 - chr1:89294-237877 iPS Fibroblasts OK 12.8434 13.5604 0.0783645 -0.0449207 0.964171 0.98172 no XLOC_001220 XLOC_001220 - chr1:89294-237877 iPS Fibroblasts OK 342.399 19.9712 -4.09969 4.21805 2.46425e-05 0.000128723 yes XLOC_001221 XLOC_001221 OR4F16 chr1:621097-622034 iPS Fibroblasts NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 443.364 109.854 -2.01291 1.78974 0.0734953 0.132924 no XLOC_001223 XLOC_001223 - chr1:661139-679736 iPS Fibroblasts OK 0 14237.7 1.79769e+308 1.79769e+308 0.467736 0.60806 no XLOC_001224 XLOC_001224 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001225 XLOC_001225 - chr1:661139-679736 iPS Fibroblasts OK 0 14237.7 1.79769e+308 1.79769e+308 0.467736 0.60806 no XLOC_001226 XLOC_001226 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001227 XLOC_001227 - chr1:700236-714006 iPS Fibroblasts OK 247.682 50.5377 -2.29306 3.18069 0.00146925 0.00473424 yes XLOC_001228 XLOC_001228 - chr1:761586-762902 iPS Fibroblasts OK 29.1742 39.9678 0.454142 -0.567774 0.570188 0.690963 no XLOC_001229 XLOC_001229 FAM41C chr1:803452-812182 iPS Fibroblasts NOTEST 17.3524 7.41126 -1.22735 1.36605 0.171923 1 no XLOC_001230 XLOC_001230 - chr1:852952-854817 iPS Fibroblasts NOTEST 0 7.62477 1.79769e+308 1.79769e+308 0.121258 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 664.491 2220.08 1.74029 -2.88195 0.00395224 0.0108268 yes XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts OK 9.49353 38.3466 2.01408 -1.97876 0.0478435 0.090216 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts OK 54.1565 33.6271 -0.68751 0.630637 0.528278 0.654318 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 95.4113 225.338 1.23986 -1.56385 0.117852 0.199024 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts NOTEST 0.346272 0 -1.79769e+308 -1.79769e+308 0.315006 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts OK 3.83745 14.2699 1.89475 -0.873494 0.382394 0.522916 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts NOTEST 1.29516 5.89401 2.18612 -0.701912 0.482734 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 961.909 9144.72 3.24897 -5.68692 1.29352e-08 1.4128e-07 yes XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts OK 17.131 75.8216 2.146 -2.50106 0.0123824 0.028221 yes XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 497.959 1991.77 1.99995 -3.94167 8.09158e-05 0.000361969 yes XLOC_001241 XLOC_001241 - chr1:1189293-1209234 iPS Fibroblasts OK 17.2606 20.3727 0.239156 -0.0846348 0.932552 0.966571 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 154.616 1130.35 2.87002 -2.89514 0.00378987 0.0104845 yes XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 937.049 3108.68 1.7301 -2.22462 0.0261065 0.0536812 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS Fibroblasts OK 275.675 1592.95 2.53066 -4.70062 2.59371e-06 1.66512e-05 yes XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 1079.39 14320 3.72974 -6.68023 2.38565e-11 3.78553e-10 yes XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 2557.58 7034.3 1.45963 -2.99354 0.00275761 0.00819486 yes XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 749.182 1273.64 0.765566 -1.45629 0.145313 0.234115 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts OK 3133.93 8744.67 1.48043 -3.20965 0.00132895 0.00429864 yes XLOC_001249 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts OK 55.0852 100.918 0.873453 -0.985008 0.32462 0.457296 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts OK 31.9981 233.834 2.86942 -3.74518 0.000180267 0.000746819 yes XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts OK 2379.43 6671.18 1.48732 -3.27366 0.00106163 0.00357134 yes XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 321.824 3685.64 3.51757 -0.726073 0.467794 0.60806 no XLOC_001253 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 81.9647 440.918 2.42744 -0.388777 0.697441 0.80349 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 439.217 1716.87 1.96678 -1.61761 0.105747 0.181496 no XLOC_001255 XLOC_001255 - chr1:1571099-1677431 iPS Fibroblasts OK 251.624 1014.62 2.0116 -2.45237 0.0141917 0.0314913 yes XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 483.898 1252.77 1.37235 -2.67111 0.00756011 0.0189228 yes XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts OK 4287.86 16708.8 1.96228 -3.94405 8.01162e-05 0.000360309 yes XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 102.168 23.4115 -2.12565 2.35529 0.018508 0.0400135 yes XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 1.6663 0 -1.79769e+308 -1.79769e+308 0.198288 1 no XLOC_001261 XLOC_001261 - chr1:1944651-1946969 iPS Fibroblasts NOTEST 4.28982 0 -1.79769e+308 -1.79769e+308 0.0384012 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts OK 13.1667 27.1259 1.04278 -0.126228 0.899551 0.954001 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts OK 426.51 2848.42 2.73951 -3.49459 0.000474788 0.00177465 yes XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 54.986 102.498 0.898453 -0.711315 0.476889 0.614212 no XLOC_001265 XLOC_001265 - chr1:2252695-2322993 iPS Fibroblasts OK 54.2991 177.628 1.70986 -2.29338 0.0218262 0.0458897 yes XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts OK 290.341 917.336 1.6597 -1.30192 0.192945 0.296107 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts OK 174.785 500.991 1.5192 -2.92007 0.00349955 0.00990951 yes XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts NOTEST 6.35744 0 -1.79769e+308 -1.79769e+308 0.0423949 1 no XLOC_001269 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts OK 2.01017 16.2233 3.01268 -0.875689 0.381199 0.522916 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0.931281 3.38316 1.86108 -0.0777597 0.938019 1 no XLOC_001271 XLOC_001271 - chr1:2976182-2980350 iPS Fibroblasts NOTEST 0.620738 0.336145 -0.884902 0.323409 0.746385 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts OK 113.568 157.419 0.47105 -0.741338 0.458488 0.599672 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 264.765 520.346 0.974758 -1.52921 0.126211 0.207717 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts OK 201.581 257.641 0.354004 -0.721506 0.470598 0.610761 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts OK 867.894 1410.28 0.700388 -1.71311 0.0866925 0.153491 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 266.214 568.38 1.09427 -1.74167 0.0815657 0.145587 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts OK 489.179 1182.73 1.27368 -2.56396 0.0103486 0.0247249 yes XLOC_001279 XLOC_001279 - chr1:5621768-5728315 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts OK 61.5073 115.136 0.904514 -1.01643 0.309423 0.441059 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 14.4353 4.07203 -1.82578 1.50713 0.131776 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts OK 2431.44 9875.13 2.02199 -4.57018 4.87316e-06 2.88615e-05 yes XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts OK 1479.52 2608.03 0.817829 -2.06715 0.0387202 0.0760834 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts OK 117.786 766.964 2.70299 -4.03768 5.39815e-05 0.00025082 yes XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 964.538 4595.76 0 0 1 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 5.92301 1.90413 -1.6372 1.26861 0.204579 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts OK 168.073 98.5393 -0.770313 0.554151 0.579475 0.7002 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts OK 503.823 363.843 -0.469602 0.957548 0.338291 0.473382 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 243.714 1056.94 2.11663 -4.35831 1.31068e-05 7.15767e-05 yes XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts OK 743.808 1731.39 1.21893 -2.76008 0.00577868 0.015046 yes XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 2.44962 0 -1.79769e+308 -1.79769e+308 0.450488 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts NOTEST 0 1.38187 1.79769e+308 1.79769e+308 0.0774008 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 778.659 2311.63 1.56984 -3.3508 0.000805796 0.00280031 yes XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 274.268 2024.49 2.8839 -4.87044 1.11349e-06 8.14301e-06 yes XLOC_001295 XLOC_001295 - chr1:8412465-8877699 iPS Fibroblasts NOTEST 20.7508 0 -1.79769e+308 -1.79769e+308 0.365376 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 22441.8 71632.5 1.67443 -4.64446 3.40962e-06 2.1553e-05 yes XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts NOTEST 0 0.725244 1.79769e+308 1.79769e+308 0.180502 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts OK 5.91022 124.086 4.39199 -2.72565 0.0064175 0.0164546 yes XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts OK 37.0457 99.8224 1.43006 -1.32551 0.185004 0.285483 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts OK 95.9263 69.3907 -0.467184 0.755747 0.449801 0.591067 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001302 XLOC_001302 - chr1:9711789-9884550 iPS Fibroblasts OK 86.8241 61.7832 -0.490881 0.0609674 0.951385 0.975766 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 478.354 4844.04 3.34006 -5.30438 1.13059e-07 1.01151e-06 yes XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts OK 479.396 509.797 0.0887044 -0.170607 0.864533 0.935743 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts OK 321.49 1022.12 1.66871 -2.86771 0.00413456 0.011253 yes XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts OK 783.778 1164.65 0.571379 -1.21263 0.22527 0.334721 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 20.9583 8.07121 -1.37667 1.16022 0.245958 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 1.66867 0.333513 -2.32288 0.608589 0.542797 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts OK 75.0649 15.0124 -2.32198 2.94408 0.00323915 0.00927943 yes XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 2174 10824.5 2.31587 -4.43593 9.16736e-06 5.17433e-05 yes XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts OK 1430.05 1642.04 0.199424 -0.499119 0.617695 0.734769 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts OK 637.839 807.821 0.340844 -0.824501 0.409655 0.553001 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts OK 308.762 72.9584 -2.08135 1.59621 0.110443 0.188785 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts OK 4485.74 2368.21 -0.921547 2.41152 0.015886 0.0347919 yes XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 178.062 650.594 1.86938 -2.55874 0.0105053 0.0250283 yes XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts OK 3.4039 18.088 2.40977 -0.308338 0.757825 0.849775 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts OK 770.486 0 -1.79769e+308 -1.79769e+308 0.000683496 0.00243568 yes XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts OK 673.993 1443.8 1.09907 -2.14667 0.0318194 0.0638666 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 1376.88 819.055 -0.749372 0.31459 0.753073 0.84829 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts OK 162.796 1951.16 3.58319 -6.22559 4.79736e-10 6.40409e-09 yes XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.672346 0 -1.79769e+308 -1.79769e+308 0.398736 1 no XLOC_001325 XLOC_001325 - chr1:13182960-13183967 iPS Fibroblasts OK 22.2793 207.399 3.21863 -4.25455 2.09472e-05 0.000112208 yes XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts NOTEST 0.200934 0 -1.79769e+308 -1.79769e+308 0.454078 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts NOTEST 6.96034 0 -1.79769e+308 -1.79769e+308 0.0128373 1 no XLOC_001334 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS Fibroblasts NOTEST 8.04305 0.859289 -3.22653 0.126847 0.899061 1 no XLOC_001335 XLOC_001335 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0.432797 2.62025 2.59795 -0.869836 0.38439 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 394.058 288.447 -0.450104 0.698656 0.484767 0.621477 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts OK 122.09 43.2083 -1.49857 0.836515 0.402865 0.546467 no XLOC_001338 XLOC_001338 - chr1:16133656-16134194 iPS Fibroblasts OK 7916.63 21049.2 1.41081 -3.46206 0.000536064 0.00196869 yes XLOC_001339 XLOC_001339 - chr1:16160709-16266950 iPS Fibroblasts OK 68.8094 39.9858 -0.783119 0.309905 0.756633 0.849571 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 179.279 666.365 1.89411 -2.68039 0.00735355 0.018516 yes XLOC_001341 XLOC_001341 - chr1:16317618-16317647 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 192.896 736.676 1.9332 -2.87615 0.00402556 0.0109919 yes XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts OK 13.6398 46.4136 1.76672 -0.1606 0.872409 0.936801 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts OK 257.159 923.073 1.84378 -3.23256 0.00122686 0.00401474 yes XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 173.274 178.951 0.0465123 -0.0725635 0.942153 0.96983 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts OK 28.2148 182.341 2.69211 -3.90462 9.4375e-05 0.000417733 yes XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 353.356 579.556 0.713825 -1.38619 0.165687 0.260942 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 1.25463 0.168084 -2.90001 0.0483682 0.961423 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 47.0375 68.2604 0.537239 -0.385434 0.699916 0.803506 no XLOC_001350 XLOC_001350 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 23.1603 0.8365 -4.79115 2.95061 0.00317145 1 no XLOC_001351 XLOC_001351 - chr1:16888922-16890082 iPS Fibroblasts OK 223.564 1764.52 2.98051 -5.386 7.20429e-08 6.73201e-07 yes XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 450.243 1717.46 1.9315 -3.05071 0.00228299 0.00693138 yes XLOC_001353 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 404.217 584.711 0.532594 -0.599369 0.548927 0.670999 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 iPS Fibroblasts NOTEST 2.07327 0 -1.79769e+308 -1.79769e+308 0.134129 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 16.1249 3.15319 -2.35441 0.224023 0.82274 1 no XLOC_001356 XLOC_001356 - chr1:17066767-17299474 iPS Fibroblasts OK 133.893 408.247 1.60836 -0.665311 0.505852 0.638771 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 1947.53 2405.66 0.304789 -0.600796 0.547976 0.670999 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 347.865 685.305 0.97822 -1.36429 0.172476 0.269615 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts OK 1562.94 5372.43 1.78131 -4.16829 3.06896e-05 0.000155401 yes XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts OK 31.43 0.887452 -5.14633 3.80549 0.000141521 0.000607243 yes XLOC_001361 XLOC_001361 - chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts OK 3342.9 1048.07 -1.67337 4.63458 3.57665e-06 2.22812e-05 yes XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 264.069 536.822 1.02353 -1.87379 0.0609595 0.113172 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts OK 102.06 303.773 1.57358 -3.15592 0.00159995 0.00507757 yes XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 878.439 2120.72 1.27154 -1.24585 0.212819 0.319608 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 353.593 2369.35 2.74433 -5.51374 3.51282e-08 3.47562e-07 yes XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 8.4734 10.5092 0.310635 -0.34638 0.729057 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts OK 16.1619 15.2534 -0.0834673 0.0945577 0.924666 0.966377 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts OK 363.217 3218.59 3.14753 -5.68921 1.27629e-08 1.41231e-07 yes XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 3724.87 19451.7 2.38464 -5.26249 1.4212e-07 1.24503e-06 yes XLOC_001372 XLOC_001372 - chr1:19665273-19811992 iPS Fibroblasts OK 37.4567 16.6971 -1.16562 0.104673 0.916635 0.96541 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 79.6954 628.12 2.97847 -2.70937 0.00674103 0.0171275 yes XLOC_001374 XLOC_001374 RNF186 chr1:20140522-20141771 iPS Fibroblasts NOTEST 1.07721 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts OK 134.324 12.952 -3.37447 3.16116 0.00157144 0.00500597 yes XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001379 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts NOTEST 0 2.56345 1.79769e+308 1.79769e+308 0.0741977 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts OK 335.378 10489.8 4.96705 -7.22264 5.09814e-13 1.07188e-11 yes XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts OK 392.307 1509.04 1.94358 -4.25254 2.11358e-05 0.000112502 yes XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts OK 4463.42 12716.5 1.51048 -3.54071 0.000399059 0.00151859 yes XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 66.5994 129.385 0.95809 -1.11479 0.264938 0.38549 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 73.6913 308.235 2.06446 -3.13342 0.00172781 0.00536196 yes XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 1913.33 4455.85 1.21962 -2.11863 0.0341215 0.0680005 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 1166.43 2118.9 0.861212 -1.77199 0.0763965 0.136992 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 228.564 6484.57 4.82634 -7.68388 1.55431e-14 4.2167e-13 yes XLOC_001388 XLOC_001388 - chr1:21543739-21672034 iPS Fibroblasts NOTEST 8.5531 0.547703 -3.96498 0.0634978 0.94937 1 no XLOC_001389 XLOC_001389 - chr1:21749600-21754300 iPS Fibroblasts OK 100.478 526.991 2.3909 -4.16704 3.08585e-05 0.000155401 yes XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts OK 56.0998 2.12911 -4.71967 4.60432 4.13812e-06 2.52185e-05 yes XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 1144.32 1523.68 0.413072 -0.822032 0.411059 0.554007 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 159.269 4755.93 4.90019 -2.90424 0.0036815 0.0103205 yes XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 15.9525 0.787764 -4.33987 3.13809 0.00170051 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts NOTEST 3.40123 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 860.605 885.771 0.041582 -0.103965 0.917197 0.96541 no XLOC_001396 XLOC_001396 HTR1D chr1:23518388-23521222 iPS Fibroblasts OK 223.865 0 -1.79769e+308 -1.79769e+308 6.06842e-05 0.000278882 yes XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 3142.27 5103.63 0.699717 -1.6791 0.0931329 0.163177 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts OK 60.989 386.766 2.66484 -3.64067 0.000271927 0.001089 yes XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 134.779 774.243 2.52219 -2.50751 0.0121584 0.0278445 yes XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 303.901 793.086 1.38388 -2.71432 0.00664127 0.0169252 yes XLOC_001401 XLOC_001401 - chr1:23755055-23811057 iPS Fibroblasts NOTEST 14.3352 0 -1.79769e+308 -1.79769e+308 0.245948 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts OK 17.3678 59.0676 1.76595 -2.48715 0.0128773 0.0290343 yes XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts OK 2524.02 1504.77 -0.746179 1.57964 0.114189 0.194006 no XLOC_001404 XLOC_001404 - chr1:24069855-24104777 iPS Fibroblasts OK 29.788 107.333 1.8493 -0.266177 0.790103 0.877776 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 309.118 762.674 1.30291 -1.78043 0.0750051 0.135073 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 216.788 1760.73 3.02182 -4.80266 1.56572e-06 1.07932e-05 yes XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts OK 207.2 142.572 -0.539327 0.599671 0.548725 0.670999 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts OK 2102.35 2465.33 0.229784 -0.507196 0.612018 0.729046 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 3.09627 0 -1.79769e+308 -1.79769e+308 0.10506 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 6.64523 3.57865 -0.892903 0.896791 0.36983 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts OK 99.4363 0.114571 -9.76139 1.60037 0.109517 0.187583 no XLOC_001413 XLOC_001413 - chr1:24580829-24580859 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 164.974 296.253 0.844593 -1.21982 0.222534 0.331828 no XLOC_000001 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts OK 0.347386 16.1506 5.5389 -0.585603 0.558142 0.67832 no XLOC_000002 XLOC_000002 OR4F5 chr1:69090-70008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000003 XLOC_000003 - chr1:321083-321114 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000004 XLOC_000004 - chr1:321145-321223 hESC Fibroblasts OK 697259 14237.7 -5.6139 1.7034 0.0884936 0.156351 no XLOC_000005 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 696.704 48.0566 -3.85774 5.9509 2.66665e-09 3.20379e-08 yes XLOC_000006 XLOC_000006 OR4F16 chr1:367658-368595 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000007 XLOC_000007 - chr1:420205-421839 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000008 XLOC_000008 - chr1:566461-568045 hESC Fibroblasts OK 91983.2 69492.5 -0.404513 1.73369 0.0829724 0.147526 no XLOC_000009 XLOC_000009 - chr1:568148-568842 hESC Fibroblasts OK 6464.44 26012.6 2.00862 -4.14783 3.35646e-05 0.000168023 yes XLOC_000010 XLOC_000010 - chr1:568843-568912 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000011 XLOC_000011 - chr1:569326-570349 hESC Fibroblasts OK 31401.9 37535.9 0.257423 -0.528984 0.596816 0.71499 no XLOC_000012 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts OK 182.273 292.077 0.680248 -0.756107 0.449585 0.591067 no XLOC_000013 XLOC_000013 - chr1:791897-794579 hESC Fibroblasts OK 28.2795 74.5004 1.39749 -2.65054 0.00803632 0.0199367 yes XLOC_000014 XLOC_000014 - chr1:846814-850328 hESC Fibroblasts OK 27.5823 0.58031 -5.57077 4.56368 5.0264e-06 2.95609e-05 yes XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts OK 6.25295 38.7341 2.63099 -0.316172 0.751872 0.84829 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 741.918 347.16 -1.09566 1.8397 0.0658119 0.121377 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 22.784 59.3098 1.38025 -1.83239 0.066893 0.122832 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts OK 987.18 3379.09 1.77525 -5.01809 5.21889e-07 4.10195e-06 yes XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts OK 1857.6 2553.38 0.458967 -1.27209 0.203343 0.307022 no XLOC_000020 XLOC_000020 - chr1:995082-1001833 hESC Fibroblasts OK 32.064 70.3957 1.13453 -1.49743 0.13428 0.218856 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts NOTEST 1.64828 0 -1.79769e+308 -1.79769e+308 0.0567344 1 no XLOC_000022 XLOC_000022 - chr1:1102483-1102578 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000023 XLOC_000023 - chr1:1103242-1103332 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000024 XLOC_000024 - chr1:1104384-1104467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts OK 16.6969 0 -1.79769e+308 -1.79769e+308 9.65945e-06 5.37987e-05 yes XLOC_000026 XLOC_000026 B3GALT6 chr1:1167628-1170418 hESC Fibroblasts OK 276.214 1068.96 1.95235 -5.91507 3.3173e-09 3.92936e-08 yes XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 74.6629 63.4772 -0.234152 0.333642 0.73865 0.838333 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 790.008 871.528 0.141681 -0.0934597 0.925538 0.966377 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts OK 187.156 781.158 2.06137 -5.7929 6.91832e-09 7.75774e-08 yes XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts NOTEST 2.57898 4.31837 0.743686 -0.805548 0.420503 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts OK 553.309 567.727 0.0371112 -0.0442295 0.964721 0.98172 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts OK 59.0363 0 -1.79769e+308 -1.79769e+308 5.12217e-06 2.99149e-05 yes XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts OK 528.289 473.976 -0.156516 0.400147 0.689048 0.796002 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts OK 69.2663 15.5201 -2.15801 3.56653 0.000361735 0.0013955 yes XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 980.283 794.244 -0.303616 0.710104 0.47764 0.614212 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts OK 1412.56 2075.75 0.555323 -1.53168 0.1256 0.207717 no XLOC_000037 XLOC_000037 - chr1:1535818-1543166 hESC Fibroblasts OK 10.6728 5.74721 -0.893003 0.807327 0.419478 0.563548 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 576.289 593.05 0.0413602 -0.0854984 0.931865 0.966571 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts OK 67.208 26.2041 -1.35884 1.25313 0.210158 0.316177 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 92.012 93.5344 0.0236747 -0.000540181 0.999569 0.999569 no XLOC_000041 XLOC_000041 - chr1:1571099-1677431 hESC Fibroblasts OK 78.5208 84.1606 0.10007 -0.0119073 0.9905 0.994837 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts NOTEST 3.15678 11.254 1.83391 -1.49266 0.135527 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts OK 26.9908 1.08118 -4.64179 2.89373 0.003807 0.0104973 yes XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts OK 41.7053 0.393202 -6.72881 3.58001 0.000343586 0.00134398 yes XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 984.342 90.8985 -3.43683 2.08882 0.0367243 0.0728423 no XLOC_000046 XLOC_000046 - chr1:1981908-2139172 hESC Fibroblasts OK 109.688 100.493 -0.126319 0.106377 0.915283 0.96541 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts OK 740.008 1645.91 1.15327 -3.57845 0.000345636 0.00134574 yes XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts OK 802.47 3941.6 2.29626 -6.15611 7.45553e-10 9.6463e-09 yes XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 2.31568 2.63403 0.185836 -0.0999129 0.920413 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 3.76675 887.589 7.88043 -6.94437 3.8014e-12 7.26586e-11 yes XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 857.758 1288.7 0.587278 -1.55351 0.120301 0.20154 no XLOC_000052 XLOC_000052 ACTRT2 chr1:2938045-2939465 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 5.29478 8.22698 0.635791 -0.97909 0.327535 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 367.393 4.78554 -6.2625 5.11548 3.12952e-07 2.58032e-06 yes XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts OK 498.776 2696.46 2.4346 -7.36838 1.72751e-13 3.92658e-12 yes XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts OK 75.1453 4.39049 -4.09723 4.24767 2.16008e-05 0.000114253 yes XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts NOTEST 2.99279 0.344217 -3.1201 1.59609 0.110469 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts OK 76.8718 58.9016 -0.38415 0.550115 0.582241 0.701525 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 hESC Fibroblasts OK 120.109 116.754 -0.0408721 0.0771314 0.938519 0.96853 no XLOC_000060 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts OK 24.9595 4.27286 -2.54632 2.24094 0.0250302 0.0518482 no XLOC_000061 XLOC_000061 - chr1:4000676-4015322 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000062 XLOC_000062 - chr1:4472110-4484744 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts OK 73.9584 1.26614 -5.86821 4.71838 2.37726e-06 1.54983e-05 yes XLOC_000064 XLOC_000064 - chr1:4847557-4852182 hESC Fibroblasts OK 18.1722 0.154615 -6.87691 3.65907 0.000253135 0.0010186 yes XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 131.769 103.077 -0.354295 0.653053 0.513722 0.642489 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 76.0702 67.9405 -0.16306 0.0104157 0.99169 0.994837 no XLOC_000067 XLOC_000067 C1orf211 chr1:6297870-6299490 hESC Fibroblasts OK 132.225 4.35392 -4.92453 5.20718 1.91728e-07 1.6623e-06 yes XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts OK 1431.61 0 -1.79769e+308 -1.79769e+308 3.8204e-30 1.78498e-28 yes XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 177.686 0.205083 -9.75891 4.01621 5.91417e-05 0.000273286 yes XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 1.25192 5.4957 2.13417 -1.03449 0.300909 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts OK 326.257 252.631 -0.36898 0.718668 0.472345 0.611152 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts OK 660.096 769.313 0.220895 -0.682623 0.494845 0.628648 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 233.593 558.455 1.25744 -1.15083 0.249801 0.366636 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts OK 1467.41 3198.34 1.12405 -3.1339 0.00172498 0.00536196 yes XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts OK 502.334 7098.44 3.82078 -10.9673 0 0 yes XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 117.867 358.538 1.60496 -3.17025 0.00152305 0.0048703 yes XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 8447.87 21648.9 1.35763 -3.39191 0.000694075 0.00245259 yes XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 39.6496 212.078 2.41922 -3.86698 0.00011019 0.000482656 yes XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts OK 93.0165 1112.18 3.57976 -10.6305 0 0 yes XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts OK 86.131 876.41 3.347 -8.50949 0 0 yes XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts OK 229.284 266.339 0.216129 -0.423553 0.671892 0.780471 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts OK 402.381 330.695 -0.283061 0.651925 0.51445 0.642489 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 441.582 175.884 -1.32806 0.349054 0.727049 0.826337 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts OK 39.4422 319.369 3.01741 -7.86539 3.77476e-15 1.22099e-13 yes XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts OK 229.575 19.7819 -3.53672 4.71889 2.3714e-06 1.54983e-05 yes XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts OK 1147.31 1440.88 0.328696 -0.636506 0.524447 0.65053 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 637.441 1046.38 0.715036 -1.1727 0.240917 0.355459 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts OK 7183.39 13970.1 0.959605 -2.30069 0.0214091 0.0451254 yes XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 hESC Fibroblasts OK 259.775 663.444 1.35271 -2.66868 0.007615 0.0190036 yes XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 hESC Fibroblasts OK 678.266 1632.34 1.26702 -1.57561 0.115116 0.195131 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts OK 2401.2 2744.34 0.192704 -0.588326 0.556313 0.677076 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0.912846 10.571 3.5336 -0.48214 0.629707 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts OK 307.383 332.294 0.112423 -0.306558 0.75918 0.85016 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts OK 74.4396 0.546311 -7.0902 4.20983 2.55562e-05 0.000132671 yes XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 558.984 425.638 -0.39318 0.694899 0.487118 0.622129 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts OK 25.5712 363.317 3.82864 -8.06025 6.66134e-16 2.43573e-14 yes XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts OK 340.257 11.5677 -4.87845 6.10186 1.04843e-09 1.31602e-08 yes XLOC_000099 XLOC_000099 - chr1:11782186-11785914 hESC Fibroblasts OK 209.081 6.38178 -5.03396 6.66245 2.69302e-11 4.19413e-10 yes XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 1610.7 1911.82 0.247261 -0.673622 0.500552 0.633982 no XLOC_000101 XLOC_000101 C1orf167 chr1:11824461-11826573 hESC Fibroblasts NOTEST 3.47934 1.86471 -0.899861 0.478603 0.632221 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 4.36698 8.96806 1.03816 -0.0547942 0.956302 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts OK 366.258 585.495 0.676795 -0.65415 0.513015 0.642489 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts OK 956.552 10441.6 3.44836 -7.55593 4.15223e-14 1.09126e-12 yes XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts OK 942.066 2871.51 1.60791 -4.64298 3.43412e-06 2.1553e-05 yes XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts OK 1223.51 575.01 -1.08937 2.79975 0.00511417 0.0135252 yes XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts OK 441.002 8.49796 -5.69753 4.41709 1.00041e-05 5.53514e-05 yes XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts OK 33.8648 1395.94 5.36531 -14.2831 0 0 yes XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 162.839 354.401 1.12193 -2.49252 0.0126839 0.0287618 yes XLOC_000110 XLOC_000110 SNORA59B chr1:12290112-12572096 hESC Fibroblasts OK 234.664 63.6142 -1.88318 0.060948 0.951401 0.975766 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts NOTEST 1.34969 0 -1.79769e+308 -1.79769e+308 0.0786442 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts OK 10.0548 0 -1.79769e+308 -1.79769e+308 6.36003e-08 6.07817e-07 yes XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts NOTEST 1.29047 0 -1.79769e+308 -1.79769e+308 0.275365 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts NOTEST 0.853096 0 -1.79769e+308 -1.79769e+308 0.111514 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000123 XLOC_000123 PRAMEF10 chr1:13629937-13635298 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts NOTEST 0.330232 0 -1.79769e+308 -1.79769e+308 0.240869 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts OK 1703.36 111.012 -3.93959 7.82462 5.10703e-15 1.59074e-13 yes XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 157.143 476.725 1.60108 -3.47998 0.000501453 0.00184966 yes XLOC_000129 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 159.342 477.168 1.58237 -3.85523 0.000115623 0.000503829 yes XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 232.379 714.037 1.61952 -3.74643 0.000179368 0.000746773 yes XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 8.41368 3.72788 -1.17438 1.00837 0.313278 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts OK 468.604 2197 2.22909 -6.83631 8.12594e-12 1.42373e-10 yes XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts NOTEST 0 5.61806 1.79769e+308 1.79769e+308 0.0900461 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts NOTEST 1.27477 0 -1.79769e+308 -1.79769e+308 0.352721 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts OK 155.023 378.574 1.28809 -2.95959 0.00308053 0.00890283 yes XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 hESC Fibroblasts OK 529.844 687.356 0.375488 -0.808656 0.418713 0.56342 no XLOC_000138 XLOC_000138 - chr1:15992765-15995535 hESC Fibroblasts OK 304.42 236.84 -0.362149 0.869668 0.384482 0.524118 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts OK 779.207 2346.33 1.59033 -4.91682 8.79633e-07 6.6051e-06 yes XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts OK 8.64413 13.9977 0.695397 -0.710138 0.477619 0.614212 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts OK 31.4534 0 -1.79769e+308 -1.79769e+308 1.02587e-11 1.72551e-10 yes XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 959.481 2443.99 1.34892 -3.27934 0.00104049 0.0035254 yes XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 381.608 461.983 0.275749 -0.768427 0.442233 0.585231 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 hESC Fibroblasts OK 89.7145 2.11931 -5.40367 0.797404 0.425216 0.570346 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 1363.34 5311.2 1.96189 -4.89827 9.66828e-07 7.1956e-06 yes XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 535.864 3729.9 2.7992 -8.14365 4.44089e-16 1.69763e-14 yes XLOC_000148 XLOC_000148 - chr1:16860385-16864669 hESC Fibroblasts OK 12.2273 1.32866 -3.20206 2.73483 0.00624132 0.016076 yes XLOC_000149 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts OK 119.12 14.8477 -3.0041 3.01969 0.00253032 0.00759998 yes XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 626.539 169.437 -1.88666 3.54813 0.000387979 0.00148991 yes XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 4.12312 0.513942 -3.00406 1.27855 0.201057 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts OK 12.671 0.32407 -5.28908 3.31366 0.000920822 0.00317382 yes XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts NOTEST 4.49965 0 -1.79769e+308 -1.79769e+308 0.020742 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts NOTEST 0.21117 0 -1.79769e+308 -1.79769e+308 0.240869 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 682.762 673.972 -0.0186951 0.043407 0.965377 0.98172 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts OK 17.1125 6.95204 -1.29954 1.74086 0.0817088 0.145587 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts OK 401.989 0 -1.79769e+308 -1.79769e+308 7.28708e-30 3.22549e-28 yes XLOC_000158 XLOC_000158 - chr1:18434239-18704976 hESC Fibroblasts OK 18.0164 0 -1.79769e+308 -1.79769e+308 0.0420629 0.081509 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts OK 217.548 0.745204 -8.18948 7.06685 1.58495e-12 3.25109e-11 yes XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 0.969331 0 -1.79769e+308 -1.79769e+308 0.0595256 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts OK 961.74 1651.61 0.780159 -2.37831 0.0173923 0.0376982 yes XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 324.654 587.782 0.856377 -1.82593 0.0678615 0.124069 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 816.248 12629.3 3.95163 -7.77872 7.32747e-15 2.05413e-13 yes XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts OK 22.3161 0 -1.79769e+308 -1.79769e+308 2.82075e-11 4.31318e-10 yes XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts OK 157.667 87.3998 -0.851179 2.02602 0.0427627 0.082485 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts OK 0.847143 149.334 7.46172 -5.14254 2.71053e-07 2.27955e-06 yes XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts NOTEST 0.361045 0 -1.79769e+308 -1.79769e+308 0.159889 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts OK 17.9074 0.492177 -5.18523 3.87498 0.000106632 0.000469515 yes XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts OK 19.2036 0.572911 -5.06693 3.61244 0.000303331 0.00120331 yes XLOC_000170 XLOC_000170 FAM43B chr1:20878931-20881512 hESC Fibroblasts OK 40.5541 1.55058 -4.70896 5.03446 4.79204e-07 3.80198e-06 yes XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts OK 141.154 232.113 0.717563 -1.23935 0.215218 0.322635 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 441.939 3045.93 2.78497 -7.40609 1.30118e-13 3.0397e-12 yes XLOC_000173 XLOC_000173 - chr1:21543739-21672034 hESC Fibroblasts NOTEST 7.51557 3.33508 -1.17216 0.0473121 0.962264 1 no XLOC_000174 XLOC_000174 - chr1:21761832-21762609 hESC Fibroblasts OK 12075.7 7652.6 -0.658091 0.637145 0.52403 0.65053 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 59.4109 528.734 3.15374 -7.24865 4.20997e-13 9.07841e-12 yes XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 5045.41 66.8214 -6.23852 8.31027 0 0 yes XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts OK 32.928 183.25 2.47643 -0.0209621 0.983276 0.993912 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000179 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts OK 431.878 533.595 0.305121 -0.652055 0.514366 0.642489 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 1626.45 9892.47 2.6046 -6.62856 3.38982e-11 4.91524e-10 yes XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts OK 221.871 230.381 0.0542986 -0.118126 0.905968 0.958765 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts OK 86.3015 0 -1.79769e+308 -1.79769e+308 4.21755e-12 7.88213e-11 yes XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts OK 301.66 947.084 1.65057 -3.98506 6.7464e-05 0.000308354 yes XLOC_000187 XLOC_000187 - chr1:23243782-23247347 hESC Fibroblasts OK 8.0467 18.4428 1.19659 -1.85611 0.0634381 0.117514 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts OK 4034.49 2352.33 -0.778295 2.28912 0.0220726 0.0461768 yes XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts OK 6.98703 100.398 3.84491 -1.9876 0.0468558 0.0887516 no XLOC_000190 XLOC_000190 - chr1:23832921-23857713 hESC Fibroblasts NOTEST 0.939918 0 -1.79769e+308 -1.79769e+308 0.263534 1 no XLOC_000191 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 74807 122735 0.714305 -1.45732 0.145029 0.234106 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts OK 523.425 1232.52 1.23556 -3.83604 0.000125032 0.000539239 yes XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts OK 1208.06 1716.37 0.506669 -1.53282 0.125321 0.207717 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 2696.47 1186.4 -1.18448 3.05149 0.00227706 0.00693138 yes XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts OK 1015.28 1795.17 0.822244 -2.59154 0.00955471 0.0231571 yes XLOC_000197 XLOC_000197 - chr1:24526729-24538180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts OK 24.5704 0.713283 -5.10631 2.9749 0.00293086 0.00858834 yes XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 146.117 1640.18 3.48866 -6.63053 3.34492e-11 4.91524e-10 yes XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 131.842 403.561 1.61398 -2.73433 0.00625073 0.016076 yes XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts NOTEST 2.35713 0.128844 -4.19333 1.83747 0.0661412 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 1796.38 1626.98 -0.142899 0.364137 0.715756 0.817867 no XLOC_001217 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 1083.74 1418.98 0.388834 -0.771857 0.440199 0.584846 no XLOC_001218 XLOC_001218 - chr1:34611-36081 hESC Fibroblasts OK 16.5503 4.32826 -1.935 1.77451 0.0759782 0.136533 no XLOC_001219 XLOC_001219 - chr1:89294-237877 hESC Fibroblasts OK 2.45836 13.5604 2.46363 -1.44662 0.148004 0.236604 no XLOC_001220 XLOC_001220 - chr1:89294-237877 hESC Fibroblasts OK 634.855 19.9712 -4.99044 5.58766 2.30155e-08 2.4195e-07 yes XLOC_001221 XLOC_001221 OR4F16 chr1:621097-622034 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 1028.56 109.854 -3.22697 3.41555 0.000636523 0.00228767 yes XLOC_001223 XLOC_001223 - chr1:661139-679736 hESC Fibroblasts OK 697259 14237.7 -5.6139 0.312732 0.754484 0.84829 no XLOC_001224 XLOC_001224 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001225 XLOC_001225 - chr1:661139-679736 hESC Fibroblasts OK 697259 14237.7 -5.6139 0.312732 0.754484 0.84829 no XLOC_001226 XLOC_001226 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001227 XLOC_001227 - chr1:700236-714006 hESC Fibroblasts OK 235.71 50.5377 -2.22158 3.66287 0.000249408 0.00100842 yes XLOC_001228 XLOC_001228 - chr1:761586-762902 hESC Fibroblasts OK 19.6665 39.9678 1.0231 -1.53129 0.125699 0.207717 no XLOC_001229 XLOC_001229 FAM41C chr1:803452-812182 hESC Fibroblasts NOTEST 2.1691 7.41126 1.77262 -1.66954 0.0950099 1 no XLOC_001230 XLOC_001230 - chr1:852952-854817 hESC Fibroblasts NOTEST 4.38548 7.62477 0.79796 -0.337126 0.736022 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 1835.15 2220.08 0.27471 -0.606563 0.544141 0.668062 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts OK 15.2361 38.3466 1.33161 -1.83045 0.0671823 0.123094 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts OK 37.4229 33.6271 -0.154296 0.155186 0.876675 0.937181 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 179.994 225.338 0.324144 -0.524193 0.600144 0.716934 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts NOTEST 5.99833 0 -1.79769e+308 -1.79769e+308 5.83424e-06 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 35.195 14.2699 -1.3024 1.62309 0.104569 0.18058 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts NOTEST 1.21775 5.89401 2.27503 -1.70433 0.0883185 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 1813.62 9144.72 2.33406 -5.12657 2.95076e-07 2.45702e-06 yes XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts OK 41.9198 75.8216 0.854975 -1.29359 0.195806 0.29832 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 714.623 1991.77 1.4788 -4.12586 3.69346e-05 0.000182638 yes XLOC_001241 XLOC_001241 - chr1:1189293-1209234 hESC Fibroblasts OK 37.017 20.3727 -0.861555 0.348989 0.727098 0.826336 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 551.917 1130.35 1.03425 -1.57474 0.115315 0.195131 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 2544.24 3108.68 0.289064 -0.445147 0.656213 0.768629 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 hESC Fibroblasts OK 1162.72 1592.95 0.454193 -1.19883 0.230594 0.342028 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 153.319 14320 6.54535 -14.037 0 0 yes XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 3660.17 7034.3 0.942496 -2.34628 0.0189619 0.040681 yes XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 1238.98 1273.64 0.0398032 -0.0926778 0.92616 0.966377 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts OK 4356.64 8744.67 1.00519 -2.83187 0.00462771 0.0123946 yes XLOC_001249 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts OK 73.1639 100.918 0.463986 -0.651479 0.514737 0.642489 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts OK 83.1162 233.834 1.49228 -2.91232 0.0035875 0.0101245 yes XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 3413.53 6671.18 0.966678 -2.68454 0.00726302 0.0183429 yes XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 2901.12 3685.64 0.345303 -0.0834759 0.933473 0.966571 no XLOC_001253 XLOC_001253 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 251.238 440.918 0.811457 -0.158057 0.874412 0.936801 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 1155.8 1716.87 0.570891 -0.531424 0.595125 0.714716 no XLOC_001255 XLOC_001255 - chr1:1571099-1677431 hESC Fibroblasts OK 341.44 1014.62 1.57123 -2.19434 0.0282108 0.0575855 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 1157.89 1252.77 0.11362 -0.314187 0.753379 0.84829 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts OK 4821.37 16708.8 1.79309 -3.79657 0.000146711 0.000616918 yes XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 291.717 23.4115 -3.63928 5.32398 1.01521e-07 9.28036e-07 yes XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts NOTEST 3.06699 0 -1.79769e+308 -1.79769e+308 0.0359621 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0.932315 0 -1.79769e+308 -1.79769e+308 0.0219603 1 no XLOC_001261 XLOC_001261 - chr1:1944651-1946969 hESC Fibroblasts NOTEST 8.18597 0 -1.79769e+308 -1.79769e+308 4.15702e-05 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts OK 33.574 27.1259 -0.307674 0.0564177 0.955009 0.978274 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts OK 1874.52 2848.42 0.603639 -1.41268 0.15775 0.249846 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 109.55 102.498 -0.0960002 0.099023 0.92112 0.966377 no XLOC_001265 XLOC_001265 - chr1:2252695-2322993 hESC Fibroblasts OK 912.804 177.628 -2.36145 4.76147 1.92183e-06 1.29301e-05 yes XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts OK 461.866 917.336 0.989975 -0.869599 0.384519 0.524118 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts OK 361.252 500.991 0.47178 -1.29987 0.193646 0.296642 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts NOTEST 2.94754 0 -1.79769e+308 -1.79769e+308 0.0305867 1 no XLOC_001269 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts OK 1.1242 16.2233 3.8511 -1.35642 0.174966 0.272999 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts OK 12.7571 3.38316 -1.91486 0.083474 0.933475 0.966571 no XLOC_001271 XLOC_001271 - chr1:2976182-2980350 hESC Fibroblasts NOTEST 0 0.336145 1.79769e+308 1.79769e+308 0.220257 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 219.592 157.419 -0.480217 1.05168 0.292948 0.419709 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 597.841 520.346 -0.200289 0.431316 0.666239 0.77649 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts OK 433.574 257.641 -0.750917 1.93985 0.0523981 0.0981444 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts OK 1345.43 1410.28 0.0679088 -0.214918 0.829831 0.902831 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 182.207 568.38 1.64128 -3.56934 0.00035788 0.00138699 yes XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts OK 551.063 1182.73 1.10183 -3.13501 0.00171846 0.00536196 yes XLOC_001279 XLOC_001279 - chr1:5621768-5728315 hESC Fibroblasts NOTEST 0.669469 0 -1.79769e+308 -1.79769e+308 0.240869 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 191.389 115.136 -0.733162 1.01277 0.311168 0.442739 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts OK 27.6918 4.07203 -2.76564 3.05786 0.00222926 0.00684235 yes XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts OK 4375.01 9875.13 1.17451 -3.1378 0.00170224 0.00534172 yes XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts OK 1334.15 2608.03 0.967038 -2.79685 0.00516036 0.0136046 yes XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts OK 272.008 766.964 1.49551 -3.45448 0.000551347 0.00200729 yes XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 3559.21 4595.76 0 0 1 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 8.65963 1.90413 -2.18518 1.77879 0.0752748 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 737.254 98.5393 -2.90339 2.5453 0.0109184 0.0258658 yes XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts OK 189.708 363.843 0.939533 -2.33908 0.0193314 0.0410548 yes XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 368.135 1056.94 1.52159 -4.41537 1.00837e-05 5.54271e-05 yes XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts OK 1372.27 1731.39 0.33537 -0.958983 0.337567 0.473157 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0.950535 0 -1.79769e+308 -1.79769e+308 0.387454 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts NOTEST 0.267901 1.38187 2.36684 -1.03459 0.30086 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 463.514 2311.63 2.31822 -6.75846 1.39464e-11 2.29979e-10 yes XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 987.152 2024.49 1.03621 -2.34114 0.0192252 0.0409327 yes XLOC_001295 XLOC_001295 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 52641 71632.5 0.444426 -1.30915 0.190483 0.292863 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts NOTEST 0.358204 0.725244 1.01768 -0.395685 0.692337 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts OK 2.9098 124.086 5.41428 -3.95795 7.55964e-05 0.000343657 yes XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts OK 62.9264 99.8224 0.665699 -0.905348 0.365281 0.505266 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts OK 212.722 69.3907 -1.61616 3.35287 0.00079978 0.00279093 yes XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0.589835 0 -1.79769e+308 -1.79769e+308 0.430197 1 no XLOC_001302 XLOC_001302 - chr1:9711789-9884550 hESC Fibroblasts OK 230.865 61.7832 -1.90176 0.241221 0.809384 0.892174 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 1730.22 4844.04 1.48525 -2.88955 0.00385799 0.0106032 yes XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts OK 655.696 509.797 -0.363105 0.953415 0.34038 0.474725 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts OK 197.728 1022.12 2.36997 -5.88377 4.01033e-09 4.68428e-08 yes XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts OK 1126.41 1164.65 0.0481601 -0.135381 0.89231 0.948714 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 109.537 8.07121 -3.76249 4.92282 8.53041e-07 6.46313e-06 yes XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 4.3281 0.333513 -3.69792 1.07353 0.283035 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts OK 57.5421 15.0124 -1.93846 2.98993 0.00279038 0.00826305 yes XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts OK 4914.1 10824.5 1.1393 -2.83384 0.00459923 0.0123577 yes XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts OK 1348.42 1642.04 0.284219 -0.862631 0.38834 0.52847 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts OK 1027.65 807.821 -0.347245 0.981943 0.326128 0.458651 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts OK 1499.45 72.9584 -4.36121 3.71713 0.000201496 0.000822611 yes XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts OK 6757.57 2368.21 -1.51271 4.77367 1.809e-06 1.22691e-05 yes XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts OK 185.116 650.594 1.81333 -3.61536 0.000299929 0.00119545 yes XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts OK 10.2838 18.088 0.814661 -0.159931 0.872936 0.936801 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 7.22153 0 -1.79769e+308 -1.79769e+308 0.0228854 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts OK 754.447 1443.8 0.93638 -2.51973 0.0117444 0.0272095 yes XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 675.842 819.055 0.277274 -0.117677 0.906324 0.958765 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts OK 2184.6 1951.16 -0.163037 0.462258 0.643896 0.757366 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001325 XLOC_001325 - chr1:13182960-13183967 hESC Fibroblasts OK 275.825 207.399 -0.411345 0.794459 0.426928 0.571731 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts NOTEST 8.16584 0 -1.79769e+308 -1.79769e+308 5.37334e-05 1 no XLOC_001334 XLOC_001334 C1orf126 chr1:14925212-15478960 hESC Fibroblasts NOTEST 9.25388 0.859289 -3.42884 0.134917 0.892678 1 no XLOC_001335 XLOC_001335 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 3.71564 2.62025 -0.503903 0.414142 0.67877 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 432.032 288.447 -0.582833 1.15624 0.247582 0.364447 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts OK 115.866 43.2083 -1.42308 0.890662 0.373111 0.513562 no XLOC_001338 XLOC_001338 - chr1:16133656-16134194 hESC Fibroblasts OK 16097 21049.2 0.386973 -1.17641 0.239429 0.353884 no XLOC_001339 XLOC_001339 - chr1:16160709-16266950 hESC Fibroblasts OK 58.2932 39.9858 -0.543842 0.228732 0.819077 0.896351 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 335.879 666.365 0.988372 -2.2638 0.0235863 0.0490992 yes XLOC_001341 XLOC_001341 - chr1:16317618-16317647 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 7.0982 736.676 6.69743 -8.8918 0 0 yes XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts OK 25.9588 46.4136 0.838324 -0.159162 0.873541 0.936801 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts OK 575.636 923.073 0.681288 -2.00994 0.044437 0.0847755 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 1002.4 178.951 -2.48582 5.41958 5.97386e-08 5.77473e-07 yes XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts OK 53.4824 182.341 1.7695 -3.52638 0.000421284 0.00158879 yes XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 268.262 579.556 1.11131 -2.96413 0.00303543 0.00880275 yes XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0.168084 1.79769e+308 1.79769e+308 0.490269 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 173.076 68.2604 -1.34229 1.13343 0.257033 0.374636 no XLOC_001350 XLOC_001350 - chr1:16860385-16864669 hESC Fibroblasts OK 11.9908 0.8365 -3.84142 2.49241 0.012688 0.0287618 yes XLOC_001351 XLOC_001351 - chr1:16888922-16890082 hESC Fibroblasts OK 175.981 1764.52 3.32578 -9.06392 0 0 yes XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 375.075 1717.46 2.19503 -4.85886 1.18066e-06 8.55981e-06 yes XLOC_001353 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 735.986 584.711 -0.331954 0.530539 0.595739 0.714716 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 hESC Fibroblasts OK 14.5824 0 -1.79769e+308 -1.79769e+308 3.7046e-05 0.000182638 yes XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts OK 41.4204 3.15319 -3.71546 0.36015 0.718735 0.820158 no XLOC_001356 XLOC_001356 - chr1:17066767-17299474 hESC Fibroblasts OK 415.352 408.247 -0.0248921 0.0164278 0.986893 0.994837 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 4866.56 2405.66 -1.01647 2.49061 0.0127524 0.02883 yes XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 1430.58 685.305 -1.06178 2.1492 0.0316185 0.0636524 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts OK 1548.47 5372.43 1.79473 -5.61323 1.98579e-08 2.11399e-07 yes XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts OK 66.1047 0.887452 -6.21894 5.15106 2.59013e-07 2.20031e-06 yes XLOC_001361 XLOC_001361 - chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts OK 5456.99 1048.07 -2.38038 7.49464 6.63913e-14 1.64221e-12 yes XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 652.489 536.822 -0.281509 0.749686 0.453444 0.594924 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts OK 89.541 303.773 1.76237 -4.98216 6.28781e-07 4.80731e-06 yes XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 2298.71 2120.72 -0.116271 0.135712 0.892049 0.948714 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 609.245 2369.35 1.9594 -5.53112 3.1819e-08 3.18568e-07 yes XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts OK 11.7019 10.5092 -0.155089 0.218303 0.827193 0.902295 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts OK 17.2325 15.2534 -0.176005 0.235969 0.813457 0.894271 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts OK 695.576 3218.59 2.21015 -6.26108 3.82316e-10 5.27095e-09 yes XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 5246.78 19451.7 1.89039 -4.71234 2.44894e-06 1.58427e-05 yes XLOC_001372 XLOC_001372 - chr1:19665273-19811992 hESC Fibroblasts OK 15.7099 16.6971 0.0879232 -0.00795373 0.993654 0.994837 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 67.0477 628.12 3.22778 -6.81436 9.46843e-12 1.62509e-10 yes XLOC_001374 XLOC_001374 RNF186 chr1:20140522-20141771 hESC Fibroblasts NOTEST 0.423276 0 -1.79769e+308 -1.79769e+308 0.240869 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts OK 35.1082 12.952 -1.43863 1.65431 0.0980649 0.170398 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001379 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts NOTEST 0.74001 2.56345 1.79247 -0.789181 0.430007 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts OK 130.773 10489.8 6.32578 -13.3009 0 0 yes XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts OK 351.837 1509.04 2.10065 -6.42614 1.30882e-10 1.83454e-09 yes XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts OK 4991.33 12716.5 1.34921 -3.48999 0.000483045 0.00178961 yes XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 171.982 129.385 -0.410588 0.621274 0.534419 0.659981 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts OK 306.55 308.235 0.00790812 -0.0190145 0.98483 0.994288 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 1065.05 4455.85 2.06478 -4.10226 4.09131e-05 0.000200046 yes XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 707.133 2118.9 1.58327 -3.92023 8.84634e-05 0.000393639 yes XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 567.103 6484.57 3.51533 -7.31781 2.52021e-13 5.57761e-12 yes XLOC_001388 XLOC_001388 - chr1:21543739-21672034 hESC Fibroblasts NOTEST 0.863796 0.547703 -0.657296 0.0105151 0.99161 1 no XLOC_001389 XLOC_001389 - chr1:21749600-21754300 hESC Fibroblasts OK 59.716 526.991 3.14159 -7.90238 2.66454e-15 8.9635e-14 yes XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 178.62 2.12911 -6.39049 7.54701 4.4631e-14 1.13741e-12 yes XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 815.156 1523.68 0.902415 -2.1363 0.032655 0.0653877 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 1050.98 4755.93 2.17799 -1.78707 0.0739262 0.133416 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts OK 73.6692 0.787764 -6.54715 5.04921 4.43646e-07 3.55339e-06 yes XLOC_001394 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts NOTEST 1.30651 0 -1.79769e+308 -1.79769e+308 0.240869 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts OK 435.794 885.771 1.02329 -2.90144 0.00371451 0.010344 yes XLOC_001396 XLOC_001396 HTR1D chr1:23518388-23521222 hESC Fibroblasts OK 138.505 0 -1.79769e+308 -1.79769e+308 1.57272e-23 6.61328e-22 yes XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 3020.37 5103.63 0.756802 -2.07394 0.038085 0.0750104 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts OK 18.4192 386.766 4.39217 -10.3872 0 0 yes XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 6.26106 774.243 6.95024 -5.5358 3.09806e-08 3.13912e-07 yes XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 762.709 793.086 0.0563441 -0.158044 0.874422 0.936801 no XLOC_001401 XLOC_001401 - chr1:23755055-23811057 hESC Fibroblasts NOTEST 1.51415 0 -1.79769e+308 -1.79769e+308 0.321706 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts OK 95.4288 59.0676 -0.692058 1.38803 0.165129 0.26055 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts OK 3183.79 1504.77 -1.0812 2.85593 0.00429109 0.0116413 yes XLOC_001404 XLOC_001404 - chr1:24069855-24104777 hESC Fibroblasts OK 77.4967 107.333 0.46989 -0.115729 0.907867 0.959192 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 568.398 762.674 0.424165 -0.956359 0.338891 0.473434 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 359.074 1760.73 2.29382 -6.07591 1.23289e-09 1.50269e-08 yes XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts OK 132.316 142.572 0.107708 -0.130272 0.896351 0.951807 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts OK 1582.97 2465.33 0.639147 -1.67213 0.0944981 0.16454 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 3.93809 0 -1.79769e+308 -1.79769e+308 0.00659178 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 7.00921 3.57865 -0.969834 1.07553 0.282138 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 206.886 0.114571 -10.8184 1.81069 0.0701891 0.127769 no XLOC_001413 XLOC_001413 - chr1:24580829-24580859 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 152.011 296.253 0.962658 -1.88521 0.0594018 0.110524 no cummeRbund/inst/extdata/genes.count_tracking0000644000175200017520000012054714516004263022353 0ustar00biocbuildbiocbuildtracking_id iPS_count iPS_count_variance iPS_count_uncertainty_var iPS_count_dispersion_var iPS_status hESC_count hESC_count_variance hESC_count_uncertainty_var hESC_count_dispersion_var hESC_status Fibroblasts_count Fibroblasts_count_variance Fibroblasts_count_uncertainty_var Fibroblasts_count_dispersion_var Fibroblasts_status XLOC_000001 11.4409 2201 -1.11022e-15 327.045 OK 0.494996 4 0 3.78504 OK 20.0725 10516 1.77636e-15 1311.87 OK XLOC_000002 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000003 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000004 0 0 0 0 OK 5.68056 5.68056 0 5.68056 OK 0.198315 0.198315 0 0.198315 OK XLOC_000005 486.456 11962.5 2.84217e-14 11852.8 OK 2495.56 30228.2 4.78506e-13 30871.1 OK 131.575 3358.82 5.68434e-14 2161.89 OK XLOC_000006 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000007 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000008 24241.4 24241.4 0 24241.4 OK 137527 137527 0 137527 OK 83353.1 1.81674e+08 0 1.81674e+08 OK XLOC_000009 141.347 1615.47 0 1615.47 OK 3500.74 53138.7 0 53138.7 OK 10962.1 1.30181e+07 0 1.30181e+07 OK XLOC_000010 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000011 2564.67 135356 0 135356 OK 28070.9 1.64e+06 0 1.64e+06 OK 26679.6 7.95059e+07 0 7.95059e+07 OK XLOC_000012 51.2037 380.022 -4.44089e-16 286.841 OK 190.335 652.866 0 466.513 OK 282.187 10990.7 -2.13163e-14 7508.98 OK XLOC_000013 9.27339 16.5672 0 16.5672 OK 75.4682 94.7225 0 94.7225 OK 160.21 3001.27 0 3001.27 OK XLOC_000014 10.277 19.049 0 19.049 OK 84.3667 115.845 0 115.845 OK 1.42934 1.42934 0 1.42934 OK XLOC_000015 102.333 5241.4 22.937 3211.26 OK 13.737 951 4.40598 263.412 OK 66.2055 148879 26.8791 16469.8 OK XLOC_000016 116.458 1640.82 6.21725e-15 1188.16 OK 1214.51 16151.7 -3.05533e-13 9636.8 OK 521.599 31432.6 -3.55271e-14 20377.4 OK XLOC_000017 5.66037 8 3.57787e-17 6.82697 OK 55.4672 124.111 0 57.2488 OK 113.654 2929.18 -2.13163e-14 1675.66 OK XLOC_000018 109.513 1080.67 0 1080.67 OK 502.184 2296.71 0 2296.71 OK 1367.24 95380.1 0 95380.1 OK XLOC_000019 480.802 11598.9 0 11598.9 OK 14167.9 517645 0 517645 OK 15728.2 1.48338e+07 0 1.48338e+07 OK XLOC_000020 7.06534 10.0913 0 7.67855 OK 25.981 29.9335 2.77556e-16 25.981 OK 46.5981 488.237 0 451.556 OK XLOC_000021 0 0 0 0 OK 2.50523 2.50523 0 2.50523 OK 0 0 0 0 OK XLOC_000022 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000023 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000024 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000025 0 0 0 0 OK 35.9407 70.2933 1.77636e-15 38.8222 OK 0 0 0 0 OK XLOC_000026 241.224 3870.14 0 3870.14 OK 768.285 4571.9 0 4571.9 OK 2400.81 257045 0 257045 OK XLOC_000027 10.0761 15.6915 3.44993e-16 13.5364 OK 196.684 957.717 1.42109e-14 494.892 OK 141.614 4124.2 -7.10543e-14 2375.53 OK XLOC_000028 160.346 7476.23 0.15544 5824.53 OK 892.768 19995.3 0.817735 22356.5 OK 792.407 782064 9.87069 346601 OK XLOC_000029 116.779 1180.53 0 1180.53 OK 400.73 1597.85 0 1597.85 OK 1352.09 93029.7 0 93029.7 OK XLOC_000030 6.14209 7.30868 0 7.30868 OK 6.51564 6.51564 0 6.51564 OK 8.81552 19.8959 0 19.8959 OK XLOC_000031 157.491 7033.69 2.11396 5149 OK 905.692 10440.6 9.30668 13681.7 OK 752.532 177670 14.4719 159978 OK XLOC_000032 0.963422 0.963422 0 0.963422 OK 19.4653 19.4653 0 19.4653 OK 0 0 0 0 OK XLOC_000033 222.274 3843 -2.4869e-14 3470.84 OK 1301.74 10895.9 -2.84217e-14 10782.4 OK 948.748 59102.9 0 53957.4 OK XLOC_000034 18.9347 54.4857 0 54.4857 OK 271.704 849.392 0 849.392 OK 49.2598 398.908 0 398.908 OK XLOC_000035 388.601 12498.2 1.03029e-13 8567.22 OK 1895.8 25082.2 6.82121e-13 19841.1 OK 1205.79 93380.6 -5.68434e-14 85489.7 OK XLOC_000036 584.561 19300.4 3.37508e-14 15650.7 OK 3375.22 72365.3 4.55813e-12 50096.6 OK 3955.85 895188 -5.11591e-13 734258 OK XLOC_000037 1.00359 1.00359 0 1.00359 OK 9.95972 9.95972 0 9.95972 OK 4.172 8.48407 0 8.48407 OK XLOC_000038 81.3317 960.497 6.21725e-15 635.737 OK 1145.48 9187.62 -5.54223e-13 8765.02 OK 1475.37 165754 -2.13163e-13 109170 OK XLOC_000039 6.04165 12.5577 -1.11022e-16 6.04165 OK 73.4222 155.316 1.06581e-14 91.0909 OK 17.8183 154.649 8.88178e-16 70.848 OK XLOC_000040 5.35927 197 0 196.548 OK 70.5268 3591 -1.77636e-15 2088.4 OK 57.2873 2.62357e+06 8.88178e-16 38765.9 OK XLOC_000041 43.7732 2702 21.2785 1605.36 OK 135.959 4371 101.205 4025.95 OK 117.065 461793 68.3686 79217.1 OK XLOC_000042 1.52548 1.52548 0 1.52548 OK 2.49503 2.49503 0 2.49503 OK 7.20104 16.8246 0 16.8246 OK XLOC_000043 2.04736 2.04736 0 2.04736 OK 26.4657 26.4657 0 26.4657 OK 0.8344 0.8344 0 0.8344 OK XLOC_000044 8.67116 12.3414 0 12.3414 OK 77.4887 98.9312 0 98.9312 OK 0.594944 0.594944 0 0.594944 OK XLOC_000045 269.319 9625.25 12.3479 6289.28 OK 2195.04 35326 102.45 34426.4 OK 139.433 24754 67.742 12742.2 OK XLOC_000046 48.2932 1128 0 1127.77 OK 205.951 3231 0 3230.08 OK 151.982 13889 0 13889 OK XLOC_000047 562.295 14778.4 0 14778.4 OK 4366.32 75900.2 0 75900.2 OK 7849.78 2.82964e+06 0 2.82964e+06 OK XLOC_000048 1005.52 42617.3 53.0116 38179.7 OK 2497.29 37501.1 239.268 37222.1 OK 9899.37 5.96779e+06 358.097 5.55159e+06 OK XLOC_000049 3.45232 9.52436 -1.11022e-16 3.45232 OK 12.4649 28.4338 0 12.4649 OK 10.9484 151.304 1.77636e-15 40.7315 OK XLOC_000050 23.827 293.897 0.194424 123.233 OK 7.25602 16.7031 0.373206 7.25602 OK 1161.88 109666 2.98695 75369.2 OK XLOC_000051 453.38 12405.2 0.087877 10611.4 OK 2295.93 32756.4 8.09863 27282.1 OK 2779.84 482545 1.43979 343990 OK XLOC_000052 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000053 3.53267 11.1273 -6.85216e-17 3.53267 OK 47.9821 51.555 0 47.9821 OK 60.6274 662.527 3.55271e-15 565.222 OK XLOC_000054 175.99 2324.21 -6.21725e-15 2306.18 OK 952.251 7088.97 -1.81188e-13 6479.63 OK 9.82027 64.9949 1.65146e-15 27.4528 OK XLOC_000055 507.179 12810 0 12809.8 OK 1193.68 9366 0 9365.61 OK 5205.43 1.2345e+06 -1.27898e-13 1.18067e+06 OK XLOC_000056 11.0797 35.6637 -6.66134e-16 16.0661 OK 203.878 706.505 1.46549e-14 520.232 OK 9.75856 38 4.23273e-16 32.7097 OK XLOC_000057 0.481711 0.481711 0 0.481711 OK 6.44423 6.44423 0 6.44423 OK 0.594944 0.594944 0 0.594944 OK XLOC_000058 4.45592 4.45592 0 4.45592 OK 29.9302 29.9302 0 29.9302 OK 17.9248 64.5406 0 64.5406 OK XLOC_000059 86.2292 978.969 2.66454e-15 696.539 OK 357.733 1853.21 2.0961e-13 1331.51 OK 287.346 9668.46 -7.10543e-15 7737.75 OK XLOC_000060 4.45592 7.90642 -5.55112e-17 4.45592 OK 27.0626 42.1913 2.22045e-16 27.0626 OK 4.88297 13.4574 0 6.98968 OK XLOC_000061 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000062 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000063 109.591 1416.74 0 1168.4 OK 193.908 444.954 -7.10543e-15 477.122 OK 2.37978 4.33669 0 3.35053 OK XLOC_000064 68.8854 578.354 0 578.354 OK 86.3464 120.977 0 120.977 OK 0.594944 0.594944 0 0.594944 OK XLOC_000065 90.8852 1105.37 -7.10543e-15 753.791 OK 403.623 2332.17 3.35731e-13 1619.54 OK 260.311 7940.62 -5.68434e-14 6634.95 OK XLOC_000066 78.9633 13095 4.44089e-16 4426.13 OK 175.392 5609.35 0.00133521 4006.66 OK 148.214 839304 0.421541 76342.7 OK XLOC_000067 25.0095 74.6717 0 74.6717 OK 150.34 309.521 0 309.521 OK 3.93254 6.43363 0 6.43363 OK XLOC_000068 92.1693 801.958 0 801.958 OK 762.203 4511.79 0 4511.79 OK 0 0 0 0 OK XLOC_000069 18.6268 83.5853 0 42.8219 OK 358.868 1291.73 1.42109e-14 1346.97 OK 0.594944 1 0 0.594944 OK XLOC_000070 3.05096 7.97535 2.22045e-16 3.05096 OK 2.48483 6.47165 0 2.48483 OK 6.37403 25.9886 -2.22045e-16 12.0397 OK XLOC_000071 159.973 2538.86 -4.44089e-14 1950.4 OK 750.876 5778.27 1.7053e-13 4401 OK 462.787 24991.7 1.27898e-13 16837.9 OK XLOC_000072 400.713 8852.95 0 8852.95 OK 2457.98 30132.5 0 30132.5 OK 2311.86 242240 0 242240 OK XLOC_000073 52.3004 5566 6.2669 1802.7 OK 300.688 4413.15 44.197 5571.76 OK 571.744 196071 43.5825 131800 OK XLOC_000074 323.018 8940.37 -4.44089e-15 6270.82 OK 1032.88 9645.83 1.42109e-14 7407.2 OK 1493.82 125795 1.95399e-14 110436 OK XLOC_000075 1254.27 50600.6 0 50600.6 OK 1083.92 8011.86 0 8011.86 OK 12340.2 7.84133e+06 0 7.84133e+06 OK XLOC_000076 580.283 20420.5 2.55795e-13 15956.7 OK 586.842 3406.6 2.84217e-13 3064.97 OK 1720.37 186443 2.38742e-12 157208 OK XLOC_000077 1447.87 79538.3 -6.31051e-13 59093.5 OK 6625.58 168739 3.80584e-12 148989 OK 13708.3 1.4489e+07 1.00822e-11 9.83376e+06 OK XLOC_000078 7.94841 13.8155 0 9.26463 OK 86.9841 215.06 -7.10543e-15 120.321 OK 366.013 18648.9 -2.84217e-14 11609.2 OK XLOC_000079 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000080 507.14 12966.8 0 12966.8 OK 888.348 5831.28 0 5831.28 OK 8578.29 3.46542e+06 0 3.46542e+06 OK XLOC_000081 105.498 1257.91 1.77636e-14 969.604 OK 258.748 1095.19 -1.42109e-14 781.37 OK 2126.92 264023 3.41061e-13 207334 OK XLOC_000082 115.011 1135 0 1134.55 OK 314.608 1048.46 -3.55271e-14 1084.64 OK 293.84 10007 2.4869e-14 8491.61 OK XLOC_000083 183.737 3891.94 0 2468.56 OK 1547.44 21306.6 2.84217e-14 14289.8 OK 1039.98 87942 4.26326e-14 64114.9 OK XLOC_000084 412.679 11122.6 1.06581e-13 16586.9 OK 2456.55 68619 0.035145 78121.6 OK 787.755 4.36954e+06 0.994677 943215 OK XLOC_000085 91.6094 881.483 0 881.483 OK 151.513 311.808 0 311.808 OK 990.476 56044 0 56044 OK XLOC_000086 22.8015 67 0 66.2587 OK 114.914 195 0 194.183 OK 7.9194 16 0 15.5536 OK XLOC_000087 1241.73 57219.5 -7.10543e-15 46949.4 OK 6456.86 148888 5.68434e-13 142900 OK 5769.8 1.75317e+06 1.13687e-12 1.46491e+06 OK XLOC_000088 3338.07 283250 -5.68434e-13 198644 OK 6267.35 191774 -8.07887e-12 136195 OK 7140.92 3.31843e+06 1.19371e-12 2.3709e+06 OK XLOC_000089 1028.12 39787.9 3.41061e-13 35685 OK 13394.7 475620 5.1088e-12 471885 OK 21093.2 3.62964e+07 7.22977e-13 3.04197e+07 OK XLOC_000090 138.336 2782.83 1.15463e-14 1536.9 OK 319.522 1711.93 -7.10543e-15 1105.36 OK 691.208 48967.1 3.01981e-14 31790.3 OK XLOC_000091 145.602 2149 -3.55271e-15 1682.98 OK 1133.86 9031.01 0 8612.26 OK 1696.8 173800 -8.52651e-14 139112 OK XLOC_000092 3201.71 187519 4.26326e-14 186839 OK 10323.6 324106 2.27374e-13 313514 OK 9554.82 4.42784e+06 0 4.42784e+06 OK XLOC_000093 21.5572 1054 0 1053.69 OK 2.0001 54 0 53.428 OK 18.6975 4303 0 4302.79 OK XLOC_000094 514.64 12989.4 0 12989.4 OK 1138.82 8677.44 0 8677.44 OK 995.51 57405.1 0 57405.1 OK XLOC_000095 49.5772 516.64 0 273.378 OK 339.421 1273.79 1.66533e-16 1220.93 OK 2.37978 5 6.57569e-17 3.35053 OK XLOC_000096 167.199 4664.69 3.55271e-14 3312.52 OK 1351.26 13206.8 0.562884 20683.8 OK 875.526 66899.6 0.228805 48311.2 OK XLOC_000097 43.9978 219.285 0 219.285 OK 37.0478 37.0478 0 37.0478 OK 425.483 14738.3 0 14738.3 OK XLOC_000098 132.594 1435.67 0 1435.67 OK 577.571 2882.6 0 2882.6 OK 15.9475 75.9065 0 75.9065 OK XLOC_000099 203.367 3003.69 0 3003.69 OK 791.077 4804.87 0 4804.87 OK 19.5788 102.199 0 102.199 OK XLOC_000100 314.948 7980.53 1.56319e-13 5958.21 OK 1734.45 22849.1 -1.7053e-13 17206.5 OK 1637.76 153089 -5.68434e-14 128564 OK XLOC_000101 1.04377 1.04377 0 1.04377 OK 2.0001 2.0001 0 2.0001 OK 0.8344 0.8344 0 0.8344 OK XLOC_000102 1.13454 24 0.25802 23.0051 OK 9.40642 145.804 1.79829 75.1475 OK 11.9147 24191 4.80797 1799.61 OK XLOC_000103 263.662 6282.05 3.21965e-15 4579.38 OK 1938.78 21491.3 -2.40363e-14 20638.6 OK 2480.71 359246 6.43929e-15 280241 OK XLOC_000104 1010.47 37275.9 -7.10543e-14 36490.3 OK 2881.74 39305 5.32907e-14 38916.7 OK 25347.2 6.16321e+07 1.02318e-12 5.51763e+07 OK XLOC_000105 1199.02 45097.9 -1.13687e-13 44749.2 OK 4499.8 76568.1 -2.27374e-13 79630.6 OK 11118.5 6.58273e+06 -1.13687e-12 6.1286e+06 OK XLOC_000106 293.932 5326 0 5326 OK 1830.86 18761.3 0 18761.3 OK 695.807 32506.4 0 32506.4 OK XLOC_000107 291.443 6309.57 6.57252e-14 5266.73 OK 1635.27 16205.9 -9.9476e-14 15646.3 OK 20.4675 270.953 0 132.169 OK XLOC_000108 21.4769 57.8239 1.23794e-15 55.8938 OK 125.813 297.332 7.10543e-15 229.173 OK 4188.31 857043 -2.27374e-13 820502 OK XLOC_000109 2355.33 137949 -2.91323e-13 119991 OK 2347.2 29425.9 1.14397e-12 28110 OK 4108.15 803038 -5.47828e-12 764435 OK XLOC_000110 1.00359 52 0 51.1274 OK 1.00129 12 0 11.9915 OK 0.420531 79 0 78.2514 OK XLOC_000111 0.521883 0.521883 0 0.521883 OK 2.0001 2.0001 0 2.0001 OK 0 0 0 0 OK XLOC_000112 89.4412 867.597 3.55271e-15 781.938 OK 41.0429 59.6164 0 41.0429 OK 0 0 0 0 OK XLOC_000113 0.521883 2 -6.71528e-17 0.521883 OK 1.01025 2.85911 0 1.01025 OK 0 0 0 0 OK XLOC_000114 2.40856 2.40856 0 2.40856 OK 1.48478 1.48478 0 1.48478 OK 0 0 0 0 OK XLOC_000115 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000116 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000117 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000118 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000119 0.21677 0.21677 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000120 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000121 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000122 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000123 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000124 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000125 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK XLOC_000126 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000127 1412.32 81694 -1.13687e-13 58605.1 OK 4770.26 85412.7 3.12639e-12 87456.2 OK 251.686 7474.34 2.84217e-14 6633.34 OK XLOC_000128 635.958 21071.4 -1.7053e-13 17737 OK 1009.46 9146 -4.83391e-13 7134.74 OK 2175.77 276294 -2.19824e-13 219499 OK XLOC_000129 104.626 1830.18 11.5951 1091.41 OK 614.398 4559.32 41.9354 3395.64 OK 1405.74 142522 4.81586 106499 OK XLOC_000130 106.179 1861.85 2.13163e-14 1049.77 OK 438.375 2886.27 4.54747e-13 1842.48 OK 1074.42 85663.7 2.27374e-13 65068.9 OK XLOC_000131 10.357 23.9551 1.11022e-16 16.0081 OK 39.3863 52.5454 0.705696 39.7138 OK 12.7786 79.5559 0.799834 50.6581 OK XLOC_000132 306.218 5761.87 0 5761.87 OK 1118.9 8437.14 0 8437.14 OK 4236.07 795691 0 795691 OK XLOC_000133 0.521883 2 6.68478e-17 0.521883 OK 0 0 0 0 OK 2.68094 4 0 3.30449 OK XLOC_000134 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000135 0 0 0 0 OK 1.00006 7 0 6.30426 OK 0 0 0 0 OK XLOC_000136 957.868 35890.2 3.82805e-13 33751.4 OK 867.124 5645.52 0.0151021 6520.96 OK 1830.88 196213 0.148077 164266 OK XLOC_000137 682.08 30907 -1.77636e-14 19729.7 OK 914.527 9219.61 7.10543e-15 6079.31 OK 959.279 84892.7 -1.42109e-14 54741.3 OK XLOC_000138 270.287 4675.89 0 4675.89 OK 839.998 5295.8 0 5295.8 OK 527.272 21076 0 21076 OK XLOC_000139 591.643 16261 0 16261 OK 3276.8 47768.8 0 47768.8 OK 7970.37 2.91049e+06 0 2.91049e+06 OK XLOC_000140 8.99218 16.1694 0 10.9216 OK 26.5677 28 -9.38919e-17 26.5677 OK 29.4756 278.666 0 156.782 OK XLOC_000141 6.42293 7.18464 0 7.18464 OK 44.9207 44.9207 0 44.9207 OK 0 0 0 0 OK XLOC_000142 1073.33 54182.9 2.27374e-13 38351.9 OK 3152.09 45568 5.11591e-13 44897.2 OK 6489.49 2.5789e+06 6.82121e-12 2.20765e+06 OK XLOC_000143 920.574 28899.4 5.68434e-14 31513.9 OK 4865.07 84189.2 -4.54747e-13 92085.4 OK 4758.67 1.32005e+06 -4.54747e-13 1.08529e+06 OK XLOC_000144 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000145 20.7737 2472 0 411.009 OK 191.88 816.956 -1.77636e-14 592.333 OK 3.63137 290 0 288.395 OK XLOC_000146 1692.31 71791.9 3.06954e-12 74338.1 OK 4960.3 98928 2.27374e-12 93235 OK 15400 1.36383e+07 0.170259 1.29896e+07 OK XLOC_000147 441.064 11848.7 0 10595.3 OK 1082.12 8280.39 2.13163e-14 7981.85 OK 5936.67 1.7084e+06 -2.27374e-12 1.55849e+06 OK XLOC_000148 7.78452 43 2.54338 27.7281 OK 29.111 44 11.898 30.9641 OK 2.56764 4 0.281855 3.69546 OK XLOC_000149 12.0433 53.8636 1.11022e-15 24.1208 OK 250.467 1283.86 9.9476e-14 752.203 OK 25.9911 279.399 4.44089e-16 125.47 OK XLOC_000150 299.279 10036 1.42109e-14 5902.91 OK 3836.41 61273.6 -1.98952e-13 64068.9 OK 743.603 44123.2 0 37568.3 OK XLOC_000151 16.4994 108.427 -8.88178e-16 49.2464 OK 11.4445 25.2423 -1.77636e-15 11.4445 OK 0.8344 2 1.96546e-17 0.8344 OK XLOC_000152 10.7182 21.9841 0 21.9841 OK 40.8185 42.6001 0 42.6001 OK 0.8344 0.8344 0 0.8344 OK XLOC_000153 3.53267 4 0 3.53267 OK 8.98007 16.8091 -8.88178e-16 8.98007 OK 0 0 0 0 OK XLOC_000154 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK XLOC_000155 460.751 15061.5 1.58984e-13 10878.8 OK 2842.9 46867.7 -4.12115e-13 38041.4 OK 2143.78 322525 1.00187e-12 215368 OK XLOC_000156 6.66397 8.52878 0 8.52878 OK 30.5271 30.5271 0 30.5271 OK 10.0054 23.5232 0 23.5232 OK XLOC_000157 44.4792 284 -1.33227e-15 218.421 OK 754.402 4425.79 9.76996e-15 4500.88 OK 0 0 0 0 OK XLOC_000158 0.521883 3 0 2.56278 OK 17.9499 108 0 107.092 OK 0 0 0 0 OK XLOC_000159 211.555 3434 0 3433.85 OK 1122.9 8479.91 2.84217e-14 8546.95 OK 2.5032 4 0 3.63915 OK XLOC_000160 1.44513 4 -4.22297e-17 1.44513 OK 6.05132 8 3.91831e-16 6.05132 OK 0 0 0 0 OK XLOC_000161 669.417 19138.8 0 19138.8 OK 2143.61 24185.8 0 24185.8 OK 2976.89 411506 0 411506 OK XLOC_000162 129.946 1974.36 3.55271e-14 1389.03 OK 586.26 3925.65 1.13687e-13 2946.64 OK 856.318 67404.7 2.84217e-13 44496.9 OK XLOC_000163 600.617 27112.2 1.77636e-15 16934.1 OK 1981.29 27364.4 8.52651e-14 21325 OK 20918.5 5.28006e+07 4.54747e-12 3.14009e+07 OK XLOC_000164 2.52907 2.52907 0 2.52907 OK 42.941 42.941 0 42.941 OK 0 0 0 0 OK XLOC_000165 387.508 8290.68 0 8290.68 OK 1065.12 7793.15 0 7793.15 OK 477.077 17737.6 0 17737.6 OK XLOC_000166 0.481711 2 8.74951e-17 0.481711 OK 1.51538 2 0 1.51538 OK 222.808 7523 0 6405.26 OK XLOC_000167 0 0 0 0 OK 0.989851 0.989851 0 0.989851 OK 0 0 0 0 OK XLOC_000168 14.2508 30.939 0 30.939 OK 53.4059 56.7037 0 56.7037 OK 1.18989 1.18989 0 1.18989 OK XLOC_000169 5.01797 11.0044 7.61652e-18 5.01797 OK 76.9836 188.528 -7.99361e-15 97.8609 OK 2.086 4 -4.30211e-16 2.70955 OK XLOC_000170 1.96702 1.96702 0 1.96702 OK 103.623 163.729 0 163.729 OK 3.21417 4.18493 0 4.18493 OK XLOC_000171 76.3134 628.847 -2.66454e-15 557.958 OK 116.226 620.832 -4.44089e-16 203.975 OK 152.599 2838 0 2837.72 OK XLOC_000172 655.455 19724.7 0 19642.6 OK 1045.8 8520.33 -5.68434e-14 7563.24 OK 5770.33 1.77713e+06 -1.13687e-12 1.51269e+06 OK XLOC_000173 2.04741 48 0 47.0509 OK 18.0315 248 0 247.92 OK 6.43574 12183 0 12182.3 OK XLOC_000174 0 0 0 0 OK 6.44423 6.44423 0 6.44423 OK 5.89881 12.4355 0 12.4355 OK XLOC_000175 140.975 2138.9 7.10543e-15 1595.59 OK 244.431 1214.31 8.52651e-14 707.707 OK 1820.06 224531 -4.54747e-13 172349 OK XLOC_000176 947.571 41095.4 -2.16716e-13 31745.1 OK 12929.7 463082 -1.79057e-12 445172 OK 137.476 4931.37 3.90799e-14 3144.06 OK XLOC_000177 21.1325 2152 13.0708 633.47 OK 99.6027 5358 71.603 3583.64 OK 167.181 2.0068e+08 176.816 1.65294e+06 OK XLOC_000178 0.481711 1 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000179 176.634 2851.35 3.55271e-15 2429.72 OK 391.959 1611.34 2.66454e-15 1539.45 OK 388.658 14536 1.06581e-14 12844.7 OK XLOC_000180 2921.04 178404 -2.98428e-13 165730 OK 3327.08 52459.9 1.49214e-13 48988.6 OK 16373 1.80178e+07 -2.33058e-11 1.5005e+07 OK XLOC_000181 347.244 8024.06 3.90799e-14 6995.42 OK 1826.49 23881.2 -3.97904e-13 19979.7 OK 1625.12 145770 9.9476e-14 127510 OK XLOC_000182 26.535 124.832 8.88178e-16 83.5016 OK 210.843 926.54 7.10543e-15 577.718 OK 0 0 0 0 OK XLOC_000183 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000184 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000185 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000186 112.804 1085 -1.06165e-15 1083.41 OK 1438.42 15095.1 6.82121e-13 12729 OK 3783.18 1.04988e+06 -1.25056e-12 903678 OK XLOC_000187 2.44873 2.44873 0 2.44873 OK 29.0321 29.0321 0 29.0321 OK 53.8757 479.607 0 479.607 OK XLOC_000188 3113.5 257703 1.13687e-13 179886 OK 12355.4 482960 -1.36424e-12 414072 OK 5819.29 1.77727e+06 -4.54747e-13 1.48864e+06 OK XLOC_000189 11.6876 441 2.85244 155.931 OK 14.4756 23.9978 0 21.7343 OK 105.589 10516.8 12.7885 7816.05 OK XLOC_000190 6.34259 31 0 30.0098 OK 2.0001 10 0 9.28648 OK 0 0 0 0 OK XLOC_000191 0.521883 2 7.95533e-18 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000192 7903.98 759076 -5.44986e-12 690586 OK 32971 2.29418e+06 -4.27747e-12 2.13745e+06 OK 43371.8 2.27591e+08 -4.40536e-12 1.71006e+08 OK XLOC_000193 1488.11 63123.9 8.82559 61311.6 OK 2660.48 35024 69.0652 34815.6 OK 5063.6 1.15113e+06 95.2926 1.1353e+06 OK XLOC_000194 639.529 18049.3 1.42109e-14 17886.4 OK 1844.28 20190.8 2.84217e-14 19026.7 OK 2116.77 208542 -5.68434e-14 204736 OK XLOC_000195 629.695 22633.4 -1.42109e-13 17474.2 OK 4118.98 96229.4 -4.09273e-12 69057.9 OK 1463.91 143960 -7.95808e-13 116447 OK XLOC_000196 1876.88 85755.8 0 85755.8 OK 2408.87 29578 0 29578 OK 3447.05 514118 0 514118 OK XLOC_000197 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_000198 22.4001 112.476 3.55271e-15 61.6624 OK 68.5495 82.0564 2.00187e-15 80.9116 OK 1.42934 3 2.68665e-16 1.42934 OK XLOC_000199 829.425 36415.1 -4.35207e-14 29744.5 OK 582.005 3749.43 9.05942e-14 2925.43 OK 6815.79 2.71964e+06 1.15463e-13 2.3092e+06 OK XLOC_000200 226.491 4582.82 -3.55271e-14 3485.52 OK 203.215 678.164 -2.84217e-14 520.036 OK 463.685 27760.6 -5.68434e-14 17365.7 OK XLOC_000201 2.04736 2.04736 0 2.04736 OK 9.49539 9.49539 0 9.49539 OK 0.4172 0.4172 0 0.4172 OK XLOC_000202 1687.92 94413.3 2.98428e-13 73631.2 OK 5611.31 129399 -3.72324e-12 113760 OK 4893.62 1.27347e+06 -8.81073e-12 1.04503e+06 OK XLOC_001217 655.489 33339.1 -9.59233e-14 18737.5 OK 1145.55 13809.5 -4.61853e-14 8759.61 OK 1123.26 127866 -2.52243e-13 73412.7 OK XLOC_001218 5.41934 5.76632 0 5.76632 OK 16.9193 16.9193 0 16.9193 OK 3.56966 6.52646 0 6.52646 OK XLOC_001219 11.6418 157 0 156.388 OK 5.74775 36 0 35.6669 OK 25.5311 198 0 197.604 OK XLOC_001220 171.761 2308 0 2307.33 OK 816.411 5067 0 5066.14 OK 20.6384 160 0 159.736 OK XLOC_001221 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001222 522.034 15787.9 -1.59872e-13 13219 OK 2612.14 48459.7 -2.45848e-12 33302.1 OK 257.984 11412.6 7.19425e-14 6647.07 OK XLOC_001223 0 0 0 0 OK 5.68056 73 0 72.4215 OK 0.198315 6 0 5.10967 OK XLOC_001224 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001225 0 0 0 0 OK 5.68056 73 0 72.4215 OK 0.198315 6 0 5.10967 OK XLOC_001226 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001227 116.658 1146.43 0 1146.43 OK 284.696 913.288 0 913.288 OK 49.0071 397.41 0 397.41 OK XLOC_001228 13.6891 25.3656 0 25.3656 OK 23.5573 23.5573 0 23.5573 OK 38.77 258.572 0 258.572 OK XLOC_001229 10.9592 15.7953 0 15.7953 OK 3.50528 3.50528 0 3.50528 OK 9.64992 23.8695 0 23.8695 OK XLOC_001230 0 0 0 0 OK 1.01025 2 0 1.01025 OK 2.02429 3 0 2.02429 OK XLOC_001231 709.296 32084.8 22.937 22258 OK 5100.3 148516 4.40598 97800.5 OK 4986.07 1.52707e+06 26.8791 1.24037e+06 OK XLOC_001232 4.05455 5 0 4.05455 OK 17.9397 21.6409 2.22045e-16 17.9397 OK 37.279 269.507 2.66454e-15 239.946 OK XLOC_001233 17.4227 48 0 47.7638 OK 32.3946 66.0791 -3.55271e-15 32.3946 OK 22.3437 212.604 -8.88178e-16 127.556 OK XLOC_001234 80.8894 865.482 3.55271e-15 617.327 OK 363.59 2358.25 1.98952e-13 1379.35 OK 358.575 21453.3 1.35003e-13 11175.5 OK XLOC_001235 0.481711 1 0 0.481711 OK 21.4756 24 0 23.1974 OK 0 0 0 0 OK XLOC_001236 1.48531 4.45559 -5.55112e-17 1.48531 OK 36.4968 64.7161 3.55271e-15 36.4968 OK 12.2618 39 -1.89519e-16 37.7139 OK XLOC_001237 0.481711 1 0 0.481711 OK 1.9899 2 0 1.9899 OK 4.46577 7 0 6.06008 OK XLOC_001238 755.389 29522.9 -2.4869e-14 23038.9 OK 3448.3 63927.2 2.55795e-13 51869 OK 14509.7 1.44729e+07 -5.79803e-12 1.14551e+07 OK XLOC_001239 6.06174 6.24262 0 6.24262 OK 38.3949 38.3949 0 38.3949 OK 55.9469 575.399 0 575.399 OK XLOC_001240 431.345 12754.6 -3.37508e-14 10099 OK 1589.17 15263 -1.13687e-13 15702.3 OK 3579.2 721186 -1.23634e-12 598865 OK XLOC_001241 23.8452 559 0 558.284 OK 131.895 1304 0 1303.23 OK 58.6426 9812 0 9811.98 OK XLOC_001242 223.725 10970.1 0.15544 8126.77 OK 1988.72 48684.8 0.669037 49801.3 OK 3351.93 1.74123e+06 4.48142 1.46614e+06 OK XLOC_001243 747.798 44169.9 1.27898e-13 27163.6 OK 4938.46 140259 0.148698 123668 OK 4950.16 4.4067e+06 5.38927 2.16521e+06 OK XLOC_001244 309.189 6798.34 -7.10543e-15 5848.24 OK 3476.32 60998.2 -1.59162e-12 52547.7 OK 3605.05 765531 -1.89004e-12 602384 OK XLOC_001245 897.877 49949.2 -9.50351e-14 37243.5 OK 333.288 1882.03 0 1186.67 OK 24551.5 5.30546e+07 -5.2367e-12 4.01725e+07 OK XLOC_001246 715.564 21339.2 -2.84217e-13 21180.9 OK 2619.7 48142.8 3.41061e-12 33400.3 OK 4130.34 1.17439e+06 4.54747e-13 788532 OK XLOC_001247 1303.91 70471.7 -7.95808e-13 50567.3 OK 4892.85 111822 9.09495e-13 91163.8 OK 4672.34 1.49905e+06 -5.00222e-12 987107 OK XLOC_001248 734.586 26672.8 2.11396 24016.5 OK 2565.8 40646.7 9.30668 38759.9 OK 4112.43 946098 14.4719 874245 OK XLOC_001249 30.6297 166.727 7.10543e-15 109.842 OK 104.077 311.13 2.84217e-14 163.929 OK 118.678 3260.27 -1.06581e-14 2096.82 OK XLOC_001250 12.3243 26.2426 0 26.2426 OK 83.2646 117.1 0 117.1 OK 186.689 3807.84 0 3807.84 OK XLOC_001251 1387.41 81880.6 2.13163e-14 55181.9 OK 4489.52 104679 2.55795e-13 79309 OK 7024.54 3.05593e+06 -2.27374e-13 2.21318e+06 OK XLOC_001252 169.119 31629.4 -9.32587e-15 6202.34 OK 4355.88 199620 -2.62013e-13 128984 OK 4931.92 1.12678e+07 4.3574e-12 3.3374e+06 OK XLOC_001253 5.39263 198 0 197.772 OK 39.9337 1183 0 1182.5 OK 56.7623 38411 0 38410.7 OK XLOC_001254 554.177 26405.2 1.56319e-13 20324.1 OK 4295.06 100481 -5.96856e-13 127183 OK 4735.28 5.05129e+06 -8.52651e-13 3.20433e+06 OK XLOC_001255 380.85 14417 21.2785 13967.5 OK 1333.14 39925 101.205 39476.4 OK 3195.71 2.28628e+06 68.3686 2.16251e+06 OK XLOC_001256 573.594 17315.9 1.77636e-14 15189 OK 3369.45 53006.6 -6.70752e-12 50074 OK 3204.06 508525 -7.95808e-13 447124 OK XLOC_001257 5224.53 390283 -1.74083e-13 383983 OK 15162.3 588633 4.61853e-14 580074 OK 42400 1.8633e+08 9.9476e-13 1.59686e+08 OK XLOC_001258 38.1366 250.79 -1.77636e-15 164.236 OK 276.892 1181.2 -1.42109e-14 872.164 OK 15.4833 50 0 49.766 OK XLOC_001259 0 0 0 0 OK 7.00036 15.4118 8.88178e-16 7.00036 OK 0 0 0 0 OK XLOC_001260 2.04736 5.12607 1.11022e-16 2.04736 OK 4.50533 5 0 4.50533 OK 0 0 0 0 OK XLOC_001261 3.1313 3.1313 0 3.1313 OK 15.4855 15.4855 0 15.4855 OK 0 0 0 0 OK XLOC_001262 5.87104 655 4.41275 137.103 OK 38.4374 743 29.1573 602.843 OK 24.8876 8539 10.5313 2274.36 OK XLOC_001263 128.857 3227.25 7.93517 3009.13 OK 1255.23 21541.9 73.2931 19686.6 OK 1675.32 193397 57.2107 153100 OK XLOC_001264 28.0605 317.147 2.88658e-15 201.367 OK 159.485 1899.34 8.9706e-14 1819.82 OK 110.277 4664.13 -7.10543e-15 3928.98 OK XLOC_001265 46.4864 334 0 333.595 OK 2013.39 22974 0 22973.9 OK 316.695 11284 0 11283.3 OK XLOC_001266 219.978 8486 53.0116 8352.6 OK 901.76 14023.3 239.268 13440.8 OK 1445.96 1.28514e+06 358.097 810896 OK XLOC_001267 177.998 2342 0 2341.89 OK 948.601 6446 0 6445.66 OK 1062.64 63378 0 63377.8 OK XLOC_001268 2.97061 2.97061 0 2.97061 OK 3.50528 3.50528 0 3.50528 OK 0 0 0 0 OK XLOC_001269 2.1868 12 0.194424 11.3101 OK 3.20882 6.61852 0.373206 3.20882 OK 37.6678 4910 2.98695 2443.44 OK XLOC_001270 1.04769 25 0.087877 24.5211 OK 37.0717 532 8.09863 440.517 OK 7.93134 15880 1.43979 981.461 OK XLOC_001271 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0.594944 0.594944 0 0.594944 OK XLOC_001272 0 0 0 0 OK 0 0 0 0 OK 3.51534 5.28145 0 5.28145 OK XLOC_001273 312.526 9800.77 0 7369.27 OK 1658.84 18714.2 1.7053e-13 16007 OK 907.669 78190.9 1.13687e-13 51790.9 OK XLOC_001274 213.324 4754.26 -1.06581e-14 3168.71 OK 1360.33 18284.8 -4.83169e-13 11595.6 OK 773.354 57030.2 -1.06581e-13 38124 OK XLOC_001275 514.963 12901 0 12900.1 OK 2823.14 38253.8 0 37631.1 OK 1294.64 96276.9 0 86399.1 OK XLOC_001276 886.334 28798.7 0 28798.7 OK 3538.15 54073.2 0 54073.2 OK 2996.18 391842 0 391842 OK XLOC_001277 462.278 14649.4 1.56319e-13 11060.6 OK 923.086 6795.73 1.98952e-13 6167.03 OK 2276.69 310817 -5.11591e-13 232457 OK XLOC_001278 305.253 6367.48 1.42109e-14 5660.97 OK 879.265 5710.28 -1.42109e-14 5694.68 OK 1502.93 120875 -7.99361e-14 111512 OK XLOC_001279 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK XLOC_001280 111.96 1622.66 -8.38218e-15 1117.3 OK 920.538 8727.25 8.30447e-14 6145.63 OK 458.074 21770.8 -1.33227e-15 16580.2 OK XLOC_001281 43.7166 439.416 -4.66294e-15 210.316 OK 195.653 777.717 7.4607e-14 491.928 OK 24.4692 220.321 8.88178e-16 116.005 OK XLOC_001282 1914.7 109209 -5.68434e-14 88285.8 OK 8864.52 244515 6.82121e-13 239547 OK 16108.2 1.66466e+07 1.81899e-12 1.45579e+07 OK XLOC_001283 2846.15 174278 0 159535 OK 6613.34 163311 0.00133521 151075 OK 10447.7 5.86922e+06 0.421541 5.38142e+06 OK XLOC_001284 121.997 2030.29 -8.88178e-16 1252.85 OK 726.676 6189.19 0 4199.91 OK 1656.1 214033 0 146291 OK XLOC_001285 502.78 19292.8 3.83693e-13 12426.9 OK 4987.66 143015 -3.32712e-12 94171.1 FAIL 5178.3 1.94141e+06 -1.0516e-12 1.52612e+06 FAIL XLOC_001286 9.99577 14.1364 0 13.1442 OK 30.5067 37.0433 0 30.5067 OK 5.41621 10.9198 0 9.70999 OK XLOC_001287 200.679 5860.88 -3.55271e-15 2872.55 OK 2088.82 32328.3 1.73372e-12 23356.8 OK 274.74 14406.7 -3.90799e-14 7520.86 OK XLOC_001288 553.019 14392 0 14391.8 OK 535.65 2587.66 0 2564.78 OK 830.74 47365 2.4869e-14 42210.4 OK XLOC_001289 461.049 9992.45 2.84217e-14 10932.1 OK 1649.77 23928.5 0 15865.6 OK 3521.08 599321 3.63798e-12 535561 OK XLOC_001290 957.313 35668 6.2669 32996.9 OK 4549.94 86241.1 44.197 84310.5 OK 4640.31 1.16961e+06 43.5825 1.0697e+06 OK XLOC_001291 0.481711 15 1.19696e-16 13.2462 OK 0.495301 3 0 2.58687 OK 0 0 0 0 OK XLOC_001292 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 2.02429 2.02429 0 2.02429 OK XLOC_001293 895.44 40630.2 2.84217e-14 29846 OK 1433.57 13854 7.10543e-15 12695.6 OK 5803.44 1.61269e+06 -2.84217e-14 1.53911e+06 OK XLOC_001294 700.026 25915.6 -5.40012e-13 20495 OK 7653.67 205954 -1.5751e-11 189071 OK 10936.5 7.94694e+06 8.36309e-12 6.28788e+06 OK XLOC_001295 3.4925 103 0 102.252 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001296 14837.2 1.82192e+06 -5.08749e-12 1.72115e+06 OK 86290.6 1.02218e+07 1.38982e-11 1.09042e+07 OK 92886.8 4.53921e+08 -2.43006e-11 3.54859e+08 OK XLOC_001297 0 0 0 0 OK 0.505127 0.505127 0 0.505127 OK 0.8344 0.8344 0 0.8344 OK XLOC_001298 4.01438 7.05896 8.32667e-17 4.01438 OK 5.48498 7 -1.8323e-17 5.48498 OK 229.793 16758.9 -2.66454e-15 7613.38 OK XLOC_001299 19.6705 103.911 -4.44089e-16 48.1434 OK 64.4779 127.59 -4.44089e-15 72.9329 OK 74.4814 1261.02 1.11022e-15 809.277 OK XLOC_001300 148.894 1762.49 0 1762.49 OK 851.217 5456.86 0 5456.86 OK 224.353 5239.76 0 5239.76 OK XLOC_001301 0 0 0 0 OK 1.01031 33 0 32.1292 OK 0 0 0 0 OK XLOC_001302 27.6993 1114 0 1113.33 OK 188.867 6007 0 6006.23 OK 40.3228 48281 0 48280.3 OK XLOC_001303 979.546 48905.7 -4.54747e-13 39371.1 OK 8732.83 304292 0.035145 277716 OK 19117.1 3.02961e+07 0.994677 2.28898e+07 OK XLOC_001304 552.878 20004 2.84217e-14 14418.4 OK 1949.6 19306.5 1.13687e-13 20761.6 OK 1223.31 96823.6 1.13687e-13 78394.8 OK XLOC_001305 172.458 2922.26 3.55271e-14 2221.03 OK 274.57 1109.42 3.55271e-14 859.956 OK 1135.78 79395.7 -3.4639e-13 69764.8 OK XLOC_001306 769.075 28671.2 -2.84217e-14 23478 OK 2617.8 31164.5 1.13687e-13 33357.1 OK 2228.87 227430 2.27374e-13 223848 OK XLOC_001307 43.1951 475.488 -5.77316e-15 221.092 OK 509.516 3934.24 -8.65974e-14 2360.05 OK 24.4149 171.543 0 112.101 OK XLOC_001308 1.44513 3 -4.33681e-18 1.44513 OK 9.93931 11.2157 -1.76942e-16 9.93931 OK 0.594944 2 5.46438e-17 0.594944 OK XLOC_001309 69.649 561.276 1.38778e-17 484.076 OK 133.966 331.387 -2.498e-16 252.311 OK 29.2361 155 0 154.83 OK XLOC_001310 769.113 33863.9 -1.13687e-13 23478.2 OK 5482.84 111642 1.13687e-13 109883 OK 9000.15 5.28437e+06 -9.09495e-13 4.14032e+06 OK XLOC_001311 1548.41 69383.3 4.26326e-14 64885.1 OK 3762.25 63337.6 2.27374e-13 59803.6 OK 3708.59 652555 8.52651e-14 597919 OK XLOC_001312 2139.21 107524 -2.84217e-14 104562 OK 8701.37 234462 2.27374e-13 232436 OK 5265.15 1.31842e+06 0 1.21165e+06 OK XLOC_001313 172.177 4355 3.77476e-15 3411.14 OK 2165.11 32603.9 0.562884 33141.2 OK 84.3335 4654 0.228805 4653.49 OK XLOC_001314 1836.93 95192.3 -4.26326e-14 83365.3 OK 7192.85 176466 -2.27374e-13 170626 OK 2148.03 210899 0 215444 OK XLOC_001315 352.933 9079.04 0.25802 7156.45 OK 1207.41 12154.4 1.79829 9645.93 OK 3370.88 770019 4.80797 509141 OK XLOC_001316 0.963422 17 0 16.7331 OK 7.46469 80 0 79.4624 OK 10.246 1158 0 1157.46 OK XLOC_001317 167.837 2748.29 0 2748.29 OK 3.99001 3.99001 0 3.99001 OK 0 0 0 0 OK XLOC_001318 612.757 25268.3 0 16873.4 OK 1756.8 20480.9 5.68434e-14 17552 OK 2708.47 450850 -5.68434e-14 376136 OK XLOC_001319 779.914 36032 2.8727e-13 23966.6 OK 987.51 9662.86 -4.68958e-13 6886.76 OK 943.459 86642.5 -1.90958e-13 52890 OK XLOC_001320 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001321 55.5587 324 0 323.913 OK 1891.46 19933 0 19932.8 OK 1375.98 102607 0 102606 OK XLOC_001322 0.120428 0.120428 0 0.120428 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001323 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001324 0.43354 3 1.37423e-17 0.43354 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001325 7.66739 9.29871 0 9.29871 OK 240.308 693.118 0 693.118 OK 146.188 2496.11 0 2496.11 OK XLOC_001326 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001327 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001328 0.16057 2 -1.19262e-17 0.16057 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001329 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001330 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001331 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001332 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001333 4.9778 4.9778 0 4.9778 OK 15.0008 15.0008 0 15.0008 OK 0 0 0 0 OK XLOC_001334 22.6294 321 11.5951 236.059 OK 67.2598 422 41.9354 371.729 OK 5.03478 7864 4.81586 381.433 OK XLOC_001335 0.521884 1 0 0.806644 OK 11.5755 13 0.705696 11.6717 OK 6.62983 27 0.799834 26.2825 OK XLOC_001336 327.13 8908.37 -9.9476e-14 6389.79 OK 840.595 7356.8 -2.27374e-13 5299.03 OK 468.195 27191.2 -4.26326e-14 17167.4 OK XLOC_001337 101.965 3593 0 3592.82 OK 248.768 1871 0.0151021 1870.79 OK 74.9987 6729 0.148077 6728.85 OK XLOC_001338 1176.82 43435.6 0 43435.6 OK 6129.63 133968 0 133968 OK 6380.34 1.97115e+06 0 1.97115e+06 OK XLOC_001339 72.6602 2488 0 2487.37 OK 158.544 3001 0 3000.9 OK 87.8318 20032 0 20031.4 OK XLOC_001340 167.481 3401.66 3.90243e-14 2222.68 OK 857.006 6797.05 4.38982e-13 5461.57 OK 1417.12 126654 -1.68254e-13 100551 OK XLOC_001341 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001342 201.487 6195.79 5.68434e-14 3986.43 OK 18.8982 75.9218 0 58.3387 OK 1558.71 146046 -1.13687e-13 123789 OK XLOC_001343 6.04182 1066 0 119.538 OK 38.39 136.233 -4.44089e-16 118.51 OK 55.362 15397 -8.88178e-16 4396.71 OK XLOC_001344 379.438 8340.73 0 8035.25 OK 2305.96 27664 2.66454e-14 27379 OK 3001.55 447835 0 447834 OK XLOC_001345 197.106 3619.86 1.42109e-14 2766.33 OK 2693.21 43913.6 -4.54747e-13 34893.7 OK 287.323 8163.51 -4.9738e-14 7737.59 OK XLOC_001346 16.0977 32.2129 0 32.2129 OK 78.8205 104.945 0 104.945 OK 215.616 4838.83 0 4838.83 OK XLOC_001347 404.062 10980.7 4.08562e-14 8902.49 OK 799.052 5505.65 -1.02363e-13 4869.8 OK 1389.41 112924 8.52651e-14 97426.3 OK XLOC_001348 0.957894 43 0 42.0774 OK 0 0 0 0 OK 0.502332 424 0.170259 423.709 OK XLOC_001349 87.293 785 -6.66134e-16 713.409 OK 347.599 1894.33 -2.13163e-14 1269.66 OK 100.531 2325.84 7.10543e-15 1387.68 OK XLOC_001350 22.0823 86 2.54338 78.6562 OK 29.4125 44 11.898 31.2848 OK 1.65868 3 0.281855 2.38724 OK XLOC_001351 90.4847 780.57 0 780.57 OK 183.038 431.934 0 431.934 OK 1470.59 112008 0 112008 OK XLOC_001352 534.906 24223.6 7.10543e-15 13998 OK 997.363 9454.48 9.23706e-14 7009.28 OK 3727.67 959836 -1.62004e-12 607000 OK XLOC_001353 232.754 7255.32 -2.59792e-14 3661.33 OK 1210.6 15042.3 -4.26326e-13 9591.79 OK 604.171 46499 4.61853e-14 25599.1 OK XLOC_001354 1.56565 2 0 1.56565 OK 25.4554 34.636 -5.55112e-17 25.4554 OK 0 0 0 0 OK XLOC_001355 26.776 1515 0 528.124 OK 177.211 3016.97 3.55271e-15 2959.46 OK 11.1644 6336 -8.88178e-16 564.05 OK XLOC_001356 10.3168 204 0 203.486 OK 78.8307 1317 0 1316.49 OK 56.7096 2866 0 2865.09 OK XLOC_001357 741.576 26025.8 -5.68434e-14 22268.5 OK 4750.62 83886 -2.27374e-13 86977.2 OK 1906.3 276042 -1.27898e-13 212611 OK XLOC_001358 446.316 13960.2 2.89546e-13 10411.1 OK 4610.76 101712 -1.35003e-13 82785.3 OK 1573.35 137201 1.3145e-12 119765 OK XLOC_001359 622.652 17272.2 0 17272.2 OK 1579.1 14771.3 0 14771.3 OK 4419.26 843537 0 843537 OK XLOC_001360 47.4502 296.728 0 247.85 OK 284.923 974.398 0 914.64 OK 2.9204 6 1.65585e-16 4.68651 OK XLOC_001361 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001362 5270.78 462599 -4.54747e-13 398570 OK 22169.8 1.21597e+06 9.09495e-13 1.09832e+06 OK 3430.99 540643 2.27374e-13 534066 OK XLOC_001363 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001364 338.453 9119.74 -3.55271e-14 6705.98 OK 2180.08 28511.3 -4.05009e-13 24863.9 OK 1464.67 130489 -1.13687e-13 105838 OK XLOC_001365 238.616 3881.51 0 3881.51 OK 540.696 2585.27 0 2585.27 OK 1481.34 112518 0 112518 OK XLOC_001366 4473.45 338397 -1.36424e-12 303457 OK 17827.6 926276 -1.48077e-11 766031 OK 12375.9 1.29101e+07 2.26663e-12 7.95418e+06 OK XLOC_001367 564.542 19426.4 4.26326e-13 14829.8 OK 2615.13 38574.6 7.95808e-13 33291.3 OK 8277.46 3.47152e+06 9.09495e-13 3.15571e+06 OK XLOC_001368 7.48679 10 3.41524e-17 8.0333 OK 26.5422 27 0 26.5422 OK 19.2924 75.9899 0 73.4272 OK XLOC_001369 7.08542 7.95273 0 7.95273 OK 19.4755 19.4755 0 19.4755 OK 13.8725 41.5589 0 41.5589 OK XLOC_001370 174.426 2712.6 -2.66454e-15 2316.3 OK 872.826 5698 1.42109e-14 5626.23 OK 3243.82 500823 -6.56364e-13 460572 OK XLOC_001371 2215.76 121725 1.6307e-12 110054 OK 8128.53 212291 6.50147e-13 208839 OK 24221.3 4.53878e+07 3.52429e-12 3.84257e+07 OK XLOC_001372 29.7061 1476 0 1475.46 OK 32.0017 823 0 822.192 OK 27.3971 43465 0 43464 OK XLOC_001373 75.9931 1240.99 -7.99361e-15 615.069 OK 186.785 591.22 -2.13163e-14 450.018 OK 1373.01 109848 3.37508e-13 94927 OK XLOC_001374 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK XLOC_001375 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001376 41.1079 371.868 0 236.164 OK 29.4556 31 -3.4792e-16 29.4556 OK 8.80812 25.4984 2.16515e-16 23.3156 OK XLOC_001377 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001378 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001379 0 0 0 0 OK 1.00005 2 0 1.00005 OK 5.0064 12 0 11.5431 OK XLOC_001380 249.7 7791.27 5.68434e-14 5433.97 OK 297.689 1072.6 -1.77636e-15 987.676 OK 17830.9 2.26341e+07 0 2.01954e+07 OK XLOC_001381 369.343 7702.97 0 7702.97 OK 853.157 5421.54 0 5421.54 OK 2956.3 383602 0 383602 OK XLOC_001382 3591.63 238811 6.39488e-14 221253 OK 10342.6 313444 -2.13163e-13 308238 OK 21264.4 3.0893e+07 4.61853e-13 2.77297e+07 OK XLOC_001383 92.4505 997.523 5.32907e-15 789.951 OK 617.028 4872.07 -2.27374e-13 3286.64 OK 222.666 9232.43 -8.52651e-14 5504.63 OK XLOC_001384 93.4545 1189.07 0 788.563 OK 1061.76 8151.18 1.7053e-13 7784.59 OK 874.097 55713.5 1.13687e-13 49035.8 OK XLOC_001385 2298.02 160521 -1.08713e-12 117499 OK 2886.91 54477.5 -3.04112e-12 39131.4 OK 11219.8 9.40223e+06 -7.38964e-12 6.35238e+06 OK XLOC_001386 2091.93 131108 -1.79057e-12 100568 OK 4264.04 83728 1.23634e-12 73035.4 OK 10050.7 5.73084e+06 8.98126e-12 4.95374e+06 OK XLOC_001387 428.676 11788.1 -8.52651e-14 9851.25 OK 2951.05 41606.6 -7.88702e-13 40574.8 OK 27418.9 6.21471e+07 -1.31308e-11 5.19017e+07 OK XLOC_001388 7.58727 175 0 174.36 OK 1.9899 28 0 27.3597 OK 1.01214 1916 0 1915.9 OK XLOC_001389 77.9796 588.486 0 588.486 OK 119.499 207.666 0 207.666 OK 848.646 44213.8 0 44213.8 OK XLOC_001390 73.5433 924.28 -7.10543e-15 522.754 OK 603.149 3116.11 2.84217e-14 3090.49 OK 5.71737 11 8.29198e-16 9.18922 OK XLOC_001391 1454.97 85794.6 1.7053e-13 59172.9 OK 3126.84 49819.3 8.81073e-13 44356.5 OK 4862.2 1.42986e+06 5.11591e-13 1.03277e+06 OK XLOC_001392 706.838 25866.2 13.0708 21188.3 OK 13733 586186 71.603 494105 OK 55508.1 7.80425e+08 176.816 5.48817e+08 OK XLOC_001393 24.568 74 2.18759e-15 72.1112 OK 293.072 989.27 0 966.596 OK 2.5032 5 2.84495e-16 3.63915 OK XLOC_001394 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK XLOC_001395 2893.15 177035 5.28644e-12 161466 OK 3907.87 79224.6 -1.79767e-12 63489.5 OK 6450.78 2.26973e+06 0 1.93158e+06 OK XLOC_001396 246.079 4099.51 0 4099.51 OK 392.791 1565.31 0 1565.31 OK 0 0 0 0 OK XLOC_001397 3152.07 226618 -3.86535e-12 182641 OK 7907.82 249848 -5.57066e-12 199395 OK 10718.3 6.87992e+06 1.45519e-11 5.77034e+06 OK XLOC_001398 106.217 2147.31 2.85244 1417.1 OK 81.3763 123 0 122.182 OK 1396.85 131933 12.7885 103399 OK XLOC_001399 56.2429 743.79 1.77636e-15 517.342 OK 3.99001 7.38014 -1.11022e-16 3.99001 OK 744.847 48841.5 9.76996e-15 35871.7 OK XLOC_001400 441.18 11753 2.55795e-13 10292.3 OK 2959.67 41569.8 3.36975e-12 40611.5 OK 2517.7 318112 6.82121e-13 283834 OK XLOC_001401 11.0396 258 0 257.543 OK 3.00016 42 0 41.1671 OK 0 0 0 0 OK XLOC_001402 36.0089 171 0 170.375 OK 511.032 2376.24 0 2372.72 OK 255.821 7221 0 7220.07 OK XLOC_001403 1186.27 62866.3 0 44551.9 OK 3761.01 60973.9 5.68434e-14 60396.4 OK 1500.14 147986 -5.68434e-14 112256 OK XLOC_001404 11.0532 1893 8.82559 455.4 OK 73.577 1212 69.0652 962.843 OK 81.7724 51466 95.2926 18334 OK XLOC_001405 182.213 3919.52 1.79856e-14 2442.65 OK 853.039 6294.65 4.20997e-13 5425.09 OK 944.299 73078 7.07434e-13 53856.2 OK XLOC_001406 132.034 2404.99 1.5099e-14 1558.43 OK 545.447 3080.77 1.26121e-13 2632.42 OK 2144.86 261899 3.12639e-13 210269 OK XLOC_001407 162.703 2007 0 2006.23 OK 255.136 826.119 5.32907e-15 761.18 OK 230.544 7636 -8.88178e-16 5421.28 OK XLOC_001408 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001409 2062.34 145389 1.13687e-13 98998.8 OK 3804.42 91806 9.09495e-13 60998.1 OK 4517.24 1.27459e+06 -3.41061e-13 882248 OK XLOC_001410 5.78053 19.9707 -6.10623e-16 8.54718 OK 17.455 42.3917 4.44089e-16 17.455 OK 0 0 0 0 OK XLOC_001411 6.94482 8 0 7.70653 OK 19.4653 30.1267 -8.88178e-16 19.4653 OK 7.85769 19.2218 4.34115e-16 16.5967 OK XLOC_001412 157.564 2558.35 7.99361e-15 1916.98 OK 441.599 2356.17 1.06581e-13 1864.58 OK 0.4172 3 -2.86229e-17 0.4172 OK XLOC_001413 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK XLOC_001414 166.036 3013.33 6.21725e-15 2261.74 OK 403.644 1980.44 -1.62093e-14 1618.96 OK 616.536 41117.5 3.4639e-14 26492.2 OK cummeRbund/inst/extdata/genes.fpkm_tracking0000644000175200017520000015531514516004263022161 0ustar00biocbuildbiocbuildtracking_id class_code nearest_ref_id gene_id gene_short_name tss_id locus length coverage iPS_FPKM iPS_conf_lo iPS_conf_hi iPS_status hESC_FPKM hESC_conf_lo hESC_conf_hi hESC_status Fibroblasts_FPKM Fibroblasts_conf_lo Fibroblasts_conf_hi Fibroblasts_status XLOC_000001 - - XLOC_000001 - TSS1 chr1:11873-29961 - - 20.2175 0 182.529 OK 0.347386 0 3.15457 OK 16.1506 0 182.924 OK XLOC_000002 - - XLOC_000002 OR4F5 - chr1:69090-70008 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000003 - - XLOC_000003 - - chr1:321083-321114 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000004 - - XLOC_000004 - - chr1:321145-321223 - - 0 0 0 OK 697259 112161 1.28236e+06 OK 14237.7 0 78180.9 OK XLOC_000005 - - XLOC_000005 - TSS2,TSS3 chr1:322036-328580 - - 355.823 204.49 507.156 OK 696.704 593.435 799.973 OK 48.0566 5.46055 90.6526 OK XLOC_000006 - - XLOC_000006 OR4F16 - chr1:367658-368595 - - 1.51396 0 5.87661 OK 0 0 0 OK 0 0 0 OK XLOC_000007 - - XLOC_000007 - TSS4 chr1:420205-421839 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000008 - - XLOC_000008 - - chr1:566461-568045 - - 41712.9 41177.1 42248.8 OK 91983.2 91487.1 92479.3 OK 69492.5 47017.9 91967.2 OK XLOC_000009 - - XLOC_000009 - - chr1:568148-568842 - - 665.127 286.861 1043.39 OK 6464.44 5613.09 7315.78 OK 26012.6 8889.07 43136.2 OK XLOC_000010 - - XLOC_000010 - - chr1:568843-568912 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000011 - - XLOC_000011 - - chr1:569326-570349 - - 7343.63 5236.71 9450.56 OK 31401.9 28536.7 34267 OK 37535.9 12446.1 62625.8 OK XLOC_000012 - - XLOC_000012 - TSS5 chr1:763063-789740 - - 121.633 0 259.917 OK 182.273 125.346 239.2 OK 292.077 0 644.751 OK XLOC_000013 - - XLOC_000013 - - chr1:791897-794579 - - 8.98318 1.09737 16.869 OK 28.2795 20.9855 35.5735 OK 74.5004 23.5495 125.451 OK XLOC_000014 - - XLOC_000014 - TSS6 chr1:846814-850328 - - 8.69571 1.30977 16.0817 OK 27.5823 20.5446 34.6199 OK 0.58031 0 1.55109 OK XLOC_000015 - - XLOC_000015 SAMD11 TSS7,TSS8,TSS9 chr1:860529-894679 - - 196.483 0 740.472 OK 6.25295 0 33.0867 OK 38.7341 0 453.498 OK XLOC_000016 - - XLOC_000016 KLHL17 TSS10,TSS11,TSS12,TSS13 chr1:895966-901095 - - 183.535 30.7277 336.341 OK 741.918 573.418 910.418 OK 347.16 71.5937 622.727 OK XLOC_000017 - - XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 - - 6.18615 0.0532496 12.3191 OK 22.784 13.6492 31.9187 OK 59.3098 2.1237 116.496 OK XLOC_000018 - - XLOC_000018 ISG15 TSS15 chr1:948846-949915 - - 550.84 220.139 881.541 OK 987.18 798.765 1175.6 OK 3379.09 1852.53 4905.64 OK XLOC_000019 - - XLOC_000019 AGRN TSS16 chr1:955502-991492 - - 162.844 89.8907 235.797 OK 1857.6 1668.93 2046.27 OK 2553.38 1302.85 3803.9 OK XLOC_000020 - - XLOC_000020 - TSS17 chr1:995082-1001833 - - 22.5944 1.03271 44.1561 OK 32.064 18.0485 46.0795 OK 70.3957 3.16407 137.627 OK XLOC_000021 - - XLOC_000021 - TSS18 chr1:1072396-1079432 - - 0 0 0 OK 1.64828 0 3.73103 OK 0 0 0 OK XLOC_000022 - - XLOC_000022 - - chr1:1102483-1102578 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000023 - - XLOC_000023 - - chr1:1103242-1103332 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000024 - - XLOC_000024 - - chr1:1104384-1104467 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000025 - - XLOC_000025 TTLL10 TSS19,TSS20 chr1:1108435-1133313 - - 0 0 0 OK 16.6969 8.88115 24.5127 OK 0 0 0 OK XLOC_000026 - - XLOC_000026 B3GALT6 - chr1:1167628-1170418 - - 223.432 108.188 338.676 OK 276.214 227.595 324.832 OK 1068.96 617.478 1520.43 OK XLOC_000027 - - XLOC_000027 SCNN1D TSS21,TSS22 chr1:1215815-1227409 - - 8.76465 1.80131 15.728 OK 74.6629 51.1168 98.209 OK 63.4772 5.05395 121.901 OK XLOC_000028 - - XLOC_000028 PUSL1 TSS23,TSS24 chr1:1227763-1260046 - - 356.49 0 730.851 OK 790.008 542.995 1037.02 OK 871.528 0 2682.72 OK XLOC_000029 - - XLOC_000029 GLTPD1 TSS25 chr1:1260142-1264275 - - 140.404 57.7844 223.024 OK 187.156 149.818 224.494 OK 781.158 428.727 1133.59 OK XLOC_000030 - - XLOC_000030 TAS1R3 TSS26 chr1:1266725-1269843 - - 6.25639 0.748851 11.7639 OK 2.57898 0.558292 4.59967 OK 4.31837 0 8.68841 OK XLOC_000031 - - XLOC_000031 - TSS27 chr1:1334909-1342693 - - 252.561 0 520.025 OK 553.309 427.762 678.856 OK 567.727 0 1215.41 OK XLOC_000032 - - XLOC_000032 - TSS28 chr1:1361507-1363166 - - 7.20193 0 21.8767 OK 59.0363 32.2743 85.7983 OK 0 0 0 OK XLOC_000033 - - XLOC_000033 VWA1 TSS29 chr1:1370908-1376145 - - 228.717 98.7236 358.71 OK 528.289 438.43 618.149 OK 473.976 229.937 718.014 OK XLOC_000034 - - XLOC_000034 ATAD3C TSS30 chr1:1385068-1405538 - - 12.4598 2.74524 22.1743 OK 69.2663 54.4066 84.1261 OK 15.5201 2.93467 28.1056 OK XLOC_000035 - - XLOC_000035 ATAD3B TSS31,TSS32,TSS33 chr1:1407163-1431581 - - 433.345 172.072 694.619 OK 980.283 785.928 1174.64 OK 794.244 350.587 1237.9 OK XLOC_000036 - - XLOC_000036 ATAD3A TSS34,TSS35 chr1:1447554-1470064 - - 620.789 326.926 914.652 OK 1412.56 1186.84 1638.27 OK 2075.75 1086.58 3064.91 OK XLOC_000037 - - XLOC_000037 - TSS36 chr1:1535818-1543166 - - 2.79141 0 8.36422 OK 10.6728 3.90909 17.4365 OK 5.74721 0 13.7722 OK XLOC_000038 - - XLOC_000038 MIB2 TSS37,TSS38,TSS39,TSS40,TSS41,TSS42 chr1:1550883-1565984 - - 88.0884 0 218.213 OK 576.289 380.569 772.009 OK 593.05 250.107 935.993 OK XLOC_000039 - - XLOC_000039 MMP23B TSS43,TSS44,TSS45 chr1:1567559-1570029 - - 13.4513 0 30.0477 OK 67.208 43.9792 90.4369 OK 26.2041 0 64.5397 OK XLOC_000040 - - XLOC_000040 - TSS46,TSS47 chr1:1571099-1677431 - - 19.4885 0 121.567 OK 92.012 0 249.8 OK 93.5344 0 5774.2 OK XLOC_000041 - - XLOC_000041 - TSS48 chr1:1571099-1677431 - - 65.0308 0 219.479 OK 78.5208 2.15522 154.886 OK 84.1606 0 1061.25 OK XLOC_000042 - - XLOC_000042 - TSS49 chr1:1822909-1824112 - - 4.99201 0 13.0756 OK 3.15678 0 7.15379 OK 11.254 0 24.0748 OK XLOC_000043 - - XLOC_000043 CALML6 TSS50 chr1:1846265-1848733 - - 5.39767 0 12.9423 OK 26.9908 16.4977 37.4839 OK 1.08118 0 3.44841 OK XLOC_000044 - - XLOC_000044 GABRD TSS51 chr1:1950767-1962192 - - 12.037 2.28368 21.7903 OK 41.7053 30.9987 52.4118 OK 0.393202 0 1.41275 OK XLOC_000045 - - XLOC_000045 PRKCZ TSS52,TSS53,TSS54,TSS55,TSS56,TSS57,TSS58 chr1:1981908-2139172 - - 323.37 56.3501 590.391 OK 984.342 811.508 1157.18 OK 90.8985 0 297.617 OK XLOC_000046 - - XLOC_000046 - - chr1:1981908-2139172 - - 66.2174 0 158.32 OK 109.688 49.1409 170.236 OK 100.493 0 256.343 OK XLOC_000047 - - XLOC_000047 SKI TSS59 chr1:2160133-2241651 - - 246.057 139.664 352.451 OK 740.008 646.624 833.392 OK 1645.91 940.496 2351.32 OK XLOC_000048 - - XLOC_000048 RER1 TSS60 chr1:2323213-2344010 - - 833.583 491.897 1175.27 OK 802.47 678.01 926.93 OK 3941.6 1997.26 5885.94 OK XLOC_000049 - - XLOC_000049 PLCH2 TSS61,TSS62,TSS63 chr1:2407753-2436969 - - 2.29682 0 7.18583 OK 2.31568 0.293897 4.33745 OK 2.63403 0 9.02462 OK XLOC_000050 - - XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 - - 48.2407 0 138.917 OK 3.76675 0 9.22407 OK 887.589 343.505 1431.67 OK XLOC_000051 - - XLOC_000051 C1orf93 TSS65,TSS66 chr1:2518248-2564481 - - 438.685 222.475 654.895 OK 857.758 722.59 992.926 OK 1288.7 644.595 1932.81 OK XLOC_000052 - - XLOC_000052 ACTRT2 - chr1:2938045-2939465 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000053 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 1.00749 0 2.90667 OK 5.29478 3.71016 6.87941 OK 8.22698 1.24217 15.2118 OK XLOC_000054 - - XLOC_000054 ARHGEF16 TSS68,TSS69,TSS70,TSS71 chr1:3371146-3397675 - - 166.428 64.3556 268.501 OK 367.393 299.763 435.024 OK 4.78554 0 12.8593 OK XLOC_000055 - - XLOC_000055 TPRG1L TSS72 chr1:3541555-3546692 - - 546.504 302.59 790.417 OK 498.776 417.899 579.653 OK 2696.46 1541.33 3851.58 OK XLOC_000056 - - XLOC_000056 TP73 TSS73,TSS74,TSS75,TSS76 chr1:3569128-3650467 - - 14.6918 0 31.7494 OK 75.1453 52.7844 97.5062 OK 4.39049 0 10.1142 OK XLOC_000057 - - XLOC_000057 CCDC27 TSS77 chr1:3668964-3688209 - - 0.580625 0 2.25377 OK 2.99279 0.634917 5.35067 OK 0.344217 0 1.23675 OK XLOC_000058 - - XLOC_000058 - TSS78 chr1:3689351-3692545 - - 29.1182 1.52983 56.7065 OK 76.8718 48.7695 104.974 OK 58.9016 6.1034 111.7 OK XLOC_000059 - - XLOC_000059 CAD,DFFB TSS79 chr1:3773844-3801992 - - 72.973 20.4154 125.531 OK 120.109 86.7161 153.501 OK 116.754 37.3661 196.141 OK XLOC_000060 - - XLOC_000060 - TSS80 chr1:3816967-3833877 - - 6.8872 0 16.8662 OK 24.9595 13.0609 36.8581 OK 4.27286 0 10.6879 OK XLOC_000061 - - XLOC_000061 - TSS81 chr1:4000676-4015322 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000062 - - XLOC_000062 - TSS82 chr1:4472110-4484744 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000063 - - XLOC_000063 AJAP1 TSS83 chr1:4715104-4843850 - - 104.444 28.7796 180.108 OK 73.9584 56.8913 91.0255 OK 1.26614 0 3.42947 OK XLOC_000064 - - XLOC_000064 - - chr1:4847557-4852182 - - 37.4079 11.2885 63.5273 OK 18.1722 13.5426 22.8018 OK 0.154615 0 0.555523 OK XLOC_000065 - - XLOC_000065 KCNAB2 TSS84,TSS85,TSS86,TSS87 chr1:6052765-6160523 - - 74.6211 19.3497 129.893 OK 131.769 99.9566 163.582 OK 103.077 29.6562 176.498 OK XLOC_000066 - - XLOC_000066 RNF207 TSS88,TSS89,TSS90 chr1:6266188-6296044 - - 77.5899 0 419.93 OK 76.0702 0 159.894 OK 67.9405 0 1540.54 OK XLOC_000067 - - XLOC_000067 C1orf211 TSS91 chr1:6297870-6299490 - - 56.5093 17.4592 95.5594 OK 132.225 101.278 163.171 OK 4.35392 0 9.9704 OK XLOC_000068 - - XLOC_000068 HES3 TSS92 chr1:6304261-6305638 - - 435.49 167.883 703.097 OK 1431.61 1179.29 1683.94 OK 0 0 0 OK XLOC_000069 - - XLOC_000069 ESPN TSS93,TSS94 chr1:6484847-6521003 - - 19 0 38.8149 OK 177.686 139.484 215.888 OK 0.205083 0 0.894501 OK XLOC_000070 - - XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 - - 3.54524 0 10.1829 OK 1.25192 0 4.24694 OK 5.4957 0 14.1083 OK XLOC_000071 - - XLOC_000071 ZBTB48 TSS96,TSS97 chr1:6640055-6649339 - - 181.164 68.0138 294.314 OK 326.257 260.756 391.758 OK 252.631 80.1211 425.14 OK XLOC_000072 - - XLOC_000072 PHF13 TSS98 chr1:6673755-6684092 - - 277.454 147.158 407.75 OK 660.096 566.862 753.331 OK 769.313 441.751 1096.88 OK XLOC_000073 - - XLOC_000073 THAP3 TSS100,TSS99 chr1:6684924-6761966 - - 104.719 0 386.06 OK 233.593 134.239 332.948 OK 558.455 0 1370.32 OK XLOC_000074 - - XLOC_000074 CAMTA1 TSS101,TSS102,TSS103,TSS104 chr1:6845383-7829763 - - 1285.68 613.601 1957.76 OK 1467.41 1192.94 1741.89 OK 3198.34 1724.85 4671.83 OK XLOC_000075 - - XLOC_000075 VAMP3 TSS105 chr1:7831328-7841491 - - 1500.64 962.379 2038.91 OK 502.334 419.37 585.299 OK 7098.44 3876.89 10320 OK XLOC_000076 - - XLOC_000076 PER3 TSS106,TSS107 chr1:7844379-7973294 - - 291.457 87.59 495.325 OK 117.867 90.2441 145.49 OK 358.538 121.352 595.724 OK XLOC_000077 - - XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 - - 4703.17 2896.45 6509.89 OK 8447.87 7405.18 9490.57 OK 21648.9 9937.46 33360.3 OK XLOC_000078 - - XLOC_000078 SLC45A1 TSS109,TSS110 chr1:8384389-8404226 - - 11.4332 0.875959 21.9904 OK 39.6496 25.4328 53.8663 OK 212.078 44.603 379.552 OK XLOC_000079 - - XLOC_000079 CA6 TSS111 chr1:9005921-9035146 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000080 - - XLOC_000080 H6PD TSS112 chr1:9294862-9331392 - - 137.324 75.6555 198.993 OK 93.0165 77.025 109.008 OK 1112.18 629.474 1594.88 OK XLOC_000081 - - XLOC_000081 SPSB1 TSS113,TSS114 chr1:9352940-9429588 - - 87.8037 28.4811 147.126 OK 86.131 64.192 108.07 OK 876.41 453.881 1298.94 OK XLOC_000082 - - XLOC_000082 SLC25A33 TSS115 chr1:9599527-9642830 - - 216.702 89.7467 343.656 OK 229.284 182.986 275.581 OK 266.339 85.7716 446.906 OK XLOC_000083 - - XLOC_000083 TMEM201 TSS116 chr1:9648976-9674935 - - 122.735 39.3309 206.14 OK 402.381 326.516 478.246 OK 330.695 141.661 519.73 OK XLOC_000084 - - XLOC_000084 PIK3CD TSS117,TSS118,TSS119 chr1:9711789-9884550 - - 192.442 94.015 290.868 OK 441.582 347.43 535.734 OK 175.884 0 1102.82 OK XLOC_000085 - - XLOC_000085 NMNAT1 TSS120 chr1:10003485-10045555 - - 61.6068 21.6744 101.539 OK 39.4422 30.2486 48.6358 OK 319.369 166.702 472.035 OK XLOC_000086 - - XLOC_000086 RBP7 TSS121 chr1:10057254-10076077 - - 115.178 32.484 197.872 OK 229.575 173.78 285.371 OK 19.7819 0 39.7651 OK XLOC_000087 - - XLOC_000087 UBE4B TSS122,TSS123,TSS124 chr1:10093015-10241294 - - 710.689 307.091 1114.29 OK 1147.31 998.458 1296.17 OK 1440.88 426.447 2455.32 OK XLOC_000088 - - XLOC_000088 KIF1B TSS125,TSS126,TSS127 chr1:10270763-10441659 - - 910.612 450.399 1370.82 OK 637.441 539.148 735.734 OK 1046.38 176.743 1916.01 OK XLOC_000089 - - XLOC_000089 PGD TSS128 chr1:10459084-10480200 - - 1416.9 868.215 1965.58 OK 7183.39 6443.81 7922.96 OK 13970.1 6021.45 21918.7 OK XLOC_000090 - - XLOC_000090 APITD1,CORT,Cort TSS129,TSS130,TSS131 chr1:10490158-10512208 - - 284.879 65.3163 504.442 OK 259.775 191.797 327.754 OK 663.444 230.782 1096.11 OK XLOC_000091 - - XLOC_000091 PEX14,Pex14 TSS132,TSS133 chr1:10535002-10690813 - - 252.617 20.0714 485.164 OK 678.266 484.546 871.986 OK 1632.34 0 3391.32 OK XLOC_000092 - - XLOC_000092 TARDBP TSS134 chr1:11072678-11085548 - - 1918.99 1399.81 2438.16 OK 2401.2 2136.18 2666.23 OK 2744.34 1535.58 3953.11 OK XLOC_000093 - - XLOC_000093 ANGPTL7 TSS135 chr1:11166588-11322608 - - 25.3243 0 101.602 OK 0.912846 0 7.62052 OK 10.571 0 84.7445 OK XLOC_000094 - - XLOC_000094 UBIAD1 TSS136 chr1:11333254-11348490 - - 358.008 199.441 516.575 OK 307.383 257.097 357.67 OK 332.294 172.345 492.244 OK XLOC_000095 - - XLOC_000095 PTCHD2 TSS137,TSS138 chr1:11539294-11597639 - - 49.6179 0 109.156 OK 74.4396 51.287 97.5922 OK 0.546311 0 1.81047 OK XLOC_000096 - - XLOC_000096 FBXO44 TSS139,TSS140 chr1:11708449-11723383 - - 170.98 0 372.797 OK 558.984 413.1 704.869 OK 425.638 110.799 740.477 OK XLOC_000097 - - XLOC_000097 FBXO6 TSS141 chr1:11724149-11734407 - - 77.8716 25.4534 130.29 OK 25.5712 17.1689 33.9736 OK 363.317 155.989 570.645 OK XLOC_000098 - - XLOC_000098 C1orf187 TSS142 chr1:11751780-11780336 - - 200.894 86.0788 315.709 OK 340.257 276.998 403.517 OK 11.5677 0 24.207 OK XLOC_000099 - - XLOC_000099 - - chr1:11782186-11785914 - - 138.448 63.8267 213.07 OK 209.081 172.44 245.722 OK 6.38178 0 12.9721 OK XLOC_000100 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 747.942 322.73 1173.15 OK 1610.7 1330.44 1890.96 OK 1911.82 997.619 2826.02 OK XLOC_000101 - - XLOC_000101 C1orf167 TSS144 chr1:11824461-11826573 - - 4.69748 0 13.8934 OK 3.47934 0 8.39975 OK 1.86471 0 5.94749 OK XLOC_000102 - - XLOC_000102 C1orf167 TSS145,TSS146 chr1:11832138-11866115 - - 1.75837 0 16.9438 OK 4.36698 0 16.9106 OK 8.96806 0 243.105 OK XLOC_000103 - - XLOC_000103 CLCN6 TSS147,TSS148 chr1:11866206-11907840 - - 155.934 0 384.013 OK 366.258 288.591 443.925 OK 585.495 0 1416.03 OK XLOC_000104 - - XLOC_000104 PLOD1 TSS149 chr1:11994745-12035593 - - 865.542 534.969 1196.12 OK 956.552 824.968 1088.14 OK 10441.6 3993.52 16889.8 OK XLOC_000105 - - XLOC_000105 MFN2 TSS150 chr1:12040237-12073571 - - 647.078 417.464 876.692 OK 942.066 826.307 1057.82 OK 2871.51 1538.86 4204.17 OK XLOC_000106 - - XLOC_000106 MIIP TSS151 chr1:12079511-12092106 - - 504.143 253.799 754.486 OK 1223.51 1040.45 1406.58 OK 575.01 277.02 872.999 OK XLOC_000107 - - XLOC_000107 TNFRSF8 TSS152,TSS153 chr1:12123433-12204262 - - 204.322 84.7479 323.895 OK 441.002 371.862 510.142 OK 8.49796 0 23.6351 OK XLOC_000108 - - XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 - - 15.3506 4.48109 26.2201 OK 33.8648 24.5574 43.1722 OK 1395.94 778.496 2013.39 OK XLOC_000109 - - XLOC_000109 VPS13D TSS155,TSS156,TSS157,TSS158,TSS159 chr1:12290112-12572096 - - 387.51 236.485 538.536 OK 162.839 135.913 189.765 OK 354.401 141.161 567.641 OK XLOC_000110 - - XLOC_000110 SNORA59B - chr1:12290112-12572096 - - 452.443 0 6954.29 OK 234.664 0 1858.36 OK 63.6142 0 2752.67 OK XLOC_000111 - - XLOC_000111 AADACL4 TSS160 chr1:12704565-12727096 - - 0.911079 0 3.43339 OK 1.34969 0 3.25839 OK 0 0 0 OK XLOC_000112 - - XLOC_000112 AADACL3 TSS161 chr1:12776117-12788726 - - 56.4313 19.1396 93.7229 OK 10.0548 6.24819 13.8614 OK 0 0 0 OK XLOC_000113 - - XLOC_000113 C1orf158 TSS162 chr1:12806162-12821101 - - 1.78177 0 10.7617 OK 1.29047 0 5.61605 OK 0 0 0 OK XLOC_000114 - - XLOC_000114 PRAMEF12 TSS163 chr1:12834983-12838046 - - 3.60576 0 8.25249 OK 0.853096 0 2.25332 OK 0 0 0 OK XLOC_000115 - - XLOC_000115 PRAMEF1 TSS164 chr1:12851545-12856223 - - 1.07984 0 3.77465 OK 0 0 0 OK 0 0 0 OK XLOC_000116 - - XLOC_000116 PRAMEF2 TSS165 chr1:12916940-12921764 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000117 - - XLOC_000117 PRAMEF8 TSS166 chr1:12976449-12980566 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000118 - - XLOC_000118 PRAMEF22 TSS167 chr1:12998301-13117751 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000119 - - XLOC_000119 PRAMEF6 TSS168 chr1:13359818-13369057 - - 0.310672 0 1.64522 OK 0 0 0 OK 0 0 0 OK XLOC_000120 - - XLOC_000120 PRAMEF9 TSS169 chr1:13421175-13428191 - - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK XLOC_000121 - - XLOC_000121 PRAMEF16 TSS170 chr1:13495253-13498257 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000122 - - XLOC_000122 PRAMEF20 TSS171 chr1:13516065-13526943 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000123 - - XLOC_000123 PRAMEF10 TSS172 chr1:13629937-13635298 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000124 - - XLOC_000124 PRAMEF9 TSS173 chr1:13641972-13648988 - - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK XLOC_000125 - - XLOC_000125 PRAMEF17 TSS174 chr1:13716087-13719064 - - 0 0 0 OK 0.330232 0 1.26905 OK 0 0 0 OK XLOC_000126 - - XLOC_000126 PRAMEF20 TSS175 chr1:13736906-13747803 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000127 - - XLOC_000127 PDPN TSS176,TSS177,TSS178 chr1:13910251-13944450 - - 1297.74 772.49 1822.98 OK 1703.36 1494.58 1912.13 OK 111.012 34.7319 187.293 OK XLOC_000128 - - XLOC_000128 PRDM2 TSS179,TSS180,TSS181,TSS182 chr1:14026734-14151572 - - 243.069 86.3004 399.838 OK 157.143 123.605 190.68 OK 476.725 190.192 763.259 OK XLOC_000129 - - XLOC_000129 - TSS183,TSS184,TSS185,TSS186,TSS187,TSS188 chr1:14925212-15478960 - - 67.1093 12.3132 121.905 OK 159.342 124.396 194.289 OK 477.168 226.638 727.699 OK XLOC_000130 - - XLOC_000130 TMEM51 TSS189,TSS190 chr1:15479027-15546973 - - 145.058 27.4297 262.686 OK 232.379 175.392 289.366 OK 714.037 323.604 1104.47 OK XLOC_000131 - - XLOC_000131 FHAD1 TSS191,TSS192,TSS193,TSS194,TSS195,TSS196 chr1:15573767-15726776 - - 5.81037 0.144622 11.4761 OK 8.41368 4.88993 11.9374 OK 3.72788 0 9.54063 OK XLOC_000132 - - XLOC_000132 EFHD2 TSS197 chr1:15736390-15756839 - - 330.754 166.776 494.733 OK 468.604 391.665 545.542 OK 2197 1271.73 3122.27 OK XLOC_000133 - - XLOC_000133 CTRC TSS198 chr1:15764937-15773153 - - 2.23637 0 13.1824 OK 0 0 0 OK 5.61806 0 14.0003 OK XLOC_000134 - - XLOC_000134 CELA2A TSS199 chr1:15783222-15798585 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000135 - - XLOC_000135 CELA2B TSS200 chr1:15802595-15851384 - - 0 0 0 OK 1.27477 0 8.01985 OK 0 0 0 OK XLOC_000136 - - XLOC_000136 DNAJC16 TSS201,TSS202 chr1:15853351-15918872 - - 471.651 263.481 679.821 OK 155.023 124.246 185.801 OK 378.574 162.881 594.267 OK XLOC_000137 - - XLOC_000137 DDI2,RSC1A1 TSS203,TSS204 chr1:15944069-15988216 - - 1019.54 491.844 1547.24 OK 529.844 418.416 641.273 OK 687.356 269.18 1105.53 OK XLOC_000138 - - XLOC_000138 - - chr1:15992765-15995535 - - 252.085 124.534 379.636 OK 304.42 251.674 357.166 OK 236.84 106.42 367.26 OK XLOC_000139 - - XLOC_000139 PLEKHM2 TSS205 chr1:16010826-16061262 - - 363.264 206.673 519.855 OK 779.207 675.262 883.152 OK 2346.33 1341.89 3350.77 OK XLOC_000140 - - XLOC_000140 SLC25A34 TSS206,TSS207 chr1:16062808-16067885 - - 8.47075 0 17.0184 OK 8.64413 5.05545 12.2328 OK 13.9977 0 32.0894 OK XLOC_000141 - - XLOC_000141 TMEM82 TSS208 chr1:16068916-16074475 - - 11.5611 1.91174 21.2104 OK 31.4534 22.0675 40.8392 OK 0 0 0 OK XLOC_000142 - - XLOC_000142 FBLIM1 TSS209,TSS210,TSS211 chr1:16083153-16114431 - - 895.201 478.673 1311.73 OK 959.481 825.487 1093.47 OK 2443.99 1092.79 3795.2 OK XLOC_000143 - - XLOC_000143 SPEN TSS212,TSS213 chr1:16160709-16266950 - - 185.864 117.26 254.468 OK 381.608 335.895 427.321 OK 461.983 238.924 685.043 OK XLOC_000144 - - XLOC_000144 C1orf64 TSS214 chr1:16330730-16333180 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000145 - - XLOC_000145 CLCNKA,CLCNKB TSS215,TSS216,TSS217,TSS218,TSS219 chr1:16340522-16400127 - - 24.3959 0 126.906 OK 89.7145 59.9702 119.459 OK 2.11931 0 22.0164 OK XLOC_000146 - - XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 - - 1222.98 804.558 1641.4 OK 1363.34 1190.43 1536.25 OK 5311.2 2440.13 8182.27 OK XLOC_000147 - - XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 - - 574.66 291.154 858.166 OK 535.864 445.659 626.07 OK 3729.9 2067.17 5392.62 OK XLOC_000148 - - XLOC_000148 - - chr1:16860385-16864669 - - 8.40518 0 22.5657 OK 12.2273 6.65505 17.7995 OK 1.32866 0 3.3985 OK XLOC_000149 - - XLOC_000149 MST1 TSS222,TSS223,TSS224 chr1:16972068-16976914 - - 15.7802 0 36.6438 OK 119.12 83.2355 155.005 OK 14.8477 0 34.8303 OK XLOC_000150 - - XLOC_000150 CROCC TSS225,TSS226,TSS227,TSS228,TSS229 chr1:17066767-17299474 - - 158.894 0 326.505 OK 626.539 531.672 721.406 OK 169.437 47.2018 291.672 OK XLOC_000151 - - XLOC_000151 PADI1 TSS230,TSS231,TSS232 chr1:17531620-17572501 - - 15.5386 0 35.2913 OK 4.12312 0.318843 7.9274 OK 0.513942 0 2.1194 OK XLOC_000152 - - XLOC_000152 PADI3 TSS233 chr1:17575592-17610725 - - 8.59656 1.07534 16.1178 OK 12.671 8.61879 16.7231 OK 0.32407 0 1.03362 OK XLOC_000153 - - XLOC_000153 PADI4 TSS234 chr1:17634689-17690495 - - 4.09774 0 8.73756 OK 4.49965 0.0853275 8.91396 OK 0 0 0 OK XLOC_000154 - - XLOC_000154 PADI6 TSS235 chr1:17698740-17728195 - - 0 0 0 OK 0.21117 0 0.811504 OK 0 0 0 OK XLOC_000155 - - XLOC_000155 ARHGEF10L TSS236,TSS237,TSS238,TSS239,TSS240,TSS241,TSS242 chr1:17866329-18024369 - - 285.209 123.494 446.924 OK 682.762 574.07 791.455 OK 673.972 286.133 1061.81 OK XLOC_000156 - - XLOC_000156 ACTL8 TSS243 chr1:18081807-18153556 - - 9.62232 1.18858 18.0561 OK 17.1125 10.9181 23.3069 OK 6.95204 0.2121 13.692 OK XLOC_000157 - - XLOC_000157 IGSF21 TSS244,TSS245 chr1:18434239-18704976 - - 61.0149 14.4575 107.572 OK 401.989 330.782 473.196 OK 0 0 0 OK XLOC_000158 - - XLOC_000158 - - chr1:18434239-18704976 - - 1.3684 0 10.4514 OK 18.0164 0 38.878 OK 0 0 0 OK XLOC_000159 - - XLOC_000159 KLHDC7A TSS246 chr1:18807423-18812539 - - 104.809 46.7452 162.873 OK 217.548 181.508 253.588 OK 0.745204 0 1.93601 OK XLOC_000160 - - XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 - - 0.594028 0 4.06958 OK 0.969331 0 2.21305 OK 0 0 0 OK XLOC_000161 - - XLOC_000161 MRTO4 TSS248 chr1:19578074-19586621 - - 773.162 453.595 1092.73 OK 961.74 822.192 1101.29 OK 1651.61 939.806 2363.42 OK XLOC_000162 - - XLOC_000162 PQLC2 TSS249,TSS250 chr1:19638739-19655793 - - 186.005 56.5489 315.461 OK 324.654 255.223 394.085 OK 587.782 226.879 948.684 OK XLOC_000163 - - XLOC_000163 C1orf151,NBL1 TSS251,TSS252,TSS253,TSS254 chr1:19923466-19984945 - - 713.47 326.311 1100.63 OK 816.248 676.822 955.674 OK 12629.3 4000.78 21257.9 OK XLOC_000164 - - XLOC_000164 HTR6 TSS255 chr1:19991779-20006054 - - 3.39355 0 7.66135 OK 22.3161 15.5051 29.1271 OK 0 0 0 OK XLOC_000165 - - XLOC_000165 OTUD3 TSS256 chr1:20208887-20239429 - - 148.118 78.5111 217.725 OK 157.667 131.532 183.802 OK 87.3998 38.6021 136.198 OK XLOC_000166 - - XLOC_000166 PLA2G5 TSS257,TSS258 chr1:20354671-20418393 - - 0.482708 0 3.205 OK 0.847143 0 2.42832 OK 149.334 37.3505 261.318 OK XLOC_000167 - - XLOC_000167 PLA2G2F TSS259 chr1:20465822-20476879 - - 0 0 0 OK 0.361045 0 1.08683 OK 0 0 0 OK XLOC_000168 - - XLOC_000168 UBXN10 TSS260 chr1:20512577-20519941 - - 12.3177 2.70219 21.9333 OK 17.9074 12.8575 22.9573 OK 0.492177 0 1.39458 OK XLOC_000169 - - XLOC_000169 VWA5B1 TSS261,TSS262 chr1:20617411-20681387 - - 3.13664 0 7.23539 OK 19.2036 12.3388 26.0685 OK 0.572911 0 1.66793 OK XLOC_000170 - - XLOC_000170 FAM43B - chr1:20878931-20881512 - - 1.9757 0 4.79309 OK 40.5541 30.5386 50.5696 OK 1.55058 0 3.52437 OK XLOC_000171 - - XLOC_000171 CDA TSS263 chr1:20915443-20945398 - - 240.92 79.6033 402.237 OK 141.154 85.2695 197.038 OK 232.113 70.0502 394.177 OK XLOC_000172 - - XLOC_000172 PINK1 TSS264,TSS265 chr1:20959947-20978003 - - 640.208 365.853 914.562 OK 441.939 359.961 523.916 OK 3045.93 1562.02 4529.84 OK XLOC_000173 - - XLOC_000173 - TSS266 chr1:21543739-21672034 - - 2.1975 0 17.0697 OK 7.51557 0 20.6432 OK 3.33508 0 117.732 OK XLOC_000174 - - XLOC_000174 - TSS267 chr1:21761832-21762609 - - 0 0 0 OK 12075.7 2561.85 21589.6 OK 7652.6 0 16802.3 OK XLOC_000175 - - XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 - - 85.2069 28.1135 142.3 OK 59.4109 42.1246 76.6971 OK 528.734 249.389 808.079 OK XLOC_000176 - - XLOC_000176 ALPL TSS269,TSS270 chr1:21835857-21904904 - - 953.058 540.412 1365.7 OK 5045.41 4513.74 5577.07 OK 66.8214 0 136.004 OK XLOC_000177 - - XLOC_000177 LDLRAD2 TSS271,TSS272 chr1:22138757-22263750 - - 22.7305 0 236.046 OK 32.928 0 126.452 OK 183.25 0 30190.5 OK XLOC_000178 - - XLOC_000178 CELA3A,CELA3B TSS273,TSS274 chr1:22303417-22339033 - - 1.39771 0 7.20083 OK 0 0 0 OK 0 0 0 OK XLOC_000179 - - XLOC_000179 - TSS275,TSS276 chr1:22351706-22357713 - - 497.821 197.762 797.881 OK 431.878 343.606 520.149 OK 533.595 205.083 862.106 OK XLOC_000180 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 3644.56 2581.85 4707.27 OK 1626.45 1402.71 1850.2 OK 9892.47 4678.47 15106.5 OK XLOC_000181 - - XLOC_000181 ZBTB40 TSS278,TSS279 chr1:22778343-22857650 - - 130.91 40.0468 221.773 OK 221.871 179.285 264.458 OK 230.381 90.3923 370.37 OK XLOC_000182 - - XLOC_000182 EPHA8 TSS280 chr1:22890003-22930087 - - 33.3894 6.81803 59.9607 OK 86.3015 61.0337 111.569 OK 0 0 0 OK XLOC_000183 - - XLOC_000183 C1QA TSS281,TSS282 chr1:22963117-22966174 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000184 - - XLOC_000184 C1QC TSS283 chr1:22970117-22974602 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000185 - - XLOC_000185 C1QB TSS284 chr1:22979681-22988028 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000186 - - XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 - - 58.2137 24.2103 92.2171 OK 301.66 249.897 353.423 OK 947.084 428.131 1466.04 OK XLOC_000187 - - XLOC_000187 - - chr1:23243782-23247347 - - 1.74546 0 3.9763 OK 8.0467 5.05988 11.0335 OK 18.4428 3.44917 33.4364 OK XLOC_000188 - - XLOC_000188 - TSS286 chr1:23345940-23410184 - - 2620.79 1768.5 3473.08 OK 4034.49 3581.17 4487.82 OK 2352.33 1275.56 3429.11 OK XLOC_000189 - - XLOC_000189 C1orf213 TSS287 chr1:23685941-23698278 - - 15.7957 0 130.327 OK 6.98703 0.988196 12.9859 OK 100.398 0 355.465 OK XLOC_000190 - - XLOC_000190 - - chr1:23832921-23857713 - - 7.64299 0 21.0616 OK 0.939918 0 3.91205 OK 0 0 0 OK XLOC_000191 - - XLOC_000191 MDS2 TSS288,TSS289 chr1:23907984-23967056 - - 0.878724 0 5.41643 OK 0 0 0 OK 0 0 0 OK XLOC_000192 - - XLOC_000192 RPL11 TSS290,TSS291 chr1:24018293-24022913 - - 45081.3 35214.4 54948.3 OK 74807 67960.5 81653.6 OK 122735 40097.5 205373 OK XLOC_000193 - - XLOC_000193 TCEB3 TSS292 chr1:24069855-24104777 - - 755.461 500.365 1010.56 OK 523.425 449.786 597.064 OK 1232.52 710.214 1754.83 OK XLOC_000194 - - XLOC_000194 C1orf128 TSS293 chr1:24104875-24114720 - - 1073.73 622.661 1524.79 OK 1208.06 1021.73 1394.38 OK 1716.37 975.756 2456.98 OK XLOC_000195 - - XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 - - 1047.53 548.302 1546.76 OK 2696.47 2292.83 3100.1 OK 1186.4 573.182 1799.61 OK XLOC_000196 - - XLOC_000196 PNRC2 TSS295 chr1:24286300-24289947 - - 2032.12 1397.99 2666.24 OK 1015.28 870.304 1160.25 OK 1795.17 1048.34 2541.99 OK XLOC_000197 - - XLOC_000197 - TSS296 chr1:24526729-24538180 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_000198 - - XLOC_000198 GRHL3 TSS297,TSS298 chr1:24645880-24681807 - - 21.0142 1.07472 40.9536 OK 24.5704 18.0735 31.0674 OK 0.713283 0 2.40005 OK XLOC_000199 - - XLOC_000199 NIPAL3 TSS299,TSS300 chr1:24742244-24799472 - - 470.28 191.8 748.759 OK 146.117 107.797 184.437 OK 1640.18 523.838 2756.53 OK XLOC_000200 - - XLOC_000200 RCAN3 TSS301,TSS302 chr1:24829386-24862425 - - 373.245 129.991 616.498 OK 131.842 95.5281 168.155 OK 403.561 92.6034 714.519 OK XLOC_000201 - - XLOC_000201 C1orf130 TSS303 chr1:24882601-24935816 - - 1.31366 0 3.14984 OK 2.35713 0.82725 3.88701 OK 0.128844 0 0.527799 OK XLOC_000202 - - XLOC_000202 SRRM1 TSS304,TSS305,TSS306 chr1:24969593-24999771 - - 1290.56 764.458 1816.67 OK 1796.38 1562.95 2029.81 OK 1626.98 767.481 2486.48 OK XLOC_001217 - - XLOC_001217 - TSS1906,TSS1907,TSS1908,TSS1909,TSS1910,TSS1911,TSS1912 chr1:11873-29961 - - 1078.51 350.341 1806.67 OK 1083.74 832.415 1335.07 OK 1418.98 484.246 2353.72 OK XLOC_001218 - - XLOC_001218 - TSS1913 chr1:34611-36081 - - 13.7184 1.56112 25.8757 OK 16.5503 8.50309 24.5975 OK 4.32826 0 10.5235 OK XLOC_001219 - - XLOC_001219 - TSS1914 chr1:89294-237877 - - 12.8434 0 40.4901 OK 2.45836 0 7.59087 OK 13.5604 0 28.5077 OK XLOC_001220 - - XLOC_001220 - - chr1:89294-237877 - - 342.399 150.861 533.938 OK 634.855 524.149 745.561 OK 19.9712 0 44.4515 OK XLOC_001221 - - XLOC_001221 OR4F16 - chr1:621097-622034 - - 1.51396 0 5.87661 OK 0 0 0 OK 0 0 0 OK XLOC_001222 - - XLOC_001222 - TSS1915,TSS1916,TSS1917 chr1:661139-679736 - - 443.364 52.1857 834.542 OK 1028.56 770.512 1286.61 OK 109.854 0 251.071 OK XLOC_001223 - - XLOC_001223 - - chr1:661139-679736 - - 0 0 0 OK 697259 0 2.79472e+06 OK 14237.7 0 365954 OK XLOC_001224 - - XLOC_001224 - - chr1:661139-679736 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001225 - - XLOC_001225 - - chr1:661139-679736 - - 0 0 0 OK 697259 0 2.79472e+06 OK 14237.7 0 365954 OK XLOC_001226 - - XLOC_001226 - - chr1:661139-679736 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001227 - - XLOC_001227 - TSS1918 chr1:700236-714006 - - 247.682 103.907 391.458 OK 235.71 185.668 285.751 OK 50.5377 9.42215 91.6533 OK XLOC_001228 - - XLOC_001228 - - chr1:761586-762902 - - 29.1742 7.70701 50.6415 OK 19.6665 11.5626 27.7703 OK 39.9678 6.81386 73.1216 OK XLOC_001229 - - XLOC_001229 FAM41C TSS1919 chr1:803452-812182 - - 17.3524 4.7668 29.9381 OK 2.1691 0 4.48622 OK 7.41126 0 14.9157 OK XLOC_001230 - - XLOC_001230 - TSS1920 chr1:852952-854817 - - 0 0 0 OK 4.38548 0 16.6636 OK 7.62477 0 20.6728 OK XLOC_001231 - - XLOC_001231 NOC2L TSS1921,TSS1922 chr1:860529-894679 - - 664.491 281.937 1047.05 OK 1835.15 1545.82 2124.48 OK 2220.08 870.871 3569.28 OK XLOC_001232 - - XLOC_001232 C1orf170 TSS1923,TSS1924 chr1:910578-917473 - - 9.49353 0 19.9648 OK 15.2361 7.7315 22.7406 OK 38.3466 4.6005 72.0926 OK XLOC_001233 - - XLOC_001233 HES4 TSS1925 chr1:934341-935552 - - 54.1565 11.0853 97.2278 OK 37.4229 18.7755 56.0703 OK 33.6271 0 76.8424 OK XLOC_001234 - - XLOC_001234 C1orf159 TSS1926,TSS1927,TSS1928,TSS1929 chr1:1017197-1051736 - - 95.4113 25.0488 165.774 OK 179.994 132.126 227.861 OK 225.338 41.6998 408.976 OK XLOC_001235 - - XLOC_001235 - TSS1930 chr1:1108435-1133313 - - 0.346272 0 1.78395 OK 5.99833 3.26167 8.73498 OK 0 0 0 OK XLOC_001236 - - XLOC_001236 TNFRSF18 TSS1931,TSS1932 chr1:1138888-1142089 - - 3.83745 0 14.6956 OK 35.195 19.4192 50.9709 OK 14.2699 0 28.7977 OK XLOC_001237 - - XLOC_001237 TNFRSF4 TSS1933 chr1:1146706-1149512 - - 1.29516 0 6.6725 OK 1.21775 0 2.94864 OK 5.89401 0 12.8778 OK XLOC_001238 - - XLOC_001238 SDF4 TSS1934,TSS1935,TSS1936 chr1:1152288-1167447 - - 961.909 476.633 1447.18 OK 1813.62 1523.33 2103.92 OK 9144.72 3561.59 14727.8 OK XLOC_001239 - - XLOC_001239 FAM132A TSS1937 chr1:1177832-1182102 - - 17.131 3.00892 31.2531 OK 41.9198 28.3894 55.4503 OK 75.8216 10.8039 140.839 OK XLOC_001240 - - XLOC_001240 UBE2J2 TSS1938,TSS1939 chr1:1189293-1209234 - - 497.959 238.296 757.623 OK 714.623 603.801 825.445 OK 1991.77 1051.54 2932 OK XLOC_001241 - - XLOC_001241 - - chr1:1189293-1209234 - - 17.2606 0 51.4891 OK 37.017 16.7475 57.2865 OK 20.3727 0 89.1972 OK XLOC_001242 - - XLOC_001242 ACAP3 TSS1940,TSS1941,TSS1942,TSS1943 chr1:1227763-1260046 - - 154.616 0 318.196 OK 551.917 417.066 686.768 OK 1130.35 138.936 2121.77 OK XLOC_001243 - - XLOC_001243 CPSF3L TSS1944,TSS1945 chr1:1227763-1260046 - - 937.049 361.425 1512.67 OK 2544.24 2138.93 2949.55 OK 3108.68 354.369 5862.98 OK XLOC_001244 - - XLOC_001244 DVL1,DVL1L1 TSS1946,TSS1947,TSS1948 chr1:1270658-1284492 - - 275.675 124.241 427.11 OK 1162.72 995.871 1329.57 OK 1592.95 788.14 2397.76 OK XLOC_001245 - - XLOC_001245 MXRA8 TSS1949,TSS1950 chr1:1288071-1297157 - - 1079.39 539.647 1619.14 OK 153.319 113.096 193.542 OK 14320 5859.88 22780.1 OK XLOC_001246 - - XLOC_001246 AURKAIP1 TSS1951,TSS1952,TSS1953 chr1:1309109-1310818 - - 2557.58 1487.24 3627.91 OK 3660.17 3043.99 4276.35 OK 7034.3 3300.38 10768.2 OK XLOC_001247 - - XLOC_001247 CCNL2 TSS1954,TSS1955,TSS1956,TSS1957 chr1:1321090-1334718 - - 749.182 417.666 1080.7 OK 1238.98 1067.35 1410.6 OK 1273.64 536.141 2011.13 OK XLOC_001248 - - XLOC_001248 MRPL20 TSS1958 chr1:1334909-1342693 - - 3133.93 1763.88 4503.98 OK 4356.64 3676.16 5037.11 OK 8744.67 4664.17 12825.2 OK XLOC_001249 - - XLOC_001249 - TSS1959 chr1:1353801-1356650 - - 55.0852 10.8581 99.3122 OK 73.1639 49.0898 97.2379 OK 100.918 6.9754 194.861 OK XLOC_001250 - - XLOC_001250 C1orf70 TSS1960 chr1:1470158-1475740 - - 31.9981 5.39734 58.5989 OK 83.1162 61.5122 104.72 OK 233.834 79.2517 388.416 OK XLOC_001251 - - XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 - - 2379.43 1408.04 3350.83 OK 3413.53 2940.95 3886.1 OK 6671.18 3471.61 9870.75 OK XLOC_001252 - - XLOC_001252 CDC2L1,CDC2L2 TSS1962,TSS1963,TSS1964,TSS1965,TSS1966,TSS1967,TSS1968 chr1:1571099-1677431 - - 321.824 0 1458.55 OK 2901.12 1438.6 4363.64 OK 3685.64 0 24739.1 OK XLOC_001253 - - XLOC_001253 CDC2L1 TSS1969 chr1:1571099-1677431 - - 81.9647 0 509.713 OK 251.238 0 684.019 OK 440.918 0 3485.7 OK XLOC_001254 - - XLOC_001254 SLC35E2 TSS1970,TSS1971,TSS1972,TSS1973 chr1:1571099-1677431 - - 439.217 80.255 798.179 OK 1155.8 911.187 1400.41 OK 1716.87 0 4247.78 OK XLOC_001255 - - XLOC_001255 - - chr1:1571099-1677431 - - 251.624 92.9647 410.284 OK 341.44 239.089 443.79 OK 1014.62 54.4883 1974.75 OK XLOC_001256 - - XLOC_001256 NADK TSS1974,TSS1975,TSS1976,TSS1977,TSS1978 chr1:1682677-1711508 - - 483.898 228.284 739.512 OK 1157.89 981.98 1333.8 OK 1252.77 654.252 1851.29 OK XLOC_001257 - - XLOC_001257 GNB1 TSS1979 chr1:1716729-1822495 - - 4287.86 3261.64 5314.08 OK 4821.37 4333.38 5309.36 OK 16708.8 5900.45 27517.1 OK XLOC_001258 - - XLOC_001258 TMEM52 TSS1980,TSS1981 chr1:1849028-1850740 - - 102.168 14.8118 189.524 OK 291.717 218.076 365.358 OK 23.4115 2.02793 44.795 OK XLOC_001259 - - XLOC_001259 C1orf222 TSS1982,TSS1983 chr1:1853396-1859368 - - 0 0 0 OK 3.06699 0 6.47552 OK 0 0 0 OK XLOC_001260 - - XLOC_001260 KIAA1751 TSS1984,TSS1985 chr1:1884751-1935276 - - 1.6663 0 5.59741 OK 0.932315 0.00687002 1.85776 OK 0 0 0 OK XLOC_001261 - - XLOC_001261 - TSS1986 chr1:1944651-1946969 - - 4.28982 0 9.13831 OK 8.18597 4.02555 12.3464 OK 0 0 0 OK XLOC_001262 - - XLOC_001262 - TSS1987 chr1:1981908-2139172 - - 13.1667 0 127.959 OK 33.574 0 81.1922 OK 27.1259 0 228.561 OK XLOC_001263 - - XLOC_001263 C1orf86 TSS1988,TSS1989 chr1:1981908-2139172 - - 426.51 24.686 828.334 OK 1874.52 1425.23 2323.82 OK 2848.42 1305.41 4391.44 OK XLOC_001264 - - XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 - - 54.986 0 123.624 OK 109.55 49.7037 169.396 OK 102.498 0 228.358 OK XLOC_001265 - - XLOC_001265 - - chr1:2252695-2322993 - - 54.2991 11.6048 96.9934 OK 912.804 775.369 1050.24 OK 177.628 58.4676 296.788 OK XLOC_001266 - - XLOC_001266 PEX10 TSS1991 chr1:2323213-2344010 - - 290.341 47.1703 533.511 OK 461.866 340.617 583.116 OK 917.336 0 2344.9 OK XLOC_001267 - - XLOC_001267 PANK4 TSS1992 chr1:2439974-2458035 - - 174.785 79.7438 269.827 OK 361.252 300.101 422.403 OK 500.991 263.612 738.37 OK XLOC_001268 - - XLOC_001268 HES5 TSS1993 chr1:2460184-2461684 - - 6.35744 0 13.7346 OK 2.94754 0 6.09621 OK 0 0 0 OK XLOC_001269 - - XLOC_001269 - TSS1994,TSS1995 chr1:2481358-2495265 - - 2.01017 0 8.49033 OK 1.1242 0 3.11534 OK 16.2233 0 73.2464 OK XLOC_001270 - - XLOC_001270 MMEL1 TSS1996,TSS1997 chr1:2518248-2564481 - - 0.931281 0 9.82019 OK 12.7571 0 28.6315 OK 3.38316 0 110.889 OK XLOC_001271 - - XLOC_001271 - TSS1998 chr1:2976182-2980350 - - 0.620738 0 2.33924 OK 0 0 0 OK 0.336145 0 1.20775 OK XLOC_001272 - - XLOC_001272 - TSS1999 chr1:2980635-2984289 - - 0 0 0 OK 0 0 0 OK 9.74659 0 22.4902 OK XLOC_001273 - - XLOC_001273 MEGF6 TSS2000,TSS2001 chr1:3404512-3528059 - - 113.568 41.4835 185.653 OK 219.592 183.067 256.118 OK 157.419 61.2729 253.566 OK XLOC_001274 - - XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 - - 264.765 95.8022 433.729 OK 597.841 477.064 718.617 OK 520.346 202.296 838.397 OK XLOC_001275 - - XLOC_001275 KIAA0495 TSS2003,TSS2004 chr1:3652549-3663886 - - 201.581 112.658 290.504 OK 433.574 372.368 494.78 OK 257.641 124.251 391.031 OK XLOC_001276 - - XLOC_001276 LRRC47 TSS2005 chr1:3696783-3713068 - - 867.894 535.552 1200.24 OK 1345.43 1168.58 1522.28 OK 1410.28 820.996 1999.56 OK XLOC_001277 - - XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 - - 266.214 98.7958 433.631 OK 182.207 144.327 220.086 OK 568.38 225.872 910.888 OK XLOC_001278 - - XLOC_001278 C1orf174 TSS2007 chr1:3805702-3816857 - - 489.179 236.635 741.722 OK 551.063 456.161 645.964 OK 1182.73 643.67 1721.78 OK XLOC_001279 - - XLOC_001279 - TSS2008 chr1:5621768-5728315 - - 0 0 0 OK 0.669469 0 2.5727 OK 0 0 0 OK XLOC_001280 - - XLOC_001280 NPHP4 TSS2009,TSS2010,TSS2011 chr1:5922869-6052531 - - 61.5073 15.3172 107.697 OK 191.389 148.94 233.838 OK 115.136 2.44746 227.825 OK XLOC_001281 - - XLOC_001281 CHD5 TSS2012,TSS2013,TSS2014,TSS2015,TSS2016 chr1:6161852-6240183 - - 14.4353 0 31.4502 OK 27.6918 17.293 38.0906 OK 4.07203 0 8.94324 OK XLOC_001282 - - XLOC_001282 RPL22 TSS2017 chr1:6245080-6259679 - - 2431.44 1591.39 3271.5 OK 4375.01 3886.91 4863.12 OK 9875.13 4870.71 14879.6 OK XLOC_001283 - - XLOC_001283 ICMT TSS2018 chr1:6266188-6296044 - - 1479.52 1045.7 1913.34 OK 1334.15 1171.21 1497.09 OK 2608.03 1399.2 3816.86 OK XLOC_001284 - - XLOC_001284 GPR153 TSS2019 chr1:6307413-6321035 - - 117.786 30.5837 204.989 OK 272.008 213.016 331 OK 766.964 337.775 1196.15 OK XLOC_001285 - - XLOC_001285 ACOT7 TSS2020,TSS2021,TSS2022,TSS2023,TSS2024 chr1:6324332-6453826 - - 964.538 435.856 1493.22 OK 3559.21 3013.12 4105.3 FAIL 4595.76 2048.17 7143.34 FAIL XLOC_001286 - - XLOC_001286 HES2 TSS2025,TSS2026 chr1:6472499-6484730 - - 5.92301 1.46722 10.3788 OK 8.65963 4.19845 13.1208 OK 1.90413 0 4.99495 OK XLOC_001287 - - XLOC_001287 PLEKHG5,TNFRSF25 TSS2027,TSS2028,TSS2029,TSS2030,TSS2031,TSS2032,TSS2033,TSS2034,TSS2035,TSS2036,TSS2037 chr1:6521220-6580069 - - 168.073 0 356.709 OK 737.254 577.905 896.604 OK 98.5393 0 252.9 OK XLOC_001288 - - XLOC_001288 NOL9 TSS2038 chr1:6585209-6614581 - - 503.823 285.234 722.412 OK 189.708 153.676 225.74 OK 363.843 173.395 554.291 OK XLOC_001289 - - XLOC_001289 KLHL21 TSS2039,TSS2040 chr1:6650778-6662929 - - 243.714 119.276 368.153 OK 368.135 298.624 437.647 OK 1056.94 593.119 1520.76 OK XLOC_001290 - - XLOC_001290 DNAJC11 TSS2041,TSS2042 chr1:6684924-6761966 - - 743.808 449.589 1038.03 OK 1372.27 1195.02 1549.51 OK 1731.39 922.337 2540.44 OK XLOC_001291 - - XLOC_001291 UTS2 TSS2043,TSS2044,TSS2045 chr1:7844379-7973294 - - 2.44962 0 41.8234 OK 0.950535 0 7.59851 OK 0 0 0 OK XLOC_001292 - - XLOC_001292 TNFRSF9 TSS2046 chr1:7979907-8000887 - - 0 0 0 OK 0.267901 0 1.02951 OK 1.38187 0 3.32436 OK XLOC_001293 - - XLOC_001293 ERRFI1 TSS2047,TSS2048 chr1:8071779-8086393 - - 778.659 410.188 1147.13 OK 463.514 385.647 541.381 OK 2311.63 1283.3 3339.95 OK XLOC_001294 - - XLOC_001294 RERE TSS2049,TSS2050,TSS2051,TSS2052 chr1:8412465-8877699 - - 274.268 121.108 427.428 OK 987.152 868.147 1106.16 OK 2024.49 806.493 3242.49 OK XLOC_001295 - - XLOC_001295 - - chr1:8412465-8877699 - - 20.7508 0 141.351 OK 0 0 0 OK 0 0 0 OK XLOC_001296 - - XLOC_001296 ENO1 TSS2053,TSS2054 chr1:8921062-8938780 - - 22441.8 18308.7 26574.8 OK 52641 48699.4 56582.7 OK 71632.5 38350.7 104914 OK XLOC_001297 - - XLOC_001297 SLC2A7 TSS2055 chr1:9063358-9086404 - - 0 0 0 OK 0.358204 0 1.3662 OK 0.725244 0 2.31316 OK XLOC_001298 - - XLOC_001298 SLC2A5 TSS2056,TSS2057,TSS2058,TSS2059 chr1:9097006-9148510 - - 5.91022 0 14.9015 OK 2.9098 0.117705 5.7019 OK 124.086 0 327.054 OK XLOC_001299 - - XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 - - 37.0457 0 79.5502 OK 62.9264 41.263 84.5898 OK 99.8224 4.04858 195.596 OK XLOC_001300 - - XLOC_001300 - TSS2061 chr1:9208346-9242451 - - 95.9263 41.8317 150.021 OK 212.722 175.801 249.643 OK 69.3907 24.6136 114.168 OK XLOC_001301 - - XLOC_001301 C1orf200 TSS2062 chr1:9711789-9884550 - - 0 0 0 OK 0.589835 0 7.29737 OK 0 0 0 OK XLOC_001302 - - XLOC_001302 - TSS2063 chr1:9711789-9884550 - - 86.8241 0 296.064 OK 230.865 41.3861 420.343 OK 61.7832 0 735.129 OK XLOC_001303 - - XLOC_001303 CLSTN1 TSS2064,TSS2065 chr1:9711789-9884550 - - 478.354 229.037 727.67 OK 1730.22 1501.95 1958.5 OK 4844.04 1452.01 8236.07 OK XLOC_001304 - - XLOC_001304 CTNNBIP1 TSS2066 chr1:9908333-9970316 - - 479.396 234.429 724.362 OK 655.696 562.205 749.188 OK 509.797 250.642 768.951 OK XLOC_001305 - - XLOC_001305 LZIC TSS2067,TSS2068 chr1:9989777-10003427 - - 321.49 118.542 524.438 OK 197.728 149.466 245.99 OK 1022.12 508.784 1535.45 OK XLOC_001306 - - XLOC_001306 DFFA TSS2069 chr1:10520604-10532613 - - 783.778 429.622 1137.93 OK 1126.41 964.355 1288.47 OK 1164.65 615.282 1714.02 OK XLOC_001307 - - XLOC_001307 CASZ1 TSS2070,TSS2071,TSS2072 chr1:10696667-10856707 - - 20.9583 0 47.854 OK 109.537 81.8881 137.186 OK 8.07121 0 16.3767 OK XLOC_001308 - - XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 - - 1.66867 0 5.63544 OK 4.3281 1.40188 7.25432 OK 0.333513 0 1.91009 OK XLOC_001309 - - XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 - - 75.0649 23.5982 126.532 OK 57.5421 41.0203 74.064 OK 15.0124 2.22666 27.7982 OK XLOC_001310 - - XLOC_001310 SRM TSS2075,TSS2076 chr1:11114648-11120091 - - 2174 1134.66 3213.34 OK 4914.1 4304.78 5523.42 OK 10824.5 4942.8 16706.2 OK XLOC_001311 - - XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 - - 1430.05 942.742 1917.36 OK 1348.42 1167.79 1529.05 OK 1642.04 925.011 2359.07 OK XLOC_001312 - - XLOC_001312 MTOR TSS2078,TSS2079 chr1:11166588-11322608 - - 637.839 434.491 841.186 OK 1027.65 908.066 1147.24 OK 807.821 423.117 1192.52 OK XLOC_001313 - - XLOC_001313 FBXO2 TSS2080,TSS2081 chr1:11708449-11723383 - - 308.762 59.8184 557.706 OK 1499.45 1248.47 1750.42 OK 72.9584 0 190.995 OK XLOC_001314 - - XLOC_001314 MAD2L2 TSS2082 chr1:11734537-11751678 - - 4485.74 3057.88 5913.6 OK 6757.57 5967.93 7547.22 OK 2368.21 1365.35 3371.08 OK XLOC_001315 - - XLOC_001315 MTHFR TSS2083,TSS2084,TSS2085 chr1:11832138-11866115 - - 178.062 40.6027 315.521 OK 185.116 142.249 227.982 OK 650.594 224.051 1077.14 OK XLOC_001316 - - XLOC_001316 NPPA TSS2086 chr1:11866206-11907840 - - 3.4039 0 32.5388 OK 10.2838 0 34.928 OK 18.088 0 138.237 OK XLOC_001317 - - XLOC_001317 NPPB TSS2087 chr1:11917521-11918992 - - 770.486 289.163 1251.81 OK 7.22153 0 14.4521 OK 0 0 0 OK XLOC_001318 - - XLOC_001318 KIAA2013 TSS2088 chr1:11980123-11986480 - - 673.993 327.238 1020.75 OK 754.447 632.031 876.864 OK 1443.8 737.85 2149.75 OK XLOC_001319 - - XLOC_001319 DHRS3 TSS2089,TSS2090,TSS2091 chr1:12627939-12677820 - - 1376.88 652.901 2100.86 OK 675.842 538.376 813.308 OK 819.055 0 3489.25 OK XLOC_001320 - - XLOC_001320 PRAMEF11 TSS2092 chr1:12884467-12891264 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001321 - - XLOC_001321 HNRNPCL1 TSS2093 chr1:12907235-12908578 - - 162.796 57.3101 268.281 OK 2184.6 1858.47 2510.73 OK 1951.16 1042.71 2859.6 OK XLOC_001322 - - XLOC_001322 PRAMEF4 TSS2094 chr1:12939032-12946025 - - 0.174144 0 1.17777 OK 0 0 0 OK 0 0 0 OK XLOC_001323 - - XLOC_001323 PRAMEF10 TSS2095 chr1:12952727-12958094 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001324 - - XLOC_001324 PRAMEF5,PRAMEF6 TSS2096,TSS2097 chr1:12998301-13117751 - - 0.672346 0 5.91234 OK 0 0 0 OK 0 0 0 OK XLOC_001325 - - XLOC_001325 - - chr1:13182960-13183967 - - 22.2793 4.558 40.0006 OK 275.825 215.388 336.261 OK 207.399 65.638 349.159 OK XLOC_001326 - - XLOC_001326 PRAMEF22 TSS2098 chr1:13328195-13331692 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001327 - - XLOC_001327 PRAMEF8 TSS2099,TSS2100 chr1:13386648-13390765 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001328 - - XLOC_001328 PRAMEF13,PRAMEF14 TSS2101 chr1:13447413-13452656 - - 0.200934 0 3.68442 OK 0 0 0 OK 0 0 0 OK XLOC_001329 - - XLOC_001329 PRAMEF18 TSS2102 chr1:13474052-13477569 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001330 - - XLOC_001330 PRAMEF8 TSS2103 chr1:13607430-13611550 - - 0.694912 0 2.69739 OK 0 0 0 OK 0 0 0 OK XLOC_001331 - - XLOC_001331 PRAMEF14 TSS2104 chr1:13668268-13673511 - - 0.803811 0 2.80977 OK 0 0 0 OK 0 0 0 OK XLOC_001332 - - XLOC_001332 PRAMEF18 TSS2105 chr1:13694888-13698405 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001333 - - XLOC_001333 LRRC38 TSS2106 chr1:13801446-13840242 - - 6.96034 0.720957 13.1997 OK 8.16584 3.94913 12.3826 OK 0 0 0 OK XLOC_001334 - - XLOC_001334 C1orf126 TSS2107 chr1:14925212-15478960 - - 8.04305 0 20.7783 OK 9.25388 3.6012 14.9066 OK 0.859289 0 31.1292 OK XLOC_001335 - - XLOC_001335 - TSS2108 chr1:15573767-15726776 - - 0.432797 0 2.09139 OK 3.71564 1.40094 6.03034 OK 2.62025 0 6.72752 OK XLOC_001336 - - XLOC_001336 CASP9 TSS2109,TSS2110,TSS2111 chr1:15802595-15851384 - - 394.058 160.443 627.674 OK 432.032 343.346 520.719 OK 288.447 95.7743 481.119 OK XLOC_001337 - - XLOC_001337 AGMAT TSS2112 chr1:15853351-15918872 - - 122.09 0 265.635 OK 115.866 75.573 156.159 OK 43.2083 0 137.727 OK XLOC_001338 - - XLOC_001338 - - chr1:16133656-16134194 - - 7916.63 5112.58 10720.7 OK 16097 14174.7 18019.4 OK 21049.2 11785.6 30312.9 OK XLOC_001339 - - XLOC_001339 - TSS2113 chr1:16160709-16266950 - - 68.8094 0 163.282 OK 58.2932 18.0093 98.5771 OK 39.9858 0 168.854 OK XLOC_001340 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 179.279 36.1088 322.448 OK 335.879 265.104 406.653 OK 666.365 288.276 1044.45 OK XLOC_001341 - - XLOC_001341 - - chr1:16317618-16317647 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001342 - - XLOC_001342 HSPB7 TSS2115,TSS2116 chr1:16340522-16400127 - - 192.896 40.6102 345.183 OK 7.0982 0.571999 13.6244 OK 736.676 372.055 1101.3 OK XLOC_001343 - - XLOC_001343 FAM131C TSS2117 chr1:16340522-16400127 - - 13.6398 0 196.505 OK 25.9588 7.90771 44.0099 OK 46.4136 0 383.774 OK XLOC_001344 - - XLOC_001344 EPHA2 TSS2118 chr1:16450831-16482564 - - 257.159 89.2372 425.081 OK 575.636 490.312 660.96 OK 923.073 511.47 1334.68 OK XLOC_001345 - - XLOC_001345 ARHGEF19 TSS2119,TSS2120 chr1:16524598-16539104 - - 173.274 62.1139 284.434 OK 1002.4 839.936 1164.87 OK 178.951 68.9224 288.981 OK XLOC_001346 - - XLOC_001346 C1orf89 TSS2121 chr1:16558182-16563659 - - 28.2148 8.31912 48.1105 OK 53.4824 39.5802 67.3846 OK 182.341 64.6878 299.993 OK XLOC_001347 - - XLOC_001347 FBXO42 TSS2122,TSS2123,TSS2124,TSS2125 chr1:16576559-16678948 - - 353.356 168.334 538.378 OK 268.262 218.298 318.225 OK 579.556 298.338 860.774 OK XLOC_001348 - - XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 - - 1.25463 0 18.4322 OK 0 0 0 OK 0.168084 0 13.948 OK XLOC_001349 - - XLOC_001349 - TSS2127,TSS2128,TSS2129 chr1:16793930-16819196 - - 47.0375 0 98.9577 OK 173.076 99.6541 246.499 OK 68.2604 0 176.521 OK XLOC_001350 - - XLOC_001350 - TSS2130 chr1:16860385-16864669 - - 23.1603 3.70763 42.613 OK 11.9908 6.58234 17.3992 OK 0.8365 0 2.58351 OK XLOC_001351 - - XLOC_001351 - - chr1:16888922-16890082 - - 223.564 85.5058 361.622 OK 175.981 136.018 215.945 OK 1764.52 961.378 2567.66 OK XLOC_001352 - - XLOC_001352 NBPF1 TSS2131,TSS2132,TSS2133,TSS2134 chr1:16890411-16939982 - - 450.243 152.131 748.356 OK 375.075 283.016 467.134 OK 1717.46 727.911 2707.01 OK XLOC_001353 - - XLOC_001353 - TSS2135,TSS2136,TSS2137,TSS2138,TSS2139 chr1:16944752-16971178 - - 404.217 36.5797 771.854 OK 735.986 552.548 919.423 OK 584.711 98.9245 1070.5 OK XLOC_001354 - - XLOC_001354 ESPN,ESPNP TSS2140,TSS2141 chr1:17017712-17046652 - - 2.07327 0 5.81874 OK 14.5824 7.22266 21.9422 OK 0 0 0 OK XLOC_001355 - - XLOC_001355 MSTP9 TSS2142,TSS2143 chr1:17066767-17299474 - - 16.1249 0 62.0736 OK 41.4204 15.7214 67.1195 OK 3.15319 0 48.2064 OK XLOC_001356 - - XLOC_001356 - TSS2144 chr1:17066767-17299474 - - 133.893 0 504.624 OK 415.352 32.9291 797.775 OK 408.247 0 1179.03 OK XLOC_001357 - - XLOC_001357 MFAP2 TSS2145,TSS2146 chr1:17300999-17308081 - - 1947.53 1100.04 2795.02 OK 4866.56 4273.21 5459.92 OK 2405.66 1076.58 3734.75 OK XLOC_001358 - - XLOC_001358 ATP13A2 TSS2147,TSS2148,TSS2149,TSS2150 chr1:17312452-17338423 - - 347.865 90.8997 604.83 OK 1430.58 1196.85 1664.31 OK 685.305 229.505 1141.11 OK XLOC_001359 - - XLOC_001359 SDHB TSS2151 chr1:17345226-17380665 - - 1562.94 903.16 2222.73 OK 1548.47 1310.11 1786.83 OK 5372.43 3139.35 7605.51 OK XLOC_001360 - - XLOC_001360 PADI2 TSS2152 chr1:17393256-17445948 - - 31.43 3.74415 59.1159 OK 66.1047 49.5775 82.632 OK 0.887452 0 2.35611 OK XLOC_001361 - - XLOC_001361 - - chr1:17393256-17445948 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001362 - - XLOC_001362 RCC2 TSS2153,TSS2154 chr1:17733251-17766220 - - 3342.9 2480.41 4205.4 OK 5456.99 4914.17 5999.81 OK 1048.07 598.531 1497.6 OK XLOC_001363 - - XLOC_001363 TAS1R2 TSS2155 chr1:19166092-19186155 - - 0.541163 0 2.03937 OK 0 0 0 OK 0 0 0 OK XLOC_001364 - - XLOC_001364 ALDH4A1 TSS2156,TSS2157 chr1:19197925-19229293 - - 264.069 112.608 415.531 OK 652.489 546.183 758.795 OK 536.822 271.415 802.23 OK XLOC_001365 - - XLOC_001365 IFFO2 TSS2158 chr1:19230773-19282826 - - 102.06 48.7649 155.355 OK 89.541 72.7006 106.381 OK 303.773 166.199 441.347 OK XLOC_001366 - - XLOC_001366 UBR4 TSS2159,TSS2160,TSS2161,TSS2162,TSS2163,TSS2164,TSS2165,TSS2166,TSS2167,TSS2168,TSS2169 chr1:19398603-19536746 - - 878.439 194.212 1562.67 OK 2298.71 2012.76 2584.66 OK 2120.72 0 4625.66 OK XLOC_001367 - - XLOC_001367 KIAA0090 TSS2170,TSS2171 chr1:19544584-19578046 - - 353.593 174.047 533.14 OK 609.245 517.011 701.479 OK 2369.35 1262.44 3476.26 OK XLOC_001368 - - XLOC_001368 AKR7L TSS2172 chr1:19592475-19600568 - - 8.4734 1.23882 15.708 OK 11.7019 7.12012 16.2836 OK 10.5092 1.01211 20.0062 OK XLOC_001369 - - XLOC_001369 AKR7A3 TSS2173 chr1:19609056-19615280 - - 16.1619 3.29675 29.0271 OK 17.2325 9.42284 25.0423 OK 15.2534 1.07679 29.43 OK XLOC_001370 - - XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 - - 363.217 139.609 586.825 OK 695.576 574.601 816.551 OK 3218.59 1746.38 4690.81 OK XLOC_001371 - - XLOC_001371 CAPZB TSS2175,TSS2176,TSS2177 chr1:19665273-19811992 - - 3724.87 2557.88 4891.86 OK 5246.78 4652.84 5840.71 OK 19451.7 8860.63 30042.8 OK XLOC_001372 - - XLOC_001372 - - chr1:19665273-19811992 - - 37.4567 0 134.342 OK 15.7099 0 43.8763 OK 16.6971 0 270.816 OK XLOC_001373 - - XLOC_001373 TMCO4 TSS2178,TSS2179,TSS2180,TSS2181 chr1:20008706-20126758 - - 79.6954 0 191.578 OK 67.0477 48.1392 85.9562 OK 628.12 255.641 1000.6 OK XLOC_001374 - - XLOC_001374 RNF186 - chr1:20140522-20141771 - - 1.07721 0 4.18133 OK 0.423276 0 1.6266 OK 0 0 0 OK XLOC_001375 - - XLOC_001375 PLA2G2E TSS2182 chr1:20246799-20250110 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001376 - - XLOC_001376 PLA2G2A TSS2183,TSS2184 chr1:20301924-20306932 - - 134.324 8.37934 260.269 OK 35.1082 21.8517 48.3647 OK 12.952 0 27.7808 OK XLOC_001377 - - XLOC_001377 PLA2G2D TSS2185 chr1:20438440-20446008 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001378 - - XLOC_001378 PLA2G2C TSS2186 chr1:20490483-20501687 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001379 - - XLOC_001379 - TSS2187,TSS2188 chr1:20687597-20755275 - - 0 0 0 OK 0.74001 0 2.83297 OK 2.56345 0 6.11092 OK XLOC_001380 - - XLOC_001380 CAMK2N1 TSS2189,TSS2190 chr1:20808884-20812728 - - 335.378 92.3166 578.44 OK 130.773 101.23 160.316 OK 10489.8 3992.43 16987.1 OK XLOC_001381 - - XLOC_001381 MUL1 TSS2191 chr1:20825942-20834674 - - 392.307 205.86 578.753 OK 351.837 291.107 412.567 OK 1509.04 876.74 2141.34 OK XLOC_001382 - - XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 - - 4463.42 3247.07 5679.77 OK 4991.33 4450.62 5532.04 OK 12716.5 6041.99 19391.1 OK XLOC_001383 - - XLOC_001383 KIF17 TSS2193,TSS2194,TSS2195 chr1:20990508-21044317 - - 66.5994 13.3859 119.813 OK 171.982 130.458 213.506 OK 129.385 15.0361 243.734 OK XLOC_001384 - - XLOC_001384 SH2D5 TSS2196,TSS2197 chr1:21046224-21059330 - - 73.6913 19.9103 127.472 OK 306.55 252.737 360.363 OK 308.235 138.957 477.514 OK XLOC_001385 - - XLOC_001385 HP1BP3 TSS2198,TSS2199,TSS2200,TSS2201,TSS2202 chr1:21069170-21113799 - - 1913.33 1096.68 2729.98 OK 1065.05 873.992 1256.11 OK 4455.85 1451.25 7460.46 OK XLOC_001386 - - XLOC_001386 EIF4G3 TSS2203,TSS2204,TSS2205,TSS2206,TSS2207,TSS2208 chr1:21132975-21503340 - - 1166.43 698.845 1634.03 OK 707.133 606.593 807.672 OK 2118.9 971.455 3266.35 OK XLOC_001387 - - XLOC_001387 ECE1 TSS2209,TSS2210,TSS2211,TSS2212 chr1:21543739-21672034 - - 228.564 96.3202 360.808 OK 567.103 486.812 647.393 OK 6484.57 2264.9 10704.2 OK XLOC_001388 - - XLOC_001388 - - chr1:21543739-21672034 - - 8.5531 0 38.3786 OK 0.863796 0 5.45777 OK 0.547703 0 47.9207 OK XLOC_001389 - - XLOC_001389 - TSS2213 chr1:21749600-21754300 - - 100.478 37.9623 162.993 OK 59.716 45.3134 74.1186 OK 526.991 265.844 788.138 OK XLOC_001390 - - XLOC_001390 RAP1GAP TSS2214,TSS2215,TSS2216 chr1:21922708-21995856 - - 56.0998 9.98173 102.218 OK 178.62 145.475 211.764 OK 2.12911 0 4.59697 OK XLOC_001391 - - XLOC_001391 USP48 TSS2217,TSS2218,TSS2219 chr1:22004793-22109688 - - 1144.32 670.926 1617.71 OK 815.156 676.838 953.475 OK 1523.68 669.697 2377.67 OK XLOC_001392 - - XLOC_001392 HSPG2 TSS2220,TSS2221,TSS2222 chr1:22138757-22263750 - - 159.269 0 417.721 OK 1050.98 914.91 1187.06 OK 4755.93 0 12767.6 OK XLOC_001393 - - XLOC_001393 WNT4 TSS2223,TSS2224 chr1:22443799-22470385 - - 15.9525 4.78036 27.1246 OK 73.6692 57.8567 89.4816 OK 0.787764 0 2.19369 OK XLOC_001394 - - XLOC_001394 - TSS2225 chr1:23337326-23342343 - - 3.40123 0 13.2023 OK 1.30651 0 5.02077 OK 0 0 0 OK XLOC_001395 - - XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 - - 860.605 603.459 1117.75 OK 435.794 372.802 498.787 OK 885.771 472.058 1299.48 OK XLOC_001396 - - XLOC_001396 HTR1D - chr1:23518388-23521222 - - 223.865 107.37 340.36 OK 138.505 110.603 166.407 OK 0 0 0 OK XLOC_001397 - - XLOC_001397 HNRNPR TSS2227,TSS2228 chr1:23636276-23670853 - - 3142.27 2179.33 4105.22 OK 3020.37 2637.33 3403.4 OK 5103.63 2604.29 7602.98 OK XLOC_001398 - - XLOC_001398 ZNF436 TSS2229,TSS2230 chr1:23685941-23698278 - - 60.989 7.80842 114.17 OK 18.4192 13.3986 23.4398 OK 386.766 186.05 587.481 OK XLOC_001399 - - XLOC_001399 TCEA3 TSS2231,TSS2232 chr1:23707554-23751261 - - 134.779 0 284.291 OK 6.26106 0 15.7884 OK 774.243 120.11 1428.38 OK XLOC_001400 - - XLOC_001400 ASAP3 TSS2233,TSS2234,TSS2235,TSS2236,TSS2237 chr1:23755055-23811057 - - 303.901 141.604 466.198 OK 762.709 630.81 894.608 OK 793.086 425.902 1160.27 OK XLOC_001401 - - XLOC_001401 - - chr1:23755055-23811057 - - 14.3352 0 56.05 OK 1.51415 0 8.05567 OK 0 0 0 OK XLOC_001402 - - XLOC_001402 E2F2 TSS2238 chr1:23832921-23857713 - - 17.3678 4.7535 29.9821 OK 95.4288 77.2231 113.634 OK 59.0676 19.8264 98.3088 OK XLOC_001403 - - XLOC_001403 ID3 TSS2239 chr1:23884409-23886322 - - 2524.02 1481.32 3566.72 OK 3183.79 2765.29 3602.29 OK 1504.77 740.202 2269.34 OK XLOC_001404 - - XLOC_001404 - TSS2240 chr1:24069855-24104777 - - 29.788 0 264.297 OK 77.4967 4.15983 150.834 OK 107.333 0 702.882 OK XLOC_001405 - - XLOC_001405 GALE TSS2241,TSS2242,TSS2243,TSS2244 chr1:24122088-24127294 - - 309.118 52.9938 565.242 OK 568.398 461.472 675.324 OK 762.674 316.231 1209.12 OK XLOC_001406 - - XLOC_001406 HMGCL TSS2245,TSS2246 chr1:24128367-24165110 - - 216.788 59.1752 374.401 OK 359.074 285.777 432.371 OK 1760.73 912.21 2609.26 OK XLOC_001407 - - XLOC_001407 FUCA1 TSS2247 chr1:24171573-24194821 - - 207.2 93.0962 321.303 OK 132.316 99.2404 165.391 OK 142.572 0 302.051 OK XLOC_001408 - - XLOC_001408 CNR2 TSS2248 chr1:24200460-24239817 - - 0.725191 0 2.81492 OK 0 0 0 OK 0 0 0 OK XLOC_001409 - - XLOC_001409 SFRS13A TSS2249 chr1:24292938-24306821 - - 2102.35 1315.04 2889.66 OK 1582.97 1324.94 1841.01 OK 2465.33 1222.33 3708.34 OK XLOC_001410 - - XLOC_001410 MYOM3 TSS2250,TSS2251,TSS2252,TSS2253 chr1:24382531-24438665 - - 3.09627 0 8.03751 OK 3.93809 0.760637 7.11554 OK 0 0 0 OK XLOC_001411 - - XLOC_001411 IL22RA1 TSS2254,TSS2255 chr1:24446260-24469611 - - 6.64523 1.2324 12.0581 OK 7.00921 3.03832 10.9801 OK 3.57865 0 7.56641 OK XLOC_001412 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 99.4363 0 272.313 OK 206.886 132.751 281.02 OK 0.114571 0 1.06264 OK XLOC_001413 - - XLOC_001413 - - chr1:24580829-24580859 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK XLOC_001414 - - XLOC_001414 C1orf201 TSS2257,TSS2258,TSS2259,TSS2260,TSS2261 chr1:24683489-24741587 - - 164.974 51.8643 278.084 OK 152.011 118.068 185.954 OK 296.253 97.244 495.263 OK cummeRbund/inst/extdata/genes.read_group_tracking0000644000175200017520000035407614516004263023360 0ustar00biocbuildbiocbuildtracking_id condition replicate raw_frags internal_scaled_frags external_scaled_frags FPKM effective_length status XLOC_000001 iPS 0 9 9.3939 16.0613 17.2049 - OK XLOC_000001 iPS 1 14 13.4879 23.0611 22.9288 - OK XLOC_000001 hESC 1 1 0.989851 0.654207 0.621918 - OK XLOC_000001 hESC 0 0 0 0 0 - OK XLOC_000001 Fibroblasts 1 31 25.8664 21.1458 20.6009 - OK XLOC_000001 Fibroblasts 0 12.0001 14.2788 11.6729 11.1815 - OK XLOC_000002 iPS 0 0 0 0 0 - OK XLOC_000002 iPS 1 0 0 0 0 - OK XLOC_000002 hESC 1 0 0 0 0 - OK XLOC_000002 hESC 0 0 0 0 0 - OK XLOC_000002 Fibroblasts 1 0 0 0 0 - OK XLOC_000002 Fibroblasts 0 0 0 0 0 - OK XLOC_000003 iPS 0 0 0 0 0 - OK XLOC_000003 iPS 1 0 0 0 0 - OK XLOC_000003 hESC 1 0 0 0 0 - OK XLOC_000003 hESC 0 0 0 0 0 - OK XLOC_000003 Fibroblasts 1 0 0 0 0 - OK XLOC_000003 Fibroblasts 0 0 0 0 0 - OK XLOC_000004 iPS 0 0 0 0 0 - OK XLOC_000004 iPS 1 0 0 0 0 - OK XLOC_000004 hESC 1 4.33333 4.28935 2.8349 835811 - OK XLOC_000004 hESC 0 7 7.07177 4.67384 1.37799e+06 - OK XLOC_000004 Fibroblasts 1 0 0 0 0 - OK XLOC_000004 Fibroblasts 0 0.333333 0.396629 0.324245 28475.5 - OK XLOC_000005 iPS 0 417.5 435.773 745.068 319.03 - OK XLOC_000005 iPS 1 557.533 537.14 918.382 390.455 - OK XLOC_000005 hESC 1 2536.57 2510.83 1659.44 721.983 - OK XLOC_000005 hESC 0 2455.11 2480.28 1639.26 687.563 - OK XLOC_000005 Fibroblasts 1 119.867 100.017 81.7639 38.0084 - OK XLOC_000005 Fibroblasts 0 137.1 163.134 133.362 57.8929 - OK XLOC_000006 iPS 0 0 0 0 0 - OK XLOC_000006 iPS 1 1 0.963422 1.64722 3.02791 - OK XLOC_000006 hESC 1 0 0 0 0 - OK XLOC_000006 hESC 0 0 0 0 0 - OK XLOC_000006 Fibroblasts 1 0 0 0 0 - OK XLOC_000006 Fibroblasts 0 0 0 0 0 - OK XLOC_000007 iPS 0 0 0 0 0 - OK XLOC_000007 iPS 1 0 0 0 0 - OK XLOC_000007 hESC 1 0 0 0 0 - OK XLOC_000007 hESC 0 0 0 0 0 - OK XLOC_000007 Fibroblasts 1 0 0 0 0 - OK XLOC_000007 Fibroblasts 0 0 0 0 0 - OK XLOC_000008 iPS 0 24157 25214.3 43110.4 43050.2 - OK XLOC_000008 iPS 1 24152 23268.6 39783.7 39728.2 - OK XLOC_000008 hESC 1 147707 146208 96630.9 100259 - OK XLOC_000008 hESC 0 127539 128847 85156.6 88354.2 - OK XLOC_000008 Fibroblasts 1 130138 108587 88770.3 89137.8 - OK XLOC_000008 Fibroblasts 0 48844 58118.9 47512.3 47709 - OK XLOC_000009 iPS 0 161 168.046 287.32 771.893 - OK XLOC_000009 iPS 1 119 114.647 196.02 526.613 - OK XLOC_000009 hESC 1 3594 3557.52 2351.22 7026.17 - OK XLOC_000009 hESC 0 3409 3443.95 2276.16 6801.86 - OK XLOC_000009 Fibroblasts 1 24798 20691.4 16915.3 46127.7 - OK XLOC_000009 Fibroblasts 0 1036 1232.72 1007.75 2748.13 - OK XLOC_000010 iPS 0 0 0 0 0 - OK XLOC_000010 iPS 1 0 0 0 0 - OK XLOC_000010 hESC 1 0 0 0 0 - OK XLOC_000010 hESC 0 0 0 0 0 - OK XLOC_000010 Fibroblasts 1 0 0 0 0 - OK XLOC_000010 Fibroblasts 0 0 0 0 0 - OK XLOC_000011 iPS 0 2531 2641.77 4516.81 7468.16 - OK XLOC_000011 iPS 1 2582 2487.56 4253.13 7032.19 - OK XLOC_000011 hESC 1 29211 28914.5 19110 33690.7 - OK XLOC_000011 hESC 0 26951 27227.3 17994.9 31724.9 - OK XLOC_000011 Fibroblasts 1 49557.5 41350.8 33804.4 56407.6 - OK XLOC_000011 Fibroblasts 0 10092 12008.3 9816.85 16380.9 - OK XLOC_000012 iPS 0 60.5 63.1479 107.968 151.289 - OK XLOC_000012 iPS 1 40.75 39.2595 67.1244 85.754 - OK XLOC_000012 hESC 1 166.417 164.728 108.871 175.394 - OK XLOC_000012 hESC 0 213.75 215.942 142.719 207.802 - OK XLOC_000012 Fibroblasts 1 348.75 290.997 237.891 272.138 - OK XLOC_000012 Fibroblasts 0 229.75 273.377 223.486 303.073 - OK XLOC_000013 iPS 0 15 15.6565 26.7689 15.0589 - OK XLOC_000013 iPS 1 3 2.89027 4.94167 2.77995 - OK XLOC_000013 hESC 1 79 78.1982 51.6823 29.7021 - OK XLOC_000013 hESC 0 72 72.7382 48.0737 27.6282 - OK XLOC_000013 Fibroblasts 1 230 191.912 156.888 88.533 - OK XLOC_000013 Fibroblasts 0 108 128.508 105.056 59.2833 - OK XLOC_000014 iPS 0 16 16.7003 28.5535 14.0463 - OK XLOC_000014 iPS 1 4 3.85369 6.58889 3.24126 - OK XLOC_000014 hESC 1 98 97.0054 64.1123 32.1328 - OK XLOC_000014 hESC 0 71 71.728 47.4061 23.7597 - OK XLOC_000014 Fibroblasts 1 2 1.6688 1.36425 0.67294 - OK XLOC_000014 Fibroblasts 0 1 1.18989 0.972736 0.47982 - OK XLOC_000015 iPS 0 192.406 200.827 343.367 369.982 - OK XLOC_000015 iPS 1 6.84033 6.59012 11.2675 14.1904 - OK XLOC_000015 hESC 1 10.6666 10.5583 6.97813 4.23036 - OK XLOC_000015 hESC 0 16.5335 16.703 11.0393 8.21721 - OK XLOC_000015 Fibroblasts 1 84.1515 70.216 57.4018 40.7491 - OK XLOC_000015 Fibroblasts 0 52.6691 62.6703 51.2331 40.9117 - OK XLOC_000016 iPS 0 141 147.171 251.628 230.13 - OK XLOC_000016 iPS 1 89 85.7446 146.603 133.256 - OK XLOC_000016 hESC 1 1269 1256.12 830.188 778.612 - OK XLOC_000016 hESC 0 1161 1172.9 775.189 744.95 - OK XLOC_000016 Fibroblasts 1 580 483.952 395.632 320.491 - OK XLOC_000016 Fibroblasts 0 470 559.247 457.186 365.838 - OK XLOC_000017 iPS 0 9 9.3939 16.0613 10.1857 - OK XLOC_000017 iPS 1 2 1.92684 3.29445 2.19245 - OK XLOC_000017 hESC 1 59 58.4012 38.5982 24.5627 - OK XLOC_000017 hESC 0 52 52.5332 34.7199 21.6849 - OK XLOC_000017 Fibroblasts 1 107 89.2808 72.9873 44.6519 - OK XLOC_000017 Fibroblasts 0 116 138.027 112.837 72.7904 - OK XLOC_000018 iPS 0 136 141.952 242.705 694.225 - OK XLOC_000018 iPS 1 80 77.0738 131.778 376.933 - OK XLOC_000018 hESC 1 536 530.56 350.655 1123.84 - OK XLOC_000018 hESC 0 469 473.809 313.147 1003.63 - OK XLOC_000018 Fibroblasts 1 1854 1546.98 1264.66 3675.44 - OK XLOC_000018 Fibroblasts 0 998 1187.51 970.791 2821.38 - OK XLOC_000019 iPS 0 465 485.352 829.836 164.14 - OK XLOC_000019 iPS 1 494.333 476.252 814.277 161.062 - OK XLOC_000019 hESC 1 14186.7 14042.7 9281.01 1849.52 - OK XLOC_000019 hESC 0 14148 14293.1 9446.49 1882.49 - OK XLOC_000019 Fibroblasts 1 23277.1 19422.4 15877.9 3144.04 - OK XLOC_000019 Fibroblasts 0 10113.6 12034 9837.85 1948.03 - OK XLOC_000020 iPS 0 8 8.35014 14.2767 25.7423 - OK XLOC_000020 iPS 1 6 5.78053 9.88334 17.3988 - OK XLOC_000020 hESC 1 28 27.7158 18.3178 35.5057 - OK XLOC_000020 hESC 0 24 24.2461 16.0246 31.8673 - OK XLOC_000020 Fibroblasts 1 19 15.8536 12.9604 23.8311 - OK XLOC_000020 Fibroblasts 0 65 77.3427 63.2279 115.929 - OK XLOC_000021 iPS 0 0 0 0 0 - OK XLOC_000021 iPS 1 0 0 0 0 - OK XLOC_000021 hESC 1 2 1.9797 1.30841 1.32641 - OK XLOC_000021 hESC 0 3 3.03076 2.00307 2.03063 - OK XLOC_000021 Fibroblasts 1 0 0 0 0 - OK XLOC_000021 Fibroblasts 0 0 0 0 0 - OK XLOC_000022 iPS 0 0 0 0 0 - OK XLOC_000022 iPS 1 0 0 0 0 - OK XLOC_000022 hESC 1 0 0 0 0 - OK XLOC_000022 hESC 0 0 0 0 0 - OK XLOC_000022 Fibroblasts 1 0 0 0 0 - OK XLOC_000022 Fibroblasts 0 0 0 0 0 - OK XLOC_000023 iPS 0 0 0 0 0 - OK XLOC_000023 iPS 1 0 0 0 0 - OK XLOC_000023 hESC 1 0 0 0 0 - OK XLOC_000023 hESC 0 0 0 0 0 - OK XLOC_000023 Fibroblasts 1 0 0 0 0 - OK XLOC_000023 Fibroblasts 0 0 0 0 0 - OK XLOC_000024 iPS 0 0 0 0 0 - OK XLOC_000024 iPS 1 0 0 0 0 - OK XLOC_000024 hESC 1 0 0 0 0 - OK XLOC_000024 hESC 0 0 0 0 0 - OK XLOC_000024 Fibroblasts 1 0 0 0 0 - OK XLOC_000024 Fibroblasts 0 0 0 0 0 - OK XLOC_000025 iPS 0 0 0 0 0 - OK XLOC_000025 iPS 1 0 0 0 0 - OK XLOC_000025 hESC 1 42 41.5737 27.4767 19.4956 - OK XLOC_000025 hESC 0 30 30.3076 20.0307 14.5913 - OK XLOC_000025 Fibroblasts 1 0 0 0 0 - OK XLOC_000025 Fibroblasts 0 0 0 0 0 - OK XLOC_000026 iPS 0 249 259.898 444.364 239.683 - OK XLOC_000026 iPS 1 231 222.551 380.509 205.241 - OK XLOC_000026 hESC 1 744 736.449 486.73 267.968 - OK XLOC_000026 hESC 0 792 800.121 528.811 291.136 - OK XLOC_000026 Fibroblasts 1 3028 2526.56 2065.47 1117.41 - OK XLOC_000026 Fibroblasts 0 1912 2275.07 1859.87 1006.18 - OK XLOC_000027 iPS 0 11 11.4814 19.6305 9.94397 - OK XLOC_000027 iPS 1 9 8.6708 14.825 7.69065 - OK XLOC_000027 hESC 1 229 226.676 149.813 86.6195 - OK XLOC_000027 hESC 0 165 166.692 110.169 64.9898 - OK XLOC_000027 Fibroblasts 1 184 153.53 125.511 68.4736 - OK XLOC_000027 Fibroblasts 0 109 129.698 106.028 57.3541 - OK XLOC_000028 iPS 0 172.299 179.84 307.483 394.342 - OK XLOC_000028 iPS 1 146.243 140.893 240.894 310.903 - OK XLOC_000028 hESC 1 923.783 914.407 604.345 834.698 - OK XLOC_000028 hESC 0 862.34 871.182 575.777 797.082 - OK XLOC_000028 Fibroblasts 1 793.154 661.808 541.029 720.77 - OK XLOC_000028 Fibroblasts 0 775.485 922.74 754.343 1001.3 - OK XLOC_000029 iPS 0 137 142.996 244.489 170.826 - OK XLOC_000029 iPS 1 94 90.5617 154.839 108.187 - OK XLOC_000029 hESC 1 380 376.143 248.599 178.383 - OK XLOC_000029 hESC 0 421 425.317 281.098 201.703 - OK XLOC_000029 Fibroblasts 1 1474 1229.91 1005.45 705.236 - OK XLOC_000029 Fibroblasts 0 1239 1474.27 1205.22 845.357 - OK XLOC_000030 iPS 0 9 9.3939 16.0613 9.50402 - OK XLOC_000030 iPS 1 3 2.89027 4.94167 2.92415 - OK XLOC_000030 hESC 1 5 4.94925 3.27103 1.97961 - OK XLOC_000030 hESC 0 8 8.08203 5.34153 3.23266 - OK XLOC_000030 Fibroblasts 1 14 11.6816 9.54973 5.66941 - OK XLOC_000030 Fibroblasts 0 5 5.94944 4.86368 2.88743 - OK XLOC_000031 iPS 0 146.981 153.414 262.302 242.85 - OK XLOC_000031 iPS 1 167.54 161.412 275.976 257.933 - OK XLOC_000031 hESC 1 925.738 916.342 605.624 572.756 - OK XLOC_000031 hESC 0 886.752 895.844 592.076 558.947 - OK XLOC_000031 Fibroblasts 1 996.361 831.363 679.642 619.084 - OK XLOC_000031 Fibroblasts 0 568.356 676.28 552.861 503.646 - OK XLOC_000032 iPS 0 0 0 0 0 - OK XLOC_000032 iPS 1 2 1.92684 3.29445 14.4039 - OK XLOC_000032 hESC 1 23 22.7666 15.0468 78.7253 - OK XLOC_000032 hESC 0 16 16.1641 10.6831 55.8942 - OK XLOC_000032 Fibroblasts 1 0 0 0 0 - OK XLOC_000032 Fibroblasts 0 0 0 0 0 - OK XLOC_000033 iPS 0 161 168.046 287.32 173.564 - OK XLOC_000033 iPS 1 287 276.502 472.753 282.342 - OK XLOC_000033 hESC 1 1309 1295.71 856.357 538.809 - OK XLOC_000033 hESC 0 1294.5 1307.77 864.326 535.053 - OK XLOC_000033 Fibroblasts 1 1437 1199.03 980.212 587.348 - OK XLOC_000033 Fibroblasts 0 587 698.464 570.996 348.628 - OK XLOC_000034 iPS 0 27.6667 28.8776 49.3738 18.9195 - OK XLOC_000034 iPS 1 9.33333 8.99194 15.3741 5.89119 - OK XLOC_000034 hESC 1 244.667 242.183 160.063 62.2307 - OK XLOC_000034 hESC 0 298.167 301.224 199.083 77.4015 - OK XLOC_000034 Fibroblasts 1 47.4833 39.6201 32.3895 12.4376 - OK XLOC_000034 Fibroblasts 0 49.5 58.8994 48.1504 18.4899 - OK XLOC_000035 iPS 0 476.167 497.007 849.764 547.107 - OK XLOC_000035 iPS 1 290.833 280.195 479.067 315.414 - OK XLOC_000035 hESC 1 1911.73 1892.33 1250.67 1041.48 - OK XLOC_000035 hESC 0 1880 1899.28 1255.26 969.023 - OK XLOC_000035 Fibroblasts 1 832.333 694.499 567.754 482.603 - OK XLOC_000035 Fibroblasts 0 1443.07 1717.09 1403.72 1094.33 - OK XLOC_000036 iPS 0 599.667 625.912 1070.16 657.86 - OK XLOC_000036 iPS 1 563.833 543.21 928.759 576.53 - OK XLOC_000036 hESC 1 3369.82 3335.62 2204.56 1431.43 - OK XLOC_000036 hESC 0 3380.17 3414.82 2256.91 1435.15 - OK XLOC_000036 Fibroblasts 1 3409.38 2844.79 2325.62 1485.84 - OK XLOC_000036 Fibroblasts 0 4258.32 5066.92 4142.22 2643.49 - OK XLOC_000037 iPS 0 1 1.04377 1.78459 2.8669 - OK XLOC_000037 iPS 1 1 0.963422 1.64722 2.64622 - OK XLOC_000037 hESC 1 14 13.8579 9.15889 15.6591 - OK XLOC_000037 hESC 0 6 6.06152 4.00615 6.84937 - OK XLOC_000037 Fibroblasts 1 10 8.344 6.82124 9.2071 - OK XLOC_000037 Fibroblasts 0 0 0 0 0 - OK XLOC_000038 iPS 0 94 98.1141 167.752 91.849 - OK XLOC_000038 iPS 1 67 64.5493 110.364 72.0915 - OK XLOC_000038 hESC 1 1104 1092.8 722.244 589.923 - OK XLOC_000038 hESC 0 1186 1198.16 791.881 608.263 - OK XLOC_000038 Fibroblasts 1 2049 1709.68 1397.67 700.03 - OK XLOC_000038 Fibroblasts 0 1043 1241.05 1014.56 497.977 - OK XLOC_000039 iPS 0 6.5 6.78449 11.5999 16.5431 - OK XLOC_000039 iPS 1 5.5 5.29882 9.05973 11.9599 - OK XLOC_000039 hESC 1 81.5 80.6728 53.3178 76.7825 - OK XLOC_000039 hESC 0 65.5 66.1716 43.7338 62.72 - OK XLOC_000039 Fibroblasts 1 13 10.8472 8.86761 13.5191 - OK XLOC_000039 Fibroblasts 0 20.8333 24.7893 20.2653 38.3416 - OK XLOC_000040 iPS 0 7.50053 7.8288 13.3854 27.8227 - OK XLOC_000040 iPS 1 3.00001 2.89027 4.94168 10.2717 - OK XLOC_000040 hESC 1 93.0001 92.0563 60.8413 127.296 - OK XLOC_000040 hESC 0 48.5 48.9973 32.383 68.26 - OK XLOC_000040 Fibroblasts 1 85.5018 71.3427 58.3228 113.957 - OK XLOC_000040 Fibroblasts 0 36.3335 43.2328 35.3429 68.4177 - OK XLOC_000041 iPS 0 51.9318 54.2047 92.6772 79.9112 - OK XLOC_000041 iPS 1 34.5665 33.3022 56.9388 49.0957 - OK XLOC_000041 hESC 1 119.863 118.646 78.4149 69.8784 - OK XLOC_000041 hESC 0 151.117 152.667 100.9 89.9153 - OK XLOC_000041 Fibroblasts 1 203.297 169.631 138.673 120.144 - OK XLOC_000041 Fibroblasts 0 54.3773 64.7029 52.8948 45.8269 - OK XLOC_000042 iPS 0 2 2.08753 3.56919 6.70016 - OK XLOC_000042 iPS 1 1 0.963422 1.64722 3.09221 - OK XLOC_000042 hESC 1 3 2.96955 1.96262 3.96399 - OK XLOC_000042 hESC 0 2 2.02051 1.33538 2.69713 - OK XLOC_000042 Fibroblasts 1 3 2.5032 2.04637 3.88173 - OK XLOC_000042 Fibroblasts 0 10 11.8989 9.72736 18.4517 - OK XLOC_000043 iPS 0 3 3.1313 5.35378 8.11241 - OK XLOC_000043 iPS 1 1 0.963422 1.64722 2.49598 - OK XLOC_000043 hESC 1 30 29.6955 19.6262 31.5351 - OK XLOC_000043 hESC 0 23 23.2358 15.3569 24.6753 - OK XLOC_000043 Fibroblasts 1 2 1.6688 1.36425 1.75278 - OK XLOC_000043 Fibroblasts 0 0 0 0 0 - OK XLOC_000044 iPS 0 12 12.5252 21.4151 17.236 - OK XLOC_000044 iPS 1 5 4.81711 8.23612 6.62886 - OK XLOC_000044 hESC 1 79 78.1982 51.6823 42.8944 - OK XLOC_000044 hESC 0 76 76.7792 50.7445 42.116 - OK XLOC_000044 Fibroblasts 1 0 0 0 0 - OK XLOC_000044 Fibroblasts 0 1 1.18989 0.972736 0.786404 - OK XLOC_000045 iPS 0 244.916 255.635 437.075 302.412 - OK XLOC_000045 iPS 1 294.472 283.701 485.061 341.128 - OK XLOC_000045 hESC 1 2227.66 2205.05 1457.35 1011.23 - OK XLOC_000045 hESC 0 2162.97 2185.15 1444.2 991.795 - OK XLOC_000045 Fibroblasts 1 247.319 206.363 168.702 134.587 - OK XLOC_000045 Fibroblasts 0 64.7788 77.0795 63.0127 48.4088 - OK XLOC_000046 iPS 0 51 53.2321 91.0143 72.5104 - OK XLOC_000046 iPS 1 45.0002 43.3542 74.1254 59.0552 - OK XLOC_000046 hESC 1 212 209.848 138.692 113.906 - OK XLOC_000046 hESC 0 200.001 202.051 133.539 109.674 - OK XLOC_000046 Fibroblasts 1 206 171.886 140.518 112.444 - OK XLOC_000046 Fibroblasts 0 111.001 132.078 107.974 86.4024 - OK XLOC_000047 iPS 0 591 616.866 1054.69 269.372 - OK XLOC_000047 iPS 1 527 507.724 868.087 221.712 - OK XLOC_000047 hESC 1 4208 4165.29 2752.9 709.915 - OK XLOC_000047 hESC 0 4521 4567.35 3018.63 778.44 - OK XLOC_000047 Fibroblasts 1 8777.5 7323.94 5987.34 1531.34 - OK XLOC_000047 Fibroblasts 0 7039 8375.62 6847.09 1751.24 - OK XLOC_000048 iPS 0 1142.05 1192.04 2038.1 984.731 - OK XLOC_000048 iPS 1 850.089 818.995 1400.29 675.221 - OK XLOC_000048 hESC 1 2553.21 2527.3 1670.33 820.931 - OK XLOC_000048 hESC 0 2444.4 2469.46 1632.1 802.898 - OK XLOC_000048 Fibroblasts 1 12436.1 10376.7 8482.99 4109.29 - OK XLOC_000048 Fibroblasts 0 7918.72 9422.39 7702.83 3728.02 - OK XLOC_000049 iPS 0 2 2.08753 3.56919 1.2132 - OK XLOC_000049 iPS 1 5 4.81711 8.23612 3.36969 - OK XLOC_000049 hESC 1 16 15.8376 10.4673 3.03539 - OK XLOC_000049 hESC 0 9 9.09228 6.00922 1.63069 - OK XLOC_000049 Fibroblasts 1 2 1.6688 1.36425 0.512637 - OK XLOC_000049 Fibroblasts 0 17 20.2281 16.5365 4.75079 - OK XLOC_000050 iPS 0 43.8004 45.7174 78.1659 90.0735 - OK XLOC_000050 iPS 1 2 1.92684 3.29445 4.12813 - OK XLOC_000050 hESC 1 9.55735 9.46035 6.25248 6.65285 - OK XLOC_000050 hESC 0 5 5.05127 3.33846 1.97078 - OK XLOC_000050 Fibroblasts 1 1659.14 1384.39 1131.74 1065.01 - OK XLOC_000050 Fibroblasts 0 789.393 939.289 767.871 687.923 - OK XLOC_000051 iPS 0 452.941 472.765 808.316 454.158 - OK XLOC_000051 iPS 1 450.468 433.991 742.022 419.518 - OK XLOC_000051 hESC 1 2385.22 2361.01 1560.43 891.894 - OK XLOC_000051 hESC 0 2208.16 2230.8 1474.37 847.066 - OK XLOC_000051 Fibroblasts 1 2938.66 2452.01 2004.53 1128.91 - OK XLOC_000051 Fibroblasts 0 2611.69 3107.61 2540.48 1432.67 - OK XLOC_000052 iPS 0 0 0 0 0 - OK XLOC_000052 iPS 1 0 0 0 0 - OK XLOC_000052 hESC 1 0 0 0 0 - OK XLOC_000052 hESC 0 0 0 0 0 - OK XLOC_000052 Fibroblasts 1 0 0 0 0 - OK XLOC_000052 Fibroblasts 0 0 0 0 0 - OK XLOC_000053 iPS 0 4 4.17507 7.13837 1.18893 - OK XLOC_000053 iPS 1 3 2.89027 4.94167 0.823042 - OK XLOC_000053 hESC 1 50 49.4925 32.7103 5.48297 - OK XLOC_000053 hESC 0 46 46.4716 30.7138 5.14828 - OK XLOC_000053 Fibroblasts 1 84 70.0896 57.2984 9.55332 - OK XLOC_000053 Fibroblasts 0 43 51.1652 41.8277 6.92723 - OK XLOC_000054 iPS 0 148 154.478 264.12 145.159 - OK XLOC_000054 iPS 1 205 197.502 337.681 186.7 - OK XLOC_000054 hESC 1 957 947.287 626.076 372.469 - OK XLOC_000054 hESC 0 947.5 957.215 632.637 373.047 - OK XLOC_000054 Fibroblasts 1 5 4.172 3.41062 1.78166 - OK XLOC_000054 Fibroblasts 0 13 15.4685 12.6456 8.12021 - OK XLOC_000055 iPS 0 598 624.173 1067.19 668.692 - OK XLOC_000055 iPS 1 405 390.186 667.125 418.016 - OK XLOC_000055 hESC 1 1231 1218.51 805.328 516.786 - OK XLOC_000055 hESC 0 1157 1168.86 772.518 495.731 - OK XLOC_000055 Fibroblasts 1 5990 4998.05 4085.92 2569.85 - OK XLOC_000055 Fibroblasts 0 4549 5412.8 4424.98 2784.35 - OK XLOC_000056 iPS 0 12 12.5252 21.4151 16.4811 - OK XLOC_000056 iPS 1 10 9.63422 16.4722 14.1907 - OK XLOC_000056 hESC 1 217 214.798 141.963 80.6509 - OK XLOC_000056 hESC 0 191 192.958 127.529 71.3587 - OK XLOC_000056 Fibroblasts 1 2 1.6688 1.36425 1.12281 - OK XLOC_000056 Fibroblasts 0 15 17.8483 14.591 8.75899 - OK XLOC_000057 iPS 0 0 0 0 0 - OK XLOC_000057 iPS 1 1 0.963422 1.64722 1.16125 - OK XLOC_000057 hESC 1 12 11.8782 7.85048 5.68504 - OK XLOC_000057 hESC 0 1 1.01025 0.667691 0.483518 - OK XLOC_000057 Fibroblasts 1 0 0 0 0 - OK XLOC_000057 Fibroblasts 0 1 1.18989 0.972736 0.688434 - OK XLOC_000058 iPS 0 3 3.1313 5.35378 20.0596 - OK XLOC_000058 iPS 1 6 5.78053 9.88334 37.0309 - OK XLOC_000058 hESC 1 37 36.6245 24.2056 105.561 - OK XLOC_000058 hESC 0 23 23.2358 15.3569 66.9717 - OK XLOC_000058 Fibroblasts 1 23 19.1912 15.6888 60.0249 - OK XLOC_000058 Fibroblasts 0 14 16.6584 13.6183 52.1031 - OK XLOC_000059 iPS 0 96 100.202 171.321 84.2743 - OK XLOC_000059 iPS 1 75 72.2567 123.542 61.1137 - OK XLOC_000059 hESC 1 336.5 333.085 220.141 118.403 - OK XLOC_000059 hESC 0 378.5 382.381 252.721 126.535 - OK XLOC_000059 Fibroblasts 1 346.5 289.119 236.356 137.139 - OK XLOC_000059 Fibroblasts 0 240 285.573 233.457 115.803 - OK XLOC_000060 iPS 0 3 3.1313 5.35378 4.55402 - OK XLOC_000060 iPS 1 6 5.78053 9.88334 9.64836 - OK XLOC_000060 hESC 1 21 20.7869 13.7383 20.0052 - OK XLOC_000060 hESC 0 33 33.3384 22.0338 31.257 - OK XLOC_000060 Fibroblasts 1 6 5.0064 4.09274 4.16177 - OK XLOC_000060 Fibroblasts 0 4 4.75955 3.89094 4.06286 - OK XLOC_000061 iPS 0 0 0 0 0 - OK XLOC_000061 iPS 1 0 0 0 0 - OK XLOC_000061 hESC 1 0 0 0 0 - OK XLOC_000061 hESC 0 0 0 0 0 - OK XLOC_000061 Fibroblasts 1 0 0 0 0 - OK XLOC_000061 Fibroblasts 0 0 0 0 0 - OK XLOC_000062 iPS 0 0 0 0 0 - OK XLOC_000062 iPS 1 0 0 0 0 - OK XLOC_000062 hESC 1 0 0 0 0 - OK XLOC_000062 hESC 0 0 0 0 0 - OK XLOC_000062 Fibroblasts 1 0 0 0 0 - OK XLOC_000062 Fibroblasts 0 0 0 0 0 - OK XLOC_000063 iPS 0 54 56.3634 96.3681 56.4297 - OK XLOC_000063 iPS 1 169 162.818 278.381 152.909 - OK XLOC_000063 hESC 1 204 201.93 133.458 77.1486 - OK XLOC_000063 hESC 0 184 185.887 122.855 72.7169 - OK XLOC_000063 Fibroblasts 1 0 0 0 0 - OK XLOC_000063 Fibroblasts 0 4 4.75955 3.89094 2.53227 - OK XLOC_000064 iPS 0 24 25.0504 42.8302 13.5918 - OK XLOC_000064 iPS 1 117 112.72 192.725 61.1595 - OK XLOC_000064 hESC 1 102 100.965 66.7291 21.4315 - OK XLOC_000064 hESC 0 71 71.728 47.4061 15.2255 - OK XLOC_000064 Fibroblasts 1 0 0 0 0 - OK XLOC_000064 Fibroblasts 0 1 1.18989 0.972736 0.309231 - OK XLOC_000065 iPS 0 80 83.5014 142.767 68.0616 - OK XLOC_000065 iPS 1 102 98.2691 168.017 81.3287 - OK XLOC_000065 hESC 1 443 438.504 289.814 144.905 - OK XLOC_000065 hESC 0 365 368.742 243.707 121.943 - OK XLOC_000065 Fibroblasts 1 353 294.543 240.79 115.74 - OK XLOC_000065 Fibroblasts 0 190 226.079 184.82 89.089 - OK XLOC_000066 iPS 0 95 99.1579 169.536 101.41 - OK XLOC_000066 iPS 1 61 58.7688 100.481 52.8831 - OK XLOC_000066 hESC 1 187 185.102 122.337 87.1254 - OK XLOC_000066 hESC 0 164.001 165.683 109.502 68.9121 - OK XLOC_000066 Fibroblasts 1 215.565 179.867 147.042 85.445 - OK XLOC_000066 Fibroblasts 0 98.005 116.615 95.333 49.124 - OK XLOC_000067 iPS 0 23 24.0066 41.0457 53.7339 - OK XLOC_000067 iPS 1 27 26.0124 44.475 58.2234 - OK XLOC_000067 hESC 1 167 165.305 109.253 150.428 - OK XLOC_000067 hESC 0 134 135.374 89.4706 123.19 - OK XLOC_000067 Fibroblasts 1 8 6.6752 5.45699 7.1959 - OK XLOC_000067 Fibroblasts 0 1 1.18989 0.972736 1.28271 - OK XLOC_000068 iPS 0 64 66.8011 114.214 310.974 - OK XLOC_000068 iPS 1 122 117.538 200.961 547.163 - OK XLOC_000068 hESC 1 746 738.429 488.038 1480.3 - OK XLOC_000068 hESC 0 778 785.977 519.464 1575.62 - OK XLOC_000068 Fibroblasts 1 0 0 0 0 - OK XLOC_000068 Fibroblasts 0 0 0 0 0 - OK XLOC_000069 iPS 0 20 20.8753 35.6919 19.2171 - OK XLOC_000069 iPS 1 17 16.3782 28.0028 18.1975 - OK XLOC_000069 hESC 1 415 410.788 271.496 207.673 - OK XLOC_000069 hESC 0 303.833 306.949 202.867 155.178 - OK XLOC_000069 Fibroblasts 1 0 0 0 0 - OK XLOC_000069 Fibroblasts 0 1 1.18989 0.972736 0.410165 - OK XLOC_000070 iPS 0 4 4.17507 7.13837 5.7096 - OK XLOC_000070 iPS 1 2 1.92684 3.29445 2.1216 - OK XLOC_000070 hESC 1 4 3.9594 2.61683 1.67897 - OK XLOC_000070 hESC 0 1 1.01025 0.667691 0.880753 - OK XLOC_000070 Fibroblasts 1 11 9.1784 7.50336 9.49601 - OK XLOC_000070 Fibroblasts 0 3 3.56966 2.91821 1.88601 - OK XLOC_000071 iPS 0 157 163.871 280.181 187.349 - OK XLOC_000071 iPS 1 162 156.074 266.85 172.161 - OK XLOC_000071 hESC 1 767 759.216 501.777 337.358 - OK XLOC_000071 hESC 0 735 742.536 490.753 325.795 - OK XLOC_000071 Fibroblasts 1 536 447.238 365.618 241.807 - OK XLOC_000071 Fibroblasts 0 402 478.335 391.04 259.433 - OK XLOC_000072 iPS 0 310 323.568 553.224 223.493 - OK XLOC_000072 iPS 1 496 477.858 817.023 330.063 - OK XLOC_000072 hESC 1 2522 2496.4 1649.91 676.812 - OK XLOC_000072 hESC 0 2395 2419.56 1599.12 655.977 - OK XLOC_000072 Fibroblasts 1 3100 2586.64 2114.58 856.164 - OK XLOC_000072 Fibroblasts 0 1712 2037.09 1665.32 674.265 - OK XLOC_000073 iPS 0 63.1295 65.8925 112.661 131.141 - OK XLOC_000073 iPS 1 40.1999 38.7295 66.2183 76.259 - OK XLOC_000073 hESC 1 329.057 325.718 215.272 258.728 - OK XLOC_000073 hESC 0 273.501 276.305 182.614 222.84 - OK XLOC_000073 Fibroblasts 1 668.837 558.077 456.23 547.773 - OK XLOC_000073 Fibroblasts 0 493.542 587.259 480.086 554.59 - OK XLOC_000074 iPS 0 360.5 376.278 643.346 1461.42 - OK XLOC_000074 iPS 1 280 269.758 461.223 1053.56 - OK XLOC_000074 hESC 1 992 981.932 648.973 1412.67 - OK XLOC_000074 hESC 0 1072.83 1083.83 716.321 1690.08 - OK XLOC_000074 Fibroblasts 1 1986.5 1657.53 1355.04 3407.48 - OK XLOC_000074 Fibroblasts 0 1117.83 1330.1 1087.36 2775.74 - OK XLOC_000075 iPS 0 1712 1786.93 3055.22 2122.13 - OK XLOC_000075 iPS 1 749 721.603 1233.77 856.964 - OK XLOC_000075 hESC 1 1147 1135.36 750.375 535.176 - OK XLOC_000075 hESC 0 1022 1032.48 682.38 486.681 - OK XLOC_000075 Fibroblasts 1 16345 13638.3 11149.3 7774.02 - OK XLOC_000075 Fibroblasts 0 9280 11042.2 9026.99 6294.2 - OK XLOC_000076 iPS 0 739 771.344 1318.81 392.023 - OK XLOC_000076 iPS 1 404 389.223 665.478 190.884 - OK XLOC_000076 hESC 1 754 746.347 493.272 153.501 - OK XLOC_000076 hESC 0 423 427.337 282.433 84.7819 - OK XLOC_000076 Fibroblasts 1 2853 2380.54 1946.1 505.017 - OK XLOC_000076 Fibroblasts 0 891 1060.19 866.708 214.667 - OK XLOC_000077 iPS 0 1579 1648.11 2817.87 5315.65 - OK XLOC_000077 iPS 1 1295 1247.63 2133.15 3935 - OK XLOC_000077 hESC 1 6503 6437 4254.31 8581.34 - OK XLOC_000077 hESC 0 6745 6814.16 4503.58 9081.27 - OK XLOC_000077 Fibroblasts 1 15742 13135.1 10738 20201.3 - OK XLOC_000077 Fibroblasts 0 12002.3 14281.4 11675.1 22134.5 - OK XLOC_000078 iPS 0 6 6.2626 10.7076 9.53485 - OK XLOC_000078 iPS 1 10 9.63422 16.4722 13.2149 - OK XLOC_000078 hESC 1 89 88.0967 58.2244 41.2698 - OK XLOC_000078 hESC 0 85 85.8715 56.7537 39.3748 - OK XLOC_000078 Fibroblasts 1 488 407.187 332.876 229.541 - OK XLOC_000078 Fibroblasts 0 273 324.839 265.557 190.698 - OK XLOC_000079 iPS 0 0 0 0 0 - OK XLOC_000079 iPS 1 0 0 0 0 - OK XLOC_000079 hESC 1 0 0 0 0 - OK XLOC_000079 hESC 0 0 0 0 0 - OK XLOC_000079 Fibroblasts 1 0 0 0 0 - OK XLOC_000079 Fibroblasts 0 0 0 0 0 - OK XLOC_000080 iPS 0 633 660.705 1129.65 178.631 - OK XLOC_000080 iPS 1 367 353.576 604.531 95.5945 - OK XLOC_000080 hESC 1 1007 996.78 658.786 104.797 - OK XLOC_000080 hESC 0 772 779.916 515.457 81.9967 - OK XLOC_000080 Fibroblasts 1 11318 9443.73 7720.28 1221.87 - OK XLOC_000080 Fibroblasts 0 6482 7712.85 6305.28 997.925 - OK XLOC_000081 iPS 0 108 112.727 192.736 94.0062 - OK XLOC_000081 iPS 1 102 98.2691 168.017 80.9367 - OK XLOC_000081 hESC 1 285 282.107 186.449 95.551 - OK XLOC_000081 hESC 0 233 235.389 155.572 78.9222 - OK XLOC_000081 Fibroblasts 1 2246 1874.06 1532.05 772.028 - OK XLOC_000081 Fibroblasts 0 2000 2379.78 1945.47 971.558 - OK XLOC_000082 iPS 0 93 97.0703 165.967 181.635 - OK XLOC_000082 iPS 1 138 132.952 227.317 248.776 - OK XLOC_000082 hESC 1 355 351.397 232.243 264.325 - OK XLOC_000082 hESC 0 275 277.82 183.615 207.776 - OK XLOC_000082 Fibroblasts 1 238 198.587 162.345 178.752 - OK XLOC_000082 Fibroblasts 0 327 389.093 318.085 349.306 - OK XLOC_000083 iPS 0 161 168.046 287.32 112.156 - OK XLOC_000083 iPS 1 207 199.428 340.975 132.661 - OK XLOC_000083 hESC 1 1610.5 1594.15 1053.6 418.517 - OK XLOC_000083 hESC 0 1485.5 1500.73 991.855 393.655 - OK XLOC_000083 Fibroblasts 1 830 692.552 566.163 220.016 - OK XLOC_000083 Fibroblasts 0 1166 1387.41 1134.21 439.399 - OK XLOC_000084 iPS 0 428 446.732 763.806 207.41 - OK XLOC_000084 iPS 1 393 378.625 647.359 176.619 - OK XLOC_000084 hESC 1 2565.03 2538.99 1678.06 459.611 - OK XLOC_000084 hESC 0 2350.01 2374.11 1569.08 429.376 - OK XLOC_000084 Fibroblasts 1 991.112 826.983 676.061 183.845 - OK XLOC_000084 Fibroblasts 0 629.079 748.533 611.927 166.704 - OK XLOC_000085 iPS 0 134 139.865 239.136 93.6381 - OK XLOC_000085 iPS 1 45 43.354 74.1251 29.0251 - OK XLOC_000085 hESC 1 151 149.467 98.7852 39.2591 - OK XLOC_000085 hESC 0 152 153.558 101.489 40.3336 - OK XLOC_000085 Fibroblasts 1 1306 1089.73 890.854 349.587 - OK XLOC_000085 Fibroblasts 0 749 891.226 728.579 285.907 - OK XLOC_000086 iPS 0 16 16.7003 28.5535 83.0164 - OK XLOC_000086 iPS 1 30 28.9027 49.4167 143.674 - OK XLOC_000086 hESC 1 124 122.742 81.1216 264.792 - OK XLOC_000086 hESC 0 106 107.087 70.7752 231.02 - OK XLOC_000086 Fibroblasts 1 9 7.5096 6.13911 18.1401 - OK XLOC_000086 Fibroblasts 0 7 8.32921 6.80915 20.1199 - OK XLOC_000087 iPS 0 1154 1204.51 2059.42 637.171 - OK XLOC_000087 iPS 1 1327.5 1278.94 2186.69 775.631 - OK XLOC_000087 hESC 1 6306 6242 4125.43 1101.12 - OK XLOC_000087 hESC 0 6604 6671.71 4409.43 1208.48 - OK XLOC_000087 Fibroblasts 1 7290 6082.77 4972.68 1481.29 - OK XLOC_000087 Fibroblasts 0 4586 5456.82 4460.97 1395.78 - OK XLOC_000088 iPS 0 3029 3161.57 5405.53 879.081 - OK XLOC_000088 iPS 1 3648 3514.56 6009.07 939.492 - OK XLOC_000088 hESC 1 6067 6005.42 3969.07 618.675 - OK XLOC_000088 hESC 0 6463 6529.27 4315.29 660.959 - OK XLOC_000088 Fibroblasts 1 9920.5 8277.66 6767.01 1215.73 - OK XLOC_000088 Fibroblasts 0 5046 6004.17 4908.43 871.139 - OK XLOC_000089 iPS 0 987 1030.2 1761.39 1412.22 - OK XLOC_000089 iPS 1 1065 1026.04 1754.29 1404.74 - OK XLOC_000089 hESC 1 13196 13062.1 8632.91 7131.86 - OK XLOC_000089 hESC 0 13588 13727.3 9072.58 7500.15 - OK XLOC_000089 Fibroblasts 1 18899.5 15769.7 12891.8 10368.6 - OK XLOC_000089 Fibroblasts 0 22201 26416.7 21595.7 17372.9 - OK XLOC_000090 iPS 0 146 152.39 260.551 305.006 - OK XLOC_000090 iPS 1 129 124.281 212.492 258.751 - OK XLOC_000090 hESC 1 319 315.762 208.692 263.35 - OK XLOC_000090 hESC 0 320 323.281 213.661 271.525 - OK XLOC_000090 Fibroblasts 1 727 606.609 495.904 569.835 - OK XLOC_000090 Fibroblasts 0 652 775.807 634.224 741.583 - OK XLOC_000091 iPS 0 159 165.959 283.75 265.276 - OK XLOC_000091 iPS 1 130 125.245 214.139 197.646 - OK XLOC_000091 hESC 1 1128.5 1117.05 738.272 699.009 - OK XLOC_000091 hESC 0 1139 1150.68 760.5 732.278 - OK XLOC_000091 Fibroblasts 1 1717 1432.66 1171.21 1366.05 - OK XLOC_000091 Fibroblasts 0 1648 1960.93 1603.07 1776.12 - OK XLOC_000092 iPS 0 3124 3260.73 5575.07 1949.32 - OK XLOC_000092 iPS 1 3262 3142.68 5373.24 1878.45 - OK XLOC_000092 hESC 1 8537 8450.36 5584.96 1977.36 - OK XLOC_000092 hESC 0 12073 12196.8 8061.03 2856.06 - OK XLOC_000092 Fibroblasts 1 10008 8350.67 6826.7 2389.86 - OK XLOC_000092 Fibroblasts 0 9042 10759 8795.48 3079.08 - OK XLOC_000093 iPS 0 21 21.9191 37.4765 25.6157 - OK XLOC_000093 iPS 1 22 21.1953 36.2389 24.7698 - OK XLOC_000093 hESC 1 2 1.9797 1.30841 0.917903 - OK XLOC_000093 hESC 0 2 2.02051 1.33538 0.936822 - OK XLOC_000093 Fibroblasts 1 22 18.3568 15.0067 10.2962 - OK XLOC_000093 Fibroblasts 0 16 19.0382 15.5638 10.6784 - OK XLOC_000094 iPS 0 412 430.032 735.253 298.392 - OK XLOC_000094 iPS 1 622 599.249 1024.57 415.809 - OK XLOC_000094 hESC 1 1113 1101.7 728.132 300.08 - OK XLOC_000094 hESC 0 1164 1175.93 777.192 320.299 - OK XLOC_000094 Fibroblasts 1 953 795.183 650.064 264.412 - OK XLOC_000094 Fibroblasts 0 1005 1195.84 977.6 397.637 - OK XLOC_000095 iPS 0 35 36.5318 62.4608 36.9199 - OK XLOC_000095 iPS 1 65 62.6225 107.07 61.5818 - OK XLOC_000095 hESC 1 349 345.458 228.318 72.7105 - OK XLOC_000095 hESC 0 330 333.384 220.338 78.0844 - OK XLOC_000095 Fibroblasts 1 0 0 0 0 - OK XLOC_000095 Fibroblasts 0 4 4.75955 3.89094 1.09262 - OK XLOC_000096 iPS 0 174.999 182.658 312.301 190.415 - OK XLOC_000096 iPS 1 157.5 151.739 259.438 149.462 - OK XLOC_000096 hESC 1 1411.58 1397.25 923.465 584.241 - OK XLOC_000096 hESC 0 1292.11 1305.36 862.73 563.446 - OK XLOC_000096 Fibroblasts 1 1043.15 870.403 711.557 444.033 - OK XLOC_000096 Fibroblasts 0 740 880.517 719.825 400.399 - OK XLOC_000097 iPS 0 52 54.2759 92.7989 95.1547 - OK XLOC_000097 iPS 1 35 33.7198 57.6528 59.1164 - OK XLOC_000097 hESC 1 32.5 32.1702 21.2617 22.6755 - OK XLOC_000097 hESC 0 41.5 41.9255 27.7092 29.5516 - OK XLOC_000097 Fibroblasts 1 535 446.404 364.936 376.331 - OK XLOC_000097 Fibroblasts 0 340 404.562 330.73 341.057 - OK XLOC_000098 iPS 0 111 115.858 198.09 174.527 - OK XLOC_000098 iPS 1 155 149.33 255.32 224.949 - OK XLOC_000098 hESC 1 623 616.677 407.571 371.39 - OK XLOC_000098 hESC 0 533 538.465 355.879 324.287 - OK XLOC_000098 Fibroblasts 1 4 3.3376 2.7285 2.41569 - OK XLOC_000098 Fibroblasts 0 24 28.5573 23.3457 20.6692 - OK XLOC_000099 iPS 0 146 152.39 260.551 103.514 - OK XLOC_000099 iPS 1 264 254.344 434.867 172.767 - OK XLOC_000099 hESC 1 738 730.51 482.805 194.72 - OK XLOC_000099 hESC 0 843 851.643 562.863 227.009 - OK XLOC_000099 Fibroblasts 1 7 5.8408 4.77487 1.90117 - OK XLOC_000099 Fibroblasts 0 28 33.3169 27.2366 10.8446 - OK XLOC_000100 iPS 0 315.5 329.308 563.039 778.344 - OK XLOC_000100 iPS 1 312 300.588 513.934 700.977 - OK XLOC_000100 hESC 1 1847 1828.25 1208.32 1754.96 - OK XLOC_000100 hESC 0 1624 1640.65 1084.33 1578.97 - OK XLOC_000100 Fibroblasts 1 2086 1740.56 1422.91 1986.29 - OK XLOC_000100 Fibroblasts 0 1290 1534.95 1254.83 1766.01 - OK XLOC_000101 iPS 0 2 2.08753 3.56919 6.9543 - OK XLOC_000101 iPS 1 0 0 0 0 - OK XLOC_000101 hESC 1 2 1.9797 1.30841 3.66236 - OK XLOC_000101 hESC 0 2 2.02051 1.33538 3.73785 - OK XLOC_000101 Fibroblasts 1 2 1.6688 1.36425 2.65814 - OK XLOC_000101 Fibroblasts 0 0 0 0 0 - OK XLOC_000102 iPS 0 1.1068 1.15524 1.97519 1.77902 - OK XLOC_000102 iPS 1 1.1557 1.11343 1.9037 1.71463 - OK XLOC_000102 hESC 1 11.4127 11.2968 7.46624 5.4048 - OK XLOC_000102 hESC 0 7.56076 7.63828 5.04825 3.44452 - OK XLOC_000102 Fibroblasts 1 23.6964 19.7722 16.1639 14.6313 - OK XLOC_000102 Fibroblasts 0 4.41645 5.25508 4.29604 3.88872 - OK XLOC_000103 iPS 0 196 204.578 349.78 108.179 - OK XLOC_000103 iPS 1 335 322.747 551.82 203.35 - OK XLOC_000103 hESC 1 1871 1852.01 1224.02 336.643 - OK XLOC_000103 hESC 0 2005 2025.56 1338.72 401.653 - OK XLOC_000103 Fibroblasts 1 3432 2863.66 2341.05 638.382 - OK XLOC_000103 Fibroblasts 0 1763 2097.77 1714.93 521.574 - OK XLOC_000104 iPS 0 1339 1397.6 2389.57 1190.97 - OK XLOC_000104 iPS 1 647 623.334 1065.75 531.193 - OK XLOC_000104 hESC 1 3045.5 3014.59 1992.39 1012.93 - OK XLOC_000104 hESC 0 2721 2748.9 1816.79 923.474 - OK XLOC_000104 Fibroblasts 1 40380.2 33693.2 27544.3 13772 - OK XLOC_000104 Fibroblasts 0 14288 17001.1 13898.5 6948.19 - OK XLOC_000105 iPS 0 1260 1315.15 2248.59 707.831 - OK XLOC_000105 iPS 1 1124 1082.89 1851.48 583 - OK XLOC_000105 hESC 1 4691.5 4643.89 3069.21 978.226 - OK XLOC_000105 hESC 0 4311.5 4355.71 2878.75 919.556 - OK XLOC_000105 Fibroblasts 1 12340 10296.5 8417.41 2648.91 - OK XLOC_000105 Fibroblasts 0 10035 11940.5 9761.41 3074.85 - OK XLOC_000106 iPS 0 278 290.167 496.117 494.029 - OK XLOC_000106 iPS 1 309 297.698 508.992 506.85 - OK XLOC_000106 hESC 1 1805 1786.68 1180.84 1221.6 - OK XLOC_000106 hESC 0 1856 1875.03 1239.23 1282.01 - OK XLOC_000106 Fibroblasts 1 671 559.882 457.705 458.299 - OK XLOC_000106 Fibroblasts 0 699 831.731 679.943 680.824 - OK XLOC_000107 iPS 0 258 269.292 460.425 185.743 - OK XLOC_000107 iPS 1 325.5 313.594 536.171 219.946 - OK XLOC_000107 hESC 1 1748.5 1730.75 1143.88 471.419 - OK XLOC_000107 hESC 0 1524.17 1539.79 1017.67 421.109 - OK XLOC_000107 Fibroblasts 1 2 1.6688 1.36425 0.976754 - OK XLOC_000107 Fibroblasts 0 33 39.2663 32.1003 16.0044 - OK XLOC_000108 iPS 0 19 19.8316 33.9073 14.1337 - OK XLOC_000108 iPS 1 24 23.1221 39.5334 16.479 - OK XLOC_000108 hESC 1 145 143.528 94.86 39.0304 - OK XLOC_000108 hESC 0 107 108.097 71.4429 29.575 - OK XLOC_000108 Fibroblasts 1 6387 5329.31 4356.72 1764.21 - OK XLOC_000108 Fibroblasts 0 2561 3047.3 2491.18 1010.17 - OK XLOC_000109 iPS 0 2498.16 2607.5 4458.21 424.792 - OK XLOC_000109 iPS 1 2183 2103.15 3595.89 348.617 - OK XLOC_000109 hESC 1 2141 2119.27 1400.66 150.254 - OK XLOC_000109 hESC 0 2549 2575.13 1701.94 176.496 - OK XLOC_000109 Fibroblasts 1 5961 4973.86 4066.14 391.534 - OK XLOC_000109 Fibroblasts 0 2725 3242.44 2650.71 316.443 - OK XLOC_000110 iPS 0 1.00229 1.04615 1.78867 333.137 - OK XLOC_000110 iPS 1 1 0.963422 1.64722 306.792 - OK XLOC_000110 hESC 1 1 0.989851 0.654207 585.268 - OK XLOC_000110 hESC 0 1.00144 1.01171 0.668656 598.194 - OK XLOC_000110 Fibroblasts 1 1 0.8344 0.682124 6.34805 - OK XLOC_000110 Fibroblasts 0 0 0 0 0 - OK XLOC_000111 iPS 0 1 1.04377 1.78459 1.60382 - OK XLOC_000111 iPS 1 0 0 0 0 - OK XLOC_000111 hESC 1 2 1.9797 1.30841 1.36757 - OK XLOC_000111 hESC 0 2 2.02051 1.33538 1.39576 - OK XLOC_000111 Fibroblasts 1 0 0 0 0 - OK XLOC_000111 Fibroblasts 0 0 0 0 0 - OK XLOC_000112 iPS 0 116 121.077 207.013 76.3378 - OK XLOC_000112 iPS 1 60 57.8053 98.8334 36.0181 - OK XLOC_000112 hESC 1 37 36.6245 24.2056 8.96689 - OK XLOC_000112 hESC 0 45 45.4614 30.0461 11.2309 - OK XLOC_000112 Fibroblasts 1 0 0 0 0 - OK XLOC_000112 Fibroblasts 0 0 0 0 0 - OK XLOC_000113 iPS 0 1 1.04377 1.78459 2.81427 - OK XLOC_000113 iPS 1 0 0 0 0 - OK XLOC_000113 hESC 1 0 0 0 0 - OK XLOC_000113 hESC 0 2 2.02051 1.33538 2.58093 - OK XLOC_000113 Fibroblasts 1 0 0 0 0 - OK XLOC_000113 Fibroblasts 0 0 0 0 0 - OK XLOC_000114 iPS 0 0 0 0 0 - OK XLOC_000114 iPS 1 5 4.81711 8.23612 7.21151 - OK XLOC_000114 hESC 1 3 2.96955 1.96262 1.55706 - OK XLOC_000114 hESC 0 0 0 0 0 - OK XLOC_000114 Fibroblasts 1 0 0 0 0 - OK XLOC_000114 Fibroblasts 0 0 0 0 0 - OK XLOC_000115 iPS 0 0 0 0 0 - OK XLOC_000115 iPS 1 1.33333 1.28456 2.1963 2.15969 - OK XLOC_000115 hESC 1 0 0 0 0 - OK XLOC_000115 hESC 0 0 0 0 0 - OK XLOC_000115 Fibroblasts 1 0 0 0 0 - OK XLOC_000115 Fibroblasts 0 0 0 0 0 - OK XLOC_000116 iPS 0 0 0 0 0 - OK XLOC_000116 iPS 1 0 0 0 0 - OK XLOC_000116 hESC 1 0 0 0 0 - OK XLOC_000116 hESC 0 0 0 0 0 - OK XLOC_000116 Fibroblasts 1 0 0 0 0 - OK XLOC_000116 Fibroblasts 0 0 0 0 0 - OK XLOC_000117 iPS 0 0 0 0 0 - OK XLOC_000117 iPS 1 0 0 0 0 - OK XLOC_000117 hESC 1 0 0 0 0 - OK XLOC_000117 hESC 0 0 0 0 0 - OK XLOC_000117 Fibroblasts 1 0 0 0 0 - OK XLOC_000117 Fibroblasts 0 0 0 0 0 - OK XLOC_000118 iPS 0 0 0 0 0 - OK XLOC_000118 iPS 1 0 0 0 0 - OK XLOC_000118 hESC 1 0 0 0 0 - OK XLOC_000118 hESC 0 0 0 0 0 - OK XLOC_000118 Fibroblasts 1 0 0 0 0 - OK XLOC_000118 Fibroblasts 0 0 0 0 0 - OK XLOC_000119 iPS 0 0 0 0 0 - OK XLOC_000119 iPS 1 0.45 0.43354 0.741251 0.621345 - OK XLOC_000119 hESC 1 0 0 0 0 - OK XLOC_000119 hESC 0 0 0 0 0 - OK XLOC_000119 Fibroblasts 1 0 0 0 0 - OK XLOC_000119 Fibroblasts 0 0 0 0 0 - OK XLOC_000120 iPS 0 0 0 0 0 - OK XLOC_000120 iPS 1 0.2 0.192684 0.329445 0.27485 - OK XLOC_000120 hESC 1 0 0 0 0 - OK XLOC_000120 hESC 0 0 0 0 0 - OK XLOC_000120 Fibroblasts 1 0 0 0 0 - OK XLOC_000120 Fibroblasts 0 0 0 0 0 - OK XLOC_000121 iPS 0 0 0 0 0 - OK XLOC_000121 iPS 1 0 0 0 0 - OK XLOC_000121 hESC 1 0 0 0 0 - OK XLOC_000121 hESC 0 0 0 0 0 - OK XLOC_000121 Fibroblasts 1 0 0 0 0 - OK XLOC_000121 Fibroblasts 0 0 0 0 0 - OK XLOC_000122 iPS 0 0 0 0 0 - OK XLOC_000122 iPS 1 0 0 0 0 - OK XLOC_000122 hESC 1 0 0 0 0 - OK XLOC_000122 hESC 0 0 0 0 0 - OK XLOC_000122 Fibroblasts 1 0 0 0 0 - OK XLOC_000122 Fibroblasts 0 0 0 0 0 - OK XLOC_000123 iPS 0 0 0 0 0 - OK XLOC_000123 iPS 1 0 0 0 0 - OK XLOC_000123 hESC 1 0 0 0 0 - OK XLOC_000123 hESC 0 0 0 0 0 - OK XLOC_000123 Fibroblasts 1 0 0 0 0 - OK XLOC_000123 Fibroblasts 0 0 0 0 0 - OK XLOC_000124 iPS 0 0 0 0 0 - OK XLOC_000124 iPS 1 0.2 0.192684 0.329445 0.27485 - OK XLOC_000124 hESC 1 0 0 0 0 - OK XLOC_000124 hESC 0 0 0 0 0 - OK XLOC_000124 Fibroblasts 1 0 0 0 0 - OK XLOC_000124 Fibroblasts 0 0 0 0 0 - OK XLOC_000125 iPS 0 0 0 0 0 - OK XLOC_000125 iPS 1 0 0 0 0 - OK XLOC_000125 hESC 1 1 0.989851 0.654207 0.594357 - OK XLOC_000125 hESC 0 0 0 0 0 - OK XLOC_000125 Fibroblasts 1 0 0 0 0 - OK XLOC_000125 Fibroblasts 0 0 0 0 0 - OK XLOC_000126 iPS 0 0 0 0 0 - OK XLOC_000126 iPS 1 0 0 0 0 - OK XLOC_000126 hESC 1 0 0 0 0 - OK XLOC_000126 hESC 0 0 0 0 0 - OK XLOC_000126 Fibroblasts 1 0 0 0 0 - OK XLOC_000126 Fibroblasts 0 0 0 0 0 - OK XLOC_000127 iPS 0 922 962.353 1645.4 881.769 - OK XLOC_000127 iPS 1 1933 1862.3 3184.08 1706.61 - OK XLOC_000127 hESC 1 4818 4769.1 3151.97 1724.32 - OK XLOC_000127 hESC 0 4723 4771.43 3153.5 1724.75 - OK XLOC_000127 Fibroblasts 1 194 161.874 132.332 71.0962 - OK XLOC_000127 Fibroblasts 0 287 341.498 279.175 150.019 - OK XLOC_000128 iPS 0 626 653.398 1117.16 254.15 - OK XLOC_000128 iPS 1 642 618.517 1057.52 230.784 - OK XLOC_000128 hESC 1 1068 1057.16 698.693 157.388 - OK XLOC_000128 hESC 0 952 961.761 635.642 157.207 - OK XLOC_000128 Fibroblasts 1 3059 2552.43 2086.62 602.567 - OK XLOC_000128 Fibroblasts 0 1512 1799.11 1470.78 358.086 - OK XLOC_000129 iPS 0 113.511 118.48 202.572 76.3333 - OK XLOC_000129 iPS 1 94.325 90.8748 155.374 57.4152 - OK XLOC_000129 hESC 1 629.772 623.38 412.001 163.513 - OK XLOC_000129 hESC 0 599.909 606.06 400.554 158.169 - OK XLOC_000129 Fibroblasts 1 2223.11 1854.96 1516.44 630.153 - OK XLOC_000129 Fibroblasts 0 804 956.67 782.08 321.249 - OK XLOC_000130 iPS 0 65 67.8449 115.999 93.8314 - OK XLOC_000130 iPS 1 150 144.513 247.084 195.176 - OK XLOC_000130 hESC 1 453 448.402 296.356 242.629 - OK XLOC_000130 hESC 0 424 428.347 283.101 230.207 - OK XLOC_000130 Fibroblasts 1 1550 1293.32 1057.29 855.023 - OK XLOC_000130 Fibroblasts 0 719 855.529 699.397 559.231 - OK XLOC_000131 iPS 0 6 6.2626 10.7076 3.68895 - OK XLOC_000131 iPS 1 15 14.4513 24.7084 7.91795 - OK XLOC_000131 hESC 1 44.6798 44.2264 29.2298 9.2216 - OK XLOC_000131 hESC 0 34.1298 34.4798 22.7882 7.76333 - OK XLOC_000131 Fibroblasts 1 16.8622 14.0698 11.5021 3.76612 - OK XLOC_000131 Fibroblasts 0 9.66672 11.5023 9.40316 3.57051 - OK XLOC_000132 iPS 0 344 359.056 613.9 385.691 - OK XLOC_000132 iPS 1 263 253.38 433.22 272.176 - OK XLOC_000132 hESC 1 1184 1171.98 774.581 498.411 - OK XLOC_000132 hESC 0 1055 1065.82 704.414 453.262 - OK XLOC_000132 Fibroblasts 1 4284 3574.57 2922.22 1842.31 - OK XLOC_000132 Fibroblasts 0 4116 4897.58 4003.78 2524.19 - OK XLOC_000133 iPS 0 1 1.04377 1.78459 3.35246 - OK XLOC_000133 iPS 1 0 0 0 0 - OK XLOC_000133 hESC 1 0 0 0 0 - OK XLOC_000133 hESC 0 0 0 0 0 - OK XLOC_000133 Fibroblasts 1 5 4.172 3.41062 8.35087 - OK XLOC_000133 Fibroblasts 0 1 1.18989 0.972736 2.38173 - OK XLOC_000134 iPS 0 0 0 0 0 - OK XLOC_000134 iPS 1 0 0 0 0 - OK XLOC_000134 hESC 1 0 0 0 0 - OK XLOC_000134 hESC 0 0 0 0 0 - OK XLOC_000134 Fibroblasts 1 0 0 0 0 - OK XLOC_000134 Fibroblasts 0 0 0 0 0 - OK XLOC_000135 iPS 0 0 0 0 0 - OK XLOC_000135 iPS 1 0 0 0 0 - OK XLOC_000135 hESC 1 1 0.989851 0.654207 1.31945 - OK XLOC_000135 hESC 0 1.00024 1.01049 0.667851 1.34697 - OK XLOC_000135 Fibroblasts 1 0 0 0 0 - OK XLOC_000135 Fibroblasts 0 0 0 0 0 - OK XLOC_000136 iPS 0 869 907.034 1550.81 453.549 - OK XLOC_000136 iPS 1 1047 1008.7 1724.64 488.628 - OK XLOC_000136 hESC 1 860.023 851.294 562.632 144.625 - OK XLOC_000136 hESC 0 874 882.961 583.562 166.509 - OK XLOC_000136 Fibroblasts 1 2553.18 2130.37 1741.58 442.356 - OK XLOC_000136 Fibroblasts 0 1287 1531.39 1251.91 313.018 - OK XLOC_000137 iPS 0 587 612.691 1047.56 909.923 - OK XLOC_000137 iPS 1 780 751.469 1284.83 1116.98 - OK XLOC_000137 hESC 1 867 858.201 567.197 507.662 - OK XLOC_000137 hESC 0 961 970.853 641.651 572.425 - OK XLOC_000137 Fibroblasts 1 1438 1199.87 980.894 848.477 - OK XLOC_000137 Fibroblasts 0 604 718.692 587.533 508.656 - OK XLOC_000138 iPS 0 229 239.023 408.672 222.126 - OK XLOC_000138 iPS 1 313 301.551 515.581 280.234 - OK XLOC_000138 hESC 1 795 786.931 520.094 288.583 - OK XLOC_000138 hESC 0 884 893.064 590.239 327.504 - OK XLOC_000138 Fibroblasts 1 769 641.653 524.553 285.969 - OK XLOC_000138 Fibroblasts 0 347 412.891 337.539 184.015 - OK XLOC_000139 iPS 0 722 753.6 1288.48 461.128 - OK XLOC_000139 iPS 1 446 429.686 734.662 262.925 - OK XLOC_000139 hESC 1 3288.5 3255.12 2151.36 780.441 - OK XLOC_000139 hESC 0 3265 3298.48 2180.01 790.835 - OK XLOC_000139 Fibroblasts 1 9458 7891.75 6451.53 2313.48 - OK XLOC_000139 Fibroblasts 0 6764.5 8048.99 6580.07 2359.58 - OK XLOC_000140 iPS 0 8 8.35014 14.2767 7.99637 - OK XLOC_000140 iPS 1 10 9.63422 16.4722 8.87931 - OK XLOC_000140 hESC 1 20 19.797 13.0841 9.06856 - OK XLOC_000140 hESC 0 33 33.3384 22.0338 10.9386 - OK XLOC_000140 Fibroblasts 1 35 29.204 23.8743 15.4425 - OK XLOC_000140 Fibroblasts 0 25 29.7472 24.3184 12.3349 - OK XLOC_000141 iPS 0 4 4.17507 7.13837 7.47676 - OK XLOC_000141 iPS 1 9 8.6708 14.825 15.5278 - OK XLOC_000141 hESC 1 53 52.4621 34.673 37.805 - OK XLOC_000141 hESC 0 37 37.3794 24.7046 26.9362 - OK XLOC_000141 Fibroblasts 1 0 0 0 0 - OK XLOC_000141 Fibroblasts 0 0 0 0 0 - OK XLOC_000142 iPS 0 1201 1253.56 2143.3 996.167 - OK XLOC_000142 iPS 1 927 893.093 1526.98 788.273 - OK XLOC_000142 hESC 1 3258 3224.93 2131.41 1009.41 - OK XLOC_000142 hESC 0 3048 3079.25 2035.12 936.47 - OK XLOC_000142 Fibroblasts 1 10660 8894.7 7271.44 3332.35 - OK XLOC_000142 Fibroblasts 0 3432.5 4084.29 3338.92 1520.77 - OK XLOC_000143 iPS 0 816 851.714 1456.23 171.808 - OK XLOC_000143 iPS 1 1027 989.435 1691.7 199.619 - OK XLOC_000143 hESC 1 4982 4931.44 3259.26 388.332 - OK XLOC_000143 hESC 0 4750 4798.7 3171.53 376.961 - OK XLOC_000143 Fibroblasts 1 7265 6061.91 4955.63 586.499 - OK XLOC_000143 Fibroblasts 0 2904 3455.43 2824.83 336.358 - OK XLOC_000144 iPS 0 0 0 0 0 - OK XLOC_000144 iPS 1 0 0 0 0 - OK XLOC_000144 hESC 1 0 0 0 0 - OK XLOC_000144 hESC 0 0 0 0 0 - OK XLOC_000144 Fibroblasts 1 0 0 0 0 - OK XLOC_000144 Fibroblasts 0 0 0 0 0 - OK XLOC_000145 iPS 0 13.4989 14.0897 24.09 15.6403 - OK XLOC_000145 iPS 1 28.5002 27.4577 46.9462 37.5412 - OK XLOC_000145 hESC 1 254.333 251.752 166.386 120.093 - OK XLOC_000145 hESC 0 130.667 132.007 87.2451 65.6736 - OK XLOC_000145 Fibroblasts 1 3.00124 2.50423 2.04722 1.48301 - OK XLOC_000145 Fibroblasts 0 4 4.75955 3.89094 2.73079 - OK XLOC_000146 iPS 0 1872 1953.93 3340.76 1415.29 - OK XLOC_000146 iPS 1 1485.01 1430.69 2446.15 1019.75 - OK XLOC_000146 hESC 1 4807 4758.21 3144.77 1320.15 - OK XLOC_000146 hESC 0 5110 5162.39 3411.9 1431.55 - OK XLOC_000146 Fibroblasts 1 17052.2 14228.4 11631.7 5130.04 - OK XLOC_000146 Fibroblasts 0 13927 16571.6 13547.3 5605.57 - OK XLOC_000147 iPS 0 571 595.991 1019 765.712 - OK XLOC_000147 iPS 1 297 286.136 489.225 374.9 - OK XLOC_000147 hESC 1 1076 1065.08 703.926 536.078 - OK XLOC_000147 hESC 0 1088 1099.16 726.448 554.099 - OK XLOC_000147 Fibroblasts 1 7603 6343.94 5186.19 4177.2 - OK XLOC_000147 Fibroblasts 0 4647 5529.41 4520.31 3362.54 - OK XLOC_000148 iPS 0 6.30573 6.58171 11.2532 7.08253 - OK XLOC_000148 iPS 1 9.31634 8.97557 15.3461 9.65854 - OK XLOC_000148 hESC 1 27.3525 27.0748 17.8942 11.5352 - OK XLOC_000148 hESC 0 30.7399 31.0551 20.5247 13.2309 - OK XLOC_000148 Fibroblasts 1 1 0.8344 0.682124 0.430813 - OK XLOC_000148 Fibroblasts 0 3.75678 4.47014 3.65435 2.308 - OK XLOC_000149 iPS 0 18 18.7878 32.1227 24.1189 - OK XLOC_000149 iPS 1 5.5 5.29882 9.05973 6.26325 - OK XLOC_000149 hESC 1 304.5 301.41 199.206 146.218 - OK XLOC_000149 hESC 0 197.5 199.525 131.869 96.3604 - OK XLOC_000149 Fibroblasts 1 29.5 24.6148 20.1227 12.562 - OK XLOC_000149 Fibroblasts 0 23 27.3674 22.3729 16.513 - OK XLOC_000150 iPS 0 313.167 326.873 558.875 165.656 - OK XLOC_000150 iPS 1 282 271.685 464.517 151.316 - OK XLOC_000150 hESC 1 3700.17 3662.61 2420.67 601.458 - OK XLOC_000150 hESC 0 3969.5 4010.2 2650.4 660.182 - OK XLOC_000150 Fibroblasts 1 995.667 830.784 679.168 187.014 - OK XLOC_000150 Fibroblasts 0 551.667 656.421 536.626 150.1 - OK XLOC_000151 iPS 0 27 28.1817 48.184 28.8303 - OK XLOC_000151 iPS 1 5 4.81711 8.23612 3.16629 - OK XLOC_000151 hESC 1 17 16.8275 11.1215 6.91912 - OK XLOC_000151 hESC 0 6 6.06152 4.00615 1.56309 - OK XLOC_000151 Fibroblasts 1 2 1.6688 1.36425 0.925122 - OK XLOC_000151 Fibroblasts 0 0 0 0 0 - OK XLOC_000152 iPS 0 3 3.1313 5.35378 2.50891 - OK XLOC_000152 iPS 1 19 18.305 31.2972 14.6666 - OK XLOC_000152 hESC 1 59 58.4012 38.5982 18.4124 - OK XLOC_000152 hESC 0 23 23.2358 15.3569 7.32565 - OK XLOC_000152 Fibroblasts 1 2 1.6688 1.36425 0.605715 - OK XLOC_000152 Fibroblasts 0 0 0 0 0 - OK XLOC_000153 iPS 0 4 4.17507 7.13837 4.81405 - OK XLOC_000153 iPS 1 3 2.89027 4.94167 3.33261 - OK XLOC_000153 hESC 1 11 10.8884 7.19627 6.13506 - OK XLOC_000153 hESC 0 7 7.07177 4.67384 3.23397 - OK XLOC_000153 Fibroblasts 1 0 0 0 0 - OK XLOC_000153 Fibroblasts 0 0 0 0 0 - OK XLOC_000154 iPS 0 0 0 0 0 - OK XLOC_000154 iPS 1 0 0 0 0 - OK XLOC_000154 hESC 1 1 0.989851 0.654207 0.394296 - OK XLOC_000154 hESC 0 0 0 0 0 - OK XLOC_000154 Fibroblasts 1 0 0 0 0 - OK XLOC_000154 Fibroblasts 0 0 0 0 0 - OK XLOC_000155 iPS 0 473.5 494.224 845.005 300.378 - OK XLOC_000155 iPS 1 443.5 427.278 730.544 268.365 - OK XLOC_000155 hESC 1 2916.5 2886.9 1907.99 700.299 - OK XLOC_000155 hESC 0 2770.5 2798.91 1849.84 677.261 - OK XLOC_000155 Fibroblasts 1 3080 2569.95 2100.94 816.74 - OK XLOC_000155 Fibroblasts 0 1443.5 1717.6 1404.14 522.719 - OK XLOC_000156 iPS 0 10 10.4377 17.8459 14.9238 - OK XLOC_000156 iPS 1 3 2.89027 4.94167 4.1325 - OK XLOC_000156 hESC 1 28 27.7158 18.3178 15.8155 - OK XLOC_000156 hESC 0 33 33.3384 22.0338 19.0239 - OK XLOC_000156 Fibroblasts 1 14 11.6816 9.54973 8.02307 - OK XLOC_000156 Fibroblasts 0 7 8.32921 6.80915 5.72061 - OK XLOC_000157 iPS 0 40 41.7507 71.3837 57.032 - OK XLOC_000157 iPS 1 49 47.2077 80.7139 64.3042 - OK XLOC_000157 hESC 1 768 760.205 502.431 412.77 - OK XLOC_000157 hESC 0 741 748.598 494.759 406.436 - OK XLOC_000157 Fibroblasts 1 0 0 0 0 - OK XLOC_000157 Fibroblasts 0 0 0 0 0 - OK XLOC_000158 iPS 0 1 1.04377 1.78459 2.2722 - OK XLOC_000158 iPS 1 0 0 0 0 - OK XLOC_000158 hESC 1 23 22.7666 15.0468 23.9054 - OK XLOC_000158 hESC 0 13 13.1333 8.67998 13.7902 - OK XLOC_000158 Fibroblasts 1 0 0 0 0 - OK XLOC_000158 Fibroblasts 0 0 0 0 0 - OK XLOC_000159 iPS 0 110 114.814 196.305 56.815 - OK XLOC_000159 iPS 1 320 308.295 527.111 152.557 - OK XLOC_000159 hESC 1 990 979.952 647.665 189.511 - OK XLOC_000159 hESC 0 1253 1265.85 836.617 248.535 - OK XLOC_000159 Fibroblasts 1 6 5.0064 4.09274 1.41447 - OK XLOC_000159 Fibroblasts 0 0 0 0 0 - OK XLOC_000160 iPS 0 0 0 0 0 - OK XLOC_000160 iPS 1 3 2.89027 4.94167 1.18806 - OK XLOC_000160 hESC 1 1 0.989851 0.654207 0.455146 - OK XLOC_000160 hESC 0 11 11.1128 7.3446 1.78164 - OK XLOC_000160 Fibroblasts 1 0 0 0 0 - OK XLOC_000160 Fibroblasts 0 0 0 0 0 - OK XLOC_000161 iPS 0 637.5 665.401 1137.68 764.687 - OK XLOC_000161 iPS 1 699 673.432 1151.41 773.916 - OK XLOC_000161 hESC 1 2168 2146 1418.32 978.03 - OK XLOC_000161 hESC 0 2119.5 2141.23 1415.17 975.859 - OK XLOC_000161 Fibroblasts 1 2660.5 2219.92 1814.79 1224.35 - OK XLOC_000161 Fibroblasts 0 3138 3733.87 3052.45 2059.34 - OK XLOC_000162 iPS 0 141 147.171 251.628 214.343 - OK XLOC_000162 iPS 1 117 112.72 192.725 155.418 - OK XLOC_000162 hESC 1 613 606.779 401.029 342.499 - OK XLOC_000162 hESC 0 560 565.742 373.907 320.766 - OK XLOC_000162 Fibroblasts 1 906 755.966 618.004 526.285 - OK XLOC_000162 Fibroblasts 0 804 956.67 782.08 649.344 - OK XLOC_000163 iPS 0 789.5 824.054 1408.94 997.106 - OK XLOC_000163 iPS 1 391.5 377.18 644.888 418.882 - OK XLOC_000163 hESC 1 1913.5 1894.08 1251.82 797.232 - OK XLOC_000163 hESC 0 2047.5 2068.49 1367.1 859.595 - OK XLOC_000163 Fibroblasts 1 17279 14417.6 11786.4 8580.65 - OK XLOC_000163 Fibroblasts 0 23043.7 27419.4 22415.4 16526 - OK XLOC_000164 iPS 0 3 3.1313 5.35378 4.17135 - OK XLOC_000164 iPS 1 2 1.92684 3.29445 2.56684 - OK XLOC_000164 hESC 1 49 48.5027 32.0561 25.7298 - OK XLOC_000164 hESC 0 37 37.3794 24.7046 19.8291 - OK XLOC_000164 Fibroblasts 1 0 0 0 0 - OK XLOC_000164 Fibroblasts 0 0 0 0 0 - OK XLOC_000165 iPS 0 389 406.025 694.207 154.925 - OK XLOC_000165 iPS 1 383 368.991 630.887 140.794 - OK XLOC_000165 hESC 1 1009 998.759 660.095 148.558 - OK XLOC_000165 hESC 0 1120 1131.48 747.814 168.3 - OK XLOC_000165 Fibroblasts 1 633 528.175 431.784 96.4793 - OK XLOC_000165 Fibroblasts 0 358 425.98 348.24 77.8118 - OK XLOC_000166 iPS 0 0 0 0 0 - OK XLOC_000166 iPS 1 1 0.963422 1.64722 0.965415 - OK XLOC_000166 hESC 1 0 0 0 0 - OK XLOC_000166 hESC 0 3 3.03076 2.00307 1.69429 - OK XLOC_000166 Fibroblasts 1 82 68.4208 55.9342 46.0621 - OK XLOC_000166 Fibroblasts 0 317 377.194 308.357 251.771 - OK XLOC_000167 iPS 0 0 0 0 0 - OK XLOC_000167 iPS 1 0 0 0 0 - OK XLOC_000167 hESC 1 2 1.9797 1.30841 0.680701 - OK XLOC_000167 hESC 0 0 0 0 0 - OK XLOC_000167 Fibroblasts 1 0 0 0 0 - OK XLOC_000167 Fibroblasts 0 0 0 0 0 - OK XLOC_000168 iPS 0 7 7.30637 12.4922 6.30307 - OK XLOC_000168 iPS 1 22 21.1953 36.2389 18.2848 - OK XLOC_000168 hESC 1 63 62.3606 41.215 21.1976 - OK XLOC_000168 hESC 0 44 44.4511 29.3784 15.1098 - OK XLOC_000168 Fibroblasts 1 0 0 0 0 - OK XLOC_000168 Fibroblasts 0 2 2.37978 1.94547 0.984354 - OK XLOC_000169 iPS 0 5 5.21883 8.92297 3.34557 - OK XLOC_000169 iPS 1 5 4.81711 8.23612 2.92695 - OK XLOC_000169 hESC 1 79 78.1982 51.6823 19.9463 - OK XLOC_000169 hESC 0 75 75.769 50.0768 18.7673 - OK XLOC_000169 Fibroblasts 1 5 4.172 3.41062 1.09175 - OK XLOC_000169 Fibroblasts 0 0 0 0 0 - OK XLOC_000170 iPS 0 1 1.04377 1.78459 1.04594 - OK XLOC_000170 iPS 1 3 2.89027 4.94167 2.89628 - OK XLOC_000170 hESC 1 92 91.0663 60.187 36.0699 - OK XLOC_000170 hESC 0 115 116.179 76.7845 46.0167 - OK XLOC_000170 Fibroblasts 1 2 1.6688 1.36425 0.802173 - OK XLOC_000170 Fibroblasts 0 4 4.75955 3.89094 2.28786 - OK XLOC_000171 iPS 0 77 80.3701 137.414 248.748 - OK XLOC_000171 iPS 1 75 72.2567 123.542 226.169 - OK XLOC_000171 hESC 1 144 142.539 94.2058 184.972 - OK XLOC_000171 hESC 0 89 89.9125 59.4245 114.155 - OK XLOC_000171 Fibroblasts 1 236 196.918 160.981 291.3 - OK XLOC_000171 Fibroblasts 0 91 108.28 88.519 160.178 - OK XLOC_000172 iPS 0 913.5 953.481 1630.23 925.553 - OK XLOC_000172 iPS 1 371 357.43 611.12 349.925 - OK XLOC_000172 hESC 1 1120 1108.63 732.711 476.649 - OK XLOC_000172 hESC 0 973 982.976 649.663 421.97 - OK XLOC_000172 Fibroblasts 1 8087 6747.79 5516.34 3588.05 - OK XLOC_000172 Fibroblasts 0 4028 4792.87 3918.18 2446.13 - OK XLOC_000173 iPS 0 3.0001 3.1314 5.35396 3.33702 - OK XLOC_000173 iPS 1 1 0.963423 1.64722 1.02668 - OK XLOC_000173 hESC 1 15 14.8478 9.8131 6.26305 - OK XLOC_000173 hESC 0 21.0005 21.2159 14.0219 8.94923 - OK XLOC_000173 Fibroblasts 1 14 11.6816 9.54973 5.97272 - OK XLOC_000173 Fibroblasts 0 1 1.18989 0.972736 0.608381 - OK XLOC_000174 iPS 0 0 0 0 0 - OK XLOC_000174 iPS 1 0 0 0 0 - OK XLOC_000174 hESC 1 12 11.8782 7.85048 52475.4 - OK XLOC_000174 hESC 0 1 1.01025 0.667691 4463.09 - OK XLOC_000174 Fibroblasts 1 12 10.0128 8.18549 18756.5 - OK XLOC_000174 Fibroblasts 0 1.5 1.78483 1.4591 3343.43 - OK XLOC_000175 iPS 0 154.75 161.523 276.166 96.7239 - OK XLOC_000175 iPS 1 125 120.428 205.903 73.7202 - OK XLOC_000175 hESC 1 236 233.605 154.393 54.89 - OK XLOC_000175 hESC 0 252.667 255.257 168.703 64.7504 - OK XLOC_000175 Fibroblasts 1 2976.33 2483.45 2030.23 722.729 - OK XLOC_000175 Fibroblasts 0 972.083 1156.67 945.581 330.492 - OK XLOC_000176 iPS 0 858.5 896.074 1532.07 899.79 - OK XLOC_000176 iPS 1 1037 999.069 1708.17 998.973 - OK XLOC_000176 hESC 1 13224.5 13090.3 8651.56 5187.44 - OK XLOC_000176 hESC 0 12639.5 12769.1 8439.28 5044.74 - OK XLOC_000176 Fibroblasts 1 301 251.154 205.319 121.007 - OK XLOC_000176 Fibroblasts 0 20 23.7978 19.4547 11.3731 - OK XLOC_000177 iPS 0 23.3556 24.3778 41.6802 27.3107 - OK XLOC_000177 iPS 1 18.6575 17.975 30.733 18.0981 - OK XLOC_000177 hESC 1 113.021 111.874 73.9393 37.2483 - OK XLOC_000177 hESC 0 86.6502 87.5387 57.8556 30.2933 - OK XLOC_000177 Fibroblasts 1 309.824 258.517 211.338 281.33 - OK XLOC_000177 Fibroblasts 0 59.6599 70.9885 58.0333 69.1711 - OK XLOC_000178 iPS 0 0 0 0 0 - OK XLOC_000178 iPS 1 1 0.963422 1.64722 2.79543 - OK XLOC_000178 hESC 1 0 0 0 0 - OK XLOC_000178 hESC 0 0 0 0 0 - OK XLOC_000178 Fibroblasts 1 0 0 0 0 - OK XLOC_000178 Fibroblasts 0 0 0 0 0 - OK XLOC_000179 iPS 0 224 233.804 399.749 647.344 - OK XLOC_000179 iPS 1 124 119.464 204.256 332.665 - OK XLOC_000179 hESC 1 398 393.961 260.374 450.987 - OK XLOC_000179 hESC 0 386 389.958 257.729 447.128 - OK XLOC_000179 Fibroblasts 1 538 448.907 366.983 602.22 - OK XLOC_000179 Fibroblasts 0 276 328.409 268.475 441.225 - OK XLOC_000180 iPS 0 3380 3527.93 6031.93 4381.8 - OK XLOC_000180 iPS 1 2402 2314.14 3956.63 2859.62 - OK XLOC_000180 hESC 1 3237 3204.15 2117.67 1589.07 - OK XLOC_000180 hESC 0 3415 3450.01 2280.16 1717.14 - OK XLOC_000180 Fibroblasts 1 18228 15209.4 12433.8 9119.64 - OK XLOC_000180 Fibroblasts 0 14738 17536.6 14336.2 10507 - OK XLOC_000181 iPS 0 370 386.194 660.3 137.008 - OK XLOC_000181 iPS 1 320 308.295 527.111 124.382 - OK XLOC_000181 hESC 1 1144 1132.39 748.412 137.1 - OK XLOC_000181 hESC 0 2495 2520.58 1665.89 308.143 - OK XLOC_000181 Fibroblasts 1 2137 1783.11 1457.7 256.278 - OK XLOC_000181 Fibroblasts 0 1233 1467.13 1199.38 204.424 - OK XLOC_000182 iPS 0 25 26.0942 44.6148 33.549 - OK XLOC_000182 iPS 1 28 26.9758 46.1223 32.8679 - OK XLOC_000182 hESC 1 277 274.189 181.215 113.972 - OK XLOC_000182 hESC 0 146 147.497 97.4829 62.4911 - OK XLOC_000182 Fibroblasts 1 0 0 0 0 - OK XLOC_000182 Fibroblasts 0 0 0 0 0 - OK XLOC_000183 iPS 0 0 0 0 0 - OK XLOC_000183 iPS 1 0 0 0 0 - OK XLOC_000183 hESC 1 0 0 0 0 - OK XLOC_000183 hESC 0 0 0 0 0 - OK XLOC_000183 Fibroblasts 1 0 0 0 0 - OK XLOC_000183 Fibroblasts 0 0 0 0 0 - OK XLOC_000184 iPS 0 0 0 0 0 - OK XLOC_000184 iPS 1 0 0 0 0 - OK XLOC_000184 hESC 1 0 0 0 0 - OK XLOC_000184 hESC 0 0 0 0 0 - OK XLOC_000184 Fibroblasts 1 0 0 0 0 - OK XLOC_000184 Fibroblasts 0 0 0 0 0 - OK XLOC_000185 iPS 0 0 0 0 0 - OK XLOC_000185 iPS 1 0 0 0 0 - OK XLOC_000185 hESC 1 0 0 0 0 - OK XLOC_000185 hESC 0 0 0 0 0 - OK XLOC_000185 Fibroblasts 1 0 0 0 0 - OK XLOC_000185 Fibroblasts 0 0 0 0 0 - OK XLOC_000186 iPS 0 110 114.814 196.305 60.7793 - OK XLOC_000186 iPS 1 115 110.794 189.431 58.4908 - OK XLOC_000186 hESC 1 1577.5 1561.49 1032.01 336.729 - OK XLOC_000186 hESC 0 1302 1315.35 869.334 272.242 - OK XLOC_000186 Fibroblasts 1 1597 1332.54 1089.35 352.35 - OK XLOC_000186 Fibroblasts 0 5239 6233.82 5096.16 1551 - OK XLOC_000187 iPS 0 1 1.04377 1.78459 0.743012 - OK XLOC_000187 iPS 1 4 3.85369 6.58889 2.74327 - OK XLOC_000187 hESC 1 26 25.7361 17.0094 7.19442 - OK XLOC_000187 hESC 0 32 32.3281 21.3661 9.03718 - OK XLOC_000187 Fibroblasts 1 45 37.548 30.6956 12.8095 - OK XLOC_000187 Fibroblasts 0 59 70.2034 57.3914 23.9499 - OK XLOC_000188 iPS 0 2715 2833.83 4845.17 2376.64 - OK XLOC_000188 iPS 1 3522 3393.17 5801.52 2847.65 - OK XLOC_000188 hESC 1 12455.5 12329.1 8148.47 4068.49 - OK XLOC_000188 hESC 0 12256 12381.7 8183.22 4092.03 - OK XLOC_000188 Fibroblasts 1 7173.33 5985.43 4893.1 2404.89 - OK XLOC_000188 Fibroblasts 0 4751 5653.16 4621.47 2271.53 - OK XLOC_000189 iPS 0 19.3285 20.1745 34.4936 27.3105 - OK XLOC_000189 iPS 1 3.20657 3.08929 5.28194 3.22344 - OK XLOC_000189 hESC 1 17.0003 16.8278 11.1217 10.5094 - OK XLOC_000189 hESC 0 12.0003 12.1233 8.01248 4.36875 - OK XLOC_000189 Fibroblasts 1 131.15 109.431 89.4602 130.282 - OK XLOC_000189 Fibroblasts 0 85.3962 101.612 83.068 69.5581 - OK XLOC_000190 iPS 0 2 2.08753 3.56919 2.51118 - OK XLOC_000190 iPS 1 11 10.5976 18.1195 12.7483 - OK XLOC_000190 hESC 1 2 1.9797 1.30841 0.945571 - OK XLOC_000190 hESC 0 2 2.02051 1.33538 0.965061 - OK XLOC_000190 Fibroblasts 1 0 0 0 0 - OK XLOC_000190 Fibroblasts 0 0 0 0 0 - OK XLOC_000191 iPS 0 1 1.04377 1.78459 1.55347 - OK XLOC_000191 iPS 1 0 0 0 0 - OK XLOC_000191 hESC 1 0 0 0 0 - OK XLOC_000191 hESC 0 0 0 0 0 - OK XLOC_000191 Fibroblasts 1 0 0 0 0 - OK XLOC_000191 Fibroblasts 0 0 0 0 0 - OK XLOC_000192 iPS 0 8257.5 8618.91 14736.3 48107.3 - OK XLOC_000192 iPS 1 7462 7189.06 12291.6 39622.1 - OK XLOC_000192 hESC 1 34667.3 34315.5 22679.6 85022.7 - OK XLOC_000192 hESC 0 31305.5 31626.5 20902.4 78059.1 - OK XLOC_000192 Fibroblasts 1 55523.8 46329.1 37874.1 125880 - OK XLOC_000192 Fibroblasts 0 33965 40414.5 33039 109348 - OK XLOC_000193 iPS 0 1409.05 1470.72 2514.58 744.997 - OK XLOC_000193 iPS 1 1562.26 1505.12 2573.4 762.424 - OK XLOC_000193 hESC 1 2522.1 2496.5 1649.97 494.345 - OK XLOC_000193 hESC 0 2794.38 2823.03 1865.78 559.003 - OK XLOC_000193 Fibroblasts 1 5747.97 4796.1 3920.82 1163.53 - OK XLOC_000193 Fibroblasts 0 4474.46 5324.1 4352.47 1291.62 - OK XLOC_000194 iPS 0 595 621.041 1061.83 1035.17 - OK XLOC_000194 iPS 1 683 658.017 1125.05 1097.18 - OK XLOC_000194 hESC 1 1727 1709.47 1129.81 1145.35 - OK XLOC_000194 hESC 0 1959 1979.09 1308.01 1323 - OK XLOC_000194 Fibroblasts 1 2283 1904.93 1557.29 1529.76 - OK XLOC_000194 Fibroblasts 0 1957 2328.61 1903.64 1867.85 - OK XLOC_000195 iPS 0 608 634.61 1085.03 1046.9 - OK XLOC_000195 iPS 1 648.5 624.779 1068.22 1033.36 - OK XLOC_000195 hESC 1 4010.33 3969.63 2623.59 2643.83 - OK XLOC_000195 hESC 0 4225 4268.32 2820.99 2863.93 - OK XLOC_000195 Fibroblasts 1 1116 931.19 761.25 747.731 - OK XLOC_000195 Fibroblasts 0 1678 1996.63 1632.25 1607.33 - OK XLOC_000196 iPS 0 1826 1905.92 3258.67 2053.69 - OK XLOC_000196 iPS 1 1918 1847.84 3159.37 1991.11 - OK XLOC_000196 hESC 1 2013.5 1993.06 1317.25 850.301 - OK XLOC_000196 hESC 0 2796 2824.67 1866.86 1205.09 - OK XLOC_000196 Fibroblasts 1 4027 3360.13 2746.91 1737.21 - OK XLOC_000196 Fibroblasts 0 2970 3533.97 2889.03 1827.09 - OK XLOC_000197 iPS 0 0 0 0 0 - OK XLOC_000197 iPS 1 0 0 0 0 - OK XLOC_000197 hESC 1 0 0 0 0 - OK XLOC_000197 hESC 0 0 0 0 0 - OK XLOC_000197 Fibroblasts 1 0 0 0 0 - OK XLOC_000197 Fibroblasts 0 0 0 0 0 - OK XLOC_000198 iPS 0 18 18.7878 32.1227 18.317 - OK XLOC_000198 iPS 1 27 26.0124 44.475 23.9509 - OK XLOC_000198 hESC 1 64 63.3505 41.8692 22.9707 - OK XLOC_000198 hESC 0 73 73.7485 48.7414 26.7409 - OK XLOC_000198 Fibroblasts 1 2 1.6688 1.36425 0.825854 - OK XLOC_000198 Fibroblasts 0 1 1.18989 0.972736 0.588849 - OK XLOC_000199 iPS 0 1317 1374.64 2350.31 777.125 - OK XLOC_000199 iPS 1 295 284.21 485.931 157.676 - OK XLOC_000199 hESC 1 535 529.57 350.001 136.664 - OK XLOC_000199 hESC 0 628 634.439 419.31 158.934 - OK XLOC_000199 Fibroblasts 1 10533 8788.73 7184.81 2073.26 - OK XLOC_000199 Fibroblasts 0 4070 4842.84 3959.04 1189.12 - OK XLOC_000200 iPS 0 230 240.066 410.457 388.854 - OK XLOC_000200 iPS 1 221 212.916 364.036 369.627 - OK XLOC_000200 hESC 1 183 181.143 119.72 122.989 - OK XLOC_000200 hESC 0 223 225.286 148.895 147.501 - OK XLOC_000200 Fibroblasts 1 705 588.252 480.897 520.367 - OK XLOC_000200 Fibroblasts 0 285 339.118 277.23 277.22 - OK XLOC_000201 iPS 0 3 3.1313 5.35378 2.00057 - OK XLOC_000201 iPS 1 1 0.963422 1.64722 0.615525 - OK XLOC_000201 hESC 1 10 9.89851 6.54207 2.47943 - OK XLOC_000201 hESC 0 9 9.09228 6.00922 2.27748 - OK XLOC_000201 Fibroblasts 1 1 0.8344 0.682124 0.244094 - OK XLOC_000201 Fibroblasts 0 0 0 0 0 - OK XLOC_000202 iPS 0 1475 1539.56 2632.28 1191.44 - OK XLOC_000202 iPS 1 1906 1836.28 3139.61 1362.93 - OK XLOC_000202 hESC 1 5783 5724.31 3783.28 1903.17 - OK XLOC_000202 hESC 0 5442.5 5498.3 3633.91 1738.14 - OK XLOC_000202 Fibroblasts 1 5428 4529.12 3702.57 1551.56 - OK XLOC_000202 Fibroblasts 0 4419 5258.11 4298.52 1708.24 - OK XLOC_001217 iPS 0 680.5 710.283 1214.42 1183.19 - OK XLOC_001217 iPS 1 623.5 600.694 1027.04 1010.76 - OK XLOC_001217 hESC 1 1146 1134.37 749.721 1166.38 - OK XLOC_001217 hESC 0 1145 1156.74 764.506 1101.03 - OK XLOC_001217 Fibroblasts 1 897 748.456 611.865 947.859 - OK XLOC_001217 Fibroblasts 0 1259 1498.07 1224.67 1841.93 - OK XLOC_001218 iPS 0 3 3.1313 5.35378 7.87617 - OK XLOC_001218 iPS 1 8 7.70738 13.1778 19.3864 - OK XLOC_001218 hESC 1 25 24.7463 16.3552 25.4692 - OK XLOC_001218 hESC 0 9 9.09228 6.00922 9.35791 - OK XLOC_001218 Fibroblasts 1 0 0 0 0 - OK XLOC_001218 Fibroblasts 0 6 7.13933 5.83642 8.65652 - OK XLOC_001219 iPS 0 14 14.6127 24.9843 16.0241 - OK XLOC_001219 iPS 1 9 8.6708 14.825 9.50827 - OK XLOC_001219 hESC 1 6 5.9391 3.92524 2.57971 - OK XLOC_001219 hESC 0 5.5 5.55639 3.6723 2.41348 - OK XLOC_001219 Fibroblasts 1 37.6667 31.4291 25.6933 16.5374 - OK XLOC_001219 Fibroblasts 0 16.5 19.6331 16.0501 10.3306 - OK XLOC_001220 iPS 0 144.667 150.998 258.171 298.722 - OK XLOC_001220 iPS 1 199.833 192.524 329.17 380.872 - OK XLOC_001220 hESC 1 837.667 829.165 548.007 662.914 - OK XLOC_001220 hESC 0 795.5 803.656 531.148 642.52 - OK XLOC_001220 Fibroblasts 1 29.2667 24.4201 19.9635 23.2476 - OK XLOC_001220 Fibroblasts 0 14.1667 16.8567 13.7804 16.0474 - OK XLOC_001221 iPS 0 0 0 0 0 - OK XLOC_001221 iPS 1 1 0.963422 1.64722 3.02791 - OK XLOC_001221 hESC 1 0 0 0 0 - OK XLOC_001221 hESC 0 0 0 0 0 - OK XLOC_001221 Fibroblasts 1 0 0 0 0 - OK XLOC_001221 Fibroblasts 0 0 0 0 0 - OK XLOC_001222 iPS 0 440.996 460.297 786.999 364.057 - OK XLOC_001222 iPS 1 605.935 583.771 998.11 518.049 - OK XLOC_001222 hESC 1 2644.13 2617.3 1729.81 1078.21 - OK XLOC_001222 hESC 0 2580.52 2606.98 1722.99 1061.92 - OK XLOC_001222 Fibroblasts 1 373.352 311.525 254.673 136.067 - OK XLOC_001222 Fibroblasts 0 171.817 204.443 167.132 79.3828 - OK XLOC_001223 iPS 0 0 0 0 0 - OK XLOC_001223 iPS 1 0 0 0 0 - OK XLOC_001223 hESC 1 4.33333 4.28935 2.8349 835811 - OK XLOC_001223 hESC 0 7 7.07177 4.67384 1.37799e+06 - OK XLOC_001223 Fibroblasts 1 0 0 0 0 - OK XLOC_001223 Fibroblasts 0 0.333333 0.396629 0.324245 28475.5 - OK XLOC_001224 iPS 0 0 0 0 0 - OK XLOC_001224 iPS 1 0 0 0 0 - OK XLOC_001224 hESC 1 0 0 0 0 - OK XLOC_001224 hESC 0 0 0 0 0 - OK XLOC_001224 Fibroblasts 1 0 0 0 0 - OK XLOC_001224 Fibroblasts 0 0 0 0 0 - OK XLOC_001225 iPS 0 0 0 0 0 - OK XLOC_001225 iPS 1 0 0 0 0 - OK XLOC_001225 hESC 1 4.33333 4.28935 2.8349 835811 - OK XLOC_001225 hESC 0 7 7.07177 4.67384 1.37799e+06 - OK XLOC_001225 Fibroblasts 1 0 0 0 0 - OK XLOC_001225 Fibroblasts 0 0.333333 0.396629 0.324245 28475.5 - OK XLOC_001226 iPS 0 0 0 0 0 - OK XLOC_001226 iPS 1 0 0 0 0 - OK XLOC_001226 hESC 1 0 0 0 0 - OK XLOC_001226 hESC 0 0 0 0 0 - OK XLOC_001226 Fibroblasts 1 0 0 0 0 - OK XLOC_001226 Fibroblasts 0 0 0 0 0 - OK XLOC_001227 iPS 0 110 114.814 196.305 241.563 - OK XLOC_001227 iPS 1 123 118.501 202.608 249.319 - OK XLOC_001227 hESC 1 291.5 288.542 190.701 246.048 - OK XLOC_001227 hESC 0 278 280.85 185.618 239.489 - OK XLOC_001227 Fibroblasts 1 71.8333 59.9377 48.9992 60.7083 - OK XLOC_001227 Fibroblasts 0 32 38.0764 31.1276 38.5659 - OK XLOC_001228 iPS 0 17 17.744 30.3381 37.3649 - OK XLOC_001228 iPS 1 10 9.63422 16.4722 20.2875 - OK XLOC_001228 hESC 1 18 17.8173 11.7757 15.2072 - OK XLOC_001228 hESC 0 29 29.2973 19.363 25.0055 - OK XLOC_001228 Fibroblasts 1 53 44.2232 36.1526 44.831 - OK XLOC_001228 Fibroblasts 0 28 33.3169 27.2366 33.7748 - OK XLOC_001229 iPS 0 9 9.3939 16.0613 14.7863 - OK XLOC_001229 iPS 1 13 12.5245 21.4139 19.7139 - OK XLOC_001229 hESC 1 3 2.96955 1.96262 1.87158 - OK XLOC_001229 hESC 0 4 4.04101 2.67076 2.54688 - OK XLOC_001229 Fibroblasts 1 16 13.3504 10.914 10.0989 - OK XLOC_001229 Fibroblasts 0 5 5.94944 4.86368 4.50045 - OK XLOC_001230 iPS 0 0 0 0 0 - OK XLOC_001230 iPS 1 0 0 0 0 - OK XLOC_001230 hESC 1 0 0 0 0 - OK XLOC_001230 hESC 0 2 2.02051 1.33538 8.77096 - OK XLOC_001230 Fibroblasts 1 2 1.6688 1.36425 6.01699 - OK XLOC_001230 Fibroblasts 0 2 2.37978 1.94547 8.58047 - OK XLOC_001231 iPS 0 681.594 711.425 1216.37 648.41 - OK XLOC_001231 iPS 1 731.16 704.416 1204.38 670.957 - OK XLOC_001231 hESC 1 4828.33 4779.33 3158.73 1743.75 - OK XLOC_001231 hESC 0 5366.47 5421.49 3583.14 1977.73 - OK XLOC_001231 Fibroblasts 1 3955.85 3300.76 2698.38 1483.61 - OK XLOC_001231 Fibroblasts 0 5606.33 6670.9 5453.48 2941.09 - OK XLOC_001232 iPS 0 5 5.21883 8.92297 12.0608 - OK XLOC_001232 iPS 1 3 2.89027 4.94167 6.67944 - OK XLOC_001232 hESC 1 24 23.7564 15.701 22.3583 - OK XLOC_001232 hESC 0 12 12.123 8.01229 9.50627 - OK XLOC_001232 Fibroblasts 1 48 40.0512 32.7419 37.0833 - OK XLOC_001232 Fibroblasts 0 29 34.5067 28.2093 38.416 - OK XLOC_001233 iPS 0 26 27.1379 46.3994 82.6075 - OK XLOC_001233 iPS 1 8 7.70738 13.1778 23.4611 - OK XLOC_001233 hESC 1 43 42.5636 28.1309 51.3532 - OK XLOC_001233 hESC 0 22 22.2256 14.6892 27.5356 - OK XLOC_001233 Fibroblasts 1 45 37.548 30.6956 54.2469 - OK XLOC_001233 Fibroblasts 0 6 7.13933 5.83642 10.4941 - OK XLOC_001234 iPS 0 71 74.1075 126.706 86.5618 - OK XLOC_001234 iPS 1 91 87.6714 149.897 109.642 - OK XLOC_001234 hESC 1 307 303.884 200.841 150.959 - OK XLOC_001234 hESC 0 419 423.296 279.762 214.409 - OK XLOC_001234 Fibroblasts 1 406 338.766 276.942 216.401 - OK XLOC_001234 Fibroblasts 0 318 378.384 309.33 231.682 - OK XLOC_001235 iPS 0 0 0 0 0 - OK XLOC_001235 iPS 1 1 0.963422 1.64722 0.692545 - OK XLOC_001235 hESC 1 24 23.7564 15.701 6.70718 - OK XLOC_001235 hESC 0 19 19.1948 12.6861 5.4193 - OK XLOC_001235 Fibroblasts 1 0 0 0 0 - OK XLOC_001235 Fibroblasts 0 0 0 0 0 - OK XLOC_001236 iPS 0 1 1.04377 1.78459 2.82201 - OK XLOC_001236 iPS 1 2 1.92684 3.29445 5.44452 - OK XLOC_001236 hESC 1 37 36.6245 24.2056 37.5565 - OK XLOC_001236 hESC 0 36 36.3691 24.0369 34.7535 - OK XLOC_001236 Fibroblasts 1 8 6.6752 5.45699 9.49793 - OK XLOC_001236 Fibroblasts 0 15 17.8483 14.591 20.5837 - OK XLOC_001237 iPS 0 0 0 0 0 - OK XLOC_001237 iPS 1 1 0.963422 1.64722 2.59032 - OK XLOC_001237 hESC 1 3 2.96955 1.96262 2.01036 - OK XLOC_001237 hESC 0 1 1.01025 0.667691 0.638442 - OK XLOC_001237 Fibroblasts 1 5 4.172 3.41062 5.41031 - OK XLOC_001237 Fibroblasts 0 4 4.75955 3.89094 6.17226 - OK XLOC_001238 iPS 0 853 890.333 1522.26 1140.76 - OK XLOC_001238 iPS 1 644 620.444 1060.81 769.116 - OK XLOC_001238 hESC 1 3411 3376.38 2231.5 1793.15 - OK XLOC_001238 hESC 0 3484.5 3520.23 2326.57 1914.65 - OK XLOC_001238 Fibroblasts 1 15279 12748.8 10422.2 7971.59 - OK XLOC_001238 Fibroblasts 0 13674 16270.5 13301.2 10168.6 - OK XLOC_001239 iPS 0 7 7.30637 12.4922 20.3456 - OK XLOC_001239 iPS 1 5 4.81711 8.23612 13.4139 - OK XLOC_001239 hESC 1 49 48.5027 32.0561 55.6135 - OK XLOC_001239 hESC 0 28 28.2871 18.6953 32.4342 - OK XLOC_001239 Fibroblasts 1 30 25.032 20.4637 33.631 - OK XLOC_001239 Fibroblasts 0 73 86.8618 71.0097 116.701 - OK XLOC_001240 iPS 0 413 431.076 737.037 495.035 - OK XLOC_001240 iPS 1 448 431.613 737.956 495.918 - OK XLOC_001240 hESC 1 1481 1465.97 968.88 668.806 - OK XLOC_001240 hESC 0 1695 1712.38 1131.74 781.374 - OK XLOC_001240 Fibroblasts 1 3240 2703.45 2210.08 1499.42 - OK XLOC_001240 Fibroblasts 0 3744 4454.94 3641.92 2461.77 - OK XLOC_001241 iPS 0 18 18.7878 32.1227 13.5659 - OK XLOC_001241 iPS 1 30 28.9027 49.4167 20.8694 - OK XLOC_001241 hESC 1 143 141.549 93.5516 40.1455 - OK XLOC_001241 hESC 0 121 122.241 80.7906 34.6694 - OK XLOC_001241 Fibroblasts 1 55 45.892 37.5168 15.8809 - OK XLOC_001241 Fibroblasts 0 60 71.3933 58.3642 24.7057 - OK XLOC_001242 iPS 0 279.035 291.248 497.965 204.04 - OK XLOC_001242 iPS 1 162.091 156.162 267 103.956 - OK XLOC_001242 hESC 1 2013.67 1993.23 1317.36 554.237 - OK XLOC_001242 hESC 0 1964.02 1984.16 1311.36 564.133 - OK XLOC_001242 Fibroblasts 1 3537.66 2951.82 2413.12 983.649 - OK XLOC_001242 Fibroblasts 0 3153.44 3752.23 3067.46 1266.47 - OK XLOC_001243 iPS 0 720.999 752.555 1286.69 928.209 - OK XLOC_001243 iPS 1 771.25 743.04 1270.42 934.355 - OK XLOC_001243 hESC 1 5146.13 5093.9 3366.63 2708.81 - OK XLOC_001243 hESC 0 4734.47 4783.01 3161.16 2488.48 - OK XLOC_001243 Fibroblasts 1 5171.6 4315.19 3527.67 2732.73 - OK XLOC_001243 Fibroblasts 0 4693.9 5585.21 4565.92 3443.98 - OK XLOC_001244 iPS 0 346 361.143 617.469 326.023 - OK XLOC_001244 iPS 1 267 257.234 439.809 222.083 - OK XLOC_001244 hESC 1 3594.67 3558.18 2351.65 1189.39 - OK XLOC_001244 hESC 0 3360 3394.45 2243.44 1161.3 - OK XLOC_001244 Fibroblasts 1 3200 2670.08 2182.8 1154.49 - OK XLOC_001244 Fibroblasts 0 3815.5 4540.02 3711.47 2009.88 - OK XLOC_001245 iPS 0 1618 1688.81 2887.47 2003.61 - OK XLOC_001245 iPS 1 111 106.94 182.842 133.761 - OK XLOC_001245 hESC 1 356 352.387 232.898 168.53 - OK XLOC_001245 hESC 0 311 314.189 207.652 144.557 - OK XLOC_001245 Fibroblasts 1 26573.7 22173.1 18126.5 13213.7 - OK XLOC_001245 Fibroblasts 0 22632.3 26929.9 22015.3 15327.5 - OK XLOC_001246 iPS 0 761 794.307 1358.08 2754.03 - OK XLOC_001246 iPS 1 661 636.822 1088.81 2273.64 - OK XLOC_001246 hESC 1 2762 2733.97 1806.92 4090.26 - OK XLOC_001246 hESC 0 2480 2505.43 1655.87 3632.19 - OK XLOC_001246 Fibroblasts 1 3704 3090.62 2526.59 5292.73 - OK XLOC_001246 Fibroblasts 0 4345 5170.06 4226.54 8511.04 - OK XLOC_001247 iPS 0 1125 1174.24 2007.67 674.251 - OK XLOC_001247 iPS 1 1488 1433.57 2451.07 820.452 - OK XLOC_001247 hESC 1 4784 4735.45 3129.72 1196.6 - OK XLOC_001247 hESC 0 4999 5050.26 3337.79 1301.81 - OK XLOC_001247 Fibroblasts 1 6693 5584.64 4565.45 1472.65 - OK XLOC_001247 Fibroblasts 0 3160 3760.04 3073.85 1046.7 - OK XLOC_001248 iPS 0 793.019 827.727 1415.22 3465.63 - OK XLOC_001248 iPS 1 665.96 641.601 1096.99 2672.39 - OK XLOC_001248 hESC 1 2465.26 2440.24 1612.79 4380.59 - OK XLOC_001248 hESC 0 2663.25 2690.56 1778.23 4850.39 - OK XLOC_001248 Fibroblasts 1 4347.97 3627.95 2965.86 7505.39 - OK XLOC_001248 Fibroblasts 0 3861.14 4594.33 3755.87 9517.68 - OK XLOC_001249 iPS 0 31 32.3568 55.3224 56.8329 - OK XLOC_001249 iPS 1 30 28.9027 49.4167 52.4369 - OK XLOC_001249 hESC 1 97 96.0155 63.458 68.5127 - OK XLOC_001249 hESC 0 111 112.138 74.1137 80.8782 - OK XLOC_001249 Fibroblasts 1 62 51.7328 42.2917 45.9671 - OK XLOC_001249 Fibroblasts 0 156 185.622 151.747 154.699 - OK XLOC_001250 iPS 0 19 19.8316 33.9073 50.5661 - OK XLOC_001250 iPS 1 5 4.81711 8.23612 12.2826 - OK XLOC_001250 hESC 1 107 105.914 70.0001 110.591 - OK XLOC_001250 hESC 0 60 60.6152 40.0615 63.2919 - OK XLOC_001250 Fibroblasts 1 235 196.084 160.299 241.04 - OK XLOC_001250 Fibroblasts 0 149 177.293 144.938 217.941 - OK XLOC_001251 iPS 0 1333 1391.34 2378.86 2480.16 - OK XLOC_001251 iPS 1 1436 1383.47 2365.41 2238.34 - OK XLOC_001251 hESC 1 4461 4415.72 2918.42 3468.08 - OK XLOC_001251 hESC 0 4517 4563.31 3015.96 3554.63 - OK XLOC_001251 Fibroblasts 1 8418 7023.98 5742.12 6624.84 - OK XLOC_001251 Fibroblasts 0 5904 7025.1 5743.03 6526.55 - OK XLOC_001252 iPS 0 170.829 178.306 304.861 309.169 - OK XLOC_001252 iPS 1 166 159.928 273.439 308.377 - OK XLOC_001252 hESC 1 4359.62 4315.37 2852.09 3562.24 - OK XLOC_001252 hESC 0 4351.77 4396.39 2905.64 3583.89 - OK XLOC_001252 Fibroblasts 1 5112.93 4266.22 3487.65 3162.18 - OK XLOC_001252 Fibroblasts 0 4704.32 5597.61 4576.06 4164.13 - OK XLOC_001253 iPS 0 4.33386 4.52354 7.73418 65.2115 - OK XLOC_001253 iPS 1 6.50001 6.26225 10.707 90.2768 - OK XLOC_001253 hESC 1 42.5834 42.1512 27.8583 344.309 - OK XLOC_001253 hESC 0 37.3333 37.7161 24.9271 308.081 - OK XLOC_001253 Fibroblasts 1 46.3343 38.6613 31.6057 279.885 - OK XLOC_001253 Fibroblasts 0 62.9169 74.864 61.2015 541.972 - OK XLOC_001254 iPS 0 496.835 518.58 886.649 419.852 - OK XLOC_001254 iPS 1 612.167 589.775 1008.38 456.945 - OK XLOC_001254 hESC 1 4096.5 4054.92 2679.96 1097.2 - OK XLOC_001254 hESC 0 4489.17 4535.2 2997.38 1248.64 - OK XLOC_001254 Fibroblasts 1 4119.64 3437.43 2810.11 1543.87 - OK XLOC_001254 Fibroblasts 0 5070.34 6033.13 4932.1 1878.66 - OK XLOC_001255 iPS 0 445.569 465.07 795.16 306.19 - OK XLOC_001255 iPS 1 307.933 296.67 507.235 195.32 - OK XLOC_001255 hESC 1 1247.64 1234.98 816.213 318.913 - OK XLOC_001255 hESC 0 1417.38 1431.92 946.374 369.77 - OK XLOC_001255 Fibroblasts 1 5392.79 4499.74 3678.55 1419.51 - OK XLOC_001255 Fibroblasts 0 1589.62 1891.47 1546.28 596.692 - OK XLOC_001256 iPS 0 554.5 578.769 989.557 483.482 - OK XLOC_001256 iPS 1 590 568.419 971.862 480.911 - OK XLOC_001256 hESC 1 3169 3136.84 2073.18 1103.62 - OK XLOC_001256 hESC 0 3565.5 3602.06 2380.65 1245.23 - OK XLOC_001256 Fibroblasts 1 3605 3008.01 2459.06 1189.05 - OK XLOC_001256 Fibroblasts 0 2857.5 3400.1 2779.59 1304.91 - OK XLOC_001257 iPS 0 5777 6029.84 10309.6 4928.26 - OK XLOC_001257 iPS 1 4587 4419.22 7555.81 3612.13 - OK XLOC_001257 hESC 1 16007 15844.5 10471.9 5097.08 - OK XLOC_001257 hESC 0 14333 14480 9570.01 4657.99 - OK XLOC_001257 Fibroblasts 1 52401.3 43723.7 35744.2 17130 - OK XLOC_001257 Fibroblasts 0 34521.2 41076.3 33580 16093.3 - OK XLOC_001258 iPS 0 38 39.6631 67.8146 107.848 - OK XLOC_001258 iPS 1 38 36.6101 62.5945 93.1511 - OK XLOC_001258 hESC 1 289 286.067 189.066 315.648 - OK XLOC_001258 hESC 0 265 267.717 176.938 291.472 - OK XLOC_001258 Fibroblasts 1 20 16.688 13.6425 24.6549 - OK XLOC_001258 Fibroblasts 0 12 14.2787 11.6728 21.0954 - OK XLOC_001259 iPS 0 0 0 0 0 - OK XLOC_001259 iPS 1 0 0 0 0 - OK XLOC_001259 hESC 1 7 6.92896 4.57945 2.95009 - OK XLOC_001259 hESC 0 7 7.07177 4.67384 3.21215 - OK XLOC_001259 Fibroblasts 1 0 0 0 0 - OK XLOC_001259 Fibroblasts 0 0 0 0 0 - OK XLOC_001260 iPS 0 3 3.1313 5.35378 2.28861 - OK XLOC_001260 iPS 1 1 0.963422 1.64722 0.96904 - OK XLOC_001260 hESC 1 4 3.9594 2.61683 0.824593 - OK XLOC_001260 hESC 0 5 5.05127 3.33845 1.05198 - OK XLOC_001260 Fibroblasts 1 0 0 0 0 - OK XLOC_001260 Fibroblasts 0 0 0 0 0 - OK XLOC_001261 iPS 0 6 6.2626 10.7076 7.75152 - OK XLOC_001261 iPS 1 0 0 0 0 - OK XLOC_001261 hESC 1 17 16.8275 11.1215 9.07601 - OK XLOC_001261 hESC 0 14 14.1435 9.34767 7.62842 - OK XLOC_001261 Fibroblasts 1 0 0 0 0 - OK XLOC_001261 Fibroblasts 0 0 0 0 0 - OK XLOC_001262 iPS 0 0 0 0 0 - OK XLOC_001262 iPS 1 11.4567 11.0377 18.8718 24.5918 - OK XLOC_001262 hESC 1 53.3133 52.7722 34.8779 47.7902 - OK XLOC_001262 hESC 0 23.713 23.9562 15.833 21.6946 - OK XLOC_001262 Fibroblasts 1 26.7216 22.2965 18.2274 23.9242 - OK XLOC_001262 Fibroblasts 0 23.3972 27.84 22.7593 29.8724 - OK XLOC_001263 iPS 0 160.084 167.09 285.685 563.364 - OK XLOC_001263 iPS 1 94.0715 90.6305 154.957 269.85 - OK XLOC_001263 hESC 1 1329.03 1315.54 869.458 2093.97 - OK XLOC_001263 hESC 0 1182.82 1194.94 789.756 1895.78 - OK XLOC_001263 Fibroblasts 1 1792.46 1495.63 1222.68 2381.07 - OK XLOC_001263 Fibroblasts 0 1554.82 1850.07 1512.43 3171.95 - OK XLOC_001264 iPS 0 27 28.1817 48.184 55.4527 - OK XLOC_001264 iPS 1 29 27.9392 47.7695 53.9717 - OK XLOC_001264 hESC 1 186.5 184.607 122.01 125.877 - OK XLOC_001264 hESC 0 133 134.364 88.8029 102.11 - OK XLOC_001264 Fibroblasts 1 126 105.134 85.9476 95.9388 - OK XLOC_001264 Fibroblasts 0 97 115.419 94.3554 106.395 - OK XLOC_001265 iPS 0 42 43.8382 74.9529 50.9605 - OK XLOC_001265 iPS 1 51 49.1345 84.0084 57.1173 - OK XLOC_001265 hESC 1 2183 2160.84 1428.13 996.455 - OK XLOC_001265 hESC 0 1847 1865.94 1233.23 860.461 - OK XLOC_001265 Fibroblasts 1 250 208.6 170.531 116.381 - OK XLOC_001265 Fibroblasts 0 357 424.79 347.267 236.997 - OK XLOC_001266 iPS 0 237.448 247.841 423.749 324.969 - OK XLOC_001266 iPS 1 199.411 192.117 328.474 251.904 - OK XLOC_001266 hESC 1 871.038 862.198 569.839 449.673 - OK XLOC_001266 hESC 0 929.605 939.136 620.689 489.788 - OK XLOC_001266 Fibroblasts 1 1472.86 1228.95 1004.67 773.275 - OK XLOC_001266 Fibroblasts 0 1397.28 1662.6 1359.18 1045.78 - OK XLOC_001267 iPS 0 186 194.141 331.934 189.749 - OK XLOC_001267 iPS 1 168 161.855 276.734 158.193 - OK XLOC_001267 hESC 1 993 982.922 649.627 379.511 - OK XLOC_001267 hESC 0 905 914.279 604.26 353.008 - OK XLOC_001267 Fibroblasts 1 1064 887.801 725.78 416.203 - OK XLOC_001267 Fibroblasts 0 1040 1237.48 1011.65 580.134 - OK XLOC_001268 iPS 0 2 2.08753 3.56919 4.43838 - OK XLOC_001268 iPS 1 4 3.85369 6.58889 8.19347 - OK XLOC_001268 hESC 1 3 2.96955 1.96262 2.56025 - OK XLOC_001268 hESC 0 4 4.04101 2.67076 3.48402 - OK XLOC_001268 Fibroblasts 1 0 0 0 0 - OK XLOC_001268 Fibroblasts 0 0 0 0 0 - OK XLOC_001269 iPS 0 4.19958 4.38339 7.49455 3.74687 - OK XLOC_001269 iPS 1 0 0 0 0 - OK XLOC_001269 hESC 1 4.44265 4.39756 2.90641 1.23759 - OK XLOC_001269 hESC 0 2 2.02051 1.33538 0.950006 - OK XLOC_001269 Fibroblasts 1 63.8606 53.2852 43.5608 22.9086 - OK XLOC_001269 Fibroblasts 0 18.6067 22.1398 18.0994 9.25736 - OK XLOC_001270 iPS 0 1.05904 1.10539 1.88996 1.0336 - OK XLOC_001270 iPS 1 1.03182 0.994078 1.69964 0.879212 - OK XLOC_001270 hESC 1 41.9443 41.5186 27.4402 14.4761 - OK XLOC_001270 hESC 0 32.3442 32.6758 21.5959 11.393 - OK XLOC_001270 Fibroblasts 1 14.3432 11.968 9.78387 5.07563 - OK XLOC_001270 Fibroblasts 0 3.31306 3.94217 3.22274 1.76783 - OK XLOC_001271 iPS 0 1 1.04377 1.78459 1.1361 - OK XLOC_001271 iPS 1 0 0 0 0 - OK XLOC_001271 hESC 1 0 0 0 0 - OK XLOC_001271 hESC 0 0 0 0 0 - OK XLOC_001271 Fibroblasts 1 0 0 0 0 - OK XLOC_001271 Fibroblasts 0 1 1.18989 0.972736 0.672289 - OK XLOC_001272 iPS 0 0 0 0 0 - OK XLOC_001272 iPS 1 0 0 0 0 - OK XLOC_001272 hESC 1 0 0 0 0 - OK XLOC_001272 hESC 0 0 0 0 0 - OK XLOC_001272 Fibroblasts 1 7 5.8408 4.77487 15.1876 - OK XLOC_001272 Fibroblasts 0 1 1.18989 0.972736 3.09402 - OK XLOC_001273 iPS 0 525 547.978 936.912 200.212 - OK XLOC_001273 iPS 1 80 77.0738 131.778 25.6599 - OK XLOC_001273 hESC 1 1757 1739.17 1149.44 231.403 - OK XLOC_001273 hESC 0 1562.5 1578.52 1043.27 209.91 - OK XLOC_001273 Fibroblasts 1 1479 1234.08 1008.86 215.562 - OK XLOC_001273 Fibroblasts 0 488.5 581.26 475.182 98.0236 - OK XLOC_001274 iPS 0 226 235.891 403.318 305.597 - OK XLOC_001274 iPS 1 198 190.758 326.15 219.733 - OK XLOC_001274 hESC 1 1310 1296.7 857.011 561.665 - OK XLOC_001274 hESC 0 1409.5 1423.95 941.11 654.169 - OK XLOC_001274 Fibroblasts 1 787 656.672 536.831 430.489 - OK XLOC_001274 Fibroblasts 0 748 890.036 727.607 601.162 - OK XLOC_001275 iPS 0 468 488.483 835.19 190.905 - OK XLOC_001275 iPS 1 562 541.443 925.74 211.603 - OK XLOC_001275 hESC 1 2774 2745.85 1814.77 423.416 - OK XLOC_001275 hESC 0 2871 2900.44 1916.94 448.06 - OK XLOC_001275 Fibroblasts 1 1429 1192.36 974.755 246.407 - OK XLOC_001275 Fibroblasts 0 1174 1396.93 1141.99 273.634 - OK XLOC_001276 iPS 0 851 888.246 1518.69 866.052 - OK XLOC_001276 iPS 1 918 884.422 1512.15 862.324 - OK XLOC_001276 hESC 1 3442 3407.07 2251.78 1312.24 - OK XLOC_001276 hESC 0 3632 3669.24 2425.05 1413.21 - OK XLOC_001276 Fibroblasts 1 3434 2865.33 2342.41 1340.01 - OK XLOC_001276 Fibroblasts 0 2628 3127.02 2556.35 1462.4 - OK XLOC_001277 iPS 0 529.5 552.675 944.942 302.093 - OK XLOC_001277 iPS 1 386 371.881 635.828 228.48 - OK XLOC_001277 hESC 1 894.5 885.422 585.188 169.468 - OK XLOC_001277 hESC 0 951 960.751 634.974 197.611 - OK XLOC_001277 Fibroblasts 1 2836 2366.36 1934.5 629.224 - OK XLOC_001277 Fibroblasts 0 1838 2187.01 1787.89 502.383 - OK XLOC_001278 iPS 0 296 308.955 528.24 494.997 - OK XLOC_001278 iPS 1 313 301.551 515.581 476.14 - OK XLOC_001278 hESC 1 907 897.795 593.365 576.84 - OK XLOC_001278 hESC 0 852 860.736 568.873 550.296 - OK XLOC_001278 Fibroblasts 1 1991 1661.29 1358.11 1291.14 - OK XLOC_001278 Fibroblasts 0 1130 1344.57 1099.19 1045.05 - OK XLOC_001279 iPS 0 0 0 0 0 - OK XLOC_001279 iPS 1 0 0 0 0 - OK XLOC_001279 hESC 1 1 0.989851 0.654207 1.09258 - OK XLOC_001279 hESC 0 0 0 0 0 - OK XLOC_001279 Fibroblasts 1 0 0 0 0 - OK XLOC_001279 Fibroblasts 0 0 0 0 0 - OK XLOC_001280 iPS 0 77 80.3701 137.414 44.3827 - OK XLOC_001280 iPS 1 149 143.55 245.436 78.753 - OK XLOC_001280 hESC 1 872 863.15 570.468 175.05 - OK XLOC_001280 hESC 0 968 977.925 646.325 210.775 - OK XLOC_001280 Fibroblasts 1 519 433.053 354.022 108.87 - OK XLOC_001280 Fibroblasts 0 406 483.094 394.931 120.651 - OK XLOC_001281 iPS 0 45 46.9695 80.3067 14.4907 - OK XLOC_001281 iPS 1 42 40.4637 69.1834 14.9076 - OK XLOC_001281 hESC 1 231 228.656 151.122 29.4871 - OK XLOC_001281 hESC 0 161 162.651 107.498 25.7798 - OK XLOC_001281 Fibroblasts 1 23 19.1912 15.6888 3.44216 - OK XLOC_001281 Fibroblasts 0 25 29.7472 24.3184 4.68617 - OK XLOC_001282 iPS 0 1832 1912.18 3269.38 2414.78 - OK XLOC_001282 iPS 1 1990 1917.21 3277.97 2421.51 - OK XLOC_001282 hESC 1 8611 8523.61 5633.37 4278.12 - OK XLOC_001282 hESC 0 9112 9205.43 6084 4619.11 - OK XLOC_001282 Fibroblasts 1 21278.5 17754.8 14514.6 10772.8 - OK XLOC_001282 Fibroblasts 0 12153.8 14461.7 11822.5 8788.16 - OK XLOC_001283 iPS 0 2727 2846.35 4866.59 1476.3 - OK XLOC_001283 iPS 1 2954 2845.95 4865.9 1476.02 - OK XLOC_001283 hESC 1 6366 6301.39 4164.68 1280.16 - OK XLOC_001283 hESC 0 6855 6925.28 4577.02 1406.1 - OK XLOC_001283 Fibroblasts 1 12805.4 10684.8 8734.89 2657.82 - OK XLOC_001283 Fibroblasts 0 8580.99 10210.4 8347.04 2539.21 - OK XLOC_001284 iPS 0 135 140.909 240.92 135.42 - OK XLOC_001284 iPS 1 107 103.086 176.253 98.9895 - OK XLOC_001284 hESC 1 812 803.759 531.216 305.206 - OK XLOC_001284 hESC 0 643 649.593 429.325 246.789 - OK XLOC_001284 Fibroblasts 1 1233 1028.81 841.059 474.338 - OK XLOC_001284 Fibroblasts 0 1919 2283.39 1866.68 1053.22 - OK XLOC_001285 iPS 0 470.5 491.092 839.651 918.849 - OK XLOC_001285 iPS 1 534 514.468 879.617 994.831 - OK XLOC_001285 hESC 1 4725 4677.05 3091.13 3485.92 - OK XLOC_001285 hESC 0 5244.5 5298.27 3501.71 3837.98 - OK XLOC_001285 Fibroblasts 1 3100 2586.64 2114.58 2401.69 - OK XLOC_001285 Fibroblasts 0 6530 7769.97 6351.97 6718.78 - OK XLOC_001286 iPS 0 9 9.3939 16.0613 5.55285 - OK XLOC_001286 iPS 1 11 10.5976 18.1195 6.2644 - OK XLOC_001286 hESC 1 30 29.6955 19.6262 9.58478 - OK XLOC_001286 hESC 0 31 31.3179 20.6984 7.25024 - OK XLOC_001286 Fibroblasts 1 3 2.5032 2.04637 1.27665 - OK XLOC_001286 Fibroblasts 0 7 8.32921 6.80915 2.35862 - OK XLOC_001287 iPS 0 217 226.497 387.257 196.481 - OK XLOC_001287 iPS 1 181.5 174.861 298.971 138.738 - OK XLOC_001287 hESC 1 2365 2341 1547.2 873.559 - OK XLOC_001287 hESC 0 1818 1836.64 1213.86 660.382 - OK XLOC_001287 Fibroblasts 1 235 196.084 160.299 57.8915 - OK XLOC_001287 Fibroblasts 0 297 353.397 288.903 130.497 - OK XLOC_001288 iPS 0 492 513.533 878.02 466.126 - OK XLOC_001288 iPS 1 615 592.505 1013.04 537.807 - OK XLOC_001288 hESC 1 474 469.189 310.094 167.976 - OK XLOC_001288 hESC 0 596 602.111 397.944 215.563 - OK XLOC_001288 Fibroblasts 1 993 828.559 677.349 360.546 - OK XLOC_001288 Fibroblasts 0 700 832.921 680.915 362.549 - OK XLOC_001289 iPS 0 385 401.85 687.069 216.639 - OK XLOC_001289 iPS 1 540 520.248 889.501 269.238 - OK XLOC_001289 hESC 1 1582 1565.94 1034.95 357.212 - OK XLOC_001289 hESC 0 1716 1733.59 1145.76 385.119 - OK XLOC_001289 Fibroblasts 1 4223 3523.67 2880.61 1067.99 - OK XLOC_001289 Fibroblasts 0 2957 3518.5 2876.38 1036.46 - OK XLOC_001290 iPS 0 846.87 883.935 1511.32 684.701 - OK XLOC_001290 iPS 1 1069.8 1030.67 1762.2 811.964 - OK XLOC_001290 hESC 1 4434.94 4389.93 2901.37 1336.78 - OK XLOC_001290 hESC 0 4661.5 4709.29 3112.44 1435.26 - OK XLOC_001290 Fibroblasts 1 4872.16 4065.33 3323.42 1510.79 - OK XLOC_001290 Fibroblasts 0 4381.46 5213.44 4262 1935.59 - OK XLOC_001291 iPS 0 0 0 0 0 - OK XLOC_001291 iPS 1 1 0.963422 1.64722 4.89973 - OK XLOC_001291 hESC 1 1.00016 0.990007 0.65431 1.43944 - OK XLOC_001291 hESC 0 0 0 0 0 - OK XLOC_001291 Fibroblasts 1 0 0 0 0 - OK XLOC_001291 Fibroblasts 0 0 0 0 0 - OK XLOC_001292 iPS 0 0 0 0 0 - OK XLOC_001292 iPS 1 0 0 0 0 - OK XLOC_001292 hESC 1 1 0.989851 0.654207 0.491457 - OK XLOC_001292 hESC 0 0 0 0 0 - OK XLOC_001292 Fibroblasts 1 2 1.6688 1.36425 1.13004 - OK XLOC_001292 Fibroblasts 0 2 2.37978 1.94547 1.61149 - OK XLOC_001293 iPS 0 634 661.748 1131.43 571.8 - OK XLOC_001293 iPS 1 1172 1129.13 1930.55 981.147 - OK XLOC_001293 hESC 1 1285 1271.96 840.656 415.738 - OK XLOC_001293 hESC 0 1579 1595.19 1054.28 520.79 - OK XLOC_001293 Fibroblasts 1 8212 6852.09 5601.6 2719.06 - OK XLOC_001293 Fibroblasts 0 3996 4754.79 3887.05 1873.69 - OK XLOC_001294 iPS 0 662 690.973 1181.4 258.527 - OK XLOC_001294 iPS 1 736 709.079 1212.36 289.048 - OK XLOC_001294 hESC 1 7379 7304.11 4827.39 937.422 - OK XLOC_001294 hESC 0 7922 8003.23 5289.45 1047.16 - OK XLOC_001294 Fibroblasts 1 15948 13307 10878.5 2506.08 - OK XLOC_001294 Fibroblasts 0 7199 8566 7002.73 1537.28 - OK XLOC_001295 iPS 0 3.00026 3.13157 5.35424 18.183 - OK XLOC_001295 iPS 1 4 3.85369 6.58889 22.3758 - OK XLOC_001295 hESC 1 0 0 0 0 - OK XLOC_001295 hESC 0 0 0 0 0 - OK XLOC_001295 Fibroblasts 1 0 0 0 0 - OK XLOC_001295 Fibroblasts 0 0 0 0 0 - OK XLOC_001296 iPS 0 14605 15244.2 26064 23044.8 - OK XLOC_001296 iPS 1 14978 14430.1 24672.1 21527.8 - OK XLOC_001296 hESC 1 84219.2 83364.4 55096.7 52264.3 - OK XLOC_001296 hESC 0 88311.3 89216.8 58964.7 55262.5 - OK XLOC_001296 Fibroblasts 1 86415.5 72105.1 58946.1 57885 - OK XLOC_001296 Fibroblasts 0 95528.8 113669 92924.4 84980 - OK XLOC_001297 iPS 0 0 0 0 0 - OK XLOC_001297 iPS 1 0 0 0 0 - OK XLOC_001297 hESC 1 0 0 0 0 - OK XLOC_001297 hESC 0 1 1.01025 0.667691 0.716409 - OK XLOC_001297 Fibroblasts 1 2 1.6688 1.36425 1.25394 - OK XLOC_001297 Fibroblasts 0 0 0 0 0 - OK XLOC_001298 iPS 0 4 4.17507 7.13837 7.62222 - OK XLOC_001298 iPS 1 4 3.85369 6.58889 4.21732 - OK XLOC_001298 hESC 1 7 6.92896 4.57945 3.76322 - OK XLOC_001298 hESC 0 4 4.04101 2.67076 2.19473 - OK XLOC_001298 Fibroblasts 1 518 432.219 353.34 230.78 - OK XLOC_001298 Fibroblasts 0 23 27.3674 22.3729 14.813 - OK XLOC_001299 iPS 0 22 22.9629 39.2611 41.6869 - OK XLOC_001299 iPS 1 17 16.3782 28.0028 30.6538 - OK XLOC_001299 hESC 1 67 66.32 43.8318 73.8892 - OK XLOC_001299 hESC 0 62 62.6357 41.3968 58.3447 - OK XLOC_001299 Fibroblasts 1 73 60.9112 49.795 77.2645 - OK XLOC_001299 Fibroblasts 0 74 88.0517 71.9825 118.934 - OK XLOC_001300 iPS 0 169 176.397 301.596 113.267 - OK XLOC_001300 iPS 1 126 121.391 207.55 77.9474 - OK XLOC_001300 hESC 1 735 727.54 480.842 183.171 - OK XLOC_001300 hESC 0 965 974.894 644.322 245.446 - OK XLOC_001300 Fibroblasts 1 321 267.842 218.962 82.404 - OK XLOC_001300 Fibroblasts 0 152 180.863 147.856 55.6441 - OK XLOC_001301 iPS 0 0 0 0 0 - OK XLOC_001301 iPS 1 0 0 0 0 - OK XLOC_001301 hESC 1 0 0 0 0 - OK XLOC_001301 hESC 0 2.00011 2.02062 1.33545 1.17967 - OK XLOC_001301 Fibroblasts 1 0 0 0 0 - OK XLOC_001301 Fibroblasts 0 0 0 0 0 - OK XLOC_001302 iPS 0 30 31.313 53.5378 96.6544 - OK XLOC_001302 iPS 1 25 24.0856 41.1806 74.3453 - OK XLOC_001302 hESC 1 203 200.94 132.804 257.213 - OK XLOC_001302 hESC 0 175 176.794 116.846 226.306 - OK XLOC_001302 Fibroblasts 1 61 50.8984 41.6096 75.8761 - OK XLOC_001302 Fibroblasts 0 25 29.7472 24.3184 44.3453 - OK XLOC_001303 iPS 0 881 919.559 1572.23 449.832 - OK XLOC_001303 iPS 1 1079 1039.53 1777.35 504.384 - OK XLOC_001303 hESC 1 8940.97 8850.23 5849.24 1780.91 - OK XLOC_001303 hESC 0 8527.99 8615.43 5694.06 1705.99 - OK XLOC_001303 Fibroblasts 1 23783.9 19845.3 16223.6 5021.61 - OK XLOC_001303 Fibroblasts 0 15454.4 18389 15033.1 4627.42 - OK XLOC_001304 iPS 0 470.5 491.092 839.651 424.835 - OK XLOC_001304 iPS 1 638 614.663 1050.93 530.624 - OK XLOC_001304 hESC 1 1999 1978.71 1307.76 674.333 - OK XLOC_001304 hESC 0 1901 1920.49 1269.28 652.675 - OK XLOC_001304 Fibroblasts 1 1509 1259.11 1029.32 521.629 - OK XLOC_001304 Fibroblasts 0 998 1187.51 970.791 491.743 - OK XLOC_001305 iPS 0 180 187.878 321.227 347.162 - OK XLOC_001305 iPS 1 163 157.038 268.497 290.222 - OK XLOC_001305 hESC 1 269 266.27 175.982 197.818 - OK XLOC_001305 hESC 0 280 282.871 186.953 207.194 - OK XLOC_001305 Fibroblasts 1 1486 1239.92 1013.64 1104.2 - OK XLOC_001305 Fibroblasts 0 867 1031.63 843.362 913.592 - OK XLOC_001306 iPS 0 774 807.876 1381.28 829.138 - OK XLOC_001306 iPS 1 758 730.274 1248.6 730.43 - OK XLOC_001306 hESC 1 2750 2722.09 1799.07 1195.92 - OK XLOC_001306 hESC 0 2488 2513.51 1661.22 1095.38 - OK XLOC_001306 Fibroblasts 1 2536 2116.04 1729.87 1108.33 - OK XLOC_001306 Fibroblasts 0 1968 2341.7 1914.34 1203.86 - OK XLOC_001307 iPS 0 56 58.451 99.9372 28.6825 - OK XLOC_001307 iPS 1 29 27.9392 47.7695 13.7866 - OK XLOC_001307 hESC 1 461 456.321 301.589 106.097 - OK XLOC_001307 hESC 0 557 562.711 371.904 114.867 - OK XLOC_001307 Fibroblasts 1 30 25.032 20.4637 8.10975 - OK XLOC_001307 Fibroblasts 0 20 23.7978 19.4547 8.01214 - OK XLOC_001308 iPS 0 0 0 0 0 - OK XLOC_001308 iPS 1 3 2.89027 4.94167 3.33734 - OK XLOC_001308 hESC 1 16 15.8376 10.4673 7.33957 - OK XLOC_001308 hESC 0 4 4.04101 2.67076 1.85068 - OK XLOC_001308 Fibroblasts 1 0 0 0 0 - OK XLOC_001308 Fibroblasts 0 1 1.18989 0.972736 0.667027 - OK XLOC_001309 iPS 0 55 57.4072 98.1526 61.9867 - OK XLOC_001309 iPS 1 85 81.8909 140.014 87.5571 - OK XLOC_001309 hESC 1 138 136.599 90.2805 58.4119 - OK XLOC_001309 hESC 0 130 131.333 86.7998 58.4985 - OK XLOC_001309 Fibroblasts 1 33 27.5352 22.5101 14.0413 - OK XLOC_001309 Fibroblasts 0 26 30.9371 25.2911 15.7761 - OK XLOC_001310 iPS 0 703 733.768 1254.57 2095.89 - OK XLOC_001310 iPS 1 835 804.458 1375.43 2196.81 - OK XLOC_001310 hESC 1 5106 5054.18 3340.38 4810.4 - OK XLOC_001310 hESC 0 5851.5 5911.5 3906.99 5315.48 - OK XLOC_001310 Fibroblasts 1 8071 6734.44 5505.42 8738.74 - OK XLOC_001310 Fibroblasts 0 9468 11265.9 9209.87 12615.7 - OK XLOC_001311 iPS 0 1599.5 1669.51 2854.46 1534.67 - OK XLOC_001311 iPS 1 1481.5 1427.31 2440.36 1312.96 - OK XLOC_001311 hESC 1 3534 3498.13 2311.97 1268.32 - OK XLOC_001311 hESC 0 3985.5 4026.36 2661.08 1460.03 - OK XLOC_001311 Fibroblasts 1 4078.5 3403.1 2782.04 1498.22 - OK XLOC_001311 Fibroblasts 0 3373.5 4014.09 3281.53 1766.71 - OK XLOC_001312 iPS 0 1869 1950.8 3335.41 582.16 - OK XLOC_001312 iPS 1 2416 2327.63 3979.69 691.841 - OK XLOC_001312 hESC 1 8511 8424.62 5567.95 1012.87 - OK XLOC_001312 hESC 0 8887 8978.12 5933.77 1051.01 - OK XLOC_001312 Fibroblasts 1 6184.5 5160.34 4218.59 756.819 - OK XLOC_001312 Fibroblasts 0 4513 5369.96 4389.96 855.41 - OK XLOC_001313 iPS 0 173.001 180.573 308.737 320.603 - OK XLOC_001313 iPS 1 170 163.782 280.028 291.935 - OK XLOC_001313 hESC 1 2531.92 2506.22 1656.4 1785.71 - OK XLOC_001313 hESC 0 1805.39 1823.9 1205.44 1298.83 - OK XLOC_001313 Fibroblasts 1 133.851 111.685 91.3029 95.0546 - OK XLOC_001313 Fibroblasts 0 47.9997 57.1143 46.6911 48.6097 - OK XLOC_001314 iPS 0 1588.83 1658.37 2835.42 3981.87 - OK XLOC_001314 iPS 1 2092 2015.48 3445.99 4904.84 - OK XLOC_001314 hESC 1 7541.67 7465.12 4933.81 7273.6 - OK XLOC_001314 hESC 0 6850.33 6920.57 4573.91 6721.97 - OK XLOC_001314 Fibroblasts 1 2086.5 1740.97 1423.25 1944.38 - OK XLOC_001314 Fibroblasts 0 2147.33 2555.09 2088.79 2727.94 - OK XLOC_001315 iPS 0 334.893 349.55 597.648 166.597 - OK XLOC_001315 iPS 1 369.844 356.316 609.216 187.968 - OK XLOC_001315 hESC 1 1081.59 1070.61 707.582 166.986 - OK XLOC_001315 hESC 0 1330.44 1344.08 888.322 205.985 - OK XLOC_001315 Fibroblasts 1 4736.3 3951.97 3230.75 764.848 - OK XLOC_001315 Fibroblasts 0 2343.58 2788.6 2279.69 529.365 - OK XLOC_001316 iPS 0 0 0 0 0 - OK XLOC_001316 iPS 1 2 1.92684 3.29445 6.80779 - OK XLOC_001316 hESC 1 11.0013 10.8896 7.19712 16.125 - OK XLOC_001316 hESC 0 4 4.04102 2.67077 5.9838 - OK XLOC_001316 Fibroblasts 1 16.0001 13.3505 10.914 22.8136 - OK XLOC_001316 Fibroblasts 0 6.00085 7.14034 5.83725 12.2016 - OK XLOC_001317 iPS 0 41 42.7944 73.1683 195.455 - OK XLOC_001317 iPS 1 304 292.88 500.756 1337.67 - OK XLOC_001317 hESC 1 5 4.94925 3.27103 9.7133 - OK XLOC_001317 hESC 0 3 3.03076 2.00307 5.9481 - OK XLOC_001317 Fibroblasts 1 0 0 0 0 - OK XLOC_001317 Fibroblasts 0 0 0 0 0 - OK XLOC_001318 iPS 0 672 701.411 1199.25 767.67 - OK XLOC_001318 iPS 1 544 524.102 896.09 572.948 - OK XLOC_001318 hESC 1 1835 1816.38 1200.47 794.197 - OK XLOC_001318 hESC 0 1680 1697.23 1121.72 738.142 - OK XLOC_001318 Fibroblasts 1 1913 1596.21 1304.9 844.54 - OK XLOC_001318 Fibroblasts 0 3211 3820.73 3123.46 2030.91 - OK XLOC_001319 iPS 0 792 826.663 1413.4 1409.34 - OK XLOC_001319 iPS 1 761 733.164 1253.54 1318.68 - OK XLOC_001319 hESC 1 942 932.439 616.263 650.383 - OK XLOC_001319 hESC 0 1032 1042.58 689.057 733.419 - OK XLOC_001319 Fibroblasts 1 881 735.106 600.951 739.443 - OK XLOC_001319 Fibroblasts 0 968 1151.81 941.609 926.234 - OK XLOC_001320 iPS 0 0 0 0 0 - OK XLOC_001320 iPS 1 0 0 0 0 - OK XLOC_001320 hESC 1 0 0 0 0 - OK XLOC_001320 hESC 0 0 0 0 0 - OK XLOC_001320 Fibroblasts 1 0 0 0 0 - OK XLOC_001320 Fibroblasts 0 0 0 0 0 - OK XLOC_001321 iPS 0 46 48.0133 82.0913 139.146 - OK XLOC_001321 iPS 1 65.5 63.1042 107.893 182.881 - OK XLOC_001321 hESC 1 1657 1640.18 1084.02 1962.48 - OK XLOC_001321 hESC 0 2121 2142.75 1416.17 2563.8 - OK XLOC_001321 Fibroblasts 1 1112 927.852 758.522 1297.86 - OK XLOC_001321 Fibroblasts 0 1533 1824.1 1491.2 2551.5 - OK XLOC_001322 iPS 0 0 0 0 0 - OK XLOC_001322 iPS 1 0.25 0.240856 0.411806 0.348287 - OK XLOC_001322 hESC 1 0 0 0 0 - OK XLOC_001322 hESC 0 0 0 0 0 - OK XLOC_001322 Fibroblasts 1 0 0 0 0 - OK XLOC_001322 Fibroblasts 0 0 0 0 0 - OK XLOC_001323 iPS 0 0 0 0 0 - OK XLOC_001323 iPS 1 0 0 0 0 - OK XLOC_001323 hESC 1 0 0 0 0 - OK XLOC_001323 hESC 0 0 0 0 0 - OK XLOC_001323 Fibroblasts 1 0 0 0 0 - OK XLOC_001323 Fibroblasts 0 0 0 0 0 - OK XLOC_001324 iPS 0 0 0 0 0 - OK XLOC_001324 iPS 1 0.9 0.86708 1.4825 1.34469 - OK XLOC_001324 hESC 1 0 0 0 0 - OK XLOC_001324 hESC 0 0 0 0 0 - OK XLOC_001324 Fibroblasts 1 0 0 0 0 - OK XLOC_001324 Fibroblasts 0 0 0 0 0 - OK XLOC_001325 iPS 0 5 5.21883 8.92297 15.0345 - OK XLOC_001325 iPS 1 10.5 10.1159 17.2958 29.1422 - OK XLOC_001325 hESC 1 211 208.859 138.038 248.31 - OK XLOC_001325 hESC 0 269 271.758 179.609 323.091 - OK XLOC_001325 Fibroblasts 1 175 146.02 119.372 203.021 - OK XLOC_001325 Fibroblasts 0 123 146.356 119.647 203.489 - OK XLOC_001326 iPS 0 0 0 0 0 - OK XLOC_001326 iPS 1 0 0 0 0 - OK XLOC_001326 hESC 1 0 0 0 0 - OK XLOC_001326 hESC 0 0 0 0 0 - OK XLOC_001326 Fibroblasts 1 0 0 0 0 - OK XLOC_001326 Fibroblasts 0 0 0 0 0 - OK XLOC_001327 iPS 0 0 0 0 0 - OK XLOC_001327 iPS 1 0 0 0 0 - OK XLOC_001327 hESC 1 0 0 0 0 - OK XLOC_001327 hESC 0 0 0 0 0 - OK XLOC_001327 Fibroblasts 1 0 0 0 0 - OK XLOC_001327 Fibroblasts 0 0 0 0 0 - OK XLOC_001328 iPS 0 0 0 0 0 - OK XLOC_001328 iPS 1 0.333333 0.321141 0.549074 0.401868 - OK XLOC_001328 hESC 1 0 0 0 0 - OK XLOC_001328 hESC 0 0 0 0 0 - OK XLOC_001328 Fibroblasts 1 0 0 0 0 - OK XLOC_001328 Fibroblasts 0 0 0 0 0 - OK XLOC_001329 iPS 0 0 0 0 0 - OK XLOC_001329 iPS 1 0 0 0 0 - OK XLOC_001329 hESC 1 0 0 0 0 - OK XLOC_001329 hESC 0 0 0 0 0 - OK XLOC_001329 Fibroblasts 1 0 0 0 0 - OK XLOC_001329 Fibroblasts 0 0 0 0 0 - OK XLOC_001330 iPS 0 0 0 0 0 - OK XLOC_001330 iPS 1 1 0.963422 1.64722 1.38982 - OK XLOC_001330 hESC 1 0 0 0 0 - OK XLOC_001330 hESC 0 0 0 0 0 - OK XLOC_001330 Fibroblasts 1 0 0 0 0 - OK XLOC_001330 Fibroblasts 0 0 0 0 0 - OK XLOC_001331 iPS 0 0 0 0 0 - OK XLOC_001331 iPS 1 1.33333 1.28456 2.1963 1.60762 - OK XLOC_001331 hESC 1 0 0 0 0 - OK XLOC_001331 hESC 0 0 0 0 0 - OK XLOC_001331 Fibroblasts 1 0 0 0 0 - OK XLOC_001331 Fibroblasts 0 0 0 0 0 - OK XLOC_001332 iPS 0 0 0 0 0 - OK XLOC_001332 iPS 1 0 0 0 0 - OK XLOC_001332 hESC 1 0 0 0 0 - OK XLOC_001332 hESC 0 0 0 0 0 - OK XLOC_001332 Fibroblasts 1 0 0 0 0 - OK XLOC_001332 Fibroblasts 0 0 0 0 0 - OK XLOC_001333 iPS 0 4 4.17507 7.13837 5.80813 - OK XLOC_001333 iPS 1 6 5.78053 9.88334 8.04156 - OK XLOC_001333 hESC 1 15 14.8478 9.8131 8.23632 - OK XLOC_001333 hESC 0 15 15.1538 10.0154 8.40609 - OK XLOC_001333 Fibroblasts 1 0 0 0 0 - OK XLOC_001333 Fibroblasts 0 0 0 0 0 - OK XLOC_001334 iPS 0 8.48853 8.86004 15.1486 3.14638 - OK XLOC_001334 iPS 1 37.675 36.297 62.0592 12.8898 - OK XLOC_001334 hESC 1 89.2283 88.3227 58.3737 12.2197 - OK XLOC_001334 hESC 0 45.0907 45.553 30.1067 6.3024 - OK XLOC_001334 Fibroblasts 1 11.8905 9.92146 8.11082 1.68656 - OK XLOC_001334 Fibroblasts 0 0 0 0 0 - OK XLOC_001335 iPS 0 1 1.04377 1.78459 0.813015 - OK XLOC_001335 iPS 1 0 0 0 0 - OK XLOC_001335 hESC 1 10.3202 10.2154 6.75152 3.3111 - OK XLOC_001335 hESC 0 12.8702 13.0021 8.59329 4.21435 - OK XLOC_001335 Fibroblasts 1 1.13779 0.949372 0.776114 0.374731 - OK XLOC_001335 Fibroblasts 0 10.3333 12.2954 10.0516 4.85319 - OK XLOC_001336 iPS 0 265 276.598 472.917 323.602 - OK XLOC_001336 iPS 1 392 377.662 645.712 460.377 - OK XLOC_001336 hESC 1 885 876.018 578.973 447.695 - OK XLOC_001336 hESC 0 797 805.172 532.15 431.283 - OK XLOC_001336 Fibroblasts 1 529 441.397 360.844 253.128 - OK XLOC_001336 Fibroblasts 0 416 494.993 404.658 309.812 - OK XLOC_001337 iPS 0 80 83.5014 142.767 99.5559 - OK XLOC_001337 iPS 1 125 120.428 205.903 143.582 - OK XLOC_001337 hESC 1 247.477 244.966 161.901 115.938 - OK XLOC_001337 hESC 0 250 252.563 166.923 119.533 - OK XLOC_001337 Fibroblasts 1 72.824 60.7643 49.675 34.7737 - OK XLOC_001337 Fibroblasts 0 75 89.2416 72.9552 51.0704 - OK XLOC_001338 iPS 0 1175 1226.43 2096.9 8005.09 - OK XLOC_001338 iPS 1 1170 1127.2 1927.25 7357.45 - OK XLOC_001338 hESC 1 7386 7311.04 4831.97 21537.1 - OK XLOC_001338 hESC 0 4898 4948.22 3270.35 14576.6 - OK XLOC_001338 Fibroblasts 1 5609 4680.15 3826.03 14920.7 - OK XLOC_001338 Fibroblasts 0 6791 8080.53 6605.85 25761.5 - OK XLOC_001339 iPS 0 70 73.0637 124.922 68.9048 - OK XLOC_001339 iPS 1 75 72.2567 123.542 68.1437 - OK XLOC_001339 hESC 1 155 153.427 101.402 57.116 - OK XLOC_001339 hESC 0 162 163.661 108.166 60.9259 - OK XLOC_001339 Fibroblasts 1 105 87.612 71.623 39.6268 - OK XLOC_001339 Fibroblasts 0 74 88.0517 71.9825 39.8257 - OK XLOC_001340 iPS 0 212 221.279 378.334 230.308 - OK XLOC_001340 iPS 1 118 113.684 194.372 126.389 - OK XLOC_001340 hESC 1 885.5 876.513 579.3 350.205 - OK XLOC_001340 hESC 0 829 837.5 553.516 332.522 - OK XLOC_001340 Fibroblasts 1 1560 1301.66 1064.11 601.953 - OK XLOC_001340 Fibroblasts 0 1288 1532.58 1252.88 720.125 - OK XLOC_001341 iPS 0 0 0 0 0 - OK XLOC_001341 iPS 1 0 0 0 0 - OK XLOC_001341 hESC 1 0 0 0 0 - OK XLOC_001341 hESC 0 0 0 0 0 - OK XLOC_001341 Fibroblasts 1 0 0 0 0 - OK XLOC_001341 Fibroblasts 0 0 0 0 0 - OK XLOC_001342 iPS 0 363.001 378.888 647.809 355.068 - OK XLOC_001342 iPS 1 24.9997 24.0853 41.1802 23.7664 - OK XLOC_001342 hESC 1 29.0001 28.7058 18.9721 11.248 - OK XLOC_001342 hESC 0 8.99966 9.09193 6.00899 3.32231 - OK XLOC_001342 Fibroblasts 1 1550 1293.32 1057.29 603.434 - OK XLOC_001342 Fibroblasts 0 1533 1824.1 1491.2 861.446 - OK XLOC_001343 iPS 0 6.50038 6.78488 11.6005 19.7101 - OK XLOC_001343 iPS 1 5.50004 5.29886 9.0598 8.36235 - OK XLOC_001343 hESC 1 49.5004 48.998 32.3835 34.9834 - OK XLOC_001343 hESC 0 27.5001 27.7821 18.3616 18.9473 - OK XLOC_001343 Fibroblasts 1 54.2691 45.2822 37.0183 38.3729 - OK XLOC_001343 Fibroblasts 0 55 65.4438 53.5005 53.5162 - OK XLOC_001344 iPS 0 332 346.531 592.485 233.19 - OK XLOC_001344 iPS 1 428 412.345 705.012 281.349 - OK XLOC_001344 hESC 1 2049 2028.2 1340.47 508.99 - OK XLOC_001344 hESC 0 2557.5 2583.72 1707.62 651.486 - OK XLOC_001344 Fibroblasts 1 2259 1884.91 1540.92 578.063 - OK XLOC_001344 Fibroblasts 0 3461 4118.2 3366.64 1262.97 - OK XLOC_001345 iPS 0 182 189.966 324.796 160.558 - OK XLOC_001345 iPS 1 212 204.246 349.211 192.644 - OK XLOC_001345 hESC 1 2809.5 2780.99 1837.99 1058.25 - OK XLOC_001345 hESC 0 2579 2605.44 1721.97 975.127 - OK XLOC_001345 Fibroblasts 1 355 296.212 242.154 180.279 - OK XLOC_001345 Fibroblasts 0 234 278.434 227.62 174.999 - OK XLOC_001346 iPS 0 17 17.744 30.3381 30.84 - OK XLOC_001346 iPS 1 15 14.4513 24.7084 25.1171 - OK XLOC_001346 hESC 1 97 96.0155 63.458 67.0708 - OK XLOC_001346 hESC 0 61 61.6254 40.7291 43.0479 - OK XLOC_001346 Fibroblasts 1 253 211.103 172.577 176.423 - OK XLOC_001346 Fibroblasts 0 185 220.129 179.956 183.966 - OK XLOC_001347 iPS 0 437.333 456.474 780.462 397.787 - OK XLOC_001347 iPS 1 365 351.649 601.237 305.795 - OK XLOC_001347 hESC 1 798 789.901 522.057 268.344 - OK XLOC_001347 hESC 0 800 808.203 534.153 274.42 - OK XLOC_001347 Fibroblasts 1 1823 1521.11 1243.51 630.343 - OK XLOC_001347 Fibroblasts 0 1057 1257.71 1028.18 521.162 - OK XLOC_001348 iPS 0 0 0 0 0 - OK XLOC_001348 iPS 1 1.98872 1.91597 3.27586 2.50951 - OK XLOC_001348 hESC 1 0 0 0 0 - OK XLOC_001348 hESC 0 0 0 0 0 - OK XLOC_001348 Fibroblasts 1 1.26129 1.05242 0.860354 0.350249 - OK XLOC_001348 Fibroblasts 0 0 0 0 0 - OK XLOC_001349 iPS 0 98.5 102.811 175.782 56.7847 - OK XLOC_001349 iPS 1 74.5 71.775 122.718 36.659 - OK XLOC_001349 hESC 1 347.833 344.303 227.555 163.131 - OK XLOC_001349 hESC 0 347.333 350.895 231.911 200.901 - OK XLOC_001349 Fibroblasts 1 155.167 129.471 105.843 85.5892 - OK XLOC_001349 Fibroblasts 0 60.1667 71.5916 58.5263 46.4969 - OK XLOC_001350 iPS 0 17.6943 18.4687 31.5771 19.2987 - OK XLOC_001350 iPS 1 26.6837 25.7076 43.9539 26.863 - OK XLOC_001350 hESC 1 29.1475 28.8517 19.0685 11.928 - OK XLOC_001350 hESC 0 29.7601 30.0653 19.8706 12.4297 - OK XLOC_001350 Fibroblasts 1 2 1.6688 1.36425 0.8366 - OK XLOC_001350 Fibroblasts 0 1.24322 1.47929 1.20933 0.741598 - OK XLOC_001351 iPS 0 112 116.902 199.874 284.86 - OK XLOC_001351 iPS 1 66.5 64.0676 109.54 156.116 - OK XLOC_001351 hESC 1 188.5 186.587 123.318 185.701 - OK XLOC_001351 hESC 0 177.667 179.488 118.626 178.636 - OK XLOC_001351 Fibroblasts 1 2219.83 1852.23 1514.2 2175.15 - OK XLOC_001351 Fibroblasts 0 915.167 1088.95 890.216 1278.79 - OK XLOC_001352 iPS 0 656.45 685.181 1171.5 553.009 - OK XLOC_001352 iPS 1 399.233 384.63 657.626 342.292 - OK XLOC_001352 hESC 1 930 920.561 608.412 326.531 - OK XLOC_001352 hESC 0 1063.26 1074.16 709.93 434.511 - OK XLOC_001352 Fibroblasts 1 4940.29 4122.17 3369.89 1852.98 - OK XLOC_001352 Fibroblasts 0 2801.25 3333.17 2724.88 1550.82 - OK XLOC_001353 iPS 0 248 258.854 442.579 452.493 - OK XLOC_001353 iPS 1 214.5 206.654 353.329 347.719 - OK XLOC_001353 hESC 1 1280.83 1267.83 837.93 831.967 - OK XLOC_001353 hESC 0 1141.67 1153.37 762.28 703.498 - OK XLOC_001353 Fibroblasts 1 705.667 588.808 481.352 577.976 - OK XLOC_001353 Fibroblasts 0 520.667 619.535 506.471 566.934 - OK XLOC_001354 iPS 0 3 3.1313 5.35378 3.75843 - OK XLOC_001354 iPS 1 0 0 0 0 - OK XLOC_001354 hESC 1 30 29.6955 19.6262 18.3709 - OK XLOC_001354 hESC 0 21 21.2153 14.0215 11.5652 - OK XLOC_001354 Fibroblasts 1 0 0 0 0 - OK XLOC_001354 Fibroblasts 0 0 0 0 0 - OK XLOC_001355 iPS 0 31 32.3567 55.3223 19.5518 - OK XLOC_001355 iPS 1 22 21.1953 36.2389 12.5959 - OK XLOC_001355 hESC 1 182 180.153 119.066 42.4094 - OK XLOC_001355 hESC 0 172.5 174.269 115.177 41.1184 - OK XLOC_001355 Fibroblasts 1 12.5 10.43 8.52655 2.95036 - OK XLOC_001355 Fibroblasts 0 10 11.8989 9.72736 3.3181 - OK XLOC_001356 iPS 0 5.00001 5.21884 8.92298 65.8754 - OK XLOC_001356 iPS 1 16 15.4148 26.3556 194.575 - OK XLOC_001356 hESC 1 96 95.0257 62.8038 641.809 - OK XLOC_001356 hESC 0 62 62.6357 41.3968 423.045 - OK XLOC_001356 Fibroblasts 1 96 80.1024 65.4839 504.172 - OK XLOC_001356 Fibroblasts 0 28 33.3169 27.2366 209.699 - OK XLOC_001357 iPS 0 749 781.781 1336.66 2028.45 - OK XLOC_001357 iPS 1 728 701.372 1199.18 1820.34 - OK XLOC_001357 hESC 1 5035 4983.9 3293.93 5301.65 - OK XLOC_001357 hESC 0 4471.5 4517.35 2985.58 4805.58 - OK XLOC_001357 Fibroblasts 1 1027 856.928 700.541 1072.39 - OK XLOC_001357 Fibroblasts 0 2484 2955.68 2416.28 3699.79 - OK XLOC_001358 iPS 0 366 382.019 653.161 295.669 - OK XLOC_001358 iPS 1 530 510.614 873.028 397.803 - OK XLOC_001358 hESC 1 4609 4562.22 3015.24 1447.68 - OK XLOC_001358 hESC 0 4612 4659.29 3079.39 1458.3 - OK XLOC_001358 Fibroblasts 1 1799 1501.08 1227.14 647.268 - OK XLOC_001358 Fibroblasts 0 1383 1645.61 1345.29 707.682 - OK XLOC_001359 iPS 0 678.5 708.196 1210.85 1755.76 - OK XLOC_001359 iPS 1 557.5 537.108 918.327 1331.6 - OK XLOC_001359 hESC 1 1528 1512.49 999.628 1533.05 - OK XLOC_001359 hESC 0 1629 1645.7 1087.67 1668.07 - OK XLOC_001359 Fibroblasts 1 5250 4380.6 3581.15 5234.69 - OK XLOC_001359 Fibroblasts 0 3746.5 4457.91 3644.36 5327.08 - OK XLOC_001360 iPS 0 54 56.3634 96.3681 40.9253 - OK XLOC_001360 iPS 1 40 38.5369 65.8889 22.4268 - OK XLOC_001360 hESC 1 294 291.016 192.337 68.4869 - OK XLOC_001360 hESC 0 276 278.83 184.283 63.3521 - OK XLOC_001360 Fibroblasts 1 7 5.8408 4.77487 1.68269 - OK XLOC_001360 Fibroblasts 0 0 0 0 0 - OK XLOC_001361 iPS 0 0 0 0 0 - OK XLOC_001361 iPS 1 0 0 0 0 - OK XLOC_001361 hESC 1 0 0 0 0 - OK XLOC_001361 hESC 0 0 0 0 0 - OK XLOC_001361 Fibroblasts 1 0 0 0 0 - OK XLOC_001361 Fibroblasts 0 0 0 0 0 - OK XLOC_001362 iPS 0 3325 3470.53 5933.77 2190.88 - OK XLOC_001362 iPS 1 7339.5 7071.04 12089.8 4482.7 - OK XLOC_001362 hESC 1 23859.5 23617.3 15609 5880.72 - OK XLOC_001362 hESC 0 20512 20722.3 13695.7 5133.09 - OK XLOC_001362 Fibroblasts 1 3227 2692.61 2201.21 818.689 - OK XLOC_001362 Fibroblasts 0 3504 4169.37 3408.47 1270.19 - OK XLOC_001363 iPS 0 1 1.04377 1.78459 1.00135 - OK XLOC_001363 iPS 1 0 0 0 0 - OK XLOC_001363 hESC 1 0 0 0 0 - OK XLOC_001363 hESC 0 0 0 0 0 - OK XLOC_001363 Fibroblasts 1 0 0 0 0 - OK XLOC_001363 Fibroblasts 0 0 0 0 0 - OK XLOC_001364 iPS 0 355 370.537 633.531 283.958 - OK XLOC_001364 iPS 1 318 306.368 523.817 242.653 - OK XLOC_001364 hESC 1 2134 2112.34 1396.08 644.181 - OK XLOC_001364 hESC 0 2225 2247.81 1485.61 674.632 - OK XLOC_001364 Fibroblasts 1 1741 1452.69 1187.58 532.982 - OK XLOC_001364 Fibroblasts 0 1241 1476.65 1207.17 535.068 - OK XLOC_001365 iPS 0 280 292.255 499.686 124.716 - OK XLOC_001365 iPS 1 192 184.977 316.267 78.9369 - OK XLOC_001365 hESC 1 524 518.682 342.804 86.3707 - OK XLOC_001365 hESC 0 557 562.711 371.904 93.7024 - OK XLOC_001365 Fibroblasts 1 2194.5 1831.09 1496.92 374.131 - OK XLOC_001365 Fibroblasts 0 951 1131.58 925.072 231.207 - OK XLOC_001366 iPS 0 4030 4206.38 7191.91 812.919 - OK XLOC_001366 iPS 1 4920.5 4740.52 8105.16 947.249 - OK XLOC_001366 hESC 1 16025 15862.4 10483.7 2100.23 - OK XLOC_001366 hESC 0 19592 19792.9 13081.4 2557.61 - OK XLOC_001366 Fibroblasts 1 16751.5 13977.4 11426.6 2165.69 - OK XLOC_001366 Fibroblasts 0 9055 10774.4 8808.13 2046.76 - OK XLOC_001367 iPS 0 551 575.116 983.311 353.957 - OK XLOC_001367 iPS 1 575 553.968 947.153 352.459 - OK XLOC_001367 hESC 1 2566 2539.96 1678.69 596.076 - OK XLOC_001367 hESC 0 2663 2690.3 1778.06 632.108 - OK XLOC_001367 Fibroblasts 1 9834 8205.49 6708.01 2339.43 - OK XLOC_001367 Fibroblasts 0 7017 8349.44 6825.69 2379.96 - OK XLOC_001368 iPS 0 6.5 6.78449 11.5999 8.41669 - OK XLOC_001368 iPS 1 8.5 8.18909 14.0014 9.22686 - OK XLOC_001368 hESC 1 22.5 22.2716 14.7196 9.94659 - OK XLOC_001368 hESC 0 30.5 30.8127 20.3646 13.761 - OK XLOC_001368 Fibroblasts 1 22 18.3568 15.0067 9.92548 - OK XLOC_001368 Fibroblasts 0 17 20.2281 16.5365 10.9373 - OK XLOC_001369 iPS 0 8.5 8.87202 15.169 19.9877 - OK XLOC_001369 iPS 1 5.5 5.29882 9.05973 11.9377 - OK XLOC_001369 hESC 1 22 21.7767 14.3925 19.9528 - OK XLOC_001369 hESC 0 17 17.1743 11.3507 15.7358 - OK XLOC_001369 Fibroblasts 1 14 11.6816 9.54973 12.6755 - OK XLOC_001369 Fibroblasts 0 13.5 16.0635 13.1319 17.4303 - OK XLOC_001370 iPS 0 205 213.972 365.842 442.371 - OK XLOC_001370 iPS 1 140 134.879 230.611 276.327 - OK XLOC_001370 hESC 1 894.5 885.422 585.188 725.941 - OK XLOC_001370 hESC 0 851.5 860.231 568.539 705.322 - OK XLOC_001370 Fibroblasts 1 3508.5 2927.49 2393.23 2942.51 - OK XLOC_001370 Fibroblasts 0 2992 3560.14 2910.43 3479.57 - OK XLOC_001371 iPS 0 2245.5 2343.78 4007.3 3899.26 - OK XLOC_001371 iPS 1 2167 2087.74 3569.53 3492.56 - OK XLOC_001371 hESC 1 8439.5 8353.85 5521.18 5524.79 - OK XLOC_001371 hESC 0 7823 7903.21 5223.35 5216.39 - OK XLOC_001371 Fibroblasts 1 30183.3 25185 20588.8 19979.9 - OK XLOC_001371 Fibroblasts 0 19546 23257.5 19013.1 18458.4 - OK XLOC_001372 iPS 0 20 20.8753 35.6919 26.2203 - OK XLOC_001372 iPS 1 40 38.5369 65.8889 48.404 - OK XLOC_001372 hESC 1 32.0002 31.6754 20.9347 15.816 - OK XLOC_001372 hESC 0 32 32.3281 21.3661 16.142 - OK XLOC_001372 Fibroblasts 1 40.001 33.3768 27.2856 20.1265 - OK XLOC_001372 Fibroblasts 0 18.0001 21.4181 17.5093 12.9153 - OK XLOC_001373 iPS 0 105 109.596 187.382 116.577 - OK XLOC_001373 iPS 1 44 42.3906 72.4778 45.0223 - OK XLOC_001373 hESC 1 209 206.879 136.729 74.8828 - OK XLOC_001373 hESC 0 165 166.692 110.169 61.3773 - OK XLOC_001373 Fibroblasts 1 1614 1346.72 1100.95 633.731 - OK XLOC_001373 Fibroblasts 0 1176 1399.31 1143.94 623.803 - OK XLOC_001374 iPS 0 0 0 0 0 - OK XLOC_001374 iPS 1 1 0.963422 1.64722 2.15443 - OK XLOC_001374 hESC 1 1 0.989851 0.654207 0.740923 - OK XLOC_001374 hESC 0 0 0 0 0 - OK XLOC_001374 Fibroblasts 1 0 0 0 0 - OK XLOC_001374 Fibroblasts 0 0 0 0 0 - OK XLOC_001375 iPS 0 0 0 0 0 - OK XLOC_001375 iPS 1 0 0 0 0 - OK XLOC_001375 hESC 1 0 0 0 0 - OK XLOC_001375 hESC 0 0 0 0 0 - OK XLOC_001375 Fibroblasts 1 0 0 0 0 - OK XLOC_001375 Fibroblasts 0 0 0 0 0 - OK XLOC_001376 iPS 0 64 66.8011 114.214 214.004 - OK XLOC_001376 iPS 1 16 15.4148 26.3556 48.502 - OK XLOC_001376 hESC 1 34 33.6549 22.243 44.1426 - OK XLOC_001376 hESC 0 25 25.2563 16.6923 31.5939 - OK XLOC_001376 Fibroblasts 1 4 3.3376 2.7285 5.41525 - OK XLOC_001376 Fibroblasts 0 12 14.2787 11.6728 20.8292 - OK XLOC_001377 iPS 0 0 0 0 0 - OK XLOC_001377 iPS 1 0 0 0 0 - OK XLOC_001377 hESC 1 0 0 0 0 - OK XLOC_001377 hESC 0 0 0 0 0 - OK XLOC_001377 Fibroblasts 1 0 0 0 0 - OK XLOC_001377 Fibroblasts 0 0 0 0 0 - OK XLOC_001378 iPS 0 0 0 0 0 - OK XLOC_001378 iPS 1 0 0 0 0 - OK XLOC_001378 hESC 1 0 0 0 0 - OK XLOC_001378 hESC 0 0 0 0 0 - OK XLOC_001378 Fibroblasts 1 0 0 0 0 - OK XLOC_001378 Fibroblasts 0 0 0 0 0 - OK XLOC_001379 iPS 0 0 0 0 0 - OK XLOC_001379 iPS 1 0 0 0 0 - OK XLOC_001379 hESC 1 1 0.989851 0.654207 0.751535 - OK XLOC_001379 hESC 0 1 1.01025 0.667691 0.767025 - OK XLOC_001379 Fibroblasts 1 12 10.0128 8.18549 4.69349 - OK XLOC_001379 Fibroblasts 0 0 0 0 0 - OK XLOC_001380 iPS 0 436 455.082 778.083 602.09 - OK XLOC_001380 iPS 1 46 44.3174 75.7723 61.1334 - OK XLOC_001380 hESC 1 330 326.651 215.888 145.603 - OK XLOC_001380 hESC 0 266 268.727 177.606 120.407 - OK XLOC_001380 Fibroblasts 1 26658 22243.4 18184.1 13550.8 - OK XLOC_001380 Fibroblasts 0 11277 13418.4 10969.5 7383.52 - OK XLOC_001381 iPS 0 386.5 403.416 689.745 426.336 - OK XLOC_001381 iPS 1 348 335.271 573.234 354.319 - OK XLOC_001381 hESC 1 842 833.454 550.842 348.578 - OK XLOC_001381 hESC 0 864 872.859 576.885 365.058 - OK XLOC_001381 Fibroblasts 1 3250 2711.8 2216.9 1374.97 - OK XLOC_001381 Fibroblasts 0 2690 3200.8 2616.66 1622.91 - OK XLOC_001382 iPS 0 3765 3929.78 6718.99 4855.09 - OK XLOC_001382 iPS 1 3377 3253.48 5562.67 4018.93 - OK XLOC_001382 hESC 1 10413 10307.3 6812.25 5059.07 - OK XLOC_001382 hESC 0 10272.5 10377.8 6858.85 5092.86 - OK XLOC_001382 Fibroblasts 1 25871 21586.8 17647.2 12796.8 - OK XLOC_001382 Fibroblasts 0 17600 20942 17120.2 12415.7 - OK XLOC_001383 iPS 0 71 74.1075 126.706 53.6401 - OK XLOC_001383 iPS 1 115 110.794 189.431 74.348 - OK XLOC_001383 hESC 1 766 758.226 501.122 223.485 - OK XLOC_001383 hESC 0 471 475.829 314.482 128.348 - OK XLOC_001383 Fibroblasts 1 374 312.065 255.114 197.026 - OK XLOC_001383 Fibroblasts 0 112 133.267 108.946 57.0801 - OK XLOC_001384 iPS 0 84 87.6764 149.906 68.0332 - OK XLOC_001384 iPS 1 103 99.2325 169.664 78.8767 - OK XLOC_001384 hESC 1 1190 1177.92 778.506 342.395 - OK XLOC_001384 hESC 0 936 945.597 624.959 277.652 - OK XLOC_001384 Fibroblasts 1 652 544.029 444.745 194.863 - OK XLOC_001384 Fibroblasts 0 1012 1204.17 984.409 419.45 - OK XLOC_001385 iPS 0 2728.5 2847.92 4869.26 2379.64 - OK XLOC_001385 iPS 1 1814.5 1748.13 2988.89 1417.35 - OK XLOC_001385 hESC 1 2663 2635.97 1742.15 990.745 - OK XLOC_001385 hESC 0 3106 3137.85 2073.85 1174.98 - OK XLOC_001385 Fibroblasts 1 15119 12615.3 10313 5051.67 - OK XLOC_001385 Fibroblasts 0 8256.5 9824.31 8031.4 3804.02 - OK XLOC_001386 iPS 0 2107 2199.22 3760.14 1217.69 - OK XLOC_001386 iPS 1 2060 1984.65 3393.28 1097.23 - OK XLOC_001386 hESC 1 4133 4091.05 2703.84 694.108 - OK XLOC_001386 hESC 0 4392 4437.03 2932.5 741.726 - OK XLOC_001386 Fibroblasts 1 13519 11280.2 9221.63 2406.45 - OK XLOC_001386 Fibroblasts 0 7413.5 8821.23 7211.38 1828.99 - OK XLOC_001387 iPS 0 442.5 461.867 789.682 259.31 - OK XLOC_001387 iPS 1 410.5 395.485 676.185 201.483 - OK XLOC_001387 hESC 1 3084.5 3053.19 2017.9 583.914 - OK XLOC_001387 hESC 0 2820 2848.91 1882.89 559.942 - OK XLOC_001387 Fibroblasts 1 33932 28312.8 23145.8 6782.82 - OK XLOC_001387 Fibroblasts 0 22292 26525 21684.2 6207.76 - OK XLOC_001388 iPS 0 9.0001 9.39401 16.0615 10.5256 - OK XLOC_001388 iPS 1 6 5.78053 9.88334 6.47687 - OK XLOC_001388 hESC 1 3 2.96955 1.96262 1.31865 - OK XLOC_001388 hESC 0 1.00053 1.01079 0.668048 0.44885 - OK XLOC_001388 Fibroblasts 1 1 0.8344 0.682124 0.448641 - OK XLOC_001388 Fibroblasts 0 1 1.18989 0.972736 0.63978 - OK XLOC_001389 iPS 0 88.5 92.3734 157.937 118.236 - OK XLOC_001389 iPS 1 66 63.5859 108.717 81.3883 - OK XLOC_001389 hESC 1 128.5 127.196 84.0656 64.756 - OK XLOC_001389 hESC 0 110.667 111.801 73.8911 56.9186 - OK XLOC_001389 Fibroblasts 1 1191.83 994.465 812.978 611.143 - OK XLOC_001389 Fibroblasts 0 590.667 702.827 574.563 431.919 - OK XLOC_001390 iPS 0 68 70.9762 121.352 53.9385 - OK XLOC_001390 iPS 1 79 76.1104 130.131 57.757 - OK XLOC_001390 hESC 1 641 634.494 419.346 190.729 - OK XLOC_001390 hESC 0 566 571.803 377.913 170.868 - OK XLOC_001390 Fibroblasts 1 8 6.6752 5.45699 2.47034 - OK XLOC_001390 Fibroblasts 0 4 4.75955 3.89094 1.76139 - OK XLOC_001391 iPS 0 1456 1519.72 2598.37 1185.18 - OK XLOC_001391 iPS 1 1443 1390.22 2376.94 1094.34 - OK XLOC_001391 hESC 1 3010 2979.45 1969.16 777.673 - OK XLOC_001391 hESC 0 3241 3274.23 2163.99 868.439 - OK XLOC_001391 Fibroblasts 1 6306 5261.72 4301.47 1622.31 - OK XLOC_001391 Fibroblasts 0 3750.5 4462.67 3648.25 1407.6 - OK XLOC_001392 iPS 0 797.261 832.155 1422.79 184.175 - OK XLOC_001392 iPS 1 603.509 581.434 994.114 132.959 - OK XLOC_001392 hESC 1 14207.1 14062.9 9294.35 1084.67 - OK XLOC_001392 hESC 0 13266.9 13402.9 8858.2 1025.31 - OK XLOC_001392 Fibroblasts 1 103025 85963.7 70275.6 7492.14 - OK XLOC_001392 Fibroblasts 0 21058.5 25057.3 20484.4 2534.31 - OK XLOC_001393 iPS 0 24 25.0504 42.8302 16.2188 - OK XLOC_001393 iPS 1 25 24.0856 41.1806 15.6779 - OK XLOC_001393 hESC 1 337 333.58 220.468 84.6913 - OK XLOC_001393 hESC 0 250 252.563 166.923 64.1224 - OK XLOC_001393 Fibroblasts 1 6 5.0064 4.09274 1.49091 - OK XLOC_001393 Fibroblasts 0 0 0 0 0 - OK XLOC_001394 iPS 0 0 0 0 0 - OK XLOC_001394 iPS 1 1 0.963422 1.64722 6.80245 - OK XLOC_001394 hESC 1 1 0.989851 0.654207 1.81454 - OK XLOC_001394 hESC 0 0 0 0 0 - OK XLOC_001394 Fibroblasts 1 0 0 0 0 - OK XLOC_001394 Fibroblasts 0 0 0 0 0 - OK XLOC_001395 iPS 0 2590 2703.36 4622.1 790.27 - OK XLOC_001395 iPS 1 3200 3082.95 5271.11 929.38 - OK XLOC_001395 hESC 1 3743 3705.01 2448.7 415.507 - OK XLOC_001395 hESC 0 4069 4110.72 2716.83 459.261 - OK XLOC_001395 Fibroblasts 1 9159 7642.27 6247.57 1046.87 - OK XLOC_001395 Fibroblasts 0 4420 5259.3 4299.49 720.529 - OK XLOC_001396 iPS 0 178 185.791 317.658 168.513 - OK XLOC_001396 iPS 1 318 306.368 523.817 277.877 - OK XLOC_001396 hESC 1 465 460.281 304.206 164.66 - OK XLOC_001396 hESC 0 322 325.302 214.996 116.373 - OK XLOC_001396 Fibroblasts 1 0 0 0 0 - OK XLOC_001396 Fibroblasts 0 0 0 0 0 - OK XLOC_001397 iPS 0 3057.5 3191.32 5456.39 3166.58 - OK XLOC_001397 iPS 1 3231 3112.82 5322.18 3089.54 - OK XLOC_001397 hESC 1 8115 8032.64 5308.89 3106.08 - OK XLOC_001397 hESC 0 7704 7782.99 5143.89 3016.81 - OK XLOC_001397 Fibroblasts 1 11006.5 9183.82 7507.8 4345.74 - OK XLOC_001397 Fibroblasts 0 10297.5 12252.9 10016.8 5801.7 - OK XLOC_001398 iPS 0 181.671 189.623 324.21 108.419 - OK XLOC_001398 iPS 1 23.7934 22.9231 39.1931 12.9298 - OK XLOC_001398 hESC 1 93.9997 93.0456 61.4952 21.2511 - OK XLOC_001398 hESC 0 68.9997 69.7072 46.0705 15.9207 - OK XLOC_001398 Fibroblasts 1 1835.85 1531.83 1252.28 423.274 - OK XLOC_001398 Fibroblasts 0 1060.6 1262 1031.69 346.952 - OK XLOC_001399 iPS 0 105 109.596 187.382 255.239 - OK XLOC_001399 iPS 1 3 2.89027 4.94167 9.62698 - OK XLOC_001399 hESC 1 5 4.94925 3.27103 11.4479 - OK XLOC_001399 hESC 0 3 3.03076 2.00307 2.88823 - OK XLOC_001399 Fibroblasts 1 1016 847.75 693.038 966.345 - OK XLOC_001399 Fibroblasts 0 539.5 641.944 524.791 634.047 - OK XLOC_001400 iPS 0 430 448.82 767.375 304.736 - OK XLOC_001400 iPS 1 450 433.54 741.25 301.303 - OK XLOC_001400 hESC 1 3057 3025.97 1999.91 803.362 - OK XLOC_001400 hESC 0 2864 2893.36 1912.27 744.559 - OK XLOC_001400 Fibroblasts 1 2675 2232.02 1824.68 691.843 - OK XLOC_001400 Fibroblasts 0 2356 2803.38 2291.77 887.956 - OK XLOC_001401 iPS 0 11.0001 11.4815 19.6307 14.8216 - OK XLOC_001401 iPS 1 11.0001 10.5978 18.1197 13.6807 - OK XLOC_001401 hESC 1 3 2.96955 1.96262 1.5251 - OK XLOC_001401 hESC 0 3.00182 3.0326 2.00429 1.55748 - OK XLOC_001401 Fibroblasts 1 0 0 0 0 - OK XLOC_001401 Fibroblasts 0 0 0 0 0 - OK XLOC_001402 iPS 0 33 34.4443 58.8916 16.5798 - OK XLOC_001402 iPS 1 39 37.5735 64.2417 18.086 - OK XLOC_001402 hESC 1 560 554.316 366.356 104.243 - OK XLOC_001402 hESC 0 463 467.747 309.141 87.9633 - OK XLOC_001402 Fibroblasts 1 154 128.498 105.047 29.62 - OK XLOC_001402 Fibroblasts 0 322 383.144 313.221 88.3184 - OK XLOC_001403 iPS 0 1368.5 1428.4 2442.22 3011.68 - OK XLOC_001403 iPS 1 980 944.154 1614.28 1979.64 - OK XLOC_001403 hESC 1 3185 3152.67 2083.65 2740.95 - OK XLOC_001403 hESC 0 4325 4369.35 2887.76 3789.19 - OK XLOC_001403 Fibroblasts 1 1518 1266.62 1035.46 1300.83 - OK XLOC_001403 Fibroblasts 0 1457 1733.67 1417.28 1686.78 - OK XLOC_001404 iPS 0 7.95208 8.30012 14.1912 22.144 - OK XLOC_001404 iPS 1 14.7359 14.1969 24.2733 37.876 - OK XLOC_001404 hESC 1 96.4006 95.4222 63.0659 104.54 - OK XLOC_001404 hESC 0 52.6225 53.162 35.1355 58.2416 - OK XLOC_001404 Fibroblasts 1 133.034 111.003 90.7456 142.83 - OK XLOC_001404 Fibroblasts 0 50.0435 59.5461 48.6791 76.6189 - OK XLOC_001405 iPS 0 195 203.535 347.996 337.313 - OK XLOC_001405 iPS 1 167 160.892 275.086 276.604 - OK XLOC_001405 hESC 1 903 893.835 590.749 604.191 - OK XLOC_001405 hESC 0 804 812.244 536.823 562.013 - OK XLOC_001405 Fibroblasts 1 811 676.698 553.202 539.524 - OK XLOC_001405 Fibroblasts 0 1018.5 1211.9 990.732 971.71 - OK XLOC_001406 iPS 0 181 188.922 323.011 309.283 - OK XLOC_001406 iPS 1 78 75.1469 128.483 119.86 - OK XLOC_001406 hESC 1 603 596.88 394.487 408.742 - OK XLOC_001406 hESC 0 489 494.014 326.501 330.936 - OK XLOC_001406 Fibroblasts 1 2858 2384.71 1949.51 1963.85 - OK XLOC_001406 Fibroblasts 0 1601 1905.01 1557.35 1534.37 - OK XLOC_001407 iPS 0 153 159.696 273.043 202.266 - OK XLOC_001407 iPS 1 172 165.709 283.322 209.881 - OK XLOC_001407 hESC 1 243 240.534 158.972 125.843 - OK XLOC_001407 hESC 0 267 269.738 178.273 143.79 - OK XLOC_001407 Fibroblasts 1 246 205.262 167.802 124.816 - OK XLOC_001407 Fibroblasts 0 215 255.826 209.138 157.817 - OK XLOC_001408 iPS 0 0 0 0 0 - OK XLOC_001408 iPS 1 1 0.963422 1.64722 1.45038 - OK XLOC_001408 hESC 1 0 0 0 0 - OK XLOC_001408 hESC 0 0 0 0 0 - OK XLOC_001408 Fibroblasts 1 0 0 0 0 - OK XLOC_001408 Fibroblasts 0 0 0 0 0 - OK XLOC_001409 iPS 0 1712 1786.93 3055.22 1828.56 - OK XLOC_001409 iPS 1 2426.5 2337.74 3996.99 2360.36 - OK XLOC_001409 hESC 1 3485 3449.63 2279.91 1484.15 - OK XLOC_001409 hESC 0 4117 4159.21 2748.88 1729.48 - OK XLOC_001409 Fibroblasts 1 5400 4505.76 3683.47 2452.58 - OK XLOC_001409 Fibroblasts 0 3806 4528.71 3702.23 2436.37 - OK XLOC_001410 iPS 0 0 0 0 0 - OK XLOC_001410 iPS 1 12 11.5611 19.7667 6.19254 - OK XLOC_001410 hESC 1 22 21.7767 14.3925 5.43831 - OK XLOC_001410 hESC 0 13 13.1333 8.67998 2.61549 - OK XLOC_001410 Fibroblasts 1 0 0 0 0 - OK XLOC_001410 Fibroblasts 0 0 0 0 0 - OK XLOC_001411 iPS 0 5 5.21883 8.92297 4.97795 - OK XLOC_001411 iPS 1 9 8.6708 14.825 8.27077 - OK XLOC_001411 hESC 1 23 22.7666 15.0468 8.25825 - OK XLOC_001411 hESC 0 16 16.1641 10.6831 5.94664 - OK XLOC_001411 Fibroblasts 1 6 5.0064 4.09274 2.29032 - OK XLOC_001411 Fibroblasts 0 9 10.709 8.75463 4.85695 - OK XLOC_001412 iPS 0 133 138.821 237.351 83.6945 - OK XLOC_001412 iPS 1 183 176.306 301.442 112.067 - OK XLOC_001412 hESC 1 434 429.595 283.926 207.294 - OK XLOC_001412 hESC 0 449 453.604 299.793 224.774 - OK XLOC_001412 Fibroblasts 1 1 0.8344 0.682124 0.218329 - OK XLOC_001412 Fibroblasts 0 0 0 0 0 - OK XLOC_001413 iPS 0 0 0 0 0 - OK XLOC_001413 iPS 1 0 0 0 0 - OK XLOC_001413 hESC 1 0 0 0 0 - OK XLOC_001413 hESC 0 0 0 0 0 - OK XLOC_001413 Fibroblasts 1 0 0 0 0 - OK XLOC_001413 Fibroblasts 0 0 0 0 0 - OK XLOC_001414 iPS 0 224 233.804 399.749 228.434 - OK XLOC_001414 iPS 1 102 98.2691 168.017 100.062 - OK XLOC_001414 hESC 1 441 436.524 288.505 165.52 - OK XLOC_001414 hESC 0 367 370.763 245.043 142.875 - OK XLOC_001414 Fibroblasts 1 799 666.685 545.017 315.495 - OK XLOC_001414 Fibroblasts 0 476 566.386 463.022 273.671 - OK cummeRbund/inst/extdata/isoform_exp.diff0000644000175200017520000153222014516004263021476 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 log2(fold_change) test_stat p_value q_value significant TCONS_00000001 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 6.88821 0 -1.79769e+308 -1.79769e+308 0.452757 1 no TCONS_00000002 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 13.1105 0.347386 -5.23803 0.613852 0.539313 1 no TCONS_00000003 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 0.218851 0 -1.79769e+308 -1.79769e+308 0.474414 1 no TCONS_00000004 XLOC_000002 OR4F5 chr1:69090-70008 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000005 XLOC_000003 - chr1:321083-321114 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000006 XLOC_000004 - chr1:321145-321223 iPS hESC OK 0 697259 1.79769e+308 1.79769e+308 0.00857693 0.0438727 yes TCONS_00000007 XLOC_000005 - chr1:322036-328580 iPS hESC OK 189.247 358.383 0.921233 -1.5444 0.12249 0.339492 no TCONS_00000008 XLOC_000005 - chr1:322036-328580 iPS hESC OK 76.6833 338.308 2.14135 -1.44737 0.147794 0.389217 no TCONS_00000009 XLOC_000005 - chr1:322036-328580 iPS hESC OK 89.8931 0.0127652 -12.7818 0.493517 0.621647 0.930687 no TCONS_00000010 XLOC_000006 OR4F16 chr1:367658-368595 iPS hESC NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00000011 XLOC_000007 - chr1:420205-421839 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000012 XLOC_000008 - chr1:566461-568045 iPS hESC NOTEST 41712.9 91983.2 1.14088 -113.525 0 1 no TCONS_00000013 XLOC_000009 - chr1:568148-568842 iPS hESC OK 665.127 6464.44 3.28082 -7.79116 6.66134e-15 4.34444e-13 yes TCONS_00000014 XLOC_000010 - chr1:568843-568912 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000015 XLOC_000011 - chr1:569326-570349 iPS hESC OK 7343.63 31401.9 2.09628 -9.65264 0 0 yes TCONS_00000016 XLOC_000012 - chr1:763063-789740 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000017 XLOC_000012 - chr1:763063-789740 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000018 XLOC_000012 - chr1:763063-789740 iPS hESC OK 0 81.4928 1.79769e+308 1.79769e+308 8.65597e-05 0.000898757 yes TCONS_00000019 XLOC_000012 - chr1:763063-789740 iPS hESC OK 40.7706 0 -1.79769e+308 -1.79769e+308 0.236496 0.530147 no TCONS_00000020 XLOC_000012 - chr1:763063-789740 iPS hESC OK 80.8625 100.78 0.317668 -0.579894 0.561986 0.87656 no TCONS_00000021 XLOC_000013 - chr1:791897-794579 iPS hESC OK 8.98318 28.2795 1.65446 -2.50677 0.012184 0.0589978 no TCONS_00000022 XLOC_000014 - chr1:846814-850328 iPS hESC OK 8.69571 27.5823 1.66536 -2.60317 0.00923651 0.0467879 yes TCONS_00000023 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 95.4282 0 -1.79769e+308 -1.79769e+308 0.357743 0.681214 no TCONS_00000024 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 52.9724 1.74761 -4.92178 0.637194 0.523999 0.844518 no TCONS_00000025 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 48.0828 4.50533 -3.41582 0.961307 0.336398 0.658595 no TCONS_00000026 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 63.5773 180.736 1.5073 -2.35201 0.0186723 0.0811857 no TCONS_00000027 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 55.6229 151.63 1.44681 -1.19456 0.23226 0.523463 no TCONS_00000028 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 29.3795 229.433 2.96519 -2.42565 0.0152811 0.0693295 no TCONS_00000029 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 34.9548 180.118 2.36538 -1.58829 0.112222 0.322155 no TCONS_00000030 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC OK 6.18605 13.3791 1.11289 -1.46733 0.142286 0.378281 no TCONS_00000031 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC OK 0.000108087 9.40489 16.4089 -0.00120417 0.999039 0.999997 no TCONS_00000032 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000033 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC OK 550.84 987.18 0.84168 -1.85219 0.0639988 0.210671 no TCONS_00000034 XLOC_000019 AGRN chr1:955502-991492 iPS hESC OK 162.844 1857.6 3.51188 -10.5984 0 0 yes TCONS_00000035 XLOC_000020 - chr1:995082-1001833 iPS hESC NOTEST 2.60573 3.11297 0.256603 -0.0847259 0.932479 1 no TCONS_00000036 XLOC_000020 - chr1:995082-1001833 iPS hESC OK 19.9887 28.951 0.534431 -0.773986 0.438939 0.763873 no TCONS_00000037 XLOC_000021 - chr1:1072396-1079432 iPS hESC NOTEST 0 1.64828 1.79769e+308 1.79769e+308 0.0567344 1 no TCONS_00000038 XLOC_000022 - chr1:1102483-1102578 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000039 XLOC_000023 - chr1:1103242-1103332 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000040 XLOC_000024 - chr1:1104384-1104467 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000041 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC OK 0 9.72146 1.79769e+308 1.79769e+308 0.000106203 0.00106991 yes TCONS_00000042 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 0.00267487 1.79769e+308 1.79769e+308 0.497608 1 no TCONS_00000043 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 6.97279 1.79769e+308 1.79769e+308 0.00246227 1 no TCONS_00000044 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS hESC OK 223.432 276.214 0.305947 -0.778231 0.436433 0.762206 no TCONS_00000045 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 2.57257 1.79769e+308 1.79769e+308 0.138957 1 no TCONS_00000046 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 8.76366 11.929 0.44487 -0.598104 0.54977 0.863424 no TCONS_00000047 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 0.000995546 25.3683 14.6372 -0.0100687 0.991967 0.999997 no TCONS_00000048 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 4.36667 1.79769e+308 1.79769e+308 0.0674182 1 no TCONS_00000049 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 0 30.4263 1.79769e+308 1.79769e+308 3.03824e-06 4.84031e-05 yes TCONS_00000050 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 253.688 666.825 1.39425 -1.4279 0.153321 0.396445 no TCONS_00000051 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 81.6371 108.47 0.410003 -0.235793 0.813593 0.999997 no TCONS_00000052 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 21.1644 14.7123 -0.524619 0.131747 0.895185 0.999997 no TCONS_00000053 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC OK 140.404 187.156 0.414652 -0.925142 0.354892 0.679505 no TCONS_00000054 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC NOTEST 6.25639 2.57898 -1.27853 1.50397 0.132589 1 no TCONS_00000055 XLOC_000031 - chr1:1334909-1342693 iPS hESC NOTEST 53.2662 152.655 1.51899 -0.741897 0.45815 1 no TCONS_00000056 XLOC_000031 - chr1:1334909-1342693 iPS hESC OK 95.5427 92.5876 -0.0453264 0.0351452 0.971964 0.999997 no TCONS_00000057 XLOC_000031 - chr1:1334909-1342693 iPS hESC OK 103.752 308.066 1.57009 -1.25001 0.211296 0.486728 no TCONS_00000058 XLOC_000032 - chr1:1361507-1363166 iPS hESC OK 7.20193 59.0363 3.03515 -2.01569 0.0438326 0.15691 no TCONS_00000059 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC OK 5.8712 58.9274 3.32721 -0.536267 0.591774 0.906113 no TCONS_00000060 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC OK 222.846 469.362 1.07466 -2.63 0.00853858 0.0437838 yes TCONS_00000061 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC OK 12.4598 69.2663 2.47488 -4.24277 2.20774e-05 0.000280948 yes TCONS_00000062 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 117.436 409.377 1.80156 -2.4613 0.0138435 0.0645899 no TCONS_00000063 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 77.2479 111.183 0.525371 -0.501154 0.616263 0.92719 no TCONS_00000064 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 202.814 138.44 -0.550889 0.914385 0.360514 0.682753 no TCONS_00000065 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 35.8479 321.282 3.16388 -1.35368 0.175839 0.431532 no TCONS_00000066 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC OK 31.4583 54.4924 0.792616 -0.421243 0.673578 0.962188 no TCONS_00000067 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 470.224 790.187 0.748847 -1.83511 0.0664896 1 no TCONS_00000068 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 100.608 542.034 2.42964 -2.70315 0.00686854 1 no TCONS_00000069 XLOC_000036 - chr1:1447554-1470064 iPS hESC OK 18.499 25.8427 0.482305 -0.220831 0.825224 0.999997 no TCONS_00000070 XLOC_000037 - chr1:1535818-1543166 iPS hESC OK 2.79141 10.6728 1.93487 -1.28059 0.200338 0.473507 no TCONS_00000071 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 13.0332 0.00352987 -11.8503 0.0946862 0.924564 1 no TCONS_00000072 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 9.17877 86.1128 3.22986 -2.04932 0.0404306 0.149343 no TCONS_00000073 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 4.48044 1.79769e+308 1.79769e+308 0.24101 1 no TCONS_00000074 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 28.9547 100.346 1.79312 -2.2638 0.0235863 0.097282 no TCONS_00000075 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000076 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 4.60985 37.6352 3.02929 -1.15925 0.246354 0.544064 no TCONS_00000077 XLOC_000038 - chr1:1550883-1565984 iPS hESC OK 0.0361283 26.2154 9.50307 -0.266707 0.789695 0.999997 no TCONS_00000078 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 3.88743 1.79769e+308 1.79769e+308 0.139724 1 no TCONS_00000079 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 0 100.348 1.79769e+308 1.79769e+308 6.18945e-08 1.40406e-06 yes TCONS_00000080 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 12.0776 0 -1.79769e+308 -1.79769e+308 0.194388 1 no TCONS_00000081 XLOC_000038 - chr1:1550883-1565984 iPS hESC OK 20.1981 217.26 3.42713 -0.793207 0.427657 0.755093 no TCONS_00000082 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC OK 3.14247 33.88 3.43046 -1.61667 0.105949 0.308389 no TCONS_00000083 XLOC_000039 - chr1:1567559-1570029 iPS hESC OK 9.57879 23.6518 1.30403 -1.37264 0.169865 0.424054 no TCONS_00000084 XLOC_000039 - chr1:1567559-1570029 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000085 XLOC_000039 - chr1:1567559-1570029 iPS hESC OK 0.730004 9.67624 3.72847 -0.514442 0.606943 0.922571 no TCONS_00000086 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 0 73.9259 1.79769e+308 1.79769e+308 0.128822 0.352362 no TCONS_00000087 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 19.4885 18.0861 -0.107739 0.020834 0.983378 0.999997 no TCONS_00000088 XLOC_000041 - chr1:1571099-1677431 iPS hESC OK 65.0308 78.5208 0.271951 -0.146899 0.883212 0.999997 no TCONS_00000089 XLOC_000042 - chr1:1822909-1824112 iPS hESC NOTEST 4.99201 3.15678 -0.661169 0.445901 0.655669 1 no TCONS_00000090 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC OK 5.39767 26.9908 2.32206 -2.21879 0.0265012 0.10555 no TCONS_00000091 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC OK 12.037 41.7053 1.79275 -2.92395 0.0034562 0.0200922 yes TCONS_00000092 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 199.815 833.609 2.0607 -3.75242 0.000175133 0.00161727 yes TCONS_00000093 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000094 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000095 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 94.566 60.5588 -0.642985 0.508906 0.610818 0.925093 no TCONS_00000096 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000097 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 5.19072 3.07856 -0.75368 0.0369448 0.970529 1 no TCONS_00000098 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 0 14.6847 1.79769e+308 1.79769e+308 0.238827 0.533652 no TCONS_00000099 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 7.19324 17.4198 1.27601 -0.157234 0.87506 0.999997 no TCONS_00000100 XLOC_000045 - chr1:1981908-2139172 iPS hESC OK 16.6051 54.9905 1.72756 -0.655703 0.512015 0.830734 no TCONS_00000101 XLOC_000046 - chr1:1981908-2139172 iPS hESC OK 66.2174 109.688 0.728127 -0.674534 0.499972 0.817744 no TCONS_00000102 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC OK 246.057 740.008 1.58855 -4.88907 1.01312e-06 1.87114e-05 yes TCONS_00000103 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC OK 800.086 772.363 -0.0508767 0.162241 0.871116 0.999997 no TCONS_00000104 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC OK 33.4962 30.1072 -0.153891 0.076269 0.939205 0.999997 no TCONS_00000105 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 1.11603 1.79769e+308 1.79769e+308 0.046878 1 no TCONS_00000106 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000107 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 6.36609e-05 1.79769e+308 1.79769e+308 0.499898 1 no TCONS_00000108 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 2.28814e-05 0 -1.79769e+308 -1.79769e+308 0.499982 1 no TCONS_00000109 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 1.08359 1.19958 0.146708 -0.105028 0.916353 1 no TCONS_00000110 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 1.2132 0 -1.79769e+308 -1.79769e+308 0.274622 1 no TCONS_00000111 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 21.3399 0.103287 -7.69076 0.331283 0.740431 1 no TCONS_00000112 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 4.50144 1.72115 -1.38702 0.425006 0.670833 1 no TCONS_00000113 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 2.02513 0.4903 -2.04628 0.832791 0.404962 1 no TCONS_00000114 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 20.3741 0 -1.79769e+308 -1.79769e+308 0.101844 1 no TCONS_00000115 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 0 1.45201 1.79769e+308 1.79769e+308 0.164535 1 no TCONS_00000116 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 222.585 431.86 0.956207 -1.53422 0.124976 0.345462 no TCONS_00000117 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 0 36.9813 1.79769e+308 1.79769e+308 0.00450519 0.0251337 yes TCONS_00000118 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 147.391 327.266 1.15082 -1.52234 0.127924 0.350365 no TCONS_00000119 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000120 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 20.6279 15.5461 -0.408049 0.20872 0.834667 0.999997 no TCONS_00000121 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000122 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 48.0815 46.1049 -0.0605623 0.0438589 0.965017 0.999997 no TCONS_00000123 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000124 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.586072 4.52426 2.94853 -2.04977 0.0403869 1 no TCONS_00000125 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.00101879 0 -1.79769e+308 -1.79769e+308 0.498566 1 no TCONS_00000126 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.419018 0.770522 0.878825 -0.363159 0.716486 1 no TCONS_00000127 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.000730027 0 -1.79769e+308 -1.79769e+308 0.498972 1 no TCONS_00000128 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 0.000653284 0 -1.79769e+308 -1.79769e+308 0.49908 1 no TCONS_00000129 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 135.254 229.313 0.761647 -1.65559 0.0978046 0.288303 no TCONS_00000130 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 0 60.5958 1.79769e+308 1.79769e+308 0.000147716 0.00140129 yes TCONS_00000131 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 23.0853 60.018 1.37842 -0.746526 0.45535 0.782797 no TCONS_00000132 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 8.08924 11.6052 0.520697 -0.108226 0.913816 0.999997 no TCONS_00000133 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 5.86138 1.79769e+308 1.79769e+308 0.177621 1 no TCONS_00000134 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC OK 546.504 498.776 -0.131839 0.384888 0.700321 0.976699 no TCONS_00000135 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000136 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 4.13128 0 -1.79769e+308 -1.79769e+308 0.197324 1 no TCONS_00000137 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC OK 5.30242 63.3435 3.57848 -3.94236 8.06837e-05 0.000848878 yes TCONS_00000138 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 1.53994 5.31366 1.78683 -0.693857 0.487772 1 no TCONS_00000139 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000140 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 4.94475 1.79769e+308 1.79769e+308 0.0476228 1 no TCONS_00000141 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0.0344885 1.79769e+308 1.79769e+308 0.463424 1 no TCONS_00000142 XLOC_000056 - chr1:3569128-3650467 iPS hESC NOTEST 3.71815 0.585598 -2.6666 0.662621 0.507574 1 no TCONS_00000143 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000144 XLOC_000056 - chr1:3569128-3650467 iPS hESC NOTEST 0 0.923281 1.79769e+308 1.79769e+308 0.436398 1 no TCONS_00000145 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC NOTEST 0.580625 2.99279 2.36581 -1.09786 0.272267 1 no TCONS_00000146 XLOC_000058 - chr1:3689351-3692545 iPS hESC OK 29.1182 76.8718 1.40054 -1.91184 0.0558967 0.18907 no TCONS_00000147 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000148 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000149 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 4.80895 1.79769e+308 1.79769e+308 0.290423 1 no TCONS_00000150 XLOC_000059 CAD chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000151 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC OK 62.8589 86.6597 0.463245 -0.872812 0.382766 0.708393 no TCONS_00000152 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 6.55552 0 -1.79769e+308 -1.79769e+308 0.283406 1 no TCONS_00000153 XLOC_000059 CAD chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000154 XLOC_000059 CAD chr1:3773844-3801992 iPS hESC NOTEST 3.55215 5.5449 0.642467 -0.119879 0.904579 1 no TCONS_00000155 XLOC_000059 CAD chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000156 XLOC_000059 CAD chr1:3773844-3801992 iPS hESC OK 0 14.4431 1.79769e+308 1.79769e+308 0.00240005 0.0146376 yes TCONS_00000157 XLOC_000059 DFFB chr1:3773844-3801992 iPS hESC NOTEST 0.00638818 8.65205 10.4034 -0.0556033 0.955658 1 no TCONS_00000158 XLOC_000060 - chr1:3816967-3833877 iPS hESC NOTEST 5.25796 0.672575 -2.96674 0.992731 0.320841 1 no TCONS_00000159 XLOC_000060 - chr1:3816967-3833877 iPS hESC OK 0.0100414 14.4718 10.4931 -0.0332975 0.973437 0.999997 no TCONS_00000160 XLOC_000060 - chr1:3816967-3833877 iPS hESC OK 1.6192 9.81514 2.59973 -1.04824 0.294528 0.612231 no TCONS_00000161 XLOC_000061 - chr1:4000676-4015322 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000162 XLOC_000062 - chr1:4472110-4484744 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000163 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC OK 25.884 24.6786 -0.0688053 0.0444575 0.96454 0.999997 no TCONS_00000164 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC OK 78.56 49.2798 -0.672797 1.16831 0.242683 0.539957 no TCONS_00000165 XLOC_000064 - chr1:4847557-4852182 iPS hESC OK 37.4079 18.1722 -1.04161 1.94277 0.0520441 0.178059 no TCONS_00000166 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 7.70132 20.2988 1.39822 -0.656659 0.5114 0.830734 no TCONS_00000167 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 4.70189 14.9138 1.66533 -0.563753 0.572922 0.885696 no TCONS_00000168 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 4.61083 0 -1.79769e+308 -1.79769e+308 0.357727 1 no TCONS_00000169 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 48.7059 95.0662 0.964836 -1.56572 0.117415 0.332489 no TCONS_00000170 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 3.9331 0.784025 -2.32669 0.451068 0.651941 1 no TCONS_00000171 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 3.90167 0.706557 -2.46521 0.41716 0.676561 1 no TCONS_00000172 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 1.06639 0 -1.79769e+308 -1.79769e+308 0.346997 1 no TCONS_00000173 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 11.3399 12.8983 0.185776 -0.0358069 0.971436 0.999997 no TCONS_00000174 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 37.9114 28.2454 -0.424615 0.2084 0.834917 0.999997 no TCONS_00000175 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 15.3246 17.0218 0.151531 -0.0142087 0.988663 0.999997 no TCONS_00000176 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 13.014 17.9047 0.460274 -0.0359132 0.971352 0.999997 no TCONS_00000177 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS hESC OK 56.5093 132.225 1.22643 -2.33032 0.0197893 0.08498 no TCONS_00000178 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC OK 435.49 1431.61 1.71693 -3.72325 0.000196678 0.00179243 yes TCONS_00000179 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 7.69434 20.3609 1.40393 -1.49018 0.136178 0.368616 no TCONS_00000180 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 11.3056 157.325 3.79864 -3.70316 0.000212931 0.00192375 yes TCONS_00000181 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 1.5274 0.605201 -1.33559 0.609435 0.542236 1 no TCONS_00000182 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 2.01343 0.10991 -4.19526 0.585451 0.558245 1 no TCONS_00000183 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 0 0.536804 1.79769e+308 1.79769e+308 0.325344 1 no TCONS_00000184 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 0.00440741 0 -1.79769e+308 -1.79769e+308 0.498413 1 no TCONS_00000185 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC OK 69.0214 15.0088 -2.20124 2.13634 0.0326517 0.125959 no TCONS_00000186 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC OK 60.0558 78.4398 0.385281 -0.442493 0.658133 0.954318 no TCONS_00000187 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC OK 28.5408 147.658 2.37116 -1.76837 0.0769987 0.242012 no TCONS_00000188 XLOC_000071 - chr1:6640055-6649339 iPS hESC OK 23.546 85.1502 1.85453 -1.33781 0.18096 0.440167 no TCONS_00000189 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC OK 277.454 660.096 1.25043 -3.53483 0.00040804 0.00333953 yes TCONS_00000190 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 69.7903 126.801 0.861471 -0.401954 0.687718 0.96893 no TCONS_00000191 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 27.7067 87.2395 1.65475 -0.378592 0.704991 0.978979 no TCONS_00000192 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 7.22222 19.5526 1.43685 -0.135009 0.892605 0.999997 no TCONS_00000193 XLOC_000074 - chr1:6845383-7829763 iPS hESC OK 1270.29 1433.01 0.173891 -0.434366 0.664023 0.957553 no TCONS_00000194 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 4.74737 8.2803 0.802554 -0.4385 0.661024 1 no TCONS_00000195 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC OK 8.87986 26.1246 1.5568 -0.726538 0.467509 0.792342 no TCONS_00000196 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000197 XLOC_000074 - chr1:6845383-7829763 iPS hESC NOTEST 1.762 0 -1.79769e+308 -1.79769e+308 0.464256 1 no TCONS_00000198 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC NOTEST 1500.64 502.334 -1.57886 5.54278 2.9771e-08 1 no TCONS_00000199 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 54.7294 7.32764 -2.9009 1.23878 0.215426 0.492976 no TCONS_00000200 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 13.107 0 -1.79769e+308 -1.79769e+308 0.315751 1 no TCONS_00000201 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 26.7829 47.2457 0.818869 -0.313421 0.753961 1 no TCONS_00000202 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 42.7797 7.06457 -2.59825 2.53795 0.0111504 0.0547548 no TCONS_00000203 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 139.727 53.7103 -1.37934 2.69854 0.00696444 0.0366116 yes TCONS_00000204 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 14.3316 2.51904 -2.50825 1.12376 0.261115 1 no TCONS_00000205 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 57.799 27.1603 -1.08954 0.479851 0.631333 0.937788 no TCONS_00000206 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 3958.08 6020.73 0.605139 -2.09362 0.0362936 0.137718 no TCONS_00000207 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 34.9676 35.935 0.0393693 -0.00554815 0.995573 0.999997 no TCONS_00000208 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 626.306 2349.66 1.90751 -2.57377 0.0100596 0.0503463 no TCONS_00000209 XLOC_000077 - chr1:8021713-8045341 iPS hESC OK 26.021 14.3833 -0.855286 0.296682 0.766709 0.999997 no TCONS_00000210 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 1.80448 29.7198 4.04176 -2.3049 0.0211723 0.0885504 no TCONS_00000211 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 9.62868 9.9298 0.0444265 -0.0464149 0.96298 0.999997 no TCONS_00000212 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000213 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000214 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC OK 137.324 93.0165 -0.562028 1.6203 0.105167 0.307399 no TCONS_00000215 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC OK 70.5381 18.3153 -1.94535 3.00918 0.00261955 0.0158006 yes TCONS_00000216 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC OK 17.2656 67.8157 1.97372 -1.56671 0.117183 0.332284 no TCONS_00000217 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC OK 216.702 207.722 -0.0610578 0.125179 0.900382 0.999997 no TCONS_00000218 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC OK 0 21.5619 1.79769e+308 1.79769e+308 0.256612 0.558976 no TCONS_00000219 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC OK 68.1769 171.51 1.33094 -2.32755 0.0199362 0.0853779 no TCONS_00000220 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC OK 54.5583 230.871 2.08121 -3.25299 0.00114196 0.00794421 yes TCONS_00000221 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 42.5258 260.118 2.61276 -2.1588 0.0308659 0.119734 no TCONS_00000222 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 132.845 155.927 0.231123 -0.359322 0.719354 0.984819 no TCONS_00000223 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 17.0706 25.5368 0.581065 -0.3318 0.74004 0.996295 no TCONS_00000224 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC OK 61.6068 39.4422 -0.643349 1.29478 0.195395 0.464983 no TCONS_00000225 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC OK 115.178 229.575 0.995102 -1.81996 0.0687653 0.223193 no TCONS_00000226 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000227 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC OK 515.733 1102.07 1.09553 -3.94881 7.85416e-05 0.000832063 yes TCONS_00000228 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC OK 15.4936 20.3244 0.391544 -0.235287 0.813986 0.999997 no TCONS_00000229 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000230 XLOC_000087 - chr1:10093015-10241294 iPS hESC NOTEST 0 4.50396 1.79769e+308 1.79769e+308 0.228983 1 no TCONS_00000231 XLOC_000087 - chr1:10093015-10241294 iPS hESC OK 171.613 10.087 -4.08858 0.965569 0.33426 0.655023 no TCONS_00000232 XLOC_000087 - chr1:10093015-10241294 iPS hESC OK 7.8499 10.3213 0.39488 -0.0346866 0.97233 0.999997 no TCONS_00000233 XLOC_000088 - chr1:10270763-10441659 iPS hESC NOTEST 3.41691 2.25564 -0.599155 0.0078892 0.993705 1 no TCONS_00000234 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 419.379 196.401 -1.09445 3.04812 0.00230279 0.0140936 yes TCONS_00000235 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 410.895 346.933 -0.244114 0.840127 0.400837 0.72929 no TCONS_00000236 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 1.09608 1.79769e+308 1.79769e+308 0.390853 1 no TCONS_00000237 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 3.19143 1.79769e+308 1.79769e+308 0.188503 1 no TCONS_00000238 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000239 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000240 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 76.9201 87.5644 0.186983 -0.177865 0.858829 0.999997 no TCONS_00000241 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC OK 1337.23 6778.74 2.34177 -8.23841 2.22045e-16 2.1064e-14 yes TCONS_00000242 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000243 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC OK 74.0847 402.424 2.44147 -1.68322 0.0923328 0.274891 no TCONS_00000244 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 5.58516 2.2212 -1.33026 0.0599717 0.952178 1 no TCONS_00000245 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC OK 67.0275 84.7865 0.339082 -0.335979 0.736887 0.994107 no TCONS_00000246 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC NOTEST 6.3006 0 -1.79769e+308 -1.79769e+308 0.412825 1 no TCONS_00000247 XLOC_000090 Cort chr1:10490158-10512208 iPS hESC OK 5.24611 9.52176 0.85998 -0.0957261 0.923738 0.999997 no TCONS_00000248 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC OK 172.607 138.152 -0.321231 0.570177 0.568558 0.882379 no TCONS_00000249 XLOC_000090 CORT chr1:10490158-10512208 iPS hESC OK 33.6985 27.3151 -0.302989 0.180451 0.856799 0.999997 no TCONS_00000250 XLOC_000091 Pex14 chr1:10535002-10690813 iPS hESC OK 31.0581 65.6226 1.07922 -0.246706 0.805135 0.999997 no TCONS_00000251 XLOC_000091 Pex14 chr1:10535002-10690813 iPS hESC OK 30.027 6.4866 -2.21073 1.04472 0.296153 0.614385 no TCONS_00000252 XLOC_000091 Pex14 chr1:10535002-10690813 iPS hESC NOTEST 18.0364 7.51008 -1.26401 0.393342 0.694067 1 no TCONS_00000253 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC OK 173.496 598.647 1.7868 -3.9015 9.55973e-05 0.000977998 yes TCONS_00000254 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000255 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000256 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000257 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000258 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC NOTEST 1888.95 2365.52 0.324571 -1.53394 0.125044 1 no TCONS_00000259 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC OK 30.0352 35.6818 0.248533 -0.127573 0.898487 0.999997 no TCONS_00000260 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC OK 25.3243 0.912846 -4.794 0.836862 0.40267 0.730692 no TCONS_00000261 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC OK 358.008 307.383 -0.219953 0.645793 0.518413 0.838054 no TCONS_00000262 XLOC_000095 - chr1:11539294-11597639 iPS hESC OK 22.631 12.7281 -0.830284 0.467764 0.639953 0.941878 no TCONS_00000263 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC OK 14.6751 61.7115 2.07216 -3.08049 0.00206663 0.0127605 yes TCONS_00000264 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC NOTEST 12.3118 0 -1.79769e+308 -1.79769e+308 0.121771 1 no TCONS_00000265 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 0 18.7336 1.79769e+308 1.79769e+308 0.0417729 0.15268 no TCONS_00000266 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 41.3995 143.48 1.79316 -0.602746 0.546678 0.860419 no TCONS_00000267 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 74.4128 158.642 1.09215 -1.42856 0.15313 0.396445 no TCONS_00000268 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 0 59.0165 1.79769e+308 1.79769e+308 0.0178035 0.0778951 no TCONS_00000269 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 55.1609 131.185 1.24989 -1.21592 0.224017 0.509839 no TCONS_00000270 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC NOTEST 0 5.92521 1.79769e+308 1.79769e+308 0.361665 1 no TCONS_00000271 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 0.00708472 42.0022 12.5335 -0.0638449 0.949094 0.999997 no TCONS_00000272 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC OK 77.8716 25.5712 -1.60658 2.97333 0.00294584 0.017616 yes TCONS_00000273 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC OK 200.894 340.257 0.760192 -1.7535 0.079517 0.24806 no TCONS_00000274 XLOC_000099 - chr1:11782186-11785914 iPS hESC OK 138.448 209.081 0.594715 -1.45467 0.14576 0.385886 no TCONS_00000275 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 107.513 212.87 0.985456 -0.622065 0.533899 0.84758 no TCONS_00000276 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 75.7885 48.0216 -0.658296 0.282614 0.777473 0.999997 no TCONS_00000277 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 326.456 1078.57 1.72416 -2.29567 0.021695 0.0905549 no TCONS_00000278 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 238.184 261.965 0.137295 -0.180129 0.857051 0.999997 no TCONS_00000279 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC NOTEST 0 9.26798 1.79769e+308 1.79769e+308 0.287517 1 no TCONS_00000280 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS hESC NOTEST 4.69748 3.47934 -0.433073 0.2486 0.80367 1 no TCONS_00000281 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 0 2.18711 1.79769e+308 1.79769e+308 0.240981 1 no TCONS_00000282 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 1.75837 2.17987 0.310008 -0.0426967 0.965943 1 no TCONS_00000283 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 22.1488 0.995584 -4.47554 0.852483 0.393946 1 no TCONS_00000284 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 7.96239 1.79769e+308 1.79769e+308 0.256685 1 no TCONS_00000285 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 4.86566 4.82023 -0.0135349 0.000515062 0.999589 1 no TCONS_00000286 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC OK 14.401 18.414 0.354638 -0.0716007 0.94292 0.999997 no TCONS_00000287 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 108.07 325.683 1.5915 -3.96863 7.22874e-05 1 no TCONS_00000288 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0.0423122 0.0955929 1.17583 -0.0526844 0.957983 1 no TCONS_00000289 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000290 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 0 8.28757 1.79769e+308 1.79769e+308 0.235002 1 no TCONS_00000291 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 3.15242 0 -1.79769e+308 -1.79769e+308 0.40462 1 no TCONS_00000292 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000293 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000294 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000295 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 3.25401 0 -1.79769e+308 -1.79769e+308 0.404659 1 no TCONS_00000296 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC OK 849.538 954.766 0.16847 -0.512305 0.608438 0.923533 no TCONS_00000297 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC NOTEST 16.0046 1.78544 -3.16414 0.346114 0.729257 1 no TCONS_00000298 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC OK 578.223 790.606 0.451333 -1.36036 0.173717 0.427814 no TCONS_00000299 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC OK 68.8548 151.46 1.1373 -0.629426 0.52907 0.847406 no TCONS_00000300 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC OK 504.143 1223.51 1.27913 -3.41913 0.000628221 0.00471618 yes TCONS_00000301 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC OK 178.549 413.544 1.21172 -2.95296 0.00314738 0.0185031 yes TCONS_00000302 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC OK 19.3321 18.4204 -0.0696942 0.0336212 0.973179 0.999997 no TCONS_00000303 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 0 9.03791 1.79769e+308 1.79769e+308 0.124497 1 no TCONS_00000304 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 6.44015 0 -1.79769e+308 -1.79769e+308 0.409812 1 no TCONS_00000305 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC OK 0 28.1716 1.79769e+308 1.79769e+308 1.64047e-12 8.15156e-11 yes TCONS_00000306 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC NOTEST 0.000432929 5.69324 13.6828 -0.00576634 0.995399 1 no TCONS_00000307 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC NOTEST 15.3502 0 -1.79769e+308 -1.79769e+308 0.00219283 1 no TCONS_00000308 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC NOTEST 12.8407 0 -1.79769e+308 -1.79769e+308 0.162096 1 no TCONS_00000309 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 315.192 71.9285 -2.13159 7.84222 4.44089e-15 3.08938e-13 yes TCONS_00000310 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 19.4784 66.1936 1.76482 -1.4902 0.136171 0.368616 no TCONS_00000311 XLOC_000109 - chr1:12290112-12572096 iPS hESC OK 39.9995 0 -1.79769e+308 -1.79769e+308 0.188331 0.453341 no TCONS_00000312 XLOC_000109 - chr1:12290112-12572096 iPS hESC OK 0 20.135 1.79769e+308 1.79769e+308 0.00200718 0.0126174 yes TCONS_00000313 XLOC_000109 - chr1:12290112-12572096 iPS hESC NOTEST 0 4.58204 1.79769e+308 1.79769e+308 0.140422 1 no TCONS_00000314 XLOC_000110 SNORA59B chr1:12290112-12572096 iPS hESC OK 452.443 234.664 -0.947137 0.0823227 0.93439 0.999997 no TCONS_00000315 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC NOTEST 0.911079 1.34969 0.566981 -0.252834 0.800396 1 no TCONS_00000316 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC NOTEST 8.82724 1.92876 -2.19429 1.30325 0.192491 1 no TCONS_00000317 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC OK 47.604 8.12602 -2.55046 4.40334 1.06599e-05 0.000147332 yes TCONS_00000318 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC NOTEST 1.78172 0.698209 -1.35154 0.340018 0.733843 1 no TCONS_00000319 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC NOTEST 5.40803e-05 0.592256 13.4188 -0.000172498 0.999862 1 no TCONS_00000320 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC NOTEST 3.60576 0.853096 -2.07952 1.38146 0.167139 1 no TCONS_00000321 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TCONS_00000322 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000323 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000324 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000325 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no TCONS_00000326 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TCONS_00000327 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000328 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000329 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000330 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TCONS_00000331 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC NOTEST 0 0.330232 1.79769e+308 1.79769e+308 0.240869 1 no TCONS_00000332 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000333 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC OK 695.717 816.633 0.231188 -0.620786 0.53474 0.848026 no TCONS_00000334 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC OK 602.018 879.809 0.547383 -1.36302 0.172875 0.42697 no TCONS_00000335 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 6.91549 1.79769e+308 1.79769e+308 0.25743 1 no TCONS_00000336 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000337 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000338 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000339 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 0 12.8679 1.79769e+308 1.79769e+308 0.0262866 0.105096 no TCONS_00000340 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 47.3072 9.21056 -2.3607 2.70488 0.00683282 0.0361015 yes TCONS_00000341 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 14.792 20.5972 0.477626 -0.376439 0.706591 0.979837 no TCONS_00000342 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 1.65694 1.79769e+308 1.79769e+308 0.351997 1 no TCONS_00000343 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 4.006 0 -1.79769e+308 -1.79769e+308 0.472753 1 no TCONS_00000344 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 173.834 111.179 -0.64482 1.59859 0.109912 0.317096 no TCONS_00000345 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0.921398 1.79769e+308 1.79769e+308 0.430702 1 no TCONS_00000346 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000347 XLOC_000128 - chr1:14026734-14151572 iPS hESC NOTEST 3.13048 0.709477 -2.14156 0.523295 0.600769 1 no TCONS_00000348 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 48.9164 45.0754 -0.117978 0.191814 0.847888 0.999997 no TCONS_00000349 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 2.81237 0 -1.79769e+308 -1.79769e+308 0.378057 1 no TCONS_00000350 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 0 9.84787 1.79769e+308 1.79769e+308 0.00171649 0.0111481 yes TCONS_00000351 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 1.99898 19.5662 3.29103 -0.45617 0.648268 0.947048 no TCONS_00000352 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000353 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 5.70387 0 -1.79769e+308 -1.79769e+308 0.275728 1 no TCONS_00000354 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 0 79.6627 1.79769e+308 1.79769e+308 5.00434e-11 1.8007e-09 yes TCONS_00000355 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 7.67766 5.19027 -0.564859 0.314148 0.753409 1 no TCONS_00000356 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC NOTEST 14.7555 0.0170528 -9.75703 0.225247 0.821787 1 no TCONS_00000357 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC NOTEST 29.1579 68.8043 1.23861 -0.974117 0.329998 1 no TCONS_00000358 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 0 17.2845 1.79769e+308 1.79769e+308 0.0138936 0.0645899 no TCONS_00000359 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 67.688 40.9662 -0.724467 0.869792 0.384414 0.708393 no TCONS_00000360 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 33.4567 105.307 1.65423 -1.56022 0.118709 0.334735 no TCONS_00000361 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 3.59181 6.18974 0.785167 -1.07098 0.28418 1 no TCONS_00000362 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 2.21856 1.79489 -0.305726 0.247618 0.80443 1 no TCONS_00000363 XLOC_000131 - chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000364 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000365 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 0 0.429055 1.79769e+308 1.79769e+308 0.297657 1 no TCONS_00000366 XLOC_000131 - chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000367 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC OK 330.754 468.604 0.502608 -1.33415 0.182153 0.442554 no TCONS_00000368 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC NOTEST 3.36755e-05 0 -1.79769e+308 -1.79769e+308 0.499996 1 no TCONS_00000369 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC NOTEST 2.23634 0 -1.79769e+308 -1.79769e+308 0.300879 1 no TCONS_00000370 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000371 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC NOTEST 0 1.27477 1.79769e+308 1.79769e+308 0.352721 1 no TCONS_00000372 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC OK 108.544 22.5422 -2.26758 2.03125 0.0422298 0.153543 no TCONS_00000373 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC OK 264.402 106.224 -1.31563 3.46564 0.000528976 0.0041193 yes TCONS_00000374 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC NOTEST 92.0125 24.4409 -1.91253 2.5485 0.0108186 1 no TCONS_00000375 XLOC_000136 - chr1:15853351-15918872 iPS hESC NOTEST 6.69281 1.81648 -1.88147 0.24849 0.803755 1 no TCONS_00000376 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC OK 45.7332 1.92594 -4.5696 0.966593 0.333747 0.654634 no TCONS_00000377 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC OK 439.099 268.762 -0.70822 1.39664 0.162523 0.411115 no TCONS_00000378 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000379 XLOC_000137 RSC1A1 chr1:15944069-15988216 iPS hESC OK 534.708 259.157 -1.04493 2.32224 0.0202201 0.0861036 no TCONS_00000380 XLOC_000138 - chr1:15992765-15995535 iPS hESC OK 252.085 304.42 0.27215 -0.705422 0.480548 0.798034 no TCONS_00000381 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC OK 363.264 779.207 1.10099 -3.38248 0.000718357 0.00531083 yes TCONS_00000382 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC NOTEST 6.39779 8.64356 0.434052 -0.610088 0.541804 1 no TCONS_00000383 XLOC_000140 - chr1:16062808-16067885 iPS hESC NOTEST 2.07297 0.000570561 -11.827 0.0077785 0.993794 1 no TCONS_00000384 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC OK 11.5611 31.4534 1.44394 -2.25831 0.0239262 0.0984892 no TCONS_00000385 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 17.9129 28.622 0.676129 -0.286547 0.774459 0.999997 no TCONS_00000386 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 565.849 821.848 0.538455 -1.58086 0.11391 0.326553 no TCONS_00000387 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000388 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 55.3931 23.593 -1.23135 0.460168 0.645396 0.945885 no TCONS_00000389 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 256.047 85.4176 -1.5838 2.43376 0.014943 0.068541 no TCONS_00000390 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 145.636 241.251 0.72817 -2.02925 0.0424326 0.153903 no TCONS_00000391 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 40.228 140.357 1.80283 -2.58447 0.00975277 0.048928 yes TCONS_00000392 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000393 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 1.3355 6.02437 2.17343 -0.0768125 0.938773 1 no TCONS_00000394 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000395 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 0 9.02387 1.79769e+308 1.79769e+308 0.0125139 1 no TCONS_00000396 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC OK 2.87744 10.1766 1.8224 -0.139807 0.888813 0.999997 no TCONS_00000397 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 5.98972 4.34296 -0.463809 0.0824885 0.934258 1 no TCONS_00000398 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 1.5524 5.14419 1.72845 -0.175939 0.860342 1 no TCONS_00000399 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 0 2.91986 1.79769e+308 1.79769e+308 0.309484 1 no TCONS_00000400 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000401 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC OK 12.6409 52.0827 2.04271 -0.708787 0.478457 0.798034 no TCONS_00000402 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 41.0821 0 -1.79769e+308 -1.79769e+308 0.316693 0.636743 no TCONS_00000403 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 407.437 532.647 0.386603 -0.874478 0.381858 0.708393 no TCONS_00000404 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 422.625 574.155 0.442061 -0.827828 0.407768 0.735128 no TCONS_00000405 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 351.835 256.538 -0.455728 0.635858 0.524869 0.844566 no TCONS_00000406 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000407 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 272.536 519.227 0.929917 -1.76005 0.0784001 0.245677 no TCONS_00000408 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 0 16.6368 1.79769e+308 1.79769e+308 0.0488547 0.16965 no TCONS_00000409 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 302.124 0 -1.79769e+308 -1.79769e+308 0.00139068 0.00940858 yes TCONS_00000410 XLOC_000148 - chr1:16860385-16864669 iPS hESC OK 8.40518 12.2273 0.540753 -0.429524 0.667542 0.959192 no TCONS_00000411 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 3.60238 4.10051 0.186852 -0.0811801 0.935299 1 no TCONS_00000412 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 0.00122752 6.52829 12.3767 -0.0060845 0.995145 1 no TCONS_00000413 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 0 1.45662 1.79769e+308 1.79769e+308 0.242714 1 no TCONS_00000414 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 0 6.80472 1.79769e+308 1.79769e+308 0.0980536 1 no TCONS_00000415 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 2.50115 3.75649 0.586795 -0.139995 0.888664 1 no TCONS_00000416 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 0 0.00527233 1.79769e+308 1.79769e+308 0.494255 1 no TCONS_00000417 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC OK 7.81031 63.0415 3.01285 -3.18958 0.00142479 0.00956121 yes TCONS_00000418 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC OK 1.86514 33.4266 4.16364 -2.01983 0.0434012 0.155901 no TCONS_00000419 XLOC_000150 - chr1:17066767-17299474 iPS hESC NOTEST 2.30684 4.93427 1.09692 -0.0279067 0.977737 1 no TCONS_00000420 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 27.4034 428.259 3.96606 -4.98435 6.21693e-07 1.20136e-05 yes TCONS_00000421 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 47.5917 30.5389 -0.640063 0.42597 0.67013 0.95993 no TCONS_00000422 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 65.6699 100.239 0.610141 -0.98137 0.32641 0.648016 no TCONS_00000423 XLOC_000150 - chr1:17066767-17299474 iPS hESC OK 15.9225 62.5679 1.97436 -0.950537 0.34184 0.664092 no TCONS_00000424 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 2.7984 1.50479 -0.895036 0.422801 0.67244 1 no TCONS_00000425 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 5.28057 0.286309 -4.20505 1.13856 0.254885 1 no TCONS_00000426 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000427 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 7.45961 6.34529e-05 -16.8431 0.00181309 0.998553 1 no TCONS_00000428 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 0 2.33196 1.79769e+308 1.79769e+308 0.0553395 1 no TCONS_00000429 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC NOTEST 8.59656 12.671 0.559694 -0.832934 0.404882 1 no TCONS_00000430 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC NOTEST 0 1.38095 1.79769e+308 1.79769e+308 0.181472 1 no TCONS_00000431 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC NOTEST 4.09774 3.11869 -0.393886 0.375803 0.707063 1 no TCONS_00000432 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC NOTEST 0 0.21117 1.79769e+308 1.79769e+308 0.240869 1 no TCONS_00000433 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 57.9053 55.941 -0.0497908 0.0542855 0.956708 0.999997 no TCONS_00000434 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 28.6581 64.0925 1.16121 -0.936903 0.348808 0.671553 no TCONS_00000435 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000436 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 158.893 479.078 1.5922 -3.50027 0.000464792 0.00370237 yes TCONS_00000437 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 2.78634 1.79769e+308 1.79769e+308 0.370368 1 no TCONS_00000438 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 24.8197 25.6249 0.0460618 -0.0320703 0.974416 0.999997 no TCONS_00000439 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 5.26 1.79769e+308 1.79769e+308 0.184349 1 no TCONS_00000440 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000441 XLOC_000155 - chr1:17866329-18024369 iPS hESC NOTEST 2.21468 5.36255 1.27582 -0.0636845 0.949221 1 no TCONS_00000442 XLOC_000155 - chr1:17866329-18024369 iPS hESC OK 12.7177 44.6171 1.81076 -0.557376 0.57727 0.889781 no TCONS_00000443 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC OK 9.62232 17.1125 0.830595 -1.21425 0.224654 0.510517 no TCONS_00000444 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC OK 58.273 398.742 2.77455 -5.33822 9.38643e-08 2.04057e-06 yes TCONS_00000445 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC NOTEST 2.74185 3.24727 0.244078 -0.0169831 0.98645 1 no TCONS_00000446 XLOC_000158 - chr1:18434239-18704976 iPS hESC OK 1.3684 18.0164 3.71875 -0.765114 0.444204 0.769978 no TCONS_00000447 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC OK 104.809 209.176 0.996955 -2.38589 0.0170378 0.0754943 no TCONS_00000448 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC NOTEST 0 8.37135 1.79769e+308 1.79769e+308 0.133101 1 no TCONS_00000449 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 5.07852e-05 7.1892e-05 0.501423 -1.47065e-05 0.999988 1 no TCONS_00000450 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 6.55753e-05 0 -1.79769e+308 -1.79769e+308 0.499977 1 no TCONS_00000451 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 0.593912 0.969259 0.706634 -0.456947 0.647709 1 no TCONS_00000452 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC OK 773.162 961.74 0.314877 -0.996481 0.319017 0.638892 no TCONS_00000453 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 70.7134 217.71 1.62235 -1.70101 0.0889416 0.268627 no TCONS_00000454 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC NOTEST 6.84301 0.0310775 -7.78262 0.25743 0.796847 1 no TCONS_00000455 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 28.264 28.45 0.00946013 -0.00576285 0.995402 0.999997 no TCONS_00000456 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 0 16.3096 1.79769e+308 1.79769e+308 0.0388485 0.145299 no TCONS_00000457 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 80.1847 62.153 -0.367503 0.445258 0.656133 0.952775 no TCONS_00000458 XLOC_000163 C1orf151 chr1:19923466-19984945 iPS hESC OK 3.27686 17.1755 2.38997 -0.111379 0.911316 0.999997 no TCONS_00000459 XLOC_000163 C1orf151 chr1:19923466-19984945 iPS hESC OK 246.288 618.381 1.32815 -2.51302 0.0119702 0.0582328 no TCONS_00000460 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC OK 0 162.125 1.79769e+308 1.79769e+308 5.14347e-08 1.20611e-06 yes TCONS_00000461 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 1.64141 1.79769e+308 1.79769e+308 0.415871 1 no TCONS_00000462 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000463 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC OK 463.905 16.9244 -4.77666 4.48648 7.24109e-06 0.000103849 yes TCONS_00000464 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC OK 3.39355 22.3161 2.71722 -2.91074 0.00360573 0.0206169 yes TCONS_00000465 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC OK 148.118 157.667 0.0901342 -0.250748 0.802009 0.999997 no TCONS_00000466 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 6.43535e-05 0 -1.79769e+308 -1.79769e+308 0.499972 1 no TCONS_00000467 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0.482643 0 -1.79769e+308 -1.79769e+308 0.31503 1 no TCONS_00000468 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0 0.847143 1.79769e+308 1.79769e+308 0.141964 1 no TCONS_00000469 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC NOTEST 0 0.361045 1.79769e+308 1.79769e+308 0.159889 1 no TCONS_00000470 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC OK 12.3177 17.9074 0.539819 -0.901624 0.367257 0.691131 no TCONS_00000471 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC OK 1.83014 11.844 2.69413 -2.42885 0.0151468 0.0688702 no TCONS_00000472 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 1.30646 6.27626 2.26425 -1.73385 0.0829441 1 no TCONS_00000473 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 3.74866e-05 0 -1.79769e+308 -1.79769e+308 0.499974 1 no TCONS_00000474 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 1.08334 1.79769e+308 1.79769e+308 0.116654 1 no TCONS_00000475 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000476 XLOC_000170 FAM43B chr1:20878931-20881512 iPS hESC OK 1.9757 40.5541 4.35941 -4.17581 2.96933e-05 0.000368869 yes TCONS_00000477 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC OK 223.547 133.245 -0.746493 1.46351 0.143329 0.380569 no TCONS_00000478 XLOC_000171 - chr1:20915443-20945398 iPS hESC NOTEST 0 1.59843 1.79769e+308 1.79769e+308 0.468868 1 no TCONS_00000479 XLOC_000171 - chr1:20915443-20945398 iPS hESC NOTEST 17.3734 6.30992 -1.46118 0.447991 0.654159 1 no TCONS_00000480 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 640.208 326.979 -0.969343 2.87415 0.00405111 0.0229124 yes TCONS_00000481 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 0 114.96 1.79769e+308 1.79769e+308 4.12982e-06 6.29119e-05 yes TCONS_00000482 XLOC_000173 - chr1:21543739-21672034 iPS hESC NOTEST 2.1975 7.51557 1.77402 -0.351856 0.724946 1 no TCONS_00000483 XLOC_000174 - chr1:21761832-21762609 iPS hESC OK 0 12075.7 1.79769e+308 1.79769e+308 0.00556566 0.0299369 yes TCONS_00000484 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 11.3784 3.12392 -1.86487 1.02838 0.30377 1 no TCONS_00000485 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC OK 68.9507 37.3701 -0.883681 1.72171 0.0851222 0.261705 no TCONS_00000486 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 0 1.81796 1.79769e+308 1.79769e+308 0.144033 1 no TCONS_00000487 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 4.87776 17.0989 1.80961 -0.632426 0.527109 1 no TCONS_00000488 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 877.819 4753.79 2.43708 -8.31431 0 0 yes TCONS_00000489 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 14.1413 40.1523 1.50557 -0.37196 0.709923 0.979971 no TCONS_00000490 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 46.976 130.881 1.47826 -0.655383 0.512221 0.830734 no TCONS_00000491 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 14.1212 120.584 3.09411 -0.705248 0.480656 0.798034 no TCONS_00000492 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000493 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC OK 10.8443 22.0415 1.02328 -0.37126 0.710444 0.979971 no TCONS_00000494 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC OK 11.8862 10.8865 -0.126752 0.00904423 0.992784 0.999997 no TCONS_00000495 XLOC_000178 CELA3B chr1:22303417-22339033 iPS hESC NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TCONS_00000496 XLOC_000178 - chr1:22303417-22339033 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000497 XLOC_000178 CELA3A chr1:22303417-22339033 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000498 XLOC_000179 - chr1:22351706-22357713 iPS hESC OK 27.4246 4.05105 -2.7591 0.788301 0.430521 0.757949 no TCONS_00000499 XLOC_000179 - chr1:22351706-22357713 iPS hESC OK 470.397 427.827 -0.136852 0.300117 0.764088 0.999997 no TCONS_00000500 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000501 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 13.0529 9.59677 -0.443746 0.0372706 0.970269 0.999997 no TCONS_00000502 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 339.897 74.2264 -2.19509 2.51308 0.0119681 0.0582328 no TCONS_00000503 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 243.283 9.02759 -4.75215 1.86227 0.0625651 0.207919 no TCONS_00000504 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 2997.59 1520.88 -0.978902 3.3316 0.000863478 0.00617151 yes TCONS_00000505 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 11.3168 3.95557 -1.51651 0.151706 0.879419 1 no TCONS_00000506 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 39.4183 8.77177 -2.16793 0.747364 0.454844 0.782571 no TCONS_00000507 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 1.95825 5.74741 1.55334 -0.312372 0.754758 1 no TCONS_00000508 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 81.1618 115.94 0.514509 -1.21863 0.222983 1 no TCONS_00000509 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC OK 5.796 76.4937 3.72221 -1.36863 0.171116 0.425142 no TCONS_00000510 XLOC_000181 - chr1:22778343-22857650 iPS hESC OK 41.9937 23.69 -0.825896 0.593722 0.552698 0.866627 no TCONS_00000511 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC OK 30.6745 69.3632 1.17713 -1.90166 0.0572152 0.192284 no TCONS_00000512 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC OK 2.71483 16.9383 2.64135 -1.90258 0.0570959 0.192192 no TCONS_00000513 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000514 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000515 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000516 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000517 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000518 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000519 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0.0140869 80.4755 12.48 -0.194153 0.846056 1 no TCONS_00000520 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 37.3058 1.79769e+308 1.79769e+308 1.49063e-05 1 no TCONS_00000521 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC OK 58.1996 183.879 1.65968 -3.68857 0.000225515 0.00200277 yes TCONS_00000522 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000523 XLOC_000187 - chr1:23243782-23247347 iPS hESC NOTEST 1.74546 8.0467 2.20479 -2.29657 0.0216434 1 no TCONS_00000524 XLOC_000188 - chr1:23345940-23410184 iPS hESC OK 2064.11 3123.43 0.59761 -2.50051 0.0124013 0.0597727 no TCONS_00000525 XLOC_000188 - chr1:23345940-23410184 iPS hESC OK 556.677 911.067 0.710716 -1.36098 0.173521 0.427814 no TCONS_00000526 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 6.87752 2.53326 -1.44089 0.121829 0.903035 1 no TCONS_00000527 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 8.91818 4.45377 -1.00172 0.487577 0.625849 1 no TCONS_00000528 XLOC_000190 - chr1:23832921-23857713 iPS hESC NOTEST 7.64299 0.939918 -3.02353 1.15889 0.2465 1 no TCONS_00000529 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC NOTEST 6.59897e-05 0 -1.79769e+308 -1.79769e+308 0.499983 1 no TCONS_00000530 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC NOTEST 0.878658 0 -1.79769e+308 -1.79769e+308 0.300891 1 no TCONS_00000531 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 6878.03 6624.43 -0.0541976 0.118432 0.905726 0.999997 no TCONS_00000532 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 728.583 1583.34 1.1198 -0.752109 0.451986 0.778938 no TCONS_00000533 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 37247.7 66407.9 0.834204 -4.57248 4.81975e-06 7.289e-05 yes TCONS_00000534 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 227.08 191.396 -0.246637 0.201686 0.840162 0.999997 no TCONS_00000535 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC OK 755.461 523.425 -0.529375 2.00618 0.0448371 0.159141 no TCONS_00000536 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC OK 1031.1 1150.34 0.157876 -0.476639 0.633619 0.939846 no TCONS_00000537 XLOC_000194 - chr1:24104875-24114720 iPS hESC OK 42.6282 57.722 0.437312 -0.241569 0.809114 0.999997 no TCONS_00000538 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 60.6827 0 -1.79769e+308 -1.79769e+308 0.178997 0.4359 no TCONS_00000539 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 107.325 366.517 1.77189 -1.66705 0.0955036 0.283119 no TCONS_00000540 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 728.399 738.535 0.0199373 -0.0473745 0.962215 0.999997 no TCONS_00000541 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 151.125 1591.41 3.3965 -3.61538 0.000299906 0.00253402 yes TCONS_00000542 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC OK 2032.12 1015.28 -1.00111 4.04417 5.25091e-05 0.000589174 yes TCONS_00000543 XLOC_000197 - chr1:24526729-24538180 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00000544 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC OK 11.6632 24.5694 1.0749 -1.2399 0.215012 0.492569 no TCONS_00000545 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 9.34923 0.00104564 -13.1262 0.0255261 0.979635 1 no TCONS_00000546 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 0.00176595 0 -1.79769e+308 -1.79769e+308 0.49932 1 no TCONS_00000547 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 5.7743 0.568882 -3.34345 0.204764 0.837756 1 no TCONS_00000548 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC OK 102.299 55.217 -0.889614 0.745301 0.45609 0.783423 no TCONS_00000549 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 340.07 80.6785 -2.07558 5.74714 9.07673e-09 1 no TCONS_00000550 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 0 4.01002 1.79769e+308 1.79769e+308 0.0509497 1 no TCONS_00000551 XLOC_000199 - chr1:24742244-24799472 iPS hESC NOTEST 22.1357 5.64277 -1.9719 0.833904 0.404335 1 no TCONS_00000552 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC OK 326.184 113.081 -1.52832 3.43158 0.000600074 0.00455399 yes TCONS_00000553 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC NOTEST 20.7252 0 -1.79769e+308 -1.79769e+308 0.270602 1 no TCONS_00000554 XLOC_000200 - chr1:24829386-24862425 iPS hESC OK 15.7185 11.8633 -0.40595 0.106175 0.915443 0.999997 no TCONS_00000555 XLOC_000200 - chr1:24829386-24862425 iPS hESC NOTEST 0 4.24998 1.79769e+308 1.79769e+308 0.226762 1 no TCONS_00000556 XLOC_000200 - chr1:24829386-24862425 iPS hESC NOTEST 10.6171 2.64685 -2.00404 0.24813 0.804034 1 no TCONS_00000557 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC NOTEST 1.31366 2.35713 0.84344 -0.758715 0.448023 1 no TCONS_00000558 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 816.952 805.739 -0.019938 0.0676096 0.946096 0.999997 no TCONS_00000559 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0.0198022 0 -1.79769e+308 -1.79769e+308 0.491242 1 no TCONS_00000560 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 41.7106 47.1916 0.178117 -0.0798044 0.936393 0.999997 no TCONS_00000561 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 347.64 876.963 1.33492 -2.40217 0.0162981 0.0731485 no TCONS_00000562 XLOC_000202 - chr1:24969593-24999771 iPS hESC OK 84.2414 66.4895 -0.341402 0.159818 0.873024 0.999997 no TCONS_00003803 XLOC_001217 - chr1:11873-29961 iPS hESC OK 0.0436773 347.213 12.9567 -0.107346 0.914514 0.999997 no TCONS_00003804 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 20.2689 0 -1.79769e+308 -1.79769e+308 0.271118 1 no TCONS_00003805 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003806 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003807 XLOC_001217 - chr1:11873-29961 iPS hESC OK 108.765 0 -1.79769e+308 -1.79769e+308 0.0812742 0.251661 no TCONS_00003808 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 10.3996 1.80263 -2.52835 0.280062 0.77943 1 no TCONS_00003809 XLOC_001217 - chr1:11873-29961 iPS hESC OK 59.4507 102.706 0.788752 -0.491371 0.623164 0.931621 no TCONS_00003810 XLOC_001217 - chr1:11873-29961 iPS hESC OK 44.5281 14.6077 -1.60799 0.87307 0.382625 0.708393 no TCONS_00003811 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003812 XLOC_001217 - chr1:11873-29961 iPS hESC OK 38.8286 13.2227 -1.5541 1.06465 0.287035 0.604482 no TCONS_00003813 XLOC_001217 - chr1:11873-29961 iPS hESC OK 74.8157 51.2562 -0.545614 0.631537 0.52769 0.846259 no TCONS_00003814 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 4.01193 2.59699 -0.627459 0.0139635 0.988859 1 no TCONS_00003815 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003816 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 12.1835 5.35614 -1.18566 0.107089 0.914718 1 no TCONS_00003817 XLOC_001217 - chr1:11873-29961 iPS hESC OK 0 36.3642 1.79769e+308 1.79769e+308 0.0396055 0.147076 no TCONS_00003818 XLOC_001217 - chr1:11873-29961 iPS hESC OK 166.699 224.306 0.428221 -0.256889 0.797265 0.999997 no TCONS_00003819 XLOC_001217 - chr1:11873-29961 iPS hESC OK 479.443 95.223 -2.33198 3.82255 0.000132079 0.00128808 yes TCONS_00003820 XLOC_001217 - chr1:11873-29961 iPS hESC OK 16.824 38.5776 1.19724 -0.160186 0.872735 0.999997 no TCONS_00003821 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 42.2462 122.62 1.5373 -0.495896 0.619968 1 no TCONS_00003822 XLOC_001217 - chr1:11873-29961 iPS hESC OK 0 27.8905 1.79769e+308 1.79769e+308 0.0876808 0.266749 no TCONS_00003823 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003824 XLOC_001218 - chr1:34611-36081 iPS hESC OK 13.7184 16.5503 0.270741 -0.371306 0.71041 0.979971 no TCONS_00003825 XLOC_001219 - chr1:89294-237877 iPS hESC NOTEST 12.8434 2.45836 -2.38526 1.10269 0.270162 1 no TCONS_00003826 XLOC_001220 - chr1:89294-237877 iPS hESC OK 342.399 634.855 0.890746 -2.10741 0.0350822 0.134096 no TCONS_00003827 XLOC_001221 OR4F16 chr1:621097-622034 iPS hESC NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00003828 XLOC_001222 - chr1:661139-679736 iPS hESC OK 15.7705 18.7126 0.246788 -0.0703098 0.943947 0.999997 no TCONS_00003829 XLOC_001222 - chr1:661139-679736 iPS hESC OK 161.143 297.645 0.885251 -1.36564 0.172053 0.426304 no TCONS_00003830 XLOC_001222 - chr1:661139-679736 iPS hESC OK 96.6862 191.32 0.984605 -1.47292 0.140771 0.375984 no TCONS_00003831 XLOC_001223 - chr1:661139-679736 iPS hESC OK 0 697259 1.79769e+308 1.79769e+308 0.25307 0.553624 no TCONS_00003832 XLOC_001224 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003833 XLOC_001225 - chr1:661139-679736 iPS hESC OK 0 697259 1.79769e+308 1.79769e+308 0.25307 0.553624 no TCONS_00003834 XLOC_001226 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003835 XLOC_001222 - chr1:661139-679736 iPS hESC OK 169.764 520.885 1.61743 -1.10067 0.27104 0.581955 no TCONS_00003836 XLOC_001227 - chr1:700236-714006 iPS hESC OK 247.682 235.71 -0.0714796 0.16032 0.872629 0.999997 no TCONS_00003837 XLOC_001228 - chr1:761586-762902 iPS hESC OK 29.1742 19.6665 -0.568958 0.935249 0.34966 0.671953 no TCONS_00003838 XLOC_001229 FAM41C chr1:803452-812182 iPS hESC NOTEST 17.3524 2.1691 -2.99997 3.22092 0.00127779 1 no TCONS_00003839 XLOC_001230 - chr1:852952-854817 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003840 XLOC_001230 - chr1:852952-854817 iPS hESC NOTEST 0 4.38548 1.79769e+308 1.79769e+308 0.237503 1 no TCONS_00003841 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 36.029 100.448 1.47922 -1.10394 0.269618 0.580695 no TCONS_00003842 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 328.516 547.174 0.736035 -1.56049 0.118644 0.334735 no TCONS_00003843 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 256.209 1090.31 2.08935 -3.95293 7.72014e-05 0.000826253 yes TCONS_00003844 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 43.7364 97.2158 1.15236 -0.313433 0.753952 0.999997 no TCONS_00003845 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC OK 9.49353 14.7182 0.632585 -0.719442 0.471869 0.793625 no TCONS_00003846 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC NOTEST 0 0.517867 1.79769e+308 1.79769e+308 0.291955 1 no TCONS_00003847 XLOC_001233 HES4 chr1:934341-935552 iPS hESC OK 54.1565 25.1834 -1.10466 1.58874 0.112119 0.322155 no TCONS_00003848 XLOC_001233 HES4 chr1:934341-935552 iPS hESC OK 0 12.2395 1.79769e+308 1.79769e+308 0.0105486 0.0522918 no TCONS_00003849 XLOC_001234 - chr1:1017197-1051736 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003850 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 9.95714 21.5806 1.11593 -0.403696 0.686436 0.96893 no TCONS_00003851 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 0.00198038 11.9017 12.5531 -0.0111413 0.991111 0.999997 no TCONS_00003852 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 16.1923 14.7307 -0.136486 0.099033 0.921112 0.999997 no TCONS_00003853 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 50.4508 91.6026 0.860512 -1.14368 0.252756 0.553624 no TCONS_00003854 XLOC_001234 - chr1:1017197-1051736 iPS hESC NOTEST 0 3.76844 1.79769e+308 1.79769e+308 0.156815 1 no TCONS_00003855 XLOC_001234 - chr1:1017197-1051736 iPS hESC OK 0 29.6027 1.79769e+308 1.79769e+308 0.000261161 0.00225224 yes TCONS_00003856 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 18.8091 6.807 -1.46634 1.10929 0.267304 1 no TCONS_00003857 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003858 XLOC_001235 - chr1:1108435-1133313 iPS hESC NOTEST 0.346272 5.99833 4.11458 -1.36562 0.172057 1 no TCONS_00003859 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 2.09869 10.3558 2.30287 -0.839548 0.401162 0.72929 no TCONS_00003860 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 1.73622 0 -1.79769e+308 -1.79769e+308 0.236518 1 no TCONS_00003861 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 0.00252879 24.8393 13.2619 -0.00980888 0.992174 0.999997 no TCONS_00003862 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003863 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC NOTEST 1.29516 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TCONS_00003864 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC NOTEST 0 1.21775 1.79769e+308 1.79769e+308 0.0797028 1 no TCONS_00003865 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 60.6719 105.623 0.799828 -0.846112 0.39749 0.725142 no TCONS_00003866 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 829.134 1473.6 0.829663 -2.44759 0.0143816 0.0664037 no TCONS_00003867 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 39.6628 17.9039 -1.14751 0.498124 0.618397 0.928485 no TCONS_00003868 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003869 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 5.79383 1.79769e+308 1.79769e+308 0.22978 1 no TCONS_00003870 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 32.4396 210.708 2.69942 -0.473552 0.635819 0.940436 no TCONS_00003871 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC OK 17.131 41.9198 1.29102 -2.02163 0.043215 0.155901 no TCONS_00003872 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 16.9893 15.5986 -0.123217 0.0470921 0.96244 0.999997 no TCONS_00003873 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 22.0748 27.7097 0.327988 -0.173285 0.862428 0.999997 no TCONS_00003874 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC NOTEST 5.41455 0 -1.79769e+308 -1.79769e+308 0.436878 1 no TCONS_00003875 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 417.932 594.103 0.507443 -1.20621 0.227737 0.514938 no TCONS_00003876 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 25.4338 37.5213 0.560967 -0.204079 0.838292 0.999997 no TCONS_00003877 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 0 18.384 1.79769e+308 1.79769e+308 0.11686 0.33182 no TCONS_00003878 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 10.1146 21.3064 1.07485 -0.255546 0.798302 0.999997 no TCONS_00003879 XLOC_001241 - chr1:1189293-1209234 iPS hESC OK 17.2606 37.017 1.10071 -0.741718 0.458258 0.785209 no TCONS_00003880 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 9.37264 139.601 3.89671 -0.778285 0.436401 0.762206 no TCONS_00003881 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 25.8307 113.499 2.13552 -1.52619 0.126964 0.348649 no TCONS_00003882 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 93.257 181.357 0.959549 -1.18867 0.23457 0.526962 no TCONS_00003883 XLOC_001242 - chr1:1227763-1260046 iPS hESC OK 26.1554 117.46 2.16699 -0.75974 0.44741 0.773608 no TCONS_00003884 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 79.6054 94.0403 0.240413 -0.214118 0.830455 0.999997 no TCONS_00003885 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 590.361 1597.84 1.43645 -3.36936 0.00075343 0.00549793 yes TCONS_00003886 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 15.5849 41.6009 1.41646 -0.385699 0.69972 0.976699 no TCONS_00003887 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 11.6979 37.6829 1.68766 -0.321644 0.747722 0.999997 no TCONS_00003888 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 0 21.2906 1.79769e+308 1.79769e+308 0.160295 0.407972 no TCONS_00003889 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003890 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003891 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 22.9173 99.7638 2.12208 -0.623542 0.532928 0.84758 no TCONS_00003892 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 28.1613 4.26182 -2.72417 0.487684 0.625774 0.933446 no TCONS_00003893 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 0 45.4548 1.79769e+308 1.79769e+308 0.0415592 0.152432 no TCONS_00003894 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 4.09686 41.7594 3.34951 -0.0937218 0.92533 0.999997 no TCONS_00003895 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 109.796 428.913 1.96586 -1.06125 0.288575 0.605282 no TCONS_00003896 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 74.8279 131.639 0.814943 -0.610214 0.54172 0.855196 no TCONS_00003897 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 63.7322 263.001 2.04497 -1.56993 0.116431 0.331504 no TCONS_00003898 XLOC_001244 DVL1L1 chr1:1270658-1284492 iPS hESC OK 8.10625 31.5522 1.96063 -0.330035 0.741373 0.996295 no TCONS_00003899 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 173.57 674.206 1.95767 -4.00397 6.22872e-05 0.000687796 yes TCONS_00003900 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 30.2667 193.963 2.67998 -2.91349 0.00357416 0.0206057 yes TCONS_00003901 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 6.14109 11.8645 0.950088 -0.054649 0.956418 0.999997 no TCONS_00003902 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 101.118 0.00314546 -14.9724 0.0628669 0.949872 0.999997 no TCONS_00003903 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 248.639 55.4345 -2.16519 1.40636 0.159619 0.407127 no TCONS_00003904 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 721.263 67.479 -3.41801 5.57463 2.4806e-08 1 no TCONS_00003905 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 2.23252 18.5375 3.0537 -0.0735157 0.941396 0.999997 no TCONS_00003906 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 1486.29 1941.94 0.38578 -0.720816 0.471023 0.793625 no TCONS_00003907 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 37.1577 185.125 2.31676 -0.453816 0.649962 0.94858 no TCONS_00003908 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 323.055 651.469 1.01192 -0.580958 0.561268 0.87633 no TCONS_00003909 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 711.073 881.639 0.310189 -0.505478 0.613223 0.925392 no TCONS_00003910 XLOC_001247 - chr1:1321090-1334718 iPS hESC OK 5.40934 15.222 1.49263 -0.137034 0.891004 0.999997 no TCONS_00003911 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 114.444 110.19 -0.0546552 0.0718411 0.942728 0.999997 no TCONS_00003912 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 6.6959 107.558 4.00569 -0.447929 0.654205 0.95211 no TCONS_00003913 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 348.681 352.289 0.0148537 -0.0401382 0.967983 0.999997 no TCONS_00003914 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 172.404 443.979 1.3647 -1.92547 0.0541706 0.184427 no TCONS_00003915 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 17.0885 96.9882 2.50478 -0.869496 0.384576 0.708393 no TCONS_00003916 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 84.4595 112.752 0.416826 -0.4414 0.658923 0.954318 no TCONS_00003917 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC OK 3025.74 4267.92 0.496242 -1.48164 0.138435 0.372312 no TCONS_00003918 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC OK 108.19 88.7189 -0.286252 0.171667 0.863699 0.999997 no TCONS_00003919 XLOC_001249 - chr1:1353801-1356650 iPS hESC NOTEST 48.4609 17.1724 -1.49673 1.91495 0.0554989 1 no TCONS_00003920 XLOC_001249 - chr1:1353801-1356650 iPS hESC OK 0.00430007 49.1286 13.4799 -0.0215387 0.982816 0.999997 no TCONS_00003921 XLOC_001249 - chr1:1353801-1356650 iPS hESC NOTEST 6.61991 6.86284 0.0519944 -0.0246203 0.980358 1 no TCONS_00003922 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC OK 31.9981 83.1162 1.37714 -2.19185 0.0283903 0.111373 no TCONS_00003923 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 1955.08 3166.29 0.695569 -2.16226 0.0305979 0.119017 no TCONS_00003924 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 17.0327 11.4081 -0.578252 0.0841977 0.932899 0.999997 no TCONS_00003925 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 407.325 235.83 -0.788432 1.59818 0.110004 0.317096 no TCONS_00003926 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 33.8277 205.562 2.6033 -0.945911 0.344194 0.66481 no TCONS_00003927 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 0 123.643 1.79769e+308 1.79769e+308 0.0030119 0.0178575 yes TCONS_00003928 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 9.33823 168.137 4.17035 -0.425932 0.670157 0.95993 no TCONS_00003929 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 10.4083 0 -1.79769e+308 -1.79769e+308 0.408108 1 no TCONS_00003930 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003931 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003932 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 0 22.1371 1.79769e+308 1.79769e+308 0.109309 0.315967 no TCONS_00003933 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003934 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 23.7584 109.837 2.20886 -0.900348 0.367935 0.691131 no TCONS_00003935 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 76.2007 816.237 3.42111 -0.632954 0.526764 0.846259 no TCONS_00003936 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS hESC OK 81.9647 251.238 1.61598 -0.407636 0.683541 0.967808 no TCONS_00003937 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 19.9963 15.2497 -0.390952 0.105424 0.916039 0.999997 no TCONS_00003938 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 57.9127 222.366 1.94098 -2.0851 0.0370606 0.139613 no TCONS_00003939 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 39.3012 80.1962 1.02896 -1.0492 0.294085 0.611919 no TCONS_00003940 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 42.2344 45.5718 0.109722 -0.106154 0.91546 0.999997 no TCONS_00003941 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 21.1415 231.222 3.45113 -2.21541 0.026732 0.106248 no TCONS_00003942 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 48.2599 122.207 1.34043 -0.494235 0.621141 0.930596 no TCONS_00003943 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 21.1432 37.3588 0.821255 -0.26874 0.78813 0.999997 no TCONS_00003944 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 4.69427 110.433 4.55612 -0.181361 0.856084 0.999997 no TCONS_00003945 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 22.682 146.455 2.69084 -0.593878 0.552594 0.866627 no TCONS_00003946 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 21.915 98.0216 2.16118 -0.449659 0.652956 0.95162 no TCONS_00003947 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 10.007 204.998 4.35653 -0.714084 0.475175 0.796539 no TCONS_00003948 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 44.5894 618 3.79283 -2.22463 0.0261062 0.104575 no TCONS_00003949 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 10.5985 162.241 3.9362 -0.515647 0.606101 0.922571 no TCONS_00003950 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003951 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 10.2217 38.1573 1.90033 -0.135727 0.892037 0.999997 no TCONS_00003952 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 0 21.7767 1.79769e+308 1.79769e+308 0.244579 0.541865 no TCONS_00003953 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0.128652 1.12006 3.12202 -0.008222 0.99344 1 no TCONS_00003954 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 8.10282 24.8037 1.61406 -0.0691344 0.944883 0.999997 no TCONS_00003955 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 2.85432 17.5163 2.61748 -0.255839 0.798075 0.999997 no TCONS_00003956 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003957 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 23.5881 12.0452 -0.969598 0.0716594 0.942873 0.999997 no TCONS_00003958 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 8.90936 0 -1.79769e+308 -1.79769e+308 0.490667 1 no TCONS_00003959 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 93.1692 127.494 0.452509 -0.346191 0.729199 0.989492 no TCONS_00003960 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003961 XLOC_001255 - chr1:1571099-1677431 iPS hESC OK 251.624 341.44 0.440361 -0.874388 0.381907 0.708393 no TCONS_00003962 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 96.0585 274.135 1.5129 -0.959605 0.337254 0.659653 no TCONS_00003963 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 10.1742 13.2843 0.384809 -0.104554 0.91673 0.999997 no TCONS_00003964 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003965 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 331.317 510.173 0.622776 -1.54768 0.1217 0.33775 no TCONS_00003966 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 38.1873 332.932 3.12406 -1.5487 0.121454 0.337516 no TCONS_00003967 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 46.8111 91.3616 0.964739 -0.864947 0.387068 0.712355 no TCONS_00003968 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 57.4086 210.14 1.87201 -0.98712 0.323584 0.645004 no TCONS_00003969 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC OK 4274.57 4816.83 0.172305 -0.924307 0.355327 0.679713 no TCONS_00003970 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC NOTEST 13.2928 4.54411 -1.54858 0.174865 0.861186 1 no TCONS_00003971 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 78.6765 212.131 1.43095 -2.30526 0.021152 0.0885504 no TCONS_00003972 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 23.4913 79.5862 1.76039 -1.05879 0.289694 0.605435 no TCONS_00003973 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC NOTEST 0 2.02001 1.79769e+308 1.79769e+308 0.0595537 1 no TCONS_00003974 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC NOTEST 0 1.04698 1.79769e+308 1.79769e+308 0.120101 1 no TCONS_00003975 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.583424 0.932315 0.676272 -0.338066 0.735314 1 no TCONS_00003976 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.437707 0 -1.79769e+308 -1.79769e+308 0.332442 1 no TCONS_00003977 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.645169 0 -1.79769e+308 -1.79769e+308 0.300876 1 no TCONS_00003978 XLOC_001261 - chr1:1944651-1946969 iPS hESC NOTEST 4.28982 8.18597 0.932235 -1.04285 0.297016 1 no TCONS_00003979 XLOC_001262 - chr1:1981908-2139172 iPS hESC OK 13.1667 33.574 1.35045 -0.211947 0.832149 0.999997 no TCONS_00003980 XLOC_001263 - chr1:1981908-2139172 iPS hESC OK 41.939 73.6555 0.812503 -0.601833 0.547285 0.860727 no TCONS_00003981 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003982 XLOC_001263 - chr1:1981908-2139172 iPS hESC OK 6.98486 25.7926 1.88466 -0.300022 0.76416 0.999997 no TCONS_00003983 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC OK 377.586 1775.08 2.233 -2.80248 0.00507108 0.0276972 yes TCONS_00003984 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC OK 5.67183 66.6827 3.55543 -0.931702 0.35149 0.674849 no TCONS_00003985 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 1.30462 2.05545 0.655827 -0.0895395 0.928653 1 no TCONS_00003986 XLOC_001265 - chr1:2252695-2322993 iPS hESC OK 54.2991 912.804 4.07131 -7.05004 1.78857e-12 8.6808e-11 yes TCONS_00003987 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC OK 40.4484 34.0396 -0.248866 0.183503 0.854403 0.999997 no TCONS_00003988 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 7.56119 6.7722 -0.158988 0.053666 0.957201 1 no TCONS_00003989 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC OK 0 9.44927 1.79769e+308 1.79769e+308 0.202975 0.478113 no TCONS_00003990 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC OK 290.341 452.417 0.639907 -1.01032 0.312342 0.630423 no TCONS_00003991 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC OK 174.785 361.252 1.04742 -2.54966 0.0107829 0.0532006 no TCONS_00003992 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003993 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC NOTEST 6.35744 2.94754 -1.10894 0.97469 0.329714 1 no TCONS_00003994 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003995 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 0.907232 0.47493 -0.933755 0.216656 0.828476 1 no TCONS_00003996 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 0 7.33509e-05 1.79769e+308 1.79769e+308 0.499935 1 no TCONS_00003997 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 1.10294 0.649192 -0.764632 0.248778 0.803533 1 no TCONS_00003998 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00003999 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC OK 0.931281 12.7571 3.77594 -0.543818 0.586567 0.900121 no TCONS_00004000 XLOC_001271 - chr1:2976182-2980350 iPS hESC NOTEST 0.620738 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TCONS_00004001 XLOC_001272 - chr1:2980635-2984289 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004002 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 69.8392 41.8309 -0.739469 1.17206 0.241174 1 no TCONS_00004003 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC OK 43.7292 177.762 2.02328 -3.11751 0.00182383 0.0116237 yes TCONS_00004004 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 179.578 319.493 0.831173 -1.3961 0.162685 0.411115 no TCONS_00004005 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 62.1764 203.665 1.71176 -1.69943 0.089238 0.268744 no TCONS_00004006 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 23.0108 74.6828 1.69846 -2.07843 0.0376699 0.141398 no TCONS_00004007 XLOC_001275 - chr1:3652549-3663886 iPS hESC OK 0 11.3698 1.79769e+308 1.79769e+308 0.0857226 0.262437 no TCONS_00004008 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC OK 201.581 422.204 1.06658 -3.19792 0.00138423 0.00940858 yes TCONS_00004009 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC OK 867.894 1345.43 0.632479 -2.16568 0.0303353 0.118336 no TCONS_00004010 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 15.12 29.6392 0.971054 -0.733677 0.463146 0.79034 no TCONS_00004011 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 139.485 100.25 -0.476509 1.10326 0.269912 0.580712 no TCONS_00004012 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 111.609 52.3176 -1.09308 1.15248 0.249124 0.549443 no TCONS_00004013 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC OK 473.292 538.523 0.186276 -0.475583 0.634371 0.940085 no TCONS_00004014 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC OK 15.8862 12.5397 -0.341271 0.173567 0.862206 0.999997 no TCONS_00004015 XLOC_001279 - chr1:5621768-5728315 iPS hESC NOTEST 0 0.669469 1.79769e+308 1.79769e+308 0.240869 1 no TCONS_00004016 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 38.0315 140.655 1.8869 -3.32273 0.000891422 0.00632789 yes TCONS_00004017 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 12.3891 32.7056 1.40046 -1.19183 0.233327 0.5253 no TCONS_00004018 XLOC_001280 - chr1:5922869-6052531 iPS hESC NOTEST 9.73733 9.30267 -0.0658819 0.0362569 0.971078 1 no TCONS_00004019 XLOC_001280 - chr1:5922869-6052531 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004020 XLOC_001280 - chr1:5922869-6052531 iPS hESC NOTEST 0 3.48039 1.79769e+308 1.79769e+308 0.181852 1 no TCONS_00004021 XLOC_001280 - chr1:5922869-6052531 iPS hESC NOTEST 1.34942 5.2451 1.95863 -0.315731 0.752207 1 no TCONS_00004022 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC NOTEST 0 3.24653 1.79769e+308 1.79769e+308 0.0171011 1 no TCONS_00004023 XLOC_001281 - chr1:6161852-6240183 iPS hESC NOTEST 3.69165 0.766551 -2.26781 1.09713 0.272586 1 no TCONS_00004024 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC OK 6.8891 13.8631 1.00887 -1.37294 0.169771 0.424054 no TCONS_00004025 XLOC_001281 - chr1:6161852-6240183 iPS hESC NOTEST 3.73417 4.78329 0.357215 -0.144714 0.884937 1 no TCONS_00004026 XLOC_001281 - chr1:6161852-6240183 iPS hESC NOTEST 0.120394 5.03226 5.38537 -0.374571 0.70798 1 no TCONS_00004027 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC OK 2222.07 4302.07 0.953127 -3.8213 0.000132751 0.00128861 yes TCONS_00004028 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC OK 209.378 72.9481 -1.52117 0.92091 0.357097 0.681214 no TCONS_00004029 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC OK 1235.93 1196.78 -0.0464449 0.191567 0.848082 0.999997 no TCONS_00004030 XLOC_001283 - chr1:6266188-6296044 iPS hESC OK 243.59 137.374 -0.826343 1.42612 0.153835 0.396852 no TCONS_00004031 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC OK 79.9572 174.868 1.12897 -2.02118 0.0432608 0.155901 no TCONS_00004032 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC OK 37.8293 97.14 1.36056 -1.57996 0.114116 0.326695 no TCONS_00004033 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 239.832 1356.8 0 0 1 1 no TCONS_00004034 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 0 0 0 0 1 1 no TCONS_00004035 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 126.845 93.6803 0 0 1 1 no TCONS_00004036 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 462.887 1047.97 0 0 1 1 no TCONS_00004037 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 134.974 731.817 0 0 1 1 no TCONS_00004038 XLOC_001285 - chr1:6324332-6453826 iPS hESC FAIL 0 4.72572 0 0 1 1 no TCONS_00004039 XLOC_001285 - chr1:6324332-6453826 iPS hESC FAIL 0 324.209 0 0 1 1 no TCONS_00004040 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 0 2.2157 1.79769e+308 1.79769e+308 0.0765414 1 no TCONS_00004041 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 5.92301 6.44393 0.121611 -0.19958 0.841809 1 no TCONS_00004042 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0.707673 1.79769e+308 1.79769e+308 0.406721 1 no TCONS_00004043 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 4.86935 0 -1.79769e+308 -1.79769e+308 0.445968 1 no TCONS_00004044 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 0 42.3646 1.79769e+308 1.79769e+308 0.0252997 0.102259 no TCONS_00004045 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004046 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 23.1541 166.161 2.84324 -1.31458 0.18865 0.453586 no TCONS_00004047 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004048 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004049 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 0 10.7434 1.79769e+308 1.79769e+308 0.18792 0.453341 no TCONS_00004050 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004051 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 22.6201 112.149 2.30975 -0.711673 0.476667 0.797119 no TCONS_00004052 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 12.7468 35.8901 1.49345 -0.693954 0.487711 0.804256 no TCONS_00004053 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 2.06233 38.9511 4.23932 -0.63114 0.527949 0.846259 no TCONS_00004054 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 14.2602 62.1096 2.12282 -1.36949 0.170845 0.424975 no TCONS_00004055 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0 73.921 1.79769e+308 1.79769e+308 8.90841e-06 0.000124778 yes TCONS_00004056 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 17.5992 43.3127 1.29928 -1.03588 0.300257 0.618774 no TCONS_00004057 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004058 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 25.7562 4.59064 -2.48815 1.06265 0.287943 0.604828 no TCONS_00004059 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0 9.71361 1.79769e+308 1.79769e+308 0.151372 0.393907 no TCONS_00004060 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0.00544137 51.9914 13.222 -0.0944698 0.924736 0.999997 no TCONS_00004061 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 14.4826 0 -1.79769e+308 -1.79769e+308 0.123134 1 no TCONS_00004062 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 6.79791 1.79769e+308 1.79769e+308 0.0932848 1 no TCONS_00004063 XLOC_001287 - chr1:6521220-6580069 iPS hESC OK 30.5163 77.8501 1.35112 -0.738174 0.460408 0.787415 no TCONS_00004064 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC OK 503.823 189.708 -1.40913 4.12461 3.71357e-05 0.000442869 yes TCONS_00004065 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004066 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 109.476 62.094 -0.818087 1.40585 0.159769 0.407127 no TCONS_00004067 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 134.239 151.442 0.173969 -0.217709 0.827656 0.999997 no TCONS_00004068 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 0 154.599 1.79769e+308 1.79769e+308 1.97652e-16 1.96428e-14 yes TCONS_00004069 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004070 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC OK 727.027 1331.6 0.873077 -2.98537 0.00283235 0.016986 yes TCONS_00004071 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC OK 11.865 28.6342 1.27102 -0.330153 0.741284 0.996295 no TCONS_00004072 XLOC_001290 - chr1:6684924-6761966 iPS hESC OK 4.91606 12.0359 1.29176 -0.126775 0.899119 0.999997 no TCONS_00004073 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004074 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 2.40953 0.950535 -1.34194 0.107691 0.914241 1 no TCONS_00004075 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 0.0400905 0 -1.79769e+308 -1.79769e+308 0.496829 1 no TCONS_00004076 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC NOTEST 0 0.267901 1.79769e+308 1.79769e+308 0.240869 1 no TCONS_00004077 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 641.313 442.172 -0.53642 1.65281 0.098369 0.289557 no TCONS_00004078 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 137.346 21.342 -2.68605 2.39853 0.0164612 0.0735642 no TCONS_00004079 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 1.40725 320.719 7.83228 -0.463892 0.642725 0.94396 no TCONS_00004080 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 16.3557 23.9344 0.549295 -0.438181 0.661255 0.956241 no TCONS_00004081 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 170.627 638.676 1.90424 -5.40243 6.57437e-08 1.47535e-06 yes TCONS_00004082 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004083 XLOC_001295 - chr1:8412465-8877699 iPS hESC NOTEST 20.7508 0 -1.79769e+308 -1.79769e+308 0.365376 1 no TCONS_00004084 XLOC_001294 - chr1:8412465-8877699 iPS hESC OK 85.8783 3.82252 -4.4897 1.16634 0.243478 0.541149 no TCONS_00004085 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 444.441 211.161 -1.07365 0.915316 0.360026 0.682753 no TCONS_00004086 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 19439.6 29778.1 0.615251 -3.78734 0.000152268 0.00142503 yes TCONS_00004087 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 0 8898.81 1.79769e+308 1.79769e+308 1.86581e-11 7.21099e-10 yes TCONS_00004088 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 0 54.1427 1.79769e+308 1.79769e+308 0.366732 0.691131 no TCONS_00004089 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 0 914.141 1.79769e+308 1.79769e+308 0.166098 0.416643 no TCONS_00004090 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 9.70153 3.84797 -1.33412 0.0249968 0.980058 1 no TCONS_00004091 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 2186.7 12561.6 2.52219 -4.76364 1.90136e-06 3.25257e-05 yes TCONS_00004092 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 10.0879 8.52523 -0.242813 0.00547469 0.995632 1 no TCONS_00004093 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 351.21 210.717 -0.737024 0.405291 0.685264 0.96893 no TCONS_00004094 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC NOTEST 0 0.358204 1.79769e+308 1.79769e+308 0.238628 1 no TCONS_00004095 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0.000167835 1.79769e+308 1.79769e+308 0.499869 1 no TCONS_00004096 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 2.90964 1.79769e+308 1.79769e+308 0.0125747 1 no TCONS_00004097 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0.00429204 0 -1.79769e+308 -1.79769e+308 0.498401 1 no TCONS_00004098 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004099 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 3.56432 0 -1.79769e+308 -1.79769e+308 0.0498603 1 no TCONS_00004100 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 2.34161 0 -1.79769e+308 -1.79769e+308 0.236394 1 no TCONS_00004101 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004102 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 9.05298 5.68802 -0.670465 0.366784 0.71378 1 no TCONS_00004103 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC OK 16.7212 50.5863 1.59707 -1.30188 0.192957 0.46023 no TCONS_00004104 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 1.60049 1.55989 -0.0370758 0.0190534 0.984798 1 no TCONS_00004105 XLOC_001299 - chr1:9164475-9189356 iPS hESC NOTEST 9.67107 5.09214 -0.925402 0.937957 0.348267 1 no TCONS_00004106 XLOC_001300 - chr1:9208346-9242451 iPS hESC OK 95.9263 212.722 1.14897 -2.69957 0.00694287 0.0365903 yes TCONS_00004107 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC NOTEST 0 0.589835 1.79769e+308 1.79769e+308 0.430197 1 no TCONS_00004108 XLOC_001302 - chr1:9711789-9884550 iPS hESC OK 86.8241 230.865 1.41088 -0.768268 0.442328 0.767364 no TCONS_00004109 XLOC_001303 - chr1:9711789-9884550 iPS hESC OK 3.82816 145.676 5.24996 -0.201001 0.840698 0.999997 no TCONS_00004110 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004111 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC OK 340.016 1063.01 1.64448 -4.49396 6.99092e-06 0.000102028 yes TCONS_00004112 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC OK 134.509 521.539 1.95507 -3.15056 0.00162957 0.0106611 yes TCONS_00004113 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC NOTEST 72.4794 124.662 0.782384 -0.822886 0.410573 1 no TCONS_00004114 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC OK 406.916 531.034 0.384071 -1.04938 0.294002 0.611919 no TCONS_00004115 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 14.1134 3.50582 -2.00924 0.588027 0.556514 1 no TCONS_00004116 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC OK 217.917 164.494 -0.405742 0.752341 0.451846 0.778938 no TCONS_00004117 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC OK 89.4602 29.7283 -1.58941 1.6591 0.0970964 0.286663 no TCONS_00004118 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004119 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC OK 485.4 857.687 0.821278 -1.82315 0.0682806 0.221965 no TCONS_00004120 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC OK 298.378 268.726 -0.151007 0.315303 0.752532 0.999997 no TCONS_00004121 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 8.71581 21.1364 1.27802 -1.81184 0.0700114 0.225484 no TCONS_00004122 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 1.21532 37.729 4.95627 -0.707612 0.479186 0.798034 no TCONS_00004123 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 8.95125 49.2697 2.46054 -2.10645 0.0351649 0.134167 no TCONS_00004124 XLOC_001307 - chr1:10696667-10856707 iPS hESC NOTEST 2.07597 1.40186 -0.566439 0.097369 0.922433 1 no TCONS_00004125 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 1.66784 0 -1.79769e+308 -1.79769e+308 0.153547 1 no TCONS_00004126 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 0 0.000964262 1.79769e+308 1.79769e+308 0.499148 1 no TCONS_00004127 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 0.000832712 4.32713 12.3433 -0.00632904 0.99495 1 no TCONS_00004128 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC OK 68.298 45.371 -0.590072 1.15201 0.249316 0.549443 no TCONS_00004129 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 1.00455 1.79769e+308 1.79769e+308 0.342184 1 no TCONS_00004130 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC OK 6.76699 11.1666 0.7226 -0.431446 0.666144 0.958788 no TCONS_00004131 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004132 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 1171.02 432.981 -1.43539 2.34312 0.0191233 1 no TCONS_00004133 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC OK 1002.98 4481.12 2.15957 -4.75079 2.02625e-06 3.41031e-05 yes TCONS_00004134 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC OK 1339.2 1276.69 -0.0689703 0.260373 0.794576 0.999997 no TCONS_00004135 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC NOTEST 0 4.49163 1.79769e+308 1.79769e+308 0.244149 1 no TCONS_00004136 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC OK 90.8453 67.2406 -0.43408 0.357367 0.720817 0.984819 no TCONS_00004137 XLOC_001312 - chr1:11166588-11322608 iPS hESC OK 59.0429 135.175 1.195 -1.06237 0.288069 0.604828 no TCONS_00004138 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC OK 578.796 892.477 0.624761 -2.6171 0.00886801 0.0450305 yes TCONS_00004139 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC OK 302.813 1488.36 2.29722 -4.30714 1.65381e-05 0.000218449 yes TCONS_00004140 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 0 7.02688 1.79769e+308 1.79769e+308 0.357358 1 no TCONS_00004141 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 5.94962 4.06337 -0.550121 0.0348578 0.972193 1 no TCONS_00004142 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC OK 107.944 309.163 1.51808 -0.469871 0.638447 0.941653 no TCONS_00004143 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC OK 4377.8 6448.41 0.558739 -2.25372 0.0242141 0.0992824 no TCONS_00004144 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 12.2816 64.418 2.39096 -1.94804 0.0514098 1 no TCONS_00004145 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC OK 98.8766 93.2442 -0.0846153 0.198665 0.842525 0.999997 no TCONS_00004146 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC OK 66.9034 27.4533 -1.2851 0.917236 0.359019 0.682753 no TCONS_00004147 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004148 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC OK 3.4039 10.2838 1.59511 -0.248783 0.803529 0.999997 no TCONS_00004149 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC NOTEST 770.486 7.22153 -6.73732 7.91417 2.44249e-15 1 no TCONS_00004150 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC OK 537.636 657.437 0.290224 -0.772108 0.44005 0.764684 no TCONS_00004151 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC OK 136.358 97.0102 -0.491188 0.590457 0.554884 0.869402 no TCONS_00004152 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 664.349 334.324 -0.990695 2.01371 0.0440397 0.157382 no TCONS_00004153 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 631.203 302.602 -1.06069 2.4074 0.0160665 0.0724209 no TCONS_00004154 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 34.783 10.8508 -1.68058 0.504821 0.613685 0.925392 no TCONS_00004155 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 29.3372 28.066 -0.0639099 0.0170247 0.986417 0.999997 no TCONS_00004156 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 17.2087 0 -1.79769e+308 -1.79769e+308 0.447612 1 no TCONS_00004157 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004158 XLOC_001321 - chr1:12907235-12908578 iPS hESC OK 162.796 2184.6 3.74623 -7.81032 5.77316e-15 3.88664e-13 yes TCONS_00004159 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004160 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no TCONS_00004161 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004162 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS hESC NOTEST 0.337687 0 -1.79769e+308 -1.79769e+308 0.414194 1 no TCONS_00004163 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS hESC NOTEST 0.334536 0 -1.79769e+308 -1.79769e+308 0.414227 1 no TCONS_00004164 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS hESC NOTEST 0.000123029 0 -1.79769e+308 -1.79769e+308 0.499966 1 no TCONS_00004165 XLOC_001325 - chr1:13182960-13183967 iPS hESC OK 22.2793 275.825 3.62998 -6.09934 1.0651e-09 3.17553e-08 yes TCONS_00004166 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004167 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004168 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004169 XLOC_001328 PRAMEF14 chr1:13447413-13452656 iPS hESC NOTEST 0.200361 0 -1.79769e+308 -1.79769e+308 0.436402 1 no TCONS_00004170 XLOC_001328 PRAMEF13 chr1:13447413-13452656 iPS hESC NOTEST 0.000572928 0 -1.79769e+308 -1.79769e+308 0.499811 1 no TCONS_00004171 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004172 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00004173 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TCONS_00004174 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004175 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC NOTEST 6.96034 8.16584 0.230444 -0.308805 0.75747 1 no TCONS_00004176 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS hESC NOTEST 8.04256 9.25388 0.202404 -0.165541 0.868518 1 no TCONS_00004177 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS hESC NOTEST 0.000490761 0 -1.79769e+308 -1.79769e+308 0.499439 1 no TCONS_00004178 XLOC_001335 - chr1:15573767-15726776 iPS hESC NOTEST 0.432797 3.71564 3.10185 -1.10753 0.268064 1 no TCONS_00004179 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 75.4615 32.8483 -1.19992 1.82987 0.06727 0.219695 no TCONS_00004180 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 0 197.024 1.79769e+308 1.79769e+308 2.85929e-13 1.53009e-11 yes TCONS_00004181 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 145.227 132.595 -0.131284 0.158193 0.874304 0.999997 no TCONS_00004182 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 0 17.767 1.79769e+308 1.79769e+308 0.0690623 0.22348 no TCONS_00004183 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004184 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004185 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 173.37 51.7979 -1.74289 2.23986 0.0250997 0.101913 no TCONS_00004186 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC OK 122.09 115.866 -0.0754893 0.0853533 0.931981 0.999997 no TCONS_00004187 XLOC_001338 - chr1:16133656-16134194 iPS hESC OK 7916.63 16097 1.02384 -3.79718 0.000146354 0.00139471 yes TCONS_00004188 XLOC_001339 - chr1:16160709-16266950 iPS hESC OK 68.8094 58.2932 -0.239277 0.215806 0.829139 0.999997 no TCONS_00004189 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 106.181 259.204 1.28756 -2.35224 0.0186609 0.0811857 no TCONS_00004190 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 6.42816 1.79769e+308 1.79769e+308 0.128036 1 no TCONS_00004191 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 35.4246 24.9031 -0.508425 0.434566 0.663877 0.957553 no TCONS_00004192 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 6.98597 1.79769e+308 1.79769e+308 0.0872004 1 no TCONS_00004193 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0.0412124 2.7664 6.06879 -0.122625 0.902404 1 no TCONS_00004194 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 10.1074 7.07875 -0.51385 0.165597 0.868474 1 no TCONS_00004195 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004196 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 11.9384 8.33768 -0.517888 0.10734 0.914519 1 no TCONS_00004197 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 15.5862 20.1751 0.372302 -0.141959 0.887112 0.999997 no TCONS_00004198 XLOC_001341 - chr1:16317618-16317647 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004199 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 100.427 3.62862 -4.79058 4.26019 2.04257e-05 0.000266428 yes TCONS_00004200 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 12.5495 0 -1.79769e+308 -1.79769e+308 0.258765 1 no TCONS_00004201 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 8.04701 0 -1.79769e+308 -1.79769e+308 0.344783 1 no TCONS_00004202 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004203 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 71.8733 3.46957 -4.37263 3.30917 0.00093574 0.0065976 yes TCONS_00004204 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC NOTEST 7.54529 4.46492 -0.756942 0.0462021 0.963149 1 no TCONS_00004205 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC OK 6.09452 21.4939 1.81834 -0.228218 0.819477 0.999997 no TCONS_00004206 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC OK 234.901 573.472 1.28767 -3.47537 0.000510153 0.00400259 yes TCONS_00004207 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC NOTEST 22.2582 2.16378 -3.36271 0.380442 0.703618 1 no TCONS_00004208 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 17.0126 324.019 4.2514 -2.46691 0.0136284 0.0640595 no TCONS_00004209 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004210 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 156.261 678.385 2.11814 -4.94328 7.68185e-07 1.44433e-05 yes TCONS_00004211 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC OK 28.2148 53.4824 0.922611 -1.70186 0.088781 0.26853 no TCONS_00004212 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 22.2988 2.24339 -3.31321 0.94358 0.345384 1 no TCONS_00004213 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 11.178 8.45144 -0.403399 0.128754 0.897552 1 no TCONS_00004214 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC OK 292.804 256.568 -0.190597 0.474516 0.635132 0.940085 no TCONS_00004215 XLOC_001347 - chr1:16576559-16678948 iPS hESC OK 27.075 0.999115 -4.76017 1.85886 0.0630466 0.208592 no TCONS_00004216 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004217 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 1.25463 0 -1.79769e+308 -1.79769e+308 0.44193 1 no TCONS_00004218 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004219 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 39.2853 48.5164 0.304485 -0.625046 0.531941 0.84758 no TCONS_00004220 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 0 76.9358 1.79769e+308 1.79769e+308 0.00484521 0.0266806 yes TCONS_00004221 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 7.75221 47.6242 2.61902 -0.613243 0.539716 0.853323 no TCONS_00004222 XLOC_001350 - chr1:16860385-16864669 iPS hESC OK 23.1603 11.9908 -0.949728 1.38101 0.167277 0.419096 no TCONS_00004223 XLOC_001351 - chr1:16888922-16890082 iPS hESC OK 223.564 175.981 -0.345265 0.727455 0.466947 0.792342 no TCONS_00004224 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 153.181 109.231 -0.487846 0.954416 0.339873 0.661902 no TCONS_00004225 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 0 120.904 1.79769e+308 1.79769e+308 0.000512351 0.00400478 yes TCONS_00004226 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 65.4571 27.9922 -1.22553 0.693202 0.488183 0.804256 no TCONS_00004227 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 2.67381 2.13127 -0.327187 0.010726 0.991442 1 no TCONS_00004228 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 100.986 59.3019 -0.768009 0.890307 0.373301 0.697684 no TCONS_00004229 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 8.12905 1.71985 -2.2408 0.446374 0.655327 1 no TCONS_00004230 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 119.817 53.7943 -1.1553 1.55404 0.120175 0.336199 no TCONS_00004231 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 146.83 39.2466 -1.9035 1.90435 0.056864 0.191721 no TCONS_00004232 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 24.9871 109.535 2.13214 -1.2701 0.20405 0.479407 no TCONS_00004233 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 0 40.9893 1.79769e+308 1.79769e+308 0.00306851 0.0180903 yes TCONS_00004234 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 62.8563 148.568 1.241 -1.57081 0.116226 0.331504 no TCONS_00004235 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 59.3619 154.311 1.37823 -1.44733 0.147805 0.389217 no TCONS_00004236 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 16.2307 32.3396 0.994576 -0.518106 0.604384 0.921832 no TCONS_00004237 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 93.9509 210.996 1.16724 -0.584707 0.558745 0.874794 no TCONS_00004238 XLOC_001354 ESPN chr1:17017712-17046652 iPS hESC OK 2.07327 11.1097 2.42183 -1.80538 0.0710156 0.228015 no TCONS_00004239 XLOC_001354 ESPNP chr1:17017712-17046652 iPS hESC NOTEST 0 3.47275 1.79769e+308 1.79769e+308 0.0482484 1 no TCONS_00004240 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC OK 14.2231 38.162 1.42391 -0.809323 0.418329 0.746199 no TCONS_00004241 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC NOTEST 1.90183 3.25841 0.776778 -0.0641904 0.948819 1 no TCONS_00004242 XLOC_001356 - chr1:17066767-17299474 iPS hESC OK 133.893 415.352 1.63325 -0.775952 0.437778 0.763873 no TCONS_00004243 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC OK 1631.49 4040.61 1.30838 -3.76113 0.000169146 0.00156893 yes TCONS_00004244 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC OK 316.038 825.956 1.38597 -1.4852 0.137492 0.371006 no TCONS_00004245 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004246 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004247 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 66.6283 366.46 2.45945 -1.08886 0.276215 0.590061 no TCONS_00004248 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 124.905 537.876 2.10644 -3.36036 0.000778423 0.00564086 yes TCONS_00004249 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 125.906 472.669 1.90849 -3.59131 0.000329021 0.00274667 yes TCONS_00004250 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 4.40168 12.3556 1.48903 -0.188342 0.850608 0.999997 no TCONS_00004251 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 0 22.7704 1.79769e+308 1.79769e+308 0.206562 0.482463 no TCONS_00004252 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 26.0242 18.4495 -0.496273 0.192583 0.847286 0.999997 no TCONS_00004253 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC OK 1562.94 1548.47 -0.0134229 0.0414128 0.966967 0.999997 no TCONS_00004254 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC OK 25.3396 62.6093 1.30498 -2.41491 0.015739 0.071098 no TCONS_00004255 XLOC_001360 - chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004256 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC NOTEST 6.09039 3.49549 -0.801041 0.27199 0.785629 1 no TCONS_00004257 XLOC_001361 - chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004258 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 2447.51 4130.7 0.75507 -3.33432 0.000855069 1 no TCONS_00004259 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC OK 895.394 1326.29 0.566807 -1.55253 0.120535 0.336479 no TCONS_00004260 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TCONS_00004261 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 85.8408 218.303 1.3466 -1.97734 0.0480029 0.167529 no TCONS_00004262 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 14.7849 13.708 -0.109107 0.0215349 0.982819 0.999997 no TCONS_00004263 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 163.444 420.478 1.36324 -2.82495 0.00472877 0.0261776 yes TCONS_00004264 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC OK 102.06 89.541 -0.188796 0.471554 0.637245 0.941276 no TCONS_00004265 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 15.0916 12.454 -0.277135 0.0526549 0.958007 0.999997 no TCONS_00004266 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 14.6135 50.0495 1.77606 -0.0664172 0.947046 0.999997 no TCONS_00004267 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 1.68163 92.8871 5.78754 -0.0529208 0.957795 0.999997 no TCONS_00004268 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 0 22.9292 1.79769e+308 1.79769e+308 0.171731 0.426163 no TCONS_00004269 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 0 167.676 1.79769e+308 1.79769e+308 0.0104565 0.0519591 no TCONS_00004270 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 28.2328 557.747 4.30416 -1.6445 0.100073 0.293331 no TCONS_00004271 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 4.91166 426.519 6.44026 -0.372414 0.709584 0.979971 no TCONS_00004272 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 623.312 765.815 0.297043 -1.44135 0.149486 0.390949 no TCONS_00004273 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 39.3315 5.33048 -2.88335 0.667548 0.504422 0.822445 no TCONS_00004274 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 38.8471 192.593 2.30967 -1.06958 0.284809 0.601617 no TCONS_00004275 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004276 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 112.418 4.71016 -4.57695 1.8239 0.0681666 0.22194 no TCONS_00004277 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 44.1215 13.1602 -1.7453 1.17092 0.241632 0.538766 no TCONS_00004278 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 256.033 452.421 0.821336 -2.11345 0.0345622 0.132351 no TCONS_00004279 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 0 27.296 1.79769e+308 1.79769e+308 0.0644234 0.211735 no TCONS_00004280 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 41.707 112.439 1.43078 -1.16481 0.244095 0.541366 no TCONS_00004281 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC NOTEST 11.7322 3.92853 -1.57841 0.347093 0.728522 1 no TCONS_00004282 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 8.47305 11.7019 0.465785 -0.723919 0.469116 1 no TCONS_00004283 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 0.000354505 0 -1.79769e+308 -1.79769e+308 0.499887 1 no TCONS_00004284 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC OK 16.1619 17.2325 0.0925378 -0.140051 0.88862 0.999997 no TCONS_00004285 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC OK 341.159 693.277 1.02299 -2.36569 0.0179965 0.0785748 no TCONS_00004286 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004287 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 22.0575 2.29939 -3.26195 0.486957 0.626289 1 no TCONS_00004288 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 1302.83 0 -1.79769e+308 -1.79769e+308 8.13491e-05 0.000848878 yes TCONS_00004289 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 43.0618 69.4828 0.690248 -0.244309 0.806991 0.999997 no TCONS_00004290 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 2361.48 5169.04 1.1302 -3.61198 0.000303867 0.00255714 yes TCONS_00004291 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 17.4929 8.25067 -1.08418 0.175966 0.860321 1 no TCONS_00004292 XLOC_001372 - chr1:19665273-19811992 iPS hESC OK 37.4567 15.7099 -1.25355 0.552166 0.580835 0.893954 no TCONS_00004293 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 6.20966 0 -1.79769e+308 -1.79769e+308 0.299442 1 no TCONS_00004294 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC OK 48.488 56.5465 0.221808 -0.372847 0.709262 0.979971 no TCONS_00004295 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 1.29633 1.79769e+308 1.79769e+308 0.337923 1 no TCONS_00004296 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 2.72756 0 -1.79769e+308 -1.79769e+308 0.425778 1 no TCONS_00004297 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 16.1889 9.20491 -0.81453 0.442929 0.657817 1 no TCONS_00004298 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 6.08129 0 -1.79769e+308 -1.79769e+308 0.444566 1 no TCONS_00004299 XLOC_001374 RNF186 chr1:20140522-20141771 iPS hESC NOTEST 1.07721 0.423276 -1.34763 0.461523 0.644423 1 no TCONS_00004300 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004301 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004302 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC NOTEST 0 0.000482041 1.79769e+308 1.79769e+308 0.499832 1 no TCONS_00004303 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC OK 61.8417 35.1077 -0.816792 0.836305 0.402983 0.730692 no TCONS_00004304 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC OK 72.4826 0 -1.79769e+308 -1.79769e+308 0.0514411 0.176575 no TCONS_00004305 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004306 XLOC_001377 - chr1:20438440-20446008 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004307 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004308 XLOC_001379 - chr1:20687597-20755275 iPS hESC NOTEST 0 0.74001 1.79769e+308 1.79769e+308 0.239739 1 no TCONS_00004309 XLOC_001379 - chr1:20687597-20755275 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004310 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC OK 163.673 6.4946 -4.65543 3.51703 0.000436412 0.00354394 yes TCONS_00004311 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC OK 171.705 124.278 -0.466364 0.783233 0.43349 0.760247 no TCONS_00004312 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC OK 392.307 351.837 -0.157076 0.430656 0.666719 0.958954 no TCONS_00004313 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC OK 4421.99 4971.96 0.169117 -0.82313 0.410434 0.737156 no TCONS_00004314 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC NOTEST 5.84642 0 -1.79769e+308 -1.79769e+308 0.477209 1 no TCONS_00004315 XLOC_001382 - chr1:20978259-20988037 iPS hESC NOTEST 5.18588 0 -1.79769e+308 -1.79769e+308 0.481145 1 no TCONS_00004316 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC OK 30.3966 19.3729 -0.649866 0.144494 0.88511 0.999997 no TCONS_00004317 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 3.5495 1.79769e+308 1.79769e+308 0.371904 1 no TCONS_00004318 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC OK 7.59828 11.229 0.563479 -0.157311 0.875 0.999997 no TCONS_00004319 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 5.90044 1.79769e+308 1.79769e+308 0.137159 1 no TCONS_00004320 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 5.15833 48.9997 3.2478 -1.10694 0.268319 1 no TCONS_00004321 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 53.8428 102.304 0.926032 -1.78352 0.0745024 1 no TCONS_00004322 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 0 16.4694 1.79769e+308 1.79769e+308 0.00567788 1 no TCONS_00004323 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 17.3446 129.453 2.89987 -2.94251 0.00325558 1 no TCONS_00004324 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC OK 56.3467 160.628 1.51132 -2.46431 0.0137277 0.0642369 no TCONS_00004325 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 44.0552 56.1343 0.34957 -0.170091 0.864938 0.999997 no TCONS_00004326 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 302.536 107.411 -1.49397 2.95173 0.00315996 0.0185248 yes TCONS_00004327 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 92.6039 183.91 0.989855 -1.02597 0.304908 0.6228 no TCONS_00004328 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 240.174 25.9672 -3.20932 3.45219 0.000556059 0.00426653 yes TCONS_00004329 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 394.454 56.9742 -2.79148 4.79882 1.59603e-06 2.79908e-05 yes TCONS_00004330 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 478.545 494.915 0.048525 -0.0769961 0.938627 0.999997 no TCONS_00004331 XLOC_001385 - chr1:21069170-21113799 iPS hESC OK 91.5259 12.355 -2.88908 1.76694 0.077239 0.242403 no TCONS_00004332 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 67.7047 19.1563 -1.82144 1.00477 0.315007 0.633963 no TCONS_00004333 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 201.731 108.229 -0.898344 0.500353 0.616827 0.92719 no TCONS_00004334 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 16.2897 6.37526 -1.3534 0.281412 0.778395 1 no TCONS_00004335 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 4.89492 0 -1.79769e+308 -1.79769e+308 0.431848 1 no TCONS_00004336 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 494.463 247.208 -1.00014 2.92283 0.00346871 0.0201089 yes TCONS_00004337 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 23.2845 0 -1.79769e+308 -1.79769e+308 0.220025 1 no TCONS_00004338 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 62.5109 265.087 2.08429 -2.25602 0.0240691 0.0988824 no TCONS_00004339 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004340 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 155.005 149.423 -0.052907 0.092478 0.926318 0.999997 no TCONS_00004341 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004342 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 310.854 0 -1.79769e+308 -1.79769e+308 0.0196006 0.0843692 no TCONS_00004343 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 99.134 39.0388 -1.34447 0.920787 0.357162 0.681214 no TCONS_00004344 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 5.98009 1.79769e+308 1.79769e+308 0.100311 1 no TCONS_00004345 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 90.6691 28.0163 -1.69434 2.15001 0.0315541 1 no TCONS_00004346 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 39.3564 95.1492 1.27359 -1.02647 0.304672 0.6228 no TCONS_00004347 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 4.34987 1.79769e+308 1.79769e+308 0.14176 1 no TCONS_00004348 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 67.8265 419.192 2.62769 -3.99154 6.56469e-05 0.000721079 yes TCONS_00004349 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 30.7121 14.4148 -1.09126 0.482243 0.629633 0.935929 no TCONS_00004350 XLOC_001388 - chr1:21543739-21672034 iPS hESC NOTEST 8.5531 0.863796 -3.30769 0.721023 0.470896 1 no TCONS_00004351 XLOC_001389 - chr1:21749600-21754300 iPS hESC OK 100.478 59.716 -0.750686 1.55954 0.118868 0.334735 no TCONS_00004352 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 3.1394 23.4017 2.89805 -0.879996 0.378862 0.705338 no TCONS_00004353 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 27.4868 67.9603 1.30596 -1.7024 0.0886796 0.26853 no TCONS_00004354 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 14.88 64.0794 2.10648 -1.82075 0.0686453 1 no TCONS_00004355 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 10.5936 23.1783 1.12958 -0.628018 0.529992 0.84758 no TCONS_00004356 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 119.181 49.6025 -1.26468 1.44177 0.149366 0.390949 no TCONS_00004357 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 397.254 512.56 0.367661 -0.988461 0.322927 0.64431 no TCONS_00004358 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004359 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 31.0054 26.2055 -0.242649 0.140056 0.888615 0.999997 no TCONS_00004360 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 9.73763 1.61711 -2.59015 0.351192 0.725444 1 no TCONS_00004361 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 40.7577 4.47726 -3.18639 1.09552 0.27329 0.585581 no TCONS_00004362 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 215.746 175.948 -0.294181 0.328472 0.742554 0.996561 no TCONS_00004363 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 330.639 44.7452 -2.88545 3.60201 0.000315763 0.00264658 yes TCONS_00004364 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 8.87162 185.017 4.38232 -1.17013 0.24195 0.5389 no TCONS_00004365 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 101.632 741.639 2.86737 -8.41776 0 0 yes TCONS_00004366 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 15.8513 124.328 2.97148 -3.02786 0.00246295 0.0149424 yes TCONS_00004367 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 32.9146 0 -1.79769e+308 -1.79769e+308 0.395674 0.722461 no TCONS_00004368 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 15.9522 73.6692 2.2073 -4.20375 2.62532e-05 1 no TCONS_00004369 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 0.000222119 0 -1.79769e+308 -1.79769e+308 0.499864 1 no TCONS_00004370 XLOC_001394 - chr1:23337326-23342343 iPS hESC NOTEST 3.40123 1.30651 -1.38034 0.472724 0.63641 1 no TCONS_00004371 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC OK 331.605 143.088 -1.21256 3.14594 0.00165553 0.0107972 yes TCONS_00004372 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC NOTEST 472.843 289.415 -0.708223 2.42415 0.0153443 1 no TCONS_00004373 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC OK 56.1574 3.29156 -4.09263 1.67482 0.0939696 0.279365 no TCONS_00004374 XLOC_001396 HTR1D chr1:23518388-23521222 iPS hESC OK 223.865 138.505 -0.692693 1.72089 0.0852712 0.261707 no TCONS_00004375 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 18.8159 3.27082 -2.52423 0.201841 0.840041 1 no TCONS_00004376 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 125.856 198.346 0.656247 -0.569007 0.569351 0.882595 no TCONS_00004377 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 871.304 1176.83 0.433658 -1.08819 0.276512 0.590061 no TCONS_00004378 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 1672.29 1344.32 -0.314945 0.980136 0.327019 0.648137 no TCONS_00004379 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 233.679 200.546 -0.220597 0.20504 0.837541 0.999997 no TCONS_00004380 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 174.016 2.65635 -6.03364 0.842537 0.399487 0.727513 no TCONS_00004381 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 0.231084 3.70001 4.00104 -0.169677 0.865264 1 no TCONS_00004382 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 46.0789 90.6925 0.976877 -0.461826 0.644206 0.944805 no TCONS_00004383 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC OK 32.0809 18.4192 -0.8005 0.984269 0.324983 0.647176 no TCONS_00004384 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC OK 28.9081 0 -1.79769e+308 -1.79769e+308 0.044174 0.157592 no TCONS_00004385 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC OK 72.9916 1.36049 -5.74553 4.01486 5.948e-05 0.000663822 yes TCONS_00004386 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 4.90057 1.79769e+308 1.79769e+308 0.130776 1 no TCONS_00004387 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC OK 61.7872 0 -1.79769e+308 -1.79769e+308 0.148114 0.389217 no TCONS_00004388 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004389 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 57.325 22.8075 -1.32966 0.993685 0.320376 0.640446 no TCONS_00004390 XLOC_001400 - chr1:23755055-23811057 iPS hESC OK 31.2959 92.1289 1.55768 -1.02864 0.303648 0.621898 no TCONS_00004391 XLOC_001400 - chr1:23755055-23811057 iPS hESC OK 33.3151 59.9998 0.84878 -0.634626 0.525673 0.845207 no TCONS_00004392 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 181.965 557.63 1.61565 -3.70019 0.00021544 0.00193803 yes TCONS_00004393 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004394 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 0 24.2074 1.79769e+308 1.79769e+308 0.0805175 0.25006 no TCONS_00004395 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 5.93528 1.79769e+308 1.79769e+308 0.435254 1 no TCONS_00004396 XLOC_001401 - chr1:23755055-23811057 iPS hESC NOTEST 14.3352 1.51415 -3.24298 0.863087 0.38809 1 no TCONS_00004397 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC OK 17.3678 95.4288 2.45801 -4.53767 5.68796e-06 8.3597e-05 yes TCONS_00004398 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC OK 2233.71 3052.85 0.450715 -1.53313 0.125244 0.345746 no TCONS_00004399 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC OK 290.313 130.941 -1.14869 1.23736 0.215955 0.493646 no TCONS_00004400 XLOC_001404 - chr1:24069855-24104777 iPS hESC OK 29.788 77.4967 1.37941 -0.241165 0.809427 0.999997 no TCONS_00004401 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 33.6768 38.3217 0.18641 -0.095538 0.923888 0.999997 no TCONS_00004402 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 0 10.1974 1.79769e+308 1.79769e+308 0.161752 0.411115 no TCONS_00004403 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 17.4871 17.3703 -0.00967201 0.00316591 0.997474 0.999997 no TCONS_00004404 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 150.589 392.012 1.38028 -2.25204 0.0243199 0.0995208 no TCONS_00004405 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 61.4119 43.8262 -0.486724 0.38186 0.702565 0.977503 no TCONS_00004406 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 34.8907 51.369 0.558054 -0.378535 0.705034 0.978979 no TCONS_00004407 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004408 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 6.56657 9.86629 0.587369 -0.0763122 0.939171 0.999997 no TCONS_00004409 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 4.49564 5.43458 0.273642 -0.0103642 0.991731 1 no TCONS_00004410 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 184.728 286.755 0.634418 -1.21005 0.226262 0.51327 no TCONS_00004411 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004412 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 0 42.7613 1.79769e+308 1.79769e+308 0.00224566 0.0137844 yes TCONS_00004413 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 7.68224 12.5886 0.712515 -0.22441 0.822439 0.999997 no TCONS_00004414 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 7.05744 9.6936 0.457888 -0.0865224 0.931051 0.999997 no TCONS_00004415 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 17.3205 7.27536 -1.25139 0.619526 0.53557 1 no TCONS_00004416 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC OK 207.2 122.432 -0.759046 1.77276 0.0762682 0.240078 no TCONS_00004417 XLOC_001407 - chr1:24171573-24194821 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004418 XLOC_001407 - chr1:24171573-24194821 iPS hESC OK 0 9.88427 1.79769e+308 1.79769e+308 0.120815 0.336637 no TCONS_00004419 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00004420 XLOC_001409 - chr1:24292938-24306821 iPS hESC OK 869.644 282.334 -1.62302 3.65869 0.000253508 0.00219948 yes TCONS_00004421 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC OK 177.784 533.444 1.58521 -1.56273 0.118117 0.334024 no TCONS_00004422 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC OK 1054.92 767.195 -0.459465 1.45011 0.147028 0.388414 no TCONS_00004423 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0 1.19576 1.79769e+308 1.79769e+308 0.127659 1 no TCONS_00004424 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.452065 1.77127 1.97018 -0.674069 0.500267 1 no TCONS_00004425 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.798149 0.363637 -1.13416 0.478214 0.632498 1 no TCONS_00004426 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 1.49896 0 -1.79769e+308 -1.79769e+308 0.204218 1 no TCONS_00004427 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.347098 0.607421 0.807353 -0.26392 0.791841 1 no TCONS_00004428 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 6.64523 1.45433 -2.19197 1.68141 0.092683 1 no TCONS_00004429 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 5.55488 1.79769e+308 1.79769e+308 0.000346682 1 no TCONS_00004430 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004431 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004432 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004433 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 81.6347 44.0625 -0.889632 1.82919 0.0673716 0.219695 no TCONS_00004434 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 4.07053 24.4887 2.58883 -0.736693 0.461309 0.787849 no TCONS_00004435 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 0 12.9816 1.79769e+308 1.79769e+308 0.00114974 0.00797177 yes TCONS_00004436 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 13.7311 125.353 3.19048 -0.368573 0.712446 0.980323 no TCONS_00004437 XLOC_001413 - chr1:24580829-24580859 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004438 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004439 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 11.5429 7.16763 -0.687434 0.321028 0.748189 1 no TCONS_00004440 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC OK 2.86176 10.1778 1.83045 -0.198733 0.842471 0.999997 no TCONS_00004441 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC OK 141.615 132.318 -0.0979634 0.20505 0.837533 0.999997 no TCONS_00004442 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no TCONS_00004443 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 8.9548 2.3477 -1.93141 0.435766 0.663007 1 no TCONS_00000001 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts NOTEST 6.88821 10.9963 0.674813 -0.0480587 0.961669 1 no TCONS_00000002 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts NOTEST 13.1105 0 -1.79769e+308 -1.79769e+308 0.40846 1 no TCONS_00000003 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts NOTEST 0.218851 5.15434 4.55777 -0.158673 0.873927 1 no TCONS_00000004 XLOC_000002 OR4F5 chr1:69090-70008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000005 XLOC_000003 - chr1:321083-321114 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000006 XLOC_000004 - chr1:321145-321223 iPS Fibroblasts OK 0 14237.7 1.79769e+308 1.79769e+308 0.328042 0.649549 no TCONS_00000007 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 189.247 29.2848 -2.69205 2.62731 0.00860621 0.0439148 yes TCONS_00000008 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 76.6833 5.01291 -3.93519 1.57798 0.11457 0.327544 no TCONS_00000009 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 89.8931 13.7589 -2.70785 1.73539 0.0826718 0.255231 no TCONS_00000010 XLOC_000006 OR4F16 chr1:367658-368595 iPS Fibroblasts NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00000011 XLOC_000007 - chr1:420205-421839 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000012 XLOC_000008 - chr1:566461-568045 iPS Fibroblasts NOTEST 41712.9 69492.5 0.736363 -3.15392 0.00161094 1 no TCONS_00000013 XLOC_000009 - chr1:568148-568842 iPS Fibroblasts NOTEST 665.127 26012.6 5.28944 -8.42916 0 1 no TCONS_00000014 XLOC_000010 - chr1:568843-568912 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000015 XLOC_000011 - chr1:569326-570349 iPS Fibroblasts OK 7343.63 37535.9 2.35371 -4.48577 7.26496e-06 0.000103849 yes TCONS_00000016 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000017 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000018 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts OK 0 60.0796 1.79769e+308 1.79769e+308 0.250273 0.550391 no TCONS_00000019 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts OK 40.7706 17.1018 -1.25338 0.11738 0.906559 0.999997 no TCONS_00000020 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts OK 80.8625 214.895 1.41009 -2.01795 0.0435968 0.156334 no TCONS_00000021 XLOC_000013 - chr1:791897-794579 iPS Fibroblasts OK 8.98318 74.5004 3.05195 -3.80203 0.000143517 0.00138028 yes TCONS_00000022 XLOC_000014 - chr1:846814-850328 iPS Fibroblasts NOTEST 8.69571 0.58031 -3.90541 2.88572 0.00390514 1 no TCONS_00000023 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 95.4282 0 -1.79769e+308 -1.79769e+308 0.357743 0.681214 no TCONS_00000024 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 52.9724 3.81714 -3.79467 0.0700385 0.944163 0.999997 no TCONS_00000025 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 48.0828 34.9169 -0.461596 0.071855 0.942717 0.999997 no TCONS_00000026 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 63.5773 138.131 1.11946 -1.35168 0.176477 0.432286 no TCONS_00000027 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 55.6229 48.7092 -0.191482 0.0905716 0.927833 0.999997 no TCONS_00000028 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 29.3795 99.7819 1.76397 -1.21385 0.224804 0.510517 no TCONS_00000029 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 34.9548 60.5379 0.792348 -0.367699 0.713097 0.980323 no TCONS_00000030 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts NOTEST 6.18605 5.90797 -0.0663546 0.0152689 0.987818 1 no TCONS_00000031 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts OK 0.000108087 22.8971 17.6926 -0.00129837 0.998964 0.999997 no TCONS_00000032 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts OK 0 30.5047 1.79769e+308 1.79769e+308 0.0475585 0.166936 no TCONS_00000033 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts OK 550.84 3379.09 2.61693 -4.82844 1.37606e-06 2.45456e-05 yes TCONS_00000034 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts OK 162.844 2553.38 3.97085 -8.29349 0 0 yes TCONS_00000035 XLOC_000020 - chr1:995082-1001833 iPS Fibroblasts NOTEST 2.60573 5.82921 1.16161 -0.289721 0.77203 1 no TCONS_00000036 XLOC_000020 - chr1:995082-1001833 iPS Fibroblasts OK 19.9887 64.5665 1.6916 -1.79883 0.0720452 0.230258 no TCONS_00000037 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000038 XLOC_000022 - chr1:1102483-1102578 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000039 XLOC_000023 - chr1:1103242-1103332 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000040 XLOC_000024 - chr1:1104384-1104467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000041 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000042 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000043 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000044 XLOC_000026 B3GALT6 chr1:1167628-1170418 iPS Fibroblasts OK 223.432 1068.96 2.25829 -4.69611 2.65164e-06 4.39204e-05 yes TCONS_00000045 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 9.60499 1.79769e+308 1.79769e+308 0.172317 1 no TCONS_00000046 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 8.76366 19.6908 1.16791 -1.10264 0.270183 0.580712 no TCONS_00000047 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 0.000995546 15.2046 13.8987 -0.00956064 0.992372 0.999997 no TCONS_00000048 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 6.75717 1.79769e+308 1.79769e+308 0.220782 1 no TCONS_00000049 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 0 12.2197 1.79769e+308 1.79769e+308 0.24525 0.542776 no TCONS_00000050 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 253.688 694.672 1.45327 -0.855802 0.392107 0.720359 no TCONS_00000051 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 81.6371 160.99 0.979678 -0.200589 0.84102 0.999997 no TCONS_00000052 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 21.1644 15.8664 -0.415662 0.0151036 0.98795 0.999997 no TCONS_00000053 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts OK 140.404 781.158 2.47603 -4.62916 3.67149e-06 5.67585e-05 yes TCONS_00000054 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts NOTEST 6.25639 4.31837 -0.534842 0.552796 0.580403 1 no TCONS_00000055 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 53.2662 319.473 2.5844 -1.09334 0.274245 0.587025 no TCONS_00000056 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 95.5427 62.6627 -0.608538 0.14276 0.88648 0.999997 no TCONS_00000057 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 103.752 185.591 0.838985 -0.391215 0.695638 0.974922 no TCONS_00000058 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 7.20193 0 -1.79769e+308 -1.79769e+308 0.163163 1 no TCONS_00000059 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts OK 5.8712 29.8843 2.34766 -0.369855 0.71149 0.980323 no TCONS_00000060 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts OK 222.846 444.091 0.994812 -1.84544 0.0649735 0.213207 no TCONS_00000061 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts OK 12.4598 15.5201 0.316864 -0.390484 0.696179 0.974922 no TCONS_00000062 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 117.436 275.225 1.22874 -1.36979 0.170754 0.424975 no TCONS_00000063 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 77.2479 43.4345 -0.830655 0.448778 0.653591 0.951881 no TCONS_00000064 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 202.814 154.302 -0.394393 0.433885 0.664372 0.957553 no TCONS_00000065 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 35.8479 321.282 3.16388 -1.30931 0.190428 0.45576 no TCONS_00000066 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 31.4583 39.157 0.31583 -0.0834739 0.933475 0.999997 no TCONS_00000067 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 470.224 819.961 0.802208 -1.27348 0.202849 0.478113 no TCONS_00000068 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 100.608 1200.71 3.57707 -3.63335 0.000279761 0.00239287 yes TCONS_00000069 XLOC_000036 - chr1:1447554-1470064 iPS Fibroblasts OK 18.499 15.9237 -0.216277 0.025893 0.979343 0.999997 no TCONS_00000070 XLOC_000037 - chr1:1535818-1543166 iPS Fibroblasts NOTEST 2.79141 5.74721 1.04187 -0.592847 0.553283 1 no TCONS_00000071 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 13.0332 17.092 0.391122 -0.137577 0.890575 0.999997 no TCONS_00000072 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 9.17877 316.769 5.10899 -3.18271 0.00145902 0.00972834 yes TCONS_00000073 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000074 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 28.9547 66.3531 1.19637 -0.870536 0.384008 0.708393 no TCONS_00000075 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000076 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 4.60985 44.1025 3.25807 -1.11083 0.266643 0.576667 no TCONS_00000077 XLOC_000038 - chr1:1550883-1565984 iPS Fibroblasts OK 0.0361283 16.9683 8.87549 -0.248354 0.80386 0.999997 no TCONS_00000078 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 0 56.0751 1.79769e+308 1.79769e+308 0.131286 0.358163 no TCONS_00000079 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 0 45.3624 1.79769e+308 1.79769e+308 0.344684 0.66481 no TCONS_00000080 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 12.0776 30.3273 1.32828 -0.211428 0.832553 0.999997 no TCONS_00000081 XLOC_000038 - chr1:1550883-1565984 iPS Fibroblasts NOTEST 20.1981 0 -1.79769e+308 -1.79769e+308 0.367618 1 no TCONS_00000082 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts NOTEST 3.14247 6.12558 0.962948 -0.369472 0.711776 1 no TCONS_00000083 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 9.57879 0 -1.79769e+308 -1.79769e+308 0.0458444 1 no TCONS_00000084 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts OK 0 13.8369 1.79769e+308 1.79769e+308 0.106259 0.308433 no TCONS_00000085 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 0.730004 6.24162 3.09594 -0.400296 0.688939 1 no TCONS_00000086 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts OK 0 90.7454 1.79769e+308 1.79769e+308 0.467191 0.792342 no TCONS_00000087 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 19.4885 2.78903 -2.80478 0.00207132 0.998347 1 no TCONS_00000088 XLOC_000041 - chr1:1571099-1677431 iPS Fibroblasts OK 65.0308 84.1606 0.37202 -0.0435204 0.965287 0.999997 no TCONS_00000089 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts NOTEST 4.99201 11.254 1.17274 -0.821142 0.411566 1 no TCONS_00000090 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 5.39767 1.08118 -2.31973 1.23799 0.215719 1 no TCONS_00000091 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 12.037 0.393202 -4.93606 2.5189 0.0117721 1 no TCONS_00000092 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 199.815 0 -1.79769e+308 -1.79769e+308 0.00340279 0.0198369 yes TCONS_00000093 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 0 45.4119 1.79769e+308 1.79769e+308 0.206902 0.482463 no TCONS_00000094 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000095 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 94.566 0 -1.79769e+308 -1.79769e+308 0.0668121 0.218562 no TCONS_00000096 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 0 34.2875 1.79769e+308 1.79769e+308 0.311842 0.630024 no TCONS_00000097 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 5.19072 0 -1.79769e+308 -1.79769e+308 0.469481 1 no TCONS_00000098 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000099 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 7.19324 0 -1.79769e+308 -1.79769e+308 0.428534 1 no TCONS_00000100 XLOC_000045 - chr1:1981908-2139172 iPS Fibroblasts NOTEST 16.6051 11.1992 -0.568231 0.0728342 0.941938 1 no TCONS_00000101 XLOC_000046 - chr1:1981908-2139172 iPS Fibroblasts OK 66.2174 100.493 0.601808 -0.400478 0.688805 0.969343 no TCONS_00000102 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts OK 246.057 1645.91 2.74182 -6.24327 4.28516e-10 1.37816e-08 yes TCONS_00000103 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts OK 800.086 3798.35 2.24715 -4.84783 1.24819e-06 2.24567e-05 yes TCONS_00000104 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts OK 33.4962 143.247 2.09644 -0.721081 0.47086 0.793625 no TCONS_00000105 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0.769693 1.79769e+308 1.79769e+308 0.320193 1 no TCONS_00000106 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000107 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0.593027 1.79769e+308 1.79769e+308 0.393566 1 no TCONS_00000108 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 2.28814e-05 0 -1.79769e+308 -1.79769e+308 0.499982 1 no TCONS_00000109 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 1.08359 1.27131 0.230486 -0.115529 0.908026 1 no TCONS_00000110 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 1.2132 0 -1.79769e+308 -1.79769e+308 0.274622 1 no TCONS_00000111 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 21.3399 118.524 2.47355 -0.780042 0.435366 0.762202 no TCONS_00000112 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 4.50144 42.8167 3.24972 -0.928059 0.353377 0.677847 no TCONS_00000113 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 2.02513 46.0527 4.5072 -1.95813 0.0502153 0.173222 no TCONS_00000114 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 20.3741 650.706 4.99719 -4.14063 3.46353e-05 0.000422713 yes TCONS_00000115 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 0 29.4904 1.79769e+308 1.79769e+308 0.303208 0.621606 no TCONS_00000116 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 222.585 616.77 1.47038 -1.95459 0.0506313 0.174369 no TCONS_00000117 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 5.26014 1.79769e+308 1.79769e+308 0.467169 1 no TCONS_00000118 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 147.391 561.382 1.92934 -2.21473 0.0267784 0.106248 no TCONS_00000119 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000120 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 20.6279 21.4195 0.0543241 -0.0120819 0.99036 0.999997 no TCONS_00000121 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000122 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 48.0815 83.8728 0.802721 -0.409495 0.682176 0.967189 no TCONS_00000123 XLOC_000052 ACTRT2 chr1:2938045-2939465 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000124 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.586072 0 -1.79769e+308 -1.79769e+308 0.152132 1 no TCONS_00000125 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.00101879 7.0186 12.7501 -0.0317777 0.974649 1 no TCONS_00000126 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.419018 0 -1.79769e+308 -1.79769e+308 0.231242 1 no TCONS_00000127 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.000730027 1.20838 10.6928 -0.019103 0.984759 1 no TCONS_00000128 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 0.000653284 0 -1.79769e+308 -1.79769e+308 0.49908 1 no TCONS_00000129 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts OK 135.254 2.38434 -5.82594 3.95142 7.76902e-05 0.000827243 yes TCONS_00000130 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 2.38281 1.79769e+308 1.79769e+308 0.214761 1 no TCONS_00000131 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 23.0853 0.0183886 -10.2939 0.230903 0.81739 1 no TCONS_00000132 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 8.08924 0 -1.79769e+308 -1.79769e+308 0.379198 1 no TCONS_00000133 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000134 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts OK 546.504 2676.03 2.29179 -5.18428 2.16846e-07 4.43683e-06 yes TCONS_00000135 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts OK 0 20.4274 1.79769e+308 1.79769e+308 0.439218 0.763873 no TCONS_00000136 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 4.13128 0.438492 -3.23597 0.775671 0.437944 1 no TCONS_00000137 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 5.30242 3.93866 -0.428943 0.333958 0.738411 1 no TCONS_00000138 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 1.53994 0 -1.79769e+308 -1.79769e+308 0.263934 1 no TCONS_00000139 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000140 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000141 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000142 XLOC_000056 - chr1:3569128-3650467 iPS Fibroblasts NOTEST 3.71815 0 -1.79769e+308 -1.79769e+308 0.210562 1 no TCONS_00000143 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000144 XLOC_000056 - chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0.0133356 1.79769e+308 1.79769e+308 0.492114 1 no TCONS_00000145 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts NOTEST 0.580625 0.344217 -0.754289 0.269747 0.787355 1 no TCONS_00000146 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts OK 29.1182 58.9016 1.01639 -1.08029 0.280014 0.595101 no TCONS_00000147 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000148 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000149 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000150 XLOC_000059 CAD chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 5.63584 1.79769e+308 1.79769e+308 0.422464 1 no TCONS_00000151 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts OK 62.8589 101.804 0.695605 -0.976158 0.328986 0.650184 no TCONS_00000152 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 6.55552 0 -1.79769e+308 -1.79769e+308 0.283406 1 no TCONS_00000153 XLOC_000059 CAD chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000154 XLOC_000059 CAD chr1:3773844-3801992 iPS Fibroblasts NOTEST 3.55215 0 -1.79769e+308 -1.79769e+308 0.39226 1 no TCONS_00000155 XLOC_000059 CAD chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000156 XLOC_000059 CAD chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 4.99183 1.79769e+308 1.79769e+308 0.331808 1 no TCONS_00000157 XLOC_000059 DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0.00638818 4.32215 9.40213 -0.0502401 0.959931 1 no TCONS_00000158 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 5.25796 1.74517 -1.59114 0.955632 0.339258 1 no TCONS_00000159 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 0.0100414 1.74564 7.44165 -0.0236142 0.98116 1 no TCONS_00000160 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 1.6192 0.782057 -1.04994 0.305968 0.759629 1 no TCONS_00000161 XLOC_000061 - chr1:4000676-4015322 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000162 XLOC_000062 - chr1:4472110-4484744 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000163 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts OK 25.884 0.851814 -4.92538 2.39148 0.0167808 0.0746881 no TCONS_00000164 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts OK 78.56 0.414322 -7.5669 3.38179 0.000720156 0.00531083 yes TCONS_00000165 XLOC_000064 - chr1:4847557-4852182 iPS Fibroblasts OK 37.4079 0.154615 -7.91852 4.08795 4.35194e-05 0.000501796 yes TCONS_00000166 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 7.70132 68.4146 3.15113 -1.43097 0.152439 0.395206 no TCONS_00000167 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 4.70189 1.91789 -1.29372 0.103894 0.917254 1 no TCONS_00000168 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 4.61083 0 -1.79769e+308 -1.79769e+308 0.357727 1 no TCONS_00000169 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 48.7059 32.7443 -0.572852 0.445155 0.656208 0.952775 no TCONS_00000170 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 3.9331 0 -1.79769e+308 -1.79769e+308 0.366965 1 no TCONS_00000171 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 3.90167 0 -1.79769e+308 -1.79769e+308 0.378482 1 no TCONS_00000172 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 1.06639 0 -1.79769e+308 -1.79769e+308 0.346997 1 no TCONS_00000173 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 11.3399 4.63395 -1.29109 0.0790859 0.936964 1 no TCONS_00000174 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts OK 37.9114 35.0042 -0.115102 0.0169289 0.986493 0.999997 no TCONS_00000175 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 15.3246 10.1307 -0.597112 0.00819778 0.993459 1 no TCONS_00000176 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts OK 13.014 18.1716 0.481616 -0.0113877 0.990914 0.999997 no TCONS_00000177 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS Fibroblasts OK 56.5093 4.35392 -3.6981 3.5032 0.000459696 0.00367581 yes TCONS_00000178 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts OK 435.49 0 -1.79769e+308 -1.79769e+308 0.000567569 0.00432306 yes TCONS_00000179 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 7.69434 0.205083 -5.22952 2.04494 0.0408612 1 no TCONS_00000180 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 11.3056 0 -1.79769e+308 -1.79769e+308 0.0762027 1 no TCONS_00000181 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 1.5274 0 -1.79769e+308 -1.79769e+308 0.179466 1 no TCONS_00000182 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 2.01343 8.05147e-05 -14.61 0.00122283 0.999024 1 no TCONS_00000183 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 0 4.20431 1.79769e+308 1.79769e+308 0.126691 1 no TCONS_00000184 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 0.00440741 1.29131 8.19469 -0.0226007 0.981969 1 no TCONS_00000185 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts OK 69.0214 40.46 -0.770547 0.517668 0.60469 0.921832 no TCONS_00000186 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts OK 60.0558 47.2474 -0.346068 0.259536 0.795222 0.999997 no TCONS_00000187 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts OK 28.5408 126.765 2.15106 -1.47442 0.140367 0.375984 no TCONS_00000188 XLOC_000071 - chr1:6640055-6649339 iPS Fibroblasts OK 23.546 38.1578 0.696497 -0.382135 0.702361 0.977503 no TCONS_00000189 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts OK 277.454 769.313 1.47132 -3.21767 0.00129234 0.0089014 yes TCONS_00000190 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 69.7903 402.426 2.52763 -1.06374 0.287445 0.604736 no TCONS_00000191 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 27.7067 129.652 2.22634 -0.433258 0.664827 0.957553 no TCONS_00000192 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 7.22222 26.3763 1.86873 -0.141646 0.887359 0.999997 no TCONS_00000193 XLOC_000074 - chr1:6845383-7829763 iPS Fibroblasts OK 1270.29 3192.65 1.3296 -2.64542 0.00815891 0.04194 yes TCONS_00000194 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 4.74737 3.72176 -0.351146 0.0793382 0.936764 1 no TCONS_00000195 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 8.87986 0 -1.79769e+308 -1.79769e+308 0.247765 1 no TCONS_00000196 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 1.97243 1.79769e+308 1.79769e+308 0.459719 1 no TCONS_00000197 XLOC_000074 - chr1:6845383-7829763 iPS Fibroblasts NOTEST 1.762 0 -1.79769e+308 -1.79769e+308 0.464256 1 no TCONS_00000198 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts NOTEST 1500.64 7098.44 2.24192 -5.37272 7.75556e-08 1 no TCONS_00000199 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 54.7294 29.553 -0.889013 0.198158 0.842922 0.999997 no TCONS_00000200 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 13.107 17.4103 0.409598 -0.101117 0.919458 0.999997 no TCONS_00000201 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 26.7829 0 -1.79769e+308 -1.79769e+308 0.289271 0.605435 no TCONS_00000202 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 42.7797 82.6263 0.949674 -0.873295 0.382502 0.708393 no TCONS_00000203 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 139.727 221.632 0.665557 -1.03506 0.300641 0.618774 no TCONS_00000204 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts NOTEST 14.3316 7.31695 -0.969883 0.24391 0.807301 1 no TCONS_00000205 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 57.799 17.1487 -1.75294 0.0312684 0.975055 0.999997 no TCONS_00000206 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 3958.08 13290.9 1.74757 -3.39052 0.00069761 0.00518118 yes TCONS_00000207 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 34.9676 301.624 3.10866 -0.338014 0.735353 0.993965 no TCONS_00000208 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 626.306 8031.84 3.68079 -4.05812 4.94686e-05 0.000558059 yes TCONS_00000209 XLOC_000077 - chr1:8021713-8045341 iPS Fibroblasts OK 26.021 7.3862 -1.81677 0.023556 0.981207 0.999997 no TCONS_00000210 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 1.80448 142.738 6.30564 -3.48523 0.000491717 0.0038725 yes TCONS_00000211 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 9.62868 69.3396 2.84827 -2.1887 0.0286188 0.112059 no TCONS_00000212 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000213 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000214 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts OK 137.324 1112.18 3.01773 -6.69857 2.10465e-11 7.98619e-10 yes TCONS_00000215 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts OK 70.5381 201.501 1.51431 -1.80076 0.0717407 0.229636 no TCONS_00000216 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts OK 17.2656 674.909 5.28872 -4.07106 4.67994e-05 0.000533718 yes TCONS_00000217 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts OK 216.702 258.098 0.25221 -0.39501 0.692836 0.973593 no TCONS_00000218 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts NOTEST 0 8.24063 1.79769e+308 1.79769e+308 0.386726 1 no TCONS_00000219 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts OK 68.1769 257.242 1.91577 -2.81963 0.00480787 0.026545 yes TCONS_00000220 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts OK 54.5583 73.4533 0.429028 -0.427787 0.668806 0.95993 no TCONS_00000221 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 42.5258 45.2674 0.0901354 -0.0104824 0.991636 0.999997 no TCONS_00000222 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 132.845 109.373 -0.280493 0.0778734 0.937929 0.999997 no TCONS_00000223 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 17.0706 21.2442 0.315552 -0.0174008 0.986117 0.999997 no TCONS_00000224 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts OK 61.6068 319.369 2.37406 -4.08642 4.38084e-05 0.000502353 yes TCONS_00000225 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts OK 115.178 19.7819 -2.54161 2.84301 0.00446892 0.0250044 yes TCONS_00000226 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000227 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts OK 515.733 1122.9 1.12254 -2.68525 0.00724762 0.0380045 yes TCONS_00000228 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts OK 15.4936 40.3364 1.38041 -0.573959 0.565996 0.881517 no TCONS_00000229 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 6.69762 1.79769e+308 1.79769e+308 0.454062 1 no TCONS_00000230 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000231 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts OK 171.613 70.0715 -1.29225 0.171361 0.86394 0.999997 no TCONS_00000232 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts OK 7.8499 200.875 4.67748 -0.414985 0.678153 0.964761 no TCONS_00000233 XLOC_000088 - chr1:10270763-10441659 iPS Fibroblasts NOTEST 3.41691 3.63439 0.0890236 -0.000561921 0.999552 1 no TCONS_00000234 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 419.379 864.235 1.04317 -2.20185 0.0276761 0.108981 no TCONS_00000235 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 410.895 143.712 -1.51559 1.92005 0.0548516 0.186139 no TCONS_00000236 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 5.57672 1.79769e+308 1.79769e+308 0.441638 1 no TCONS_00000237 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000238 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000239 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000240 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 76.9201 29.2168 -1.39656 0.470731 0.637833 0.941412 no TCONS_00000241 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts OK 1337.23 13482.1 3.33373 -6.93367 4.1005e-12 1.86038e-10 yes TCONS_00000242 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000243 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts OK 74.0847 483.083 2.70502 -0.823133 0.410433 0.737156 no TCONS_00000244 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 5.58516 4.89393 -0.190605 0.000597733 0.999523 1 no TCONS_00000245 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 67.0275 99.6012 0.57141 -0.354168 0.723213 0.9865 no TCONS_00000246 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 6.3006 21.9227 1.79887 -0.252094 0.800969 0.999997 no TCONS_00000247 XLOC_000090 Cort chr1:10490158-10512208 iPS Fibroblasts NOTEST 5.24611 3.73278 -0.490996 0.0197763 0.984222 1 no TCONS_00000248 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 172.607 526.06 1.60774 -2.3914 0.0167842 0.0746881 no TCONS_00000249 XLOC_000090 CORT chr1:10490158-10512208 iPS Fibroblasts OK 33.6985 12.1268 -1.47448 0.209345 0.834179 0.999997 no TCONS_00000250 XLOC_000091 Pex14 chr1:10535002-10690813 iPS Fibroblasts OK 31.0581 523.392 4.07485 -0.891589 0.372613 0.697684 no TCONS_00000251 XLOC_000091 Pex14 chr1:10535002-10690813 iPS Fibroblasts OK 30.027 19.6946 -0.608463 0.0810907 0.93537 0.999997 no TCONS_00000252 XLOC_000091 Pex14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 18.0364 3.68586 -2.29084 0.0470281 0.962491 1 no TCONS_00000253 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts OK 173.496 1041.13 2.58517 -4.65136 3.29748e-06 5.21352e-05 yes TCONS_00000254 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000255 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000256 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts OK 0 44.4442 1.79769e+308 1.79769e+308 0.230648 0.520393 no TCONS_00000257 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000258 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts OK 1888.95 2744.34 0.538874 -1.44282 0.149072 0.390846 no TCONS_00000259 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts OK 30.0352 0 -1.79769e+308 -1.79769e+308 0.211276 0.486728 no TCONS_00000260 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts OK 25.3243 10.571 -1.26041 0.228828 0.819003 0.999997 no TCONS_00000261 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts OK 358.008 332.294 -0.10753 0.227893 0.81973 0.999997 no TCONS_00000262 XLOC_000095 - chr1:11539294-11597639 iPS Fibroblasts NOTEST 22.631 0 -1.79769e+308 -1.79769e+308 0.163406 1 no TCONS_00000263 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 14.6751 0.546235 -4.74771 3.44418 0.000572799 1 no TCONS_00000264 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 12.3118 7.55415e-05 -17.3143 0.00208675 0.998335 1 no TCONS_00000265 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 10.2274 1.79769e+308 1.79769e+308 0.339517 1 no TCONS_00000266 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 41.3995 66.4903 0.683529 -0.180489 0.856769 0.999997 no TCONS_00000267 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 74.4128 19.1948 -1.95484 1.13418 0.256717 0.558976 no TCONS_00000268 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 0 138.586 1.79769e+308 1.79769e+308 0.012153 0.0589843 no TCONS_00000269 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 55.1609 183.066 1.73065 -1.55894 0.11901 0.334735 no TCONS_00000270 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 8.07306 1.79769e+308 1.79769e+308 0.374931 1 no TCONS_00000271 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0.00708472 0 -1.79769e+308 -1.79769e+308 0.497068 1 no TCONS_00000272 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts OK 77.8716 363.317 2.22206 -3.49068 0.000481788 0.00380868 yes TCONS_00000273 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts OK 200.894 11.5677 -4.11826 4.62994 3.65767e-06 5.67585e-05 yes TCONS_00000274 XLOC_000099 - chr1:11782186-11785914 iPS Fibroblasts OK 138.448 6.38178 -4.43925 5.28305 1.27049e-07 2.70562e-06 yes TCONS_00000275 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 107.513 117.552 0.128785 -0.0498548 0.960238 0.999997 no TCONS_00000276 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 75.7885 31.884 -1.24914 0.269581 0.787482 0.999997 no TCONS_00000277 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 326.456 1331.71 2.02832 -2.40475 0.0161834 0.0727904 no TCONS_00000278 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 238.184 389.478 0.709464 -0.675104 0.499609 0.817744 no TCONS_00000279 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 0 41.1964 1.79769e+308 1.79769e+308 0.343024 0.664092 no TCONS_00000280 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS Fibroblasts NOTEST 4.69748 1.86471 -1.33293 0.629152 0.529249 1 no TCONS_00000281 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000282 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 1.75837 8.96806 2.35056 -0.118497 0.905674 1 no TCONS_00000283 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 22.1488 0 -1.79769e+308 -1.79769e+308 0.290424 1 no TCONS_00000284 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 11.3029 1.79769e+308 1.79769e+308 0.473198 1 no TCONS_00000285 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 4.86566 2.44992 -0.989904 0.00623635 0.995024 1 no TCONS_00000286 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts OK 14.401 40.6369 1.49663 -0.222257 0.824114 0.999997 no TCONS_00000287 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 108.07 514.96 2.2525 -4.52731 5.97379e-06 1 no TCONS_00000288 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0.0423122 0 -1.79769e+308 -1.79769e+308 0.473118 1 no TCONS_00000289 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000290 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts OK 0 16.145 1.79769e+308 1.79769e+308 0.468903 0.793032 no TCONS_00000291 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts NOTEST 3.15242 0 -1.79769e+308 -1.79769e+308 0.40462 1 no TCONS_00000292 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000293 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000294 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000295 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts NOTEST 3.25401 0 -1.79769e+308 -1.79769e+308 0.404659 1 no TCONS_00000296 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts OK 849.538 10325.2 3.60335 -6.728 1.72007e-11 6.90343e-10 yes TCONS_00000297 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts OK 16.0046 116.452 2.86317 -0.214412 0.830226 0.999997 no TCONS_00000298 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts OK 578.223 2718.63 2.23318 -4.12875 3.64742e-05 0.00044001 yes TCONS_00000299 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts OK 68.8548 152.885 1.15082 -0.174168 0.861734 0.999997 no TCONS_00000300 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts OK 504.143 575.01 0.189755 -0.366506 0.713987 0.980323 no TCONS_00000301 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts OK 178.549 4.49588 -5.31158 4.33892 1.43182e-05 0.000191952 yes TCONS_00000302 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 19.3321 0.000474981 -15.3128 0.0148937 0.988117 1 no TCONS_00000303 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000304 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 6.44015 4.00161 -0.686515 0.102872 0.918064 1 no TCONS_00000305 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts OK 0 1285.44 1.79769e+308 1.79769e+308 5.48538e-06 8.11913e-05 yes TCONS_00000306 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts OK 0.000432929 110.504 17.9615 -0.00756951 0.99396 0.999997 no TCONS_00000307 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts NOTEST 15.3502 0 -1.79769e+308 -1.79769e+308 0.00219283 1 no TCONS_00000308 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts NOTEST 12.8407 0 -1.79769e+308 -1.79769e+308 0.162096 1 no TCONS_00000309 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 315.192 191.792 -0.716688 1.13339 0.257051 0.558976 no TCONS_00000310 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 19.4784 94.7776 2.28267 -1.3543 0.175642 0.431532 no TCONS_00000311 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts OK 39.9995 0 -1.79769e+308 -1.79769e+308 0.188331 0.453341 no TCONS_00000312 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts OK 0 65.4483 1.79769e+308 1.79769e+308 0.120597 0.336479 no TCONS_00000313 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 2.38321 1.79769e+308 1.79769e+308 0.485245 1 no TCONS_00000314 XLOC_000110 SNORA59B chr1:12290112-12572096 iPS Fibroblasts OK 452.443 63.6142 -2.83031 0.0878811 0.929971 0.999997 no TCONS_00000315 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts NOTEST 0.911079 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TCONS_00000316 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts NOTEST 8.82724 0 -1.79769e+308 -1.79769e+308 0.161692 1 no TCONS_00000317 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts OK 47.604 0 -1.79769e+308 -1.79769e+308 0.00203352 0.0126698 yes TCONS_00000318 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts NOTEST 1.78172 0 -1.79769e+308 -1.79769e+308 0.300882 1 no TCONS_00000319 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts NOTEST 5.40803e-05 0 -1.79769e+308 -1.79769e+308 0.499993 1 no TCONS_00000320 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts NOTEST 3.60576 0 -1.79769e+308 -1.79769e+308 0.0603368 1 no TCONS_00000321 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TCONS_00000322 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000323 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000324 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000325 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no TCONS_00000326 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TCONS_00000327 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000328 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000329 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000330 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TCONS_00000331 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000332 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000333 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts OK 695.717 40.2891 -4.11004 3.86513 0.000111028 0.00110869 yes TCONS_00000334 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts OK 602.018 70.7232 -3.08955 4.2368 2.26731e-05 0.00028678 yes TCONS_00000335 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000336 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000337 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000338 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000339 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 0 27.8928 1.79769e+308 1.79769e+308 0.277099 0.59071 no TCONS_00000340 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 47.3072 0 -1.79769e+308 -1.79769e+308 0.0199638 0.0853779 no TCONS_00000341 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 14.792 14.8538 0.0060104 -0.00313125 0.997502 0.999997 no TCONS_00000342 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000343 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 4.006 43.9125 3.4544 -0.162823 0.870658 0.999997 no TCONS_00000344 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 173.834 358.942 1.04605 -2.0786 0.0376544 0.141398 no TCONS_00000345 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 0 28.7964 1.79769e+308 1.79769e+308 0.304984 0.6228 no TCONS_00000346 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000347 XLOC_000128 - chr1:14026734-14151572 iPS Fibroblasts NOTEST 3.13048 2.32779 -0.427428 0.0218389 0.982576 1 no TCONS_00000348 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 48.9164 3.19938 -3.93445 0.315983 0.752016 0.999997 no TCONS_00000349 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 2.81237 0 -1.79769e+308 -1.79769e+308 0.378057 1 no TCONS_00000350 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 6.7035 1.79769e+308 1.79769e+308 0.332558 1 no TCONS_00000351 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 1.99898 29.388 3.87789 -0.5242 0.60014 0.916234 no TCONS_00000352 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 0 13.2968 1.79769e+308 1.79769e+308 0.307255 0.62499 no TCONS_00000353 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 5.70387 205.94 5.17414 -2.0117 0.0442514 0.157599 no TCONS_00000354 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 0 208.608 1.79769e+308 1.79769e+308 0.0620669 0.206923 no TCONS_00000355 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 7.67766 10.0324 0.385926 -0.115068 0.908391 1 no TCONS_00000356 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts NOTEST 14.7555 0 -1.79769e+308 -1.79769e+308 0.240932 1 no TCONS_00000357 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 29.1579 34.1487 0.227946 -0.10696 0.914821 0.999997 no TCONS_00000358 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 0 65.7759 1.79769e+308 1.79769e+308 0.136154 0.368616 no TCONS_00000359 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 67.688 359.502 2.40903 -2.47425 0.0133515 0.0631851 no TCONS_00000360 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 33.4567 254.61 2.92792 -2.45994 0.013896 0.0645899 no TCONS_00000361 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 3.59181 2.29329 -0.647296 0.50928 0.610556 1 no TCONS_00000362 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 2.21856 0.862567 -1.36291 0.494457 0.620983 1 no TCONS_00000363 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000364 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000365 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0.572031 1.79769e+308 1.79769e+308 0.365615 1 no TCONS_00000366 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000367 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts OK 330.754 2197 2.7317 -5.82153 5.83102e-09 1.56017e-07 yes TCONS_00000368 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts NOTEST 3.36755e-05 0 -1.79769e+308 -1.79769e+308 0.499996 1 no TCONS_00000369 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts NOTEST 2.23634 5.61806 1.32893 -0.447969 0.654175 1 no TCONS_00000370 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000371 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000372 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 108.544 18.3447 -2.56484 0.623671 0.532844 0.84758 no TCONS_00000373 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 264.402 279.288 0.0790189 -0.155739 0.876239 0.999997 no TCONS_00000374 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 92.0125 78.8225 -0.223223 0.226356 0.820925 0.999997 no TCONS_00000375 XLOC_000136 - chr1:15853351-15918872 iPS Fibroblasts NOTEST 6.69281 2.11882 -1.65935 0.0533227 0.957475 1 no TCONS_00000376 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts OK 45.7332 0.922843 -5.63101 0.511007 0.609346 0.923533 no TCONS_00000377 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts OK 439.099 310.347 -0.500666 0.688084 0.4914 0.808795 no TCONS_00000378 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000379 XLOC_000137 RSC1A1 chr1:15944069-15988216 iPS Fibroblasts OK 534.708 376.086 -0.507689 0.801185 0.423024 0.752161 no TCONS_00000380 XLOC_000138 - chr1:15992765-15995535 iPS Fibroblasts OK 252.085 236.84 -0.0899987 0.166835 0.8675 0.999997 no TCONS_00000381 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts OK 363.264 2346.33 2.69132 -6.1413 8.18468e-10 2.51198e-08 yes TCONS_00000382 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts NOTEST 6.39779 9.3373 0.545433 -0.543143 0.587032 1 no TCONS_00000383 XLOC_000140 - chr1:16062808-16067885 iPS Fibroblasts NOTEST 2.07297 4.66039 1.16876 -0.396505 0.691732 1 no TCONS_00000384 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 11.5611 0 -1.79769e+308 -1.79769e+308 0.00828204 1 no TCONS_00000385 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 17.9129 72.561 2.0182 -0.402187 0.687547 0.96893 no TCONS_00000386 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 565.849 2026.56 1.84054 -3.6201 0.00029449 0.00249837 yes TCONS_00000387 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000388 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 55.3931 11.5775 -2.25838 0.0556055 0.955656 0.999997 no TCONS_00000389 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 256.047 333.297 0.380402 -0.302342 0.762391 0.999997 no TCONS_00000390 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 145.636 293.864 1.01278 -1.91218 0.0558529 0.18907 no TCONS_00000391 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 40.228 168.12 2.06322 -2.47059 0.0134892 0.0635484 no TCONS_00000392 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000393 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 1.3355 0 -1.79769e+308 -1.79769e+308 0.479662 1 no TCONS_00000394 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000395 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000396 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 2.87744 0.308418 -3.22183 0.15158 0.879518 1 no TCONS_00000397 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 5.98972 0 -1.79769e+308 -1.79769e+308 0.39699 1 no TCONS_00000398 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 1.5524 0 -1.79769e+308 -1.79769e+308 0.44066 1 no TCONS_00000399 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000400 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000401 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 12.6409 1.81089 -2.80332 0.353537 0.723686 1 no TCONS_00000402 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 41.0821 133.313 1.69824 -0.194736 0.8456 0.999997 no TCONS_00000403 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 407.437 1857.43 2.18866 -2.7506 0.00594866 0.0317515 yes TCONS_00000404 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 422.625 1815.92 2.10325 -2.31021 0.0208765 0.0878412 no TCONS_00000405 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 351.835 1504.54 2.09635 -2.3117 0.0207945 0.0878412 no TCONS_00000406 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 0 218.793 1.79769e+308 1.79769e+308 0.205588 0.481348 no TCONS_00000407 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 272.536 3410.49 3.64546 -6.02531 1.68784e-09 4.89238e-08 yes TCONS_00000408 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 0 100.612 1.79769e+308 1.79769e+308 0.276283 0.590061 no TCONS_00000409 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 302.124 0 -1.79769e+308 -1.79769e+308 0.00139068 0.00940858 yes TCONS_00000410 XLOC_000148 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 8.40518 1.32866 -2.66131 1.60784 0.107871 1 no TCONS_00000411 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 3.60238 0 -1.79769e+308 -1.79769e+308 0.184077 1 no TCONS_00000412 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 0.00122752 0 -1.79769e+308 -1.79769e+308 0.499717 1 no TCONS_00000413 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 0 6.5283 1.79769e+308 1.79769e+308 0.0697153 1 no TCONS_00000414 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 0 3.089 1.79769e+308 1.79769e+308 0.207986 1 no TCONS_00000415 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 2.50115 1.53504 -0.704317 0.122165 0.902768 1 no TCONS_00000416 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000417 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 7.81031 3.07999 -1.34245 0.66194 0.50801 1 no TCONS_00000418 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 1.86514 0.615404 -1.59968 0.412393 0.680052 1 no TCONS_00000419 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts NOTEST 2.30684 0 -1.79769e+308 -1.79769e+308 0.485306 1 no TCONS_00000420 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 27.4034 98.6818 1.84843 -1.99736 0.0457856 0.161957 no TCONS_00000421 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 47.5917 3.8214 -3.63854 0.338375 0.735081 0.993964 no TCONS_00000422 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 65.6699 17.1632 -1.93591 1.03814 0.299204 0.618774 no TCONS_00000423 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts OK 15.9225 49.7705 1.64423 -0.719566 0.471792 0.793625 no TCONS_00000424 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 2.7984 0 -1.79769e+308 -1.79769e+308 0.230408 1 no TCONS_00000425 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 5.28057 0 -1.79769e+308 -1.79769e+308 0.17586 1 no TCONS_00000426 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000427 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 7.45961 6.06956e-06 -20.2291 0.000165328 0.999868 1 no TCONS_00000428 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 0 0.513935 1.79769e+308 1.79769e+308 0.202031 1 no TCONS_00000429 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 8.59656 0.32407 -4.72938 2.78066 0.00542479 1 no TCONS_00000430 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000431 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts NOTEST 4.09774 0 -1.79769e+308 -1.79769e+308 0.0386699 1 no TCONS_00000432 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000433 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 57.9053 9.97606 -2.53715 0.492082 0.622661 0.931537 no TCONS_00000434 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 28.6581 18.9462 -0.597038 0.247053 0.804867 0.999997 no TCONS_00000435 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 0 208.168 1.79769e+308 1.79769e+308 0.00509617 0.0276972 yes TCONS_00000436 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 158.893 35.3353 -2.16888 1.24574 0.212861 0.489792 no TCONS_00000437 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 5.30615 1.79769e+308 1.79769e+308 0.472061 1 no TCONS_00000438 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 24.8197 0 -1.79769e+308 -1.79769e+308 0.140881 0.375984 no TCONS_00000439 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000440 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 0 381.592 1.79769e+308 1.79769e+308 0.000456313 0.00366279 yes TCONS_00000441 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts NOTEST 2.21468 0 -1.79769e+308 -1.79769e+308 0.471176 1 no TCONS_00000442 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts OK 12.7177 14.6487 0.203942 -0.0310917 0.975196 0.999997 no TCONS_00000443 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 9.62232 6.95204 -0.468948 0.497417 0.618895 1 no TCONS_00000444 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts OK 58.273 0 -1.79769e+308 -1.79769e+308 0.00185698 0.011744 yes TCONS_00000445 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts NOTEST 2.74185 0 -1.79769e+308 -1.79769e+308 0.4079 1 no TCONS_00000446 XLOC_000158 - chr1:18434239-18704976 iPS Fibroblasts NOTEST 1.3684 0 -1.79769e+308 -1.79769e+308 0.381589 1 no TCONS_00000447 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts OK 104.809 0 -1.79769e+308 -1.79769e+308 0.000153023 0.00142571 yes TCONS_00000448 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts NOTEST 0 0.745204 1.79769e+308 1.79769e+308 0.105358 1 no TCONS_00000449 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 5.07852e-05 0 -1.79769e+308 -1.79769e+308 0.499982 1 no TCONS_00000450 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 6.55753e-05 0 -1.79769e+308 -1.79769e+308 0.499977 1 no TCONS_00000451 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 0.593912 0 -1.79769e+308 -1.79769e+308 0.15344 1 no TCONS_00000452 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts OK 773.162 1651.61 1.09504 -2.54218 0.0110164 0.0542246 no TCONS_00000453 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 70.7134 338.197 2.25781 -2.14478 0.0319704 0.12356 no TCONS_00000454 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 6.84301 25.1112 1.87563 -0.340387 0.733565 0.993478 no TCONS_00000455 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 28.264 68.4588 1.27627 -0.670212 0.502723 0.820603 no TCONS_00000456 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 0 16.9445 1.79769e+308 1.79769e+308 0.354394 0.679174 no TCONS_00000457 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 80.1847 139.07 0.794409 -0.70124 0.483153 0.801543 no TCONS_00000458 XLOC_000163 C1orf151 chr1:19923466-19984945 iPS Fibroblasts OK 3.27686 91.329 4.80069 -0.190978 0.848543 0.999997 no TCONS_00000459 XLOC_000163 C1orf151 chr1:19923466-19984945 iPS Fibroblasts OK 246.288 1693.34 2.78146 -2.34735 0.0189074 0.0818668 no TCONS_00000460 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 0 8926.42 1.79769e+308 1.79769e+308 0.00139303 0.00940858 yes TCONS_00000461 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 3.52907 1.79769e+308 1.79769e+308 0.498836 1 no TCONS_00000462 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 0 30.6081 1.79769e+308 1.79769e+308 0.487077 0.804217 no TCONS_00000463 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 463.905 1884.11 2.02198 -1.83292 0.0668147 0.218562 no TCONS_00000464 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 3.39355 0 -1.79769e+308 -1.79769e+308 0.0558829 1 no TCONS_00000465 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts OK 148.118 87.3998 -0.761045 1.44569 0.148264 0.389217 no TCONS_00000466 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 6.43535e-05 2.12447 15.0107 -0.000726876 0.99942 1 no TCONS_00000467 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 0.482643 0 -1.79769e+308 -1.79769e+308 0.31503 1 no TCONS_00000468 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts OK 0 147.21 1.79769e+308 1.79769e+308 0.00318923 0.0186441 yes TCONS_00000469 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000470 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 12.3177 0.492177 -4.64542 3.23168 0.00123066 1 no TCONS_00000471 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 1.83014 0 -1.79769e+308 -1.79769e+308 0.0888144 1 no TCONS_00000472 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 1.30646 0.000774709 -10.7197 0.0212375 0.983056 1 no TCONS_00000473 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 3.74866e-05 0.572137 13.8977 -0.000633687 0.999494 1 no TCONS_00000474 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000475 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000476 XLOC_000170 FAM43B chr1:20878931-20881512 iPS Fibroblasts NOTEST 1.9757 1.55058 -0.349553 0.253507 0.799876 1 no TCONS_00000477 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts OK 223.547 232.113 0.0542521 -0.0783655 0.937537 0.999997 no TCONS_00000478 XLOC_000171 - chr1:20915443-20945398 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000479 XLOC_000171 - chr1:20915443-20945398 iPS Fibroblasts NOTEST 17.3734 0 -1.79769e+308 -1.79769e+308 0.304417 1 no TCONS_00000480 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 640.208 2213.85 1.78994 -3.8392 0.000123435 0.00121514 yes TCONS_00000481 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 0 832.083 1.79769e+308 1.79769e+308 0.0365779 0.138294 no TCONS_00000482 XLOC_000173 - chr1:21543739-21672034 iPS Fibroblasts NOTEST 2.1975 3.33508 0.601856 -0.0238642 0.980961 1 no TCONS_00000483 XLOC_000174 - chr1:21761832-21762609 iPS Fibroblasts OK 0 7652.6 1.79769e+308 1.79769e+308 0.0471877 0.166353 no TCONS_00000484 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 11.3784 50.1038 2.13862 -1.09785 0.272268 0.583992 no TCONS_00000485 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 68.9507 428.32 2.63505 -4.33602 1.45087e-05 0.000192864 yes TCONS_00000486 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 0 15.9541 1.79769e+308 1.79769e+308 0.30867 0.626038 no TCONS_00000487 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 4.87776 34.3555 2.81625 -0.814494 0.415362 0.743492 no TCONS_00000488 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts OK 877.819 56.7111 -3.95222 5.36676 8.01626e-08 1.76105e-06 yes TCONS_00000489 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 14.1413 0 -1.79769e+308 -1.79769e+308 0.353934 1 no TCONS_00000490 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts OK 46.976 2.32536 -4.3364 0.417589 0.676248 0.962974 no TCONS_00000491 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 14.1212 0 -1.79769e+308 -1.79769e+308 0.370142 1 no TCONS_00000492 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 0 7.78492 1.79769e+308 1.79769e+308 0.260295 1 no TCONS_00000493 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts OK 10.8443 16.2682 0.585113 -0.00216545 0.998272 0.999997 no TCONS_00000494 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts OK 11.8862 166.982 3.81233 -0.0298855 0.976158 0.999997 no TCONS_00000495 XLOC_000178 CELA3B chr1:22303417-22339033 iPS Fibroblasts NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TCONS_00000496 XLOC_000178 - chr1:22303417-22339033 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000497 XLOC_000178 CELA3A chr1:22303417-22339033 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000498 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts OK 27.4246 6.30679 -2.12049 0.16794 0.866631 0.999997 no TCONS_00000499 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts OK 470.397 527.288 0.164712 -0.272084 0.785557 0.999997 no TCONS_00000500 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000501 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 13.0529 70.2619 2.42838 -0.11925 0.905078 0.999997 no TCONS_00000502 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 339.897 668.209 0.975201 -0.570957 0.568028 0.882379 no TCONS_00000503 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 243.283 0 -1.79769e+308 -1.79769e+308 0.220794 0.503053 no TCONS_00000504 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 2997.59 9098.98 1.6019 -3.5062 0.000454553 0.00366279 yes TCONS_00000505 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 11.3168 0 -1.79769e+308 -1.79769e+308 0.440365 1 no TCONS_00000506 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 39.4183 55.0216 0.481134 -0.0360543 0.971239 0.999997 no TCONS_00000507 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts NOTEST 1.95825 7.10626 1.85952 -0.346625 0.728873 1 no TCONS_00000508 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts OK 81.1618 203.748 1.32791 -2.56714 0.0102541 0.0511969 no TCONS_00000509 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts NOTEST 5.796 7.15473 0.30384 -0.0853469 0.931986 1 no TCONS_00000510 XLOC_000181 - chr1:22778343-22857650 iPS Fibroblasts OK 41.9937 12.3722 -1.76307 0.306621 0.759132 0.999997 no TCONS_00000511 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts OK 30.6745 0 -1.79769e+308 -1.79769e+308 0.00608258 0.0323835 yes TCONS_00000512 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts NOTEST 2.71483 0 -1.79769e+308 -1.79769e+308 0.144438 1 no TCONS_00000513 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000514 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000515 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000516 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000517 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000518 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000519 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts OK 0.0140869 73.628 12.3517 -0.192065 0.847692 0.999997 no TCONS_00000520 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts OK 0 79.1362 1.79769e+308 1.79769e+308 0.172687 0.42697 no TCONS_00000521 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 58.1996 794.32 3.77064 -6.39262 1.63069e-10 1 no TCONS_00000522 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000523 XLOC_000187 - chr1:23243782-23247347 iPS Fibroblasts OK 1.74546 18.4428 3.40138 -3.11295 0.00185227 0.011744 yes TCONS_00000524 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts OK 2064.11 1754.94 -0.2341 0.56142 0.574511 0.887288 no TCONS_00000525 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts OK 556.677 597.396 0.101847 -0.130849 0.895895 0.999997 no TCONS_00000526 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts OK 6.87752 73.0221 3.40837 -0.284277 0.776198 0.999997 no TCONS_00000527 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts OK 8.91818 27.3759 1.61809 -0.615549 0.538192 0.851559 no TCONS_00000528 XLOC_000190 - chr1:23832921-23857713 iPS Fibroblasts NOTEST 7.64299 0 -1.79769e+308 -1.79769e+308 0.127318 1 no TCONS_00000529 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts NOTEST 6.59897e-05 0 -1.79769e+308 -1.79769e+308 0.499983 1 no TCONS_00000530 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts NOTEST 0.878658 0 -1.79769e+308 -1.79769e+308 0.300891 1 no TCONS_00000531 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 6878.03 57034.4 3.05177 -3.40828 0.000653738 0.00487269 yes TCONS_00000532 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 728.583 8804.01 3.595 -1.35066 0.176806 0.432583 no TCONS_00000533 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 37247.7 56810.6 0.60901 -0.912252 0.361636 0.684256 no TCONS_00000534 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 227.08 86.3727 -1.39455 0.032494 0.974078 0.999997 no TCONS_00000535 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts OK 755.461 1232.52 0.706187 -1.80674 0.0708034 0.227684 no TCONS_00000536 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts OK 1031.1 1578.13 0.614039 -1.36 0.173831 0.427814 no TCONS_00000537 XLOC_000194 - chr1:24104875-24114720 iPS Fibroblasts OK 42.6282 138.236 1.69725 -0.809573 0.418186 0.746199 no TCONS_00000538 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 60.6827 0 -1.79769e+308 -1.79769e+308 0.178997 0.4359 no TCONS_00000539 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 107.325 138.908 0.372137 -0.248664 0.803621 0.999997 no TCONS_00000540 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 728.399 245.964 -1.56628 1.85221 0.0639955 0.210671 no TCONS_00000541 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 151.125 801.526 2.40701 -2.3487 0.0188389 0.0817398 no TCONS_00000542 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts OK 2032.12 1795.17 -0.178866 0.476805 0.633501 0.939846 no TCONS_00000543 XLOC_000197 - chr1:24526729-24538180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000544 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 11.6632 0 -1.79769e+308 -1.79769e+308 0.0440615 1 no TCONS_00000545 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 9.34923 3.65658e-05 -17.964 0.000986009 0.999213 1 no TCONS_00000546 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 0.00176595 0.713246 8.65781 -0.0102322 0.991836 1 no TCONS_00000547 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 5.7743 2.27352 -1.34472 0.0068295 0.994551 1 no TCONS_00000548 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts OK 102.299 181.782 0.829414 -0.356443 0.721509 0.984819 no TCONS_00000549 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 340.07 1388.46 2.02958 -4.08439 4.41925e-05 1 no TCONS_00000550 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts OK 0 60.0129 1.79769e+308 1.79769e+308 0.359802 0.682753 no TCONS_00000551 XLOC_000199 - chr1:24742244-24799472 iPS Fibroblasts NOTEST 22.1357 7.66113 -1.53075 0.0515202 0.958911 1 no TCONS_00000552 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 326.184 219.138 -0.573846 0.851455 0.394517 0.722242 no TCONS_00000553 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 20.7252 77.2898 1.89889 -0.603725 0.546026 0.860043 no TCONS_00000554 XLOC_000200 - chr1:24829386-24862425 iPS Fibroblasts OK 15.7185 51.8532 1.72197 -0.327879 0.743003 0.996561 no TCONS_00000555 XLOC_000200 - chr1:24829386-24862425 iPS Fibroblasts OK 0 46.3362 1.79769e+308 1.79769e+308 0.302015 0.619769 no TCONS_00000556 XLOC_000200 - chr1:24829386-24862425 iPS Fibroblasts NOTEST 10.6171 8.94425 -0.247357 0.0204523 0.983683 1 no TCONS_00000557 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts NOTEST 1.31366 0.128844 -3.34989 1.36696 0.171638 1 no TCONS_00000558 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 816.952 789.315 -0.0496498 0.0968883 0.922815 0.999997 no TCONS_00000559 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 0.0198022 574.066 14.8233 -0.225562 0.821542 0.999997 no TCONS_00000560 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 41.7106 28.5028 -0.549309 0.090301 0.928048 0.999997 no TCONS_00000561 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 347.64 164.784 -1.07702 0.485858 0.627068 0.933446 no TCONS_00000562 XLOC_000202 - chr1:24969593-24999771 iPS Fibroblasts OK 84.2414 70.3113 -0.260773 0.0585298 0.953327 0.999997 no TCONS_00003803 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 0.0436773 560.298 13.647 -0.113064 0.909979 0.999997 no TCONS_00003804 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 20.2689 0 -1.79769e+308 -1.79769e+308 0.271118 1 no TCONS_00003805 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003806 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003807 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 108.765 0 -1.79769e+308 -1.79769e+308 0.0812742 0.251661 no TCONS_00003808 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 10.3996 7.75088 -0.424093 0.0335134 0.973265 1 no TCONS_00003809 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 59.4507 173.783 1.54752 -0.844251 0.398529 0.726402 no TCONS_00003810 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 44.5281 21.7772 -1.0319 0.265212 0.790846 0.999997 no TCONS_00003811 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003812 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 38.8286 47.9895 0.305599 -0.184261 0.853809 0.999997 no TCONS_00003813 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 74.8157 0 -1.79769e+308 -1.79769e+308 0.0362837 0.137718 no TCONS_00003814 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 4.01193 0 -1.79769e+308 -1.79769e+308 0.487081 1 no TCONS_00003815 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003816 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 12.1835 0 -1.79769e+308 -1.79769e+308 0.446837 1 no TCONS_00003817 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0.0461934 1.79769e+308 1.79769e+308 0.491613 1 no TCONS_00003818 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 166.699 240.082 0.526283 -0.259654 0.795131 0.999997 no TCONS_00003819 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 479.443 76.652 -2.64496 1.72158 0.0851451 0.261705 no TCONS_00003820 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 16.824 16.2553 -0.0496109 0.00460012 0.99633 0.999997 no TCONS_00003821 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 42.2462 228.081 2.43265 -0.753697 0.451031 0.778579 no TCONS_00003822 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 0 46.2659 1.79769e+308 1.79769e+308 0.357112 0.681214 no TCONS_00003823 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003824 XLOC_001218 - chr1:34611-36081 iPS Fibroblasts NOTEST 13.7184 4.32826 -1.66426 1.37047 0.17054 1 no TCONS_00003825 XLOC_001219 - chr1:89294-237877 iPS Fibroblasts OK 12.8434 13.5604 0.0783645 -0.0449207 0.964171 0.999997 no TCONS_00003826 XLOC_001220 - chr1:89294-237877 iPS Fibroblasts OK 342.399 19.9712 -4.09969 4.21805 2.46425e-05 0.000309813 yes TCONS_00003827 XLOC_001221 OR4F16 chr1:621097-622034 iPS Fibroblasts NOTEST 1.51396 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00003828 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 15.7705 1.6027 -3.29865 0.362728 0.716808 1 no TCONS_00003829 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 161.143 39.9694 -2.01137 2.2363 0.0253321 0.102259 no TCONS_00003830 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 96.6862 22.9579 -2.07432 1.7523 0.0797217 0.248327 no TCONS_00003831 XLOC_001223 - chr1:661139-679736 iPS Fibroblasts OK 0 14237.7 1.79769e+308 1.79769e+308 0.467736 0.792342 no TCONS_00003832 XLOC_001224 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003833 XLOC_001225 - chr1:661139-679736 iPS Fibroblasts OK 0 14237.7 1.79769e+308 1.79769e+308 0.467736 0.792342 no TCONS_00003834 XLOC_001226 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003835 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 169.764 45.3238 -1.90519 0.784563 0.43271 0.759956 no TCONS_00003836 XLOC_001227 - chr1:700236-714006 iPS Fibroblasts OK 247.682 50.5377 -2.29306 3.18069 0.00146925 0.00976536 yes TCONS_00003837 XLOC_001228 - chr1:761586-762902 iPS Fibroblasts OK 29.1742 39.9678 0.454142 -0.567774 0.570188 0.882777 no TCONS_00003838 XLOC_001229 FAM41C chr1:803452-812182 iPS Fibroblasts NOTEST 17.3524 7.41126 -1.22735 1.36605 0.171923 1 no TCONS_00003839 XLOC_001230 - chr1:852952-854817 iPS Fibroblasts NOTEST 0 7.62477 1.79769e+308 1.79769e+308 0.121258 1 no TCONS_00003840 XLOC_001230 - chr1:852952-854817 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003841 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 36.029 55.7714 0.630367 -0.108681 0.913455 0.999997 no TCONS_00003842 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 328.516 646.349 0.976348 -1.30767 0.190985 0.456571 no TCONS_00003843 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 256.209 1445.11 2.49578 -3.49404 0.000475771 0.00377541 yes TCONS_00003844 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 43.7364 72.8474 0.736042 -0.0822844 0.934421 0.999997 no TCONS_00003845 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts OK 9.49353 36.2061 1.93122 -1.86716 0.0618794 0.206628 no TCONS_00003846 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts NOTEST 0 2.14049 1.79769e+308 1.79769e+308 0.233217 1 no TCONS_00003847 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts OK 54.1565 29.4876 -0.877029 0.827243 0.408099 0.735128 no TCONS_00003848 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts NOTEST 0 4.13955 1.79769e+308 1.79769e+308 0.350783 1 no TCONS_00003849 XLOC_001234 - chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 6.02886 1.79769e+308 1.79769e+308 0.405618 1 no TCONS_00003850 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 9.95714 22.7448 1.19173 -0.2866 0.774418 0.999997 no TCONS_00003851 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 0.00198038 53.0677 14.7098 -0.0130554 0.989584 0.999997 no TCONS_00003852 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 16.1923 0 -1.79769e+308 -1.79769e+308 0.127864 1 no TCONS_00003853 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 50.4508 59.219 0.231184 -0.149613 0.88107 0.999997 no TCONS_00003854 XLOC_001234 - chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 4.24905 1.79769e+308 1.79769e+308 0.413904 1 no TCONS_00003855 XLOC_001234 - chr1:1017197-1051736 iPS Fibroblasts OK 0 39.2481 1.79769e+308 1.79769e+308 0.0998123 0.292979 no TCONS_00003856 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 18.8091 19.7743 0.0721984 -0.0396618 0.968363 0.999997 no TCONS_00003857 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 0 21.0061 1.79769e+308 1.79769e+308 0.227237 0.514364 no TCONS_00003858 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts NOTEST 0.346272 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TCONS_00003859 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 2.09869 0 -1.79769e+308 -1.79769e+308 0.293864 1 no TCONS_00003860 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts OK 1.73622 14.2685 3.03882 -1.42171 0.15511 0.399648 no TCONS_00003861 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0.00252879 0.00130815 -0.95092 0.000515119 0.999589 1 no TCONS_00003862 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003863 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts NOTEST 1.29516 5.89401 2.18612 -0.701912 0.482734 1 no TCONS_00003864 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003865 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 60.6719 71.6823 0.240588 -0.0431911 0.965549 0.999997 no TCONS_00003866 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 829.134 8370.57 3.33565 -6.96476 3.28981e-12 1.52574e-10 yes TCONS_00003867 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 39.6628 539.303 3.76524 -1.38865 0.164938 0.414709 no TCONS_00003868 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003869 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 0 49.0895 1.79769e+308 1.79769e+308 0.458864 0.785603 no TCONS_00003870 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 32.4396 114.07 1.81409 -0.0863577 0.931182 0.999997 no TCONS_00003871 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts OK 17.131 75.8216 2.146 -2.50106 0.0123824 0.0597727 no TCONS_00003872 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 16.9893 27.9153 0.716428 -0.129263 0.89715 0.999997 no TCONS_00003873 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 22.0748 45.6069 1.04685 -0.312514 0.75465 0.999997 no TCONS_00003874 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts NOTEST 5.41455 2.68872 -1.00992 0.0152138 0.987862 1 no TCONS_00003875 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 417.932 1659.15 1.9891 -3.79076 0.000150185 0.00141826 yes TCONS_00003876 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 25.4338 75.7217 1.57396 -0.499978 0.61709 0.92719 no TCONS_00003877 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 0 85.2438 1.79769e+308 1.79769e+308 0.198589 0.470972 no TCONS_00003878 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 10.1146 95.4488 3.23829 -0.710164 0.477602 0.797405 no TCONS_00003879 XLOC_001241 - chr1:1189293-1209234 iPS Fibroblasts OK 17.2606 20.3727 0.239156 -0.0846348 0.932552 0.999997 no TCONS_00003880 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 9.37264 101.369 3.43502 -0.620169 0.535146 0.848026 no TCONS_00003881 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 25.8307 86.9123 1.75048 -0.820189 0.412108 0.739527 no TCONS_00003882 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 93.257 810.457 3.11945 -3.19403 0.00140303 0.00944554 yes TCONS_00003883 XLOC_001242 - chr1:1227763-1260046 iPS Fibroblasts OK 26.1554 131.616 2.33116 -0.550923 0.581687 0.894606 no TCONS_00003884 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 79.6054 120.03 0.592453 -0.238418 0.811557 0.999997 no TCONS_00003885 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 590.361 2355.04 1.99608 -3.08333 0.00204701 0.0126769 yes TCONS_00003886 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 15.5849 16.3417 0.0684059 -0.00349088 0.997215 0.999997 no TCONS_00003887 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 11.6979 23.1589 0.98532 -0.0659454 0.947421 0.999997 no TCONS_00003888 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 3.63351 1.79769e+308 1.79769e+308 0.496427 1 no TCONS_00003889 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003890 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003891 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 22.9173 74.3645 1.69817 -0.255255 0.798526 0.999997 no TCONS_00003892 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 28.1613 3.66246 -2.94283 0.0214227 0.982908 0.999997 no TCONS_00003893 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 0 82.7322 1.79769e+308 1.79769e+308 0.369875 0.693556 no TCONS_00003894 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 4.09686 7.63052 0.897263 -0.0101301 0.991918 1 no TCONS_00003895 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 109.796 407.64 1.89247 -0.707177 0.479456 0.798034 no TCONS_00003896 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 74.8279 14.441 -2.37341 0.104376 0.916871 0.999997 no TCONS_00003897 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 63.7322 252.541 1.98642 -1.01255 0.311277 0.630024 no TCONS_00003898 XLOC_001244 DVL1L1 chr1:1270658-1284492 iPS Fibroblasts OK 8.10625 49.6575 2.6149 -0.311764 0.75522 0.999997 no TCONS_00003899 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 173.57 1267.03 2.86786 -4.88324 1.04359e-06 1.9105e-05 yes TCONS_00003900 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 30.2667 23.7193 -0.351671 0.119057 0.90523 0.999997 no TCONS_00003901 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 6.14109 95.5511 3.95971 -0.167997 0.866585 0.999997 no TCONS_00003902 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 101.118 2934.02 4.85876 -3.33592 0.000850168 0.00609725 yes TCONS_00003903 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 248.639 2864.03 3.52592 -1.99852 0.0456602 0.161788 no TCONS_00003904 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 721.263 8407.76 3.54312 -4.7796 1.75645e-06 1 no TCONS_00003905 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 2.23252 18.6477 3.06225 -0.0420455 0.966462 0.999997 no TCONS_00003906 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 1486.29 3221.31 1.11593 -1.55704 0.11946 0.33555 no TCONS_00003907 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 37.1577 358.847 3.27164 -0.598018 0.549828 0.863424 no TCONS_00003908 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 323.055 1592.97 2.30187 -1.24142 0.214449 0.492361 no TCONS_00003909 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 711.073 1861.17 1.38814 -1.71255 0.0867961 0.26483 no TCONS_00003910 XLOC_001247 - chr1:1321090-1334718 iPS Fibroblasts NOTEST 5.40934 6.77005 0.323712 -0.013806 0.988985 1 no TCONS_00003911 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 114.444 134.515 0.233129 -0.175207 0.860917 0.999997 no TCONS_00003912 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 6.6959 19.8352 1.56671 -0.139295 0.889217 0.999997 no TCONS_00003913 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 348.681 674.159 0.951184 -1.81513 0.0695036 0.224542 no TCONS_00003914 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 172.404 322.484 0.903435 -0.710685 0.477279 0.797405 no TCONS_00003915 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 17.0885 18.1877 0.0899369 -0.0121093 0.990338 0.999997 no TCONS_00003916 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 84.4595 97.6848 0.209875 -0.105166 0.916244 0.999997 no TCONS_00003917 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts OK 3025.74 8706.81 1.52485 -3.31303 0.0009229 0.00652913 yes TCONS_00003918 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts OK 108.19 37.8673 -1.51454 0.150867 0.88008 0.999997 no TCONS_00003919 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts OK 48.4609 85.2846 0.815462 -0.945383 0.344463 0.66481 no TCONS_00003920 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts NOTEST 0.00430007 0.00204697 -1.07087 0.00120516 0.999038 1 no TCONS_00003921 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts OK 6.61991 15.6317 1.2396 -0.496243 0.619723 0.929807 no TCONS_00003922 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts OK 31.9981 233.834 2.86942 -3.74518 0.000180267 0.00165007 yes TCONS_00003923 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts OK 1955.08 6236.3 1.67347 -3.6634 0.00024889 0.00218704 yes TCONS_00003924 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts NOTEST 17.0327 4.14556 -2.03867 0.0181171 0.985545 1 no TCONS_00003925 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts OK 407.325 430.732 0.0806121 -0.0822887 0.934417 0.999997 no TCONS_00003926 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 33.8277 286.25 3.081 -0.800519 0.42341 0.752161 no TCONS_00003927 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 0 186.844 1.79769e+308 1.79769e+308 0.328653 0.650141 no TCONS_00003928 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 9.33823 179.943 4.26825 -0.407798 0.683422 0.967808 no TCONS_00003929 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 10.4083 0 -1.79769e+308 -1.79769e+308 0.408108 1 no TCONS_00003930 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003931 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003932 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 6.57877 1.79769e+308 1.79769e+308 0.493408 1 no TCONS_00003933 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003934 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 23.7584 182.067 2.93796 -0.814452 0.415386 0.743492 no TCONS_00003935 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 76.2007 795.035 3.38314 -0.179219 0.857765 0.999997 no TCONS_00003936 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 81.9647 440.918 2.42744 -0.388777 0.697441 0.974922 no TCONS_00003937 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 19.9963 8.02851 -1.31653 0.0181367 0.98553 1 no TCONS_00003938 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 57.9127 276.724 2.2565 -1.53229 0.125451 0.345859 no TCONS_00003939 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 39.3012 47.7522 0.280991 -0.0716214 0.942903 0.999997 no TCONS_00003940 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 42.2344 234.425 2.47264 -1.66431 0.0960513 0.284339 no TCONS_00003941 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 21.1415 216.993 3.3595 -1.67259 0.0944078 0.280269 no TCONS_00003942 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 48.2599 362.567 2.90935 -0.729277 0.465832 0.792342 no TCONS_00003943 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 21.1432 25.3689 0.262864 -0.0120889 0.990355 0.999997 no TCONS_00003944 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 4.69427 19.8478 2.08001 -0.0455343 0.963681 0.999997 no TCONS_00003945 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 22.682 84.2667 1.89341 -0.172819 0.862794 0.999997 no TCONS_00003946 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 21.915 85.2622 1.95999 -0.173234 0.862467 0.999997 no TCONS_00003947 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 10.007 293.354 4.87356 -0.773811 0.439043 0.763873 no TCONS_00003948 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 44.5894 1043.7 4.54886 -2.37866 0.0173759 0.0766208 no TCONS_00003949 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 10.5985 113.359 3.41896 -0.360114 0.718762 0.984819 no TCONS_00003950 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 0 84.1064 1.79769e+308 1.79769e+308 0.427221 0.754962 no TCONS_00003951 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 10.2217 87.1897 3.09253 -0.167227 0.867191 0.999997 no TCONS_00003952 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 7.69268 1.79769e+308 1.79769e+308 0.49711 1 no TCONS_00003953 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0.128652 3.69003 4.84208 -0.00891762 0.992885 1 no TCONS_00003954 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 8.10282 114.365 3.81907 -0.149635 0.881053 0.999997 no TCONS_00003955 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 2.85432 91.7595 5.00664 -0.243239 0.80782 0.999997 no TCONS_00003956 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003957 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 23.5881 20.3251 -0.214794 0.00185115 0.998523 0.999997 no TCONS_00003958 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 8.90936 0 -1.79769e+308 -1.79769e+308 0.490667 1 no TCONS_00003959 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 93.1692 113.042 0.278934 -0.0529189 0.957797 0.999997 no TCONS_00003960 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003961 XLOC_001255 - chr1:1571099-1677431 iPS Fibroblasts OK 251.624 1014.62 2.0116 -2.45237 0.0141917 0.0658179 no TCONS_00003962 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 96.0585 431.974 2.16896 -0.832357 0.405208 0.733328 no TCONS_00003963 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 10.1742 1.85523 -2.45525 0.0404214 0.967757 1 no TCONS_00003964 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 0 215.942 1.79769e+308 1.79769e+308 0.208575 0.484201 no TCONS_00003965 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 331.317 988.439 1.57694 -2.64886 0.0080763 0.0418244 yes TCONS_00003966 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 38.1873 0 -1.79769e+308 -1.79769e+308 0.235731 0.529001 no TCONS_00003967 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 46.8111 2.79122 -4.06788 0.143026 0.88627 0.999997 no TCONS_00003968 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 57.4086 43.7417 -0.392256 0.0819804 0.934662 0.999997 no TCONS_00003969 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts OK 4274.57 16698 1.96582 -4.12892 3.64475e-05 0.00044001 yes TCONS_00003970 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts NOTEST 13.2928 10.8403 -0.294245 0.00132502 0.998943 1 no TCONS_00003971 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 78.6765 0 -1.79769e+308 -1.79769e+308 0.00735151 0.0383565 yes TCONS_00003972 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 23.4913 23.4115 -0.00490924 0.00281086 0.997757 0.999997 no TCONS_00003973 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003974 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003975 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.583424 0 -1.79769e+308 -1.79769e+308 0.219947 1 no TCONS_00003976 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.437707 0 -1.79769e+308 -1.79769e+308 0.332442 1 no TCONS_00003977 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.645169 0 -1.79769e+308 -1.79769e+308 0.300876 1 no TCONS_00003978 XLOC_001261 - chr1:1944651-1946969 iPS Fibroblasts NOTEST 4.28982 0 -1.79769e+308 -1.79769e+308 0.0384012 1 no TCONS_00003979 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts OK 13.1667 27.1259 1.04278 -0.126228 0.899551 0.999997 no TCONS_00003980 XLOC_001263 - chr1:1981908-2139172 iPS Fibroblasts OK 41.939 137.693 1.71509 -1.10552 0.268934 0.580418 no TCONS_00003981 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts OK 0 40.4901 1.79769e+308 1.79769e+308 0.256401 0.558976 no TCONS_00003982 XLOC_001263 - chr1:1981908-2139172 iPS Fibroblasts OK 6.98486 78.7015 3.49409 -0.548475 0.583366 0.895867 no TCONS_00003983 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts OK 377.586 2591.54 2.77893 -3.16998 0.00152447 0.0100683 yes TCONS_00003984 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 5.67183 19.3469 1.77022 -0.404889 0.685559 0.96893 no TCONS_00003985 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts NOTEST 1.30462 0 -1.79769e+308 -1.79769e+308 0.368444 1 no TCONS_00003986 XLOC_001265 - chr1:2252695-2322993 iPS Fibroblasts OK 54.2991 177.628 1.70986 -2.29338 0.0218262 0.0909209 no TCONS_00003987 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 40.4484 64.133 0.664984 -0.436761 0.662285 0.956531 no TCONS_00003988 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 7.56119 19.0177 1.33066 -0.394483 0.693224 0.973593 no TCONS_00003989 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts OK 0 23.7899 1.79769e+308 1.79769e+308 0.473642 0.795246 no TCONS_00003990 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts OK 290.341 893.546 1.6218 -1.39291 0.163648 0.412481 no TCONS_00003991 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts OK 174.785 500.991 1.5192 -2.92007 0.00349955 0.0202315 yes TCONS_00003992 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003993 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts NOTEST 6.35744 0 -1.79769e+308 -1.79769e+308 0.0423949 1 no TCONS_00003994 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003995 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts NOTEST 0.907232 6.38716 2.81563 -0.545215 0.585605 1 no TCONS_00003996 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003997 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts NOTEST 1.10294 9.83614 3.15674 -0.697049 0.485772 1 no TCONS_00003998 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003999 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0.931281 3.38316 1.86108 -0.0777597 0.938019 1 no TCONS_00004000 XLOC_001271 - chr1:2976182-2980350 iPS Fibroblasts NOTEST 0.620738 0.336145 -0.884902 0.323409 0.746385 1 no TCONS_00004001 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no TCONS_00004002 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 69.8392 92.849 0.410849 -0.552337 0.580718 1 no TCONS_00004003 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts OK 43.7292 64.5702 0.562274 -0.623806 0.532755 0.84758 no TCONS_00004004 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 179.578 402.167 1.16318 -1.61871 0.105509 0.307968 no TCONS_00004005 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 62.1764 99.5061 0.678419 -0.444767 0.656488 0.952775 no TCONS_00004006 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 23.0108 18.6731 -0.30135 0.219913 0.825939 0.999997 no TCONS_00004007 XLOC_001275 - chr1:3652549-3663886 iPS Fibroblasts OK 0 30.0855 1.79769e+308 1.79769e+308 0.199297 0.471788 no TCONS_00004008 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts OK 201.581 227.555 0.174861 -0.373366 0.708876 0.979971 no TCONS_00004009 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts OK 867.894 1410.28 0.700388 -1.71311 0.0866925 0.26483 no TCONS_00004010 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 15.12 85.1871 2.49418 -1.68931 0.0911601 0.272566 no TCONS_00004011 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 139.485 305.484 1.13099 -2.05028 0.0403376 0.149263 no TCONS_00004012 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 111.609 177.709 0.671069 -0.486136 0.626871 0.933446 no TCONS_00004013 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts OK 473.292 1178.32 1.31593 -2.66537 0.00769042 0.0400247 yes TCONS_00004014 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts NOTEST 15.8862 4.40735 -1.84979 0.135552 0.892175 1 no TCONS_00004015 XLOC_001279 - chr1:5621768-5728315 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004016 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts OK 38.0315 98.804 1.37738 -1.96448 0.0494749 0.170951 no TCONS_00004017 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 12.3891 8.76607 -0.499075 0.249038 0.803332 1 no TCONS_00004018 XLOC_001280 - chr1:5922869-6052531 iPS Fibroblasts NOTEST 9.73733 3.94762 -1.30254 0.253584 0.799817 1 no TCONS_00004019 XLOC_001280 - chr1:5922869-6052531 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004020 XLOC_001280 - chr1:5922869-6052531 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004021 XLOC_001280 - chr1:5922869-6052531 iPS Fibroblasts NOTEST 1.34942 3.61882 1.42318 -0.0776635 0.938096 1 no TCONS_00004022 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 0 2.58654 1.79769e+308 1.79769e+308 0.0700196 1 no TCONS_00004023 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts NOTEST 3.69165 0.873718 -2.07903 0.871562 0.383447 1 no TCONS_00004024 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 6.8891 0.611774 -3.49325 1.46963 0.141662 1 no TCONS_00004025 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts NOTEST 3.73417 0 -1.79769e+308 -1.79769e+308 0.269027 1 no TCONS_00004026 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts NOTEST 0.120394 0 -1.79769e+308 -1.79769e+308 0.459936 1 no TCONS_00004027 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts OK 2222.07 7509.61 1.75684 -3.8057 0.000141403 0.00136624 yes TCONS_00004028 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts OK 209.378 2365.52 3.49798 -2.79239 0.00523204 0.0282883 yes TCONS_00004029 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts OK 1235.93 2319.74 0.908368 -2.18637 0.0287882 0.112511 no TCONS_00004030 XLOC_001283 - chr1:6266188-6296044 iPS Fibroblasts OK 243.59 288.283 0.243029 -0.201212 0.840533 0.999997 no TCONS_00004031 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts OK 79.9572 498.6 2.64058 -3.88265 0.000103322 0.00105187 yes TCONS_00004032 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts OK 37.8293 268.364 2.82662 -2.76946 0.00561494 0.0301244 yes TCONS_00004033 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 239.832 2679.84 0 0 1 1 no TCONS_00004034 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 0 39.0287 0 0 1 1 no TCONS_00004035 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 126.845 110.585 0 0 1 1 no TCONS_00004036 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 462.887 732.481 0 0 1 1 no TCONS_00004037 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 134.974 70.6091 0 0 1 1 no TCONS_00004038 XLOC_001285 - chr1:6324332-6453826 iPS Fibroblasts FAIL 0 0 0 0 1 1 no TCONS_00004039 XLOC_001285 - chr1:6324332-6453826 iPS Fibroblasts FAIL 0 963.208 0 0 1 1 no TCONS_00004040 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 0 0.48661 1.79769e+308 1.79769e+308 0.338266 1 no TCONS_00004041 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 5.92301 1.41752 -2.06296 2.01896 0.0434917 1 no TCONS_00004042 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 6.84793 1.79769e+308 1.79769e+308 0.434436 1 no TCONS_00004043 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 4.86935 0 -1.79769e+308 -1.79769e+308 0.445968 1 no TCONS_00004044 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0.414166 1.79769e+308 1.79769e+308 0.449964 1 no TCONS_00004045 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004046 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 23.1541 5.81123 -1.99435 0.307084 0.758779 1 no TCONS_00004047 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004048 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004049 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004050 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004051 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 22.6201 11.3936 -0.989383 0.147664 0.882608 1 no TCONS_00004052 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 12.7468 1.74109 -2.87207 0.301357 0.763142 1 no TCONS_00004053 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 2.06233 2.5797 0.32293 -0.0411122 0.967206 1 no TCONS_00004054 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 14.2602 0 -1.79769e+308 -1.79769e+308 0.17142 1 no TCONS_00004055 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004056 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 17.5992 34.905 0.987923 -0.737732 0.460678 0.787415 no TCONS_00004057 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004058 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 25.7562 0.024414 -10.043 0.377839 0.70555 0.979044 no TCONS_00004059 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004060 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 0.00544137 18.3016 11.7157 -0.0837056 0.93329 0.999997 no TCONS_00004061 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 14.4826 0 -1.79769e+308 -1.79769e+308 0.123134 1 no TCONS_00004062 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 3.95345 1.79769e+308 1.79769e+308 0.308371 1 no TCONS_00004063 XLOC_001287 - chr1:6521220-6580069 iPS Fibroblasts OK 30.5163 12.5671 -1.27992 0.383901 0.701052 0.976699 no TCONS_00004064 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts OK 503.823 361.435 -0.47918 1.00025 0.317189 0.637127 no TCONS_00004065 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts NOTEST 0 2.40754 1.79769e+308 1.79769e+308 0.466312 1 no TCONS_00004066 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 109.476 77.2985 -0.5021 0.468422 0.639483 0.941849 no TCONS_00004067 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 134.239 601.611 2.16403 -2.03687 0.0416632 0.152546 no TCONS_00004068 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 0 378.033 1.79769e+308 1.79769e+308 0.0627513 0.208207 no TCONS_00004069 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004070 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts OK 727.027 1673.01 1.20236 -2.78749 0.00531181 0.0286453 yes TCONS_00004071 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts OK 11.865 29.7673 1.32701 -0.226486 0.820823 0.999997 no TCONS_00004072 XLOC_001290 - chr1:6684924-6761966 iPS Fibroblasts OK 4.91606 28.6155 2.54122 -0.22929 0.818643 0.999997 no TCONS_00004073 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004074 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 2.40953 0 -1.79769e+308 -1.79769e+308 0.449621 1 no TCONS_00004075 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0.0400905 0 -1.79769e+308 -1.79769e+308 0.496829 1 no TCONS_00004076 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts NOTEST 0 1.38187 1.79769e+308 1.79769e+308 0.0774008 1 no TCONS_00004077 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 641.313 2240.53 1.80474 -4.1258 3.69455e-05 0.000442869 yes TCONS_00004078 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 137.346 71.1003 -0.949889 0.287302 0.773881 0.999997 no TCONS_00004079 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 1.40725 1692.19 10.2318 -0.605892 0.544586 0.859071 no TCONS_00004080 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts NOTEST 16.3557 9.81398 -0.736883 0.0584609 0.953381 1 no TCONS_00004081 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 170.627 268.727 0.655297 -0.357935 0.720392 0.984819 no TCONS_00004082 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 0 47.6257 1.79769e+308 1.79769e+308 0.43296 0.759956 no TCONS_00004083 XLOC_001295 - chr1:8412465-8877699 iPS Fibroblasts NOTEST 20.7508 0 -1.79769e+308 -1.79769e+308 0.365376 1 no TCONS_00004084 XLOC_001294 - chr1:8412465-8877699 iPS Fibroblasts OK 85.8783 6.13498 -3.80716 0.0566625 0.954814 0.999997 no TCONS_00004085 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 444.441 181.074 -1.29541 0.0760813 0.939354 0.999997 no TCONS_00004086 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 19439.6 33570.6 0.788198 -1.7791 0.0752231 0.238226 no TCONS_00004087 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 0 12912.6 1.79769e+308 1.79769e+308 0.0175203 0.076817 no TCONS_00004088 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004089 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 0 679.817 1.79769e+308 1.79769e+308 0.409236 0.736271 no TCONS_00004090 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 9.70153 0 -1.79769e+308 -1.79769e+308 0.484244 1 no TCONS_00004091 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 2186.7 24138 3.46448 -4.67229 2.97853e-06 4.78169e-05 yes TCONS_00004092 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 10.0879 0 -1.79769e+308 -1.79769e+308 0.485793 1 no TCONS_00004093 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 351.21 150.373 -1.22379 0.0312347 0.975082 0.999997 no TCONS_00004094 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts NOTEST 0 0.725244 1.79769e+308 1.79769e+308 0.180502 1 no TCONS_00004095 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 7.16648 1.79769e+308 1.79769e+308 0.382366 1 no TCONS_00004096 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004097 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts OK 0.00429204 51.3731 13.5471 -0.0376447 0.969971 0.999997 no TCONS_00004098 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004099 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts OK 3.56432 61.3688 4.10581 -2.97039 0.00297426 0.0177222 yes TCONS_00004100 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 2.34161 4.17775 0.835229 -0.0307 0.975509 1 no TCONS_00004101 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004102 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts OK 9.05298 24.4065 1.4308 -0.669934 0.5029 0.820603 no TCONS_00004103 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts OK 16.7212 72.7269 2.12081 -1.5239 0.127533 0.349752 no TCONS_00004104 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts NOTEST 1.60049 1.42116 -0.171454 0.0540506 0.956895 1 no TCONS_00004105 XLOC_001299 - chr1:9164475-9189356 iPS Fibroblasts NOTEST 9.67107 1.26783 -2.93131 0.910899 0.362349 1 no TCONS_00004106 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts OK 95.9263 69.3907 -0.467184 0.755747 0.449801 0.777098 no TCONS_00004107 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004108 XLOC_001302 - chr1:9711789-9884550 iPS Fibroblasts OK 86.8241 61.7832 -0.490881 0.0609674 0.951385 0.999997 no TCONS_00004109 XLOC_001303 - chr1:9711789-9884550 iPS Fibroblasts OK 3.82816 695.497 7.50525 -0.286002 0.774877 0.999997 no TCONS_00004110 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 0 2515.79 1.79769e+308 1.79769e+308 0.0020398 0.0126698 yes TCONS_00004111 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 340.016 1606.44 2.24019 -3.17472 0.00149981 0.00993685 yes TCONS_00004112 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 134.509 26.3156 -2.35372 0.150575 0.880311 0.999997 no TCONS_00004113 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts OK 72.4794 95.0697 0.391415 -0.320564 0.74854 0.999997 no TCONS_00004114 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts OK 406.916 414.727 0.027429 -0.0541346 0.956828 0.999997 no TCONS_00004115 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 14.1134 7.08002 -0.995239 0.0690022 0.944988 1 no TCONS_00004116 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts OK 217.917 674.732 1.63054 -2.44812 0.0143603 0.0664037 no TCONS_00004117 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts OK 89.4602 335.17 1.90558 -1.87849 0.0603138 0.201722 no TCONS_00004118 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 0 5.13452 1.79769e+308 1.79769e+308 0.473347 1 no TCONS_00004119 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts OK 485.4 848.024 0.804932 -1.13123 0.257958 0.560206 no TCONS_00004120 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts OK 298.378 316.625 0.0856349 -0.0931565 0.925779 0.999997 no TCONS_00004121 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 8.71581 0.352429 -4.62823 1.35562 0.175222 1 no TCONS_00004122 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 1.21532 1.6466 0.438153 -0.0605317 0.951732 1 no TCONS_00004123 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 8.95125 6.07219 -0.559873 0.391727 0.69526 1 no TCONS_00004124 XLOC_001307 - chr1:10696667-10856707 iPS Fibroblasts NOTEST 2.07597 0 -1.79769e+308 -1.79769e+308 0.393422 1 no TCONS_00004125 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 1.66784 0.00205508 -9.66457 0.0248422 0.980181 1 no TCONS_00004126 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 0 0.331458 1.79769e+308 1.79769e+308 0.277181 1 no TCONS_00004127 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 0.000832712 0 -1.79769e+308 -1.79769e+308 0.499705 1 no TCONS_00004128 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts OK 68.298 15.0124 -2.18569 2.8138 0.00489594 0.026889 yes TCONS_00004129 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004130 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 6.76699 0 -1.79769e+308 -1.79769e+308 0.186969 1 no TCONS_00004131 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004132 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 1171.02 3003.63 1.35894 -1.46892 0.141855 0.377617 no TCONS_00004133 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 1002.98 7820.85 2.96303 -5.16451 2.41072e-07 4.88464e-06 yes TCONS_00004134 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts OK 1339.2 1601.03 0.25762 -0.653821 0.513227 0.831603 no TCONS_00004135 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts NOTEST 0 7.79258 1.79769e+308 1.79769e+308 0.461701 1 no TCONS_00004136 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts OK 90.8453 33.2215 -1.4513 0.418606 0.675504 0.962974 no TCONS_00004137 XLOC_001312 - chr1:11166588-11322608 iPS Fibroblasts OK 59.0429 170.948 1.53372 -1.03527 0.300544 0.618774 no TCONS_00004138 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts OK 578.796 636.873 0.137951 -0.350853 0.725699 0.987954 no TCONS_00004139 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts OK 302.813 72.9584 -2.05328 1.60748 0.107949 0.312468 no TCONS_00004140 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004141 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 5.94962 0 -1.79769e+308 -1.79769e+308 0.460599 1 no TCONS_00004142 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts OK 107.944 303.3 1.49046 -0.417332 0.676435 0.962975 no TCONS_00004143 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts OK 4377.8 2064.91 -1.08412 2.26733 0.0233703 0.0965817 no TCONS_00004144 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 12.2816 263.856 4.42518 -3.37199 0.000746263 0.00546474 yes TCONS_00004145 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 98.8766 277.975 1.49125 -2.48281 0.0130349 0.0619678 no TCONS_00004146 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 66.9034 108.763 0.701034 -0.312463 0.754688 0.999997 no TCONS_00004147 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004148 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts OK 3.4039 18.088 2.40977 -0.308338 0.757825 0.999997 no TCONS_00004149 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts NOTEST 770.486 0 -1.79769e+308 -1.79769e+308 0.000683496 1 no TCONS_00004150 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts OK 537.636 1330.79 1.30758 -2.64697 0.00812157 0.0418511 yes TCONS_00004151 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts OK 136.358 113.009 -0.270955 0.114022 0.90922 0.999997 no TCONS_00004152 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 664.349 292.677 -1.18263 1.47016 0.141518 0.377201 no TCONS_00004153 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 631.203 457.869 -0.463169 0.779474 0.435701 0.762202 no TCONS_00004154 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 34.783 0 -1.79769e+308 -1.79769e+308 0.314212 0.633285 no TCONS_00004155 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 29.3372 1.34044 -4.45195 0.0357642 0.97147 0.999997 no TCONS_00004156 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 17.2087 67.1677 1.96463 -0.0649752 0.948194 0.999997 no TCONS_00004157 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004158 XLOC_001321 - chr1:12907235-12908578 iPS Fibroblasts OK 162.796 1951.16 3.58319 -6.22559 4.79736e-10 1.50257e-08 yes TCONS_00004159 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004160 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no TCONS_00004161 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004162 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.337687 0 -1.79769e+308 -1.79769e+308 0.414194 1 no TCONS_00004163 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.334536 0 -1.79769e+308 -1.79769e+308 0.414227 1 no TCONS_00004164 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.000123029 0 -1.79769e+308 -1.79769e+308 0.499966 1 no TCONS_00004165 XLOC_001325 - chr1:13182960-13183967 iPS Fibroblasts OK 22.2793 207.399 3.21863 -4.25455 2.09472e-05 0.000271534 yes TCONS_00004166 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004167 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004168 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004169 XLOC_001328 PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts NOTEST 0.200361 0 -1.79769e+308 -1.79769e+308 0.436402 1 no TCONS_00004170 XLOC_001328 PRAMEF13 chr1:13447413-13452656 iPS Fibroblasts NOTEST 0.000572928 0 -1.79769e+308 -1.79769e+308 0.499811 1 no TCONS_00004171 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004172 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00004173 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TCONS_00004174 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004175 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts NOTEST 6.96034 0 -1.79769e+308 -1.79769e+308 0.0128373 1 no TCONS_00004176 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS Fibroblasts NOTEST 8.04256 0.859289 -3.22644 0.126844 0.899064 1 no TCONS_00004177 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS Fibroblasts NOTEST 0.000490761 0 -1.79769e+308 -1.79769e+308 0.499439 1 no TCONS_00004178 XLOC_001335 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0.432797 2.62025 2.59795 -0.869836 0.38439 1 no TCONS_00004179 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 75.4615 25.7553 -1.55087 1.34744 0.177839 0.434602 no TCONS_00004180 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 0 118.428 1.79769e+308 1.79769e+308 0.0208665 0.0878412 no TCONS_00004181 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 145.227 55.404 -1.39025 0.982531 0.325838 0.648016 no TCONS_00004182 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 8.22122 1.79769e+308 1.79769e+308 0.372819 1 no TCONS_00004183 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004184 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 0 29.4638 1.79769e+308 1.79769e+308 0.209826 0.484983 no TCONS_00004185 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 173.37 51.1746 -1.76035 1.40989 0.158573 0.405565 no TCONS_00004186 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts OK 122.09 43.2083 -1.49857 0.836515 0.402865 0.730692 no TCONS_00004187 XLOC_001338 - chr1:16133656-16134194 iPS Fibroblasts OK 7916.63 21049.2 1.41081 -3.46206 0.000536064 0.00415898 yes TCONS_00004188 XLOC_001339 - chr1:16160709-16266950 iPS Fibroblasts OK 68.8094 39.9858 -0.783119 0.309905 0.756633 0.999997 no TCONS_00004189 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 106.181 560.414 2.39997 -3.78818 0.000151755 0.00142503 yes TCONS_00004190 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 5.22855 1.79769e+308 1.79769e+308 0.447966 1 no TCONS_00004191 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 35.4246 48.555 0.45487 -0.264338 0.791519 0.999997 no TCONS_00004192 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004193 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 0.0412124 13.5911 8.36537 -0.168209 0.866419 0.999997 no TCONS_00004194 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 10.1074 9.63291 -0.0693738 0.00850889 0.993211 1 no TCONS_00004195 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004196 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 11.9384 26.7081 1.16167 -0.176522 0.859884 0.999997 no TCONS_00004197 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 15.5862 2.23494 -2.80197 0.260092 0.794793 1 no TCONS_00004198 XLOC_001341 - chr1:16317618-16317647 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004199 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 100.427 235.204 1.22777 -1.43136 0.152326 0.395206 no TCONS_00004200 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 12.5495 16.7923 0.420171 -0.111119 0.911522 0.999997 no TCONS_00004201 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 8.04701 26.6845 1.72948 -0.396402 0.691809 0.972914 no TCONS_00004202 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 0 60.3352 1.79769e+308 1.79769e+308 0.252071 0.553179 no TCONS_00004203 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 71.8733 397.66 2.46801 -2.27742 0.0227612 0.0944387 no TCONS_00004204 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts NOTEST 7.54529 7.5659 0.0039345 -0.000115232 0.999908 1 no TCONS_00004205 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts OK 6.09452 38.8477 2.67224 -0.323259 0.746499 0.99993 no TCONS_00004206 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts OK 234.901 923.073 1.97439 -4.11694 3.83937e-05 0.000452698 yes TCONS_00004207 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts NOTEST 22.2582 0 -1.79769e+308 -1.79769e+308 0.383855 1 no TCONS_00004208 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 17.0126 132.515 2.96148 -1.64755 0.0994451 0.292313 no TCONS_00004209 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 0 38.3291 1.79769e+308 1.79769e+308 0.209842 0.484983 no TCONS_00004210 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 156.261 8.10745 -4.26857 2.04693 0.0406646 0.149942 no TCONS_00004211 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts OK 28.2148 182.341 2.69211 -3.90462 9.4375e-05 0.000970249 yes TCONS_00004212 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 22.2988 15.5838 -0.516918 0.12646 0.899368 0.999997 no TCONS_00004213 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 11.178 30.8971 1.4668 -0.347568 0.728165 0.989375 no TCONS_00004214 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 292.804 533.075 0.864402 -1.69108 0.0908206 0.271941 no TCONS_00004215 XLOC_001347 - chr1:16576559-16678948 iPS Fibroblasts OK 27.075 0 -1.79769e+308 -1.79769e+308 0.157924 0.404402 no TCONS_00004216 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 0 0.168084 1.79769e+308 1.79769e+308 0.490269 1 no TCONS_00004217 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 1.25463 0 -1.79769e+308 -1.79769e+308 0.44193 1 no TCONS_00004218 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004219 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 39.2853 16.8693 -1.21959 1.57059 0.116279 0.331504 no TCONS_00004220 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 0 33.8911 1.79769e+308 1.79769e+308 0.214876 0.492569 no TCONS_00004221 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 7.75221 17.5001 1.17468 -0.248451 0.803786 0.999997 no TCONS_00004222 XLOC_001350 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 23.1603 0.8365 -4.79115 2.95061 0.00317145 1 no TCONS_00004223 XLOC_001351 - chr1:16888922-16890082 iPS Fibroblasts OK 223.564 1764.52 2.98051 -5.386 7.20429e-08 1.59951e-06 yes TCONS_00004224 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 153.181 592.825 1.95237 -3.11856 0.00181737 0.0116237 yes TCONS_00004225 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 0 551.679 1.79769e+308 1.79769e+308 0.0269954 0.106703 no TCONS_00004226 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 65.4571 232.03 1.82569 -0.890098 0.373413 0.697684 no TCONS_00004227 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 2.67381 2.38008 -0.16789 0.0019933 0.99841 1 no TCONS_00004228 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 100.986 99.1905 -0.0258845 0.014713 0.988261 0.999997 no TCONS_00004229 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 8.12905 41.2295 2.34252 -0.464521 0.642275 0.94396 no TCONS_00004230 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 119.817 198.126 0.725593 -0.626134 0.531227 0.84758 no TCONS_00004231 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 146.83 151.051 0.0408874 -0.0380439 0.969653 0.999997 no TCONS_00004232 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 24.9871 60.3527 1.27223 -0.651752 0.514561 0.833118 no TCONS_00004233 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 0 22.2743 1.79769e+308 1.79769e+308 0.218228 0.498296 no TCONS_00004234 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 62.8563 44.2115 -0.507636 0.380731 0.703403 0.978016 no TCONS_00004235 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 59.3619 73.4927 0.308063 -0.230683 0.817561 0.999997 no TCONS_00004236 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 16.2307 16.1259 -0.00935092 0.00306727 0.997553 0.999997 no TCONS_00004237 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 93.9509 217.203 1.20907 -0.536698 0.591476 0.906113 no TCONS_00004238 XLOC_001354 ESPN chr1:17017712-17046652 iPS Fibroblasts NOTEST 2.07327 0 -1.79769e+308 -1.79769e+308 0.134129 1 no TCONS_00004239 XLOC_001354 ESPNP chr1:17017712-17046652 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004240 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 14.2231 1.55467 -3.19355 0.207314 0.835764 1 no TCONS_00004241 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 1.90183 1.59851 -0.250659 0.0136945 0.989074 1 no TCONS_00004242 XLOC_001356 - chr1:17066767-17299474 iPS Fibroblasts OK 133.893 408.247 1.60836 -0.665311 0.505852 0.823569 no TCONS_00004243 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 1631.49 1960.36 0.264924 -0.514704 0.60676 0.922571 no TCONS_00004244 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 316.038 401.58 0.34559 -0.28627 0.774671 0.999997 no TCONS_00004245 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 0 31.938 1.79769e+308 1.79769e+308 0.416789 0.744725 no TCONS_00004246 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 0 11.7873 1.79769e+308 1.79769e+308 0.472296 0.793625 no TCONS_00004247 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 66.6283 231.387 1.7961 -0.742034 0.458067 0.785209 no TCONS_00004248 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 124.905 177.11 0.503814 -0.624101 0.532562 0.84758 no TCONS_00004249 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 125.906 205.856 0.709292 -0.949951 0.342137 0.664092 no TCONS_00004250 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 4.40168 24.341 2.46726 -0.369653 0.711641 0.980323 no TCONS_00004251 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 0 46.6117 1.79769e+308 1.79769e+308 0.321011 0.641101 no TCONS_00004252 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 26.0242 0 -1.79769e+308 -1.79769e+308 0.257123 0.558976 no TCONS_00004253 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts OK 1562.94 5372.43 1.78131 -4.16829 3.06896e-05 0.000378834 yes TCONS_00004254 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts OK 25.3396 1.76593e-05 -20.4525 0.000899178 0.999283 0.999997 no TCONS_00004255 XLOC_001360 - chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0.887434 1.79769e+308 1.79769e+308 0.095774 1 no TCONS_00004256 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts NOTEST 6.09039 0 -1.79769e+308 -1.79769e+308 0.263624 1 no TCONS_00004257 XLOC_001361 - chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004258 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 2447.51 869.89 -1.49241 3.66306 0.000249219 1 no TCONS_00004259 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts OK 895.394 178.175 -2.32923 2.83374 0.00460074 0.0255366 yes TCONS_00004260 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TCONS_00004261 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 85.8408 130.588 0.605284 -0.641601 0.521132 0.841147 no TCONS_00004262 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts NOTEST 14.7849 0 -1.79769e+308 -1.79769e+308 0.267429 1 no TCONS_00004263 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 163.444 406.234 1.31352 -2.23806 0.0252172 0.102191 no TCONS_00004264 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts OK 102.06 303.773 1.57358 -3.15592 0.00159995 0.0105334 yes TCONS_00004265 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 15.0916 9.6791 -0.6408 0.018265 0.985427 1 no TCONS_00004266 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 14.6135 229.039 3.97022 -0.144739 0.884917 0.999997 no TCONS_00004267 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 1.68163 294.701 7.45324 -0.0681441 0.945671 0.999997 no TCONS_00004268 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 0 22.1323 1.79769e+308 1.79769e+308 0.468787 0.793032 no TCONS_00004269 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004270 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 28.2328 470.997 4.06027 -1.41628 0.156694 0.402423 no TCONS_00004271 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 4.91166 243.59 5.6321 -0.323463 0.746345 0.99993 no TCONS_00004272 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 623.312 666.218 0.0960407 -0.218497 0.827042 0.999997 no TCONS_00004273 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 39.3315 5.62521 -2.80571 0.0408876 0.967386 0.999997 no TCONS_00004274 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 38.8471 171.68 2.14385 -0.711689 0.476657 0.797119 no TCONS_00004275 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004276 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 112.418 7.05837 -3.99339 0.139907 0.888733 0.999997 no TCONS_00004277 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 44.1215 6.73706 -2.71129 0.0671761 0.946442 0.999997 no TCONS_00004278 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 256.033 2042.6 2.996 -5.71891 1.0721e-08 2.79685e-07 yes TCONS_00004279 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 0 57.4804 1.79769e+308 1.79769e+308 0.30057 0.618774 no TCONS_00004280 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 41.707 247.27 2.56773 -1.26108 0.20728 0.482804 no TCONS_00004281 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 11.7322 15.2695 0.38018 -0.0327198 0.973898 0.999997 no TCONS_00004282 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 8.47305 10.5092 0.310695 -0.356588 0.7214 1 no TCONS_00004283 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 0.000354505 0 -1.79769e+308 -1.79769e+308 0.499887 1 no TCONS_00004284 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts OK 16.1619 15.2534 -0.0834673 0.0945577 0.924666 0.999997 no TCONS_00004285 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts OK 341.159 3035.54 3.15344 -5.5553 2.77133e-08 6.64801e-07 yes TCONS_00004286 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts OK 0 179.738 1.79769e+308 1.79769e+308 0.393924 0.721791 no TCONS_00004287 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts NOTEST 22.0575 3.31248 -2.73528 0.0232293 0.981467 1 no TCONS_00004288 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 1302.83 0 -1.79769e+308 -1.79769e+308 8.13491e-05 0.000848878 yes TCONS_00004289 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 43.0618 70.755 0.716423 -0.0354422 0.971727 0.999997 no TCONS_00004290 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 2361.48 19294.6 3.03043 -6.22473 4.82377e-10 1.50257e-08 yes TCONS_00004291 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 17.4929 86.3183 2.3029 -0.130683 0.896026 0.999997 no TCONS_00004292 XLOC_001372 - chr1:19665273-19811992 iPS Fibroblasts OK 37.4567 16.6971 -1.16562 0.104673 0.916635 0.999997 no TCONS_00004293 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 6.20966 36.9795 2.57414 -0.570371 0.568426 0.882379 no TCONS_00004294 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 48.488 464.48 3.25992 -4.77692 1.78002e-06 3.07017e-05 yes TCONS_00004295 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004296 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 2.72756 73.4655 4.75138 -0.610414 0.541587 0.855196 no TCONS_00004297 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 16.1889 32.2829 0.995766 -0.340705 0.733325 0.993478 no TCONS_00004298 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 6.08129 20.9118 1.78187 -0.142277 0.886861 0.999997 no TCONS_00004299 XLOC_001374 RNF186 chr1:20140522-20141771 iPS Fibroblasts NOTEST 1.07721 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00004300 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004301 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004302 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts NOTEST 0 0.000476318 1.79769e+308 1.79769e+308 0.499866 1 no TCONS_00004303 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts OK 61.8417 12.9515 -2.25546 1.81798 0.0690678 0.22348 no TCONS_00004304 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts OK 72.4826 0 -1.79769e+308 -1.79769e+308 0.0514411 0.176575 no TCONS_00004305 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004306 XLOC_001377 - chr1:20438440-20446008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004307 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004308 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004309 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts NOTEST 0 2.56345 1.79769e+308 1.79769e+308 0.0741977 1 no TCONS_00004310 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts OK 163.673 2654.04 4.0193 -2.24345 0.0248677 0.101167 no TCONS_00004311 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts OK 171.705 7835.73 5.51206 -7.85065 4.21885e-15 3.03612e-13 yes TCONS_00004312 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts OK 392.307 1509.04 1.94358 -4.25254 2.11358e-05 0.000272287 yes TCONS_00004313 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts OK 4421.99 12703.4 1.52245 -3.69885 0.00021658 0.00193993 yes TCONS_00004314 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts NOTEST 5.84642 0 -1.79769e+308 -1.79769e+308 0.477209 1 no TCONS_00004315 XLOC_001382 - chr1:20978259-20988037 iPS Fibroblasts NOTEST 5.18588 0 -1.79769e+308 -1.79769e+308 0.481145 1 no TCONS_00004316 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts OK 30.3966 13.1454 -1.20935 0.0122497 0.990226 0.999997 no TCONS_00004317 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 4.98873 1.79769e+308 1.79769e+308 0.40849 1 no TCONS_00004318 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 7.59828 82.6962 3.44407 -1.02281 0.306396 0.624462 no TCONS_00004319 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 0 11.7825 1.79769e+308 1.79769e+308 0.246188 0.544064 no TCONS_00004320 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 5.15833 0 -1.79769e+308 -1.79769e+308 0.310698 1 no TCONS_00004321 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 53.8428 29.9178 -0.847751 0.789424 0.429864 0.757942 no TCONS_00004322 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 0 89.3077 1.79769e+308 1.79769e+308 0.0630672 0.208592 no TCONS_00004323 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 17.3446 86.3601 2.31588 -1.78759 0.0738423 0.234922 no TCONS_00004324 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 56.3467 132.567 1.23432 -1.50551 0.132193 0.360166 no TCONS_00004325 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 44.0552 89.2902 1.01919 -0.246332 0.805425 0.999997 no TCONS_00004326 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 302.536 147.345 -1.0379 0.50504 0.613531 0.925392 no TCONS_00004327 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 92.6039 97.5133 0.0745255 -0.0160608 0.987186 0.999997 no TCONS_00004328 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 240.174 1021.61 2.0887 -2.02882 0.0424763 0.153903 no TCONS_00004329 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 394.454 1426.22 1.85427 -2.73477 0.00624244 0.0330659 yes TCONS_00004330 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 478.545 1140.1 1.25244 -1.19078 0.233742 0.525667 no TCONS_00004331 XLOC_001385 - chr1:21069170-21113799 iPS Fibroblasts OK 91.5259 12.8279 -2.83489 0.0845078 0.932653 0.999997 no TCONS_00004332 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 67.7047 234.83 1.79429 -0.761163 0.44656 0.772778 no TCONS_00004333 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 201.731 286.111 0.504142 -0.104316 0.916919 0.999997 no TCONS_00004334 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 16.2897 487.969 4.90476 -1.03572 0.300334 0.618774 no TCONS_00004335 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 4.89492 48.898 3.32042 -0.363707 0.716077 0.982546 no TCONS_00004336 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 494.463 640.112 0.372462 -0.374339 0.708152 0.979971 no TCONS_00004337 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 23.2845 233.937 3.32867 -1.41416 0.157315 0.403336 no TCONS_00004338 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 62.5109 347.572 2.47513 -2.05053 0.0403127 0.149263 no TCONS_00004339 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004340 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 155.005 310.62 1.00284 -0.98089 0.326647 0.648016 no TCONS_00004341 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004342 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 310.854 0 -1.79769e+308 -1.79769e+308 0.0196006 0.0843692 no TCONS_00004343 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 99.134 49.7966 -0.993333 0.110693 0.91186 0.999997 no TCONS_00004344 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 0 127.783 1.79769e+308 1.79769e+308 0.384443 0.708393 no TCONS_00004345 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 90.6691 986.479 3.4436 -2.43061 0.0150735 0.0686863 no TCONS_00004346 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 39.3564 1395.64 5.14819 -2.43204 0.0150139 0.0686363 no TCONS_00004347 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 0 15.8926 1.79769e+308 1.79769e+308 0.486465 0.804217 no TCONS_00004348 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 67.8265 3871.51 5.8349 -6.42094 1.35436e-10 4.63369e-09 yes TCONS_00004349 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 30.7121 87.2531 1.5064 -0.0820123 0.934637 0.999997 no TCONS_00004350 XLOC_001388 - chr1:21543739-21672034 iPS Fibroblasts NOTEST 8.5531 0.547703 -3.96498 0.0634978 0.94937 1 no TCONS_00004351 XLOC_001389 - chr1:21749600-21754300 iPS Fibroblasts OK 100.478 526.991 2.3909 -4.16704 3.08585e-05 0.000378834 yes TCONS_00004352 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 3.1394 0 -1.79769e+308 -1.79769e+308 0.325714 1 no TCONS_00004353 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts OK 27.4868 2.12746 -3.69153 3.45464 0.000551018 0.00424345 yes TCONS_00004354 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 14.88 0.00165223 -13.1367 0.0408286 0.967433 1 no TCONS_00004355 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 10.5936 0 -1.79769e+308 -1.79769e+308 0.203811 1 no TCONS_00004356 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 119.181 49.025 -1.28157 0.570022 0.568663 0.882379 no TCONS_00004357 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 397.254 1051.93 1.4049 -2.85298 0.00433118 0.0242989 yes TCONS_00004358 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004359 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 31.0054 44.2579 0.513415 -0.199311 0.84202 0.999997 no TCONS_00004360 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 9.73763 0 -1.79769e+308 -1.79769e+308 0.347079 1 no TCONS_00004361 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 40.7577 1.54293 -4.72333 0.0325374 0.974043 0.999997 no TCONS_00004362 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 215.746 194.761 -0.147629 0.0635172 0.949355 0.999997 no TCONS_00004363 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 330.639 182.168 -0.859989 0.38542 0.699926 0.976699 no TCONS_00004364 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 8.87162 262.104 4.8848 -0.257172 0.797046 0.999997 no TCONS_00004365 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 101.632 3722.7 5.19493 -6.40741 1.48016e-10 4.9824e-09 yes TCONS_00004366 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 15.8513 771.12 5.60429 -3.1199 0.00180915 0.0116237 yes TCONS_00004367 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 32.9146 0 -1.79769e+308 -1.79769e+308 0.395674 0.722461 no TCONS_00004368 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 15.9522 0.00537242 -11.5359 0.13724 0.890841 1 no TCONS_00004369 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 0.000222119 0.782392 11.7823 -0.00277907 0.997783 1 no TCONS_00004370 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts NOTEST 3.40123 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00004371 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 331.605 398.717 0.2659 -0.456086 0.648328 0.947048 no TCONS_00004372 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 472.843 487.054 0.0427205 -0.0852687 0.932048 0.999997 no TCONS_00004373 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 56.1574 0 -1.79769e+308 -1.79769e+308 0.169084 0.423116 no TCONS_00004374 XLOC_001396 HTR1D chr1:23518388-23521222 iPS Fibroblasts OK 223.865 0 -1.79769e+308 -1.79769e+308 6.06842e-05 0.000673659 yes TCONS_00004375 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 18.8159 0 -1.79769e+308 -1.79769e+308 0.43101 1 no TCONS_00004376 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 125.856 337.66 1.4238 -0.771008 0.440702 0.76518 no TCONS_00004377 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 871.304 1348.2 0.629788 -0.581645 0.560806 0.87633 no TCONS_00004378 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 1672.29 2703.15 0.692816 -1.28753 0.197908 0.469891 no TCONS_00004379 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 233.679 618.972 1.40534 -0.742424 0.457831 0.785209 no TCONS_00004380 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 174.016 0 -1.79769e+308 -1.79769e+308 0.053774 0.183376 no TCONS_00004381 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 0.231084 0 -1.79769e+308 -1.79769e+308 0.475171 1 no TCONS_00004382 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 46.0789 95.6502 1.05366 -0.220708 0.82532 0.999997 no TCONS_00004383 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts OK 32.0809 264.956 3.04597 -3.4306 0.000602252 0.00455399 yes TCONS_00004384 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts OK 28.9081 121.81 2.07509 -1.97013 0.0488238 0.16965 no TCONS_00004385 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 72.9916 539.056 2.88463 -3.41524 0.000637264 0.00476692 yes TCONS_00004386 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 0 75.1132 1.79769e+308 1.79769e+308 0.332048 0.653758 no TCONS_00004387 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 61.7872 147.495 1.25528 -0.628209 0.529867 0.84758 no TCONS_00004388 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 0 12.5792 1.79769e+308 1.79769e+308 0.466455 0.792342 no TCONS_00004389 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 57.325 97.6727 0.768792 -0.486906 0.626325 0.933446 no TCONS_00004390 XLOC_001400 - chr1:23755055-23811057 iPS Fibroblasts OK 31.2959 41.7841 0.41698 -0.182298 0.855349 0.999997 no TCONS_00004391 XLOC_001400 - chr1:23755055-23811057 iPS Fibroblasts OK 33.3151 61.9722 0.895443 -0.541534 0.58814 0.901872 no TCONS_00004392 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 181.965 591.657 1.7011 -3.08718 0.00202068 0.0126641 yes TCONS_00004393 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004394 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004395 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004396 XLOC_001401 - chr1:23755055-23811057 iPS Fibroblasts NOTEST 14.3352 0 -1.79769e+308 -1.79769e+308 0.245948 1 no TCONS_00004397 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts OK 17.3678 59.0676 1.76595 -2.48715 0.0128773 0.0613581 no TCONS_00004398 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts OK 2233.71 1179.44 -0.921339 1.94336 0.0519728 0.178059 no TCONS_00004399 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts OK 290.313 325.332 0.164305 -0.153351 0.878121 0.999997 no TCONS_00004400 XLOC_001404 - chr1:24069855-24104777 iPS Fibroblasts OK 29.788 107.333 1.8493 -0.266177 0.790103 0.999997 no TCONS_00004401 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 33.6768 12.7034 -1.40654 0.232084 0.816472 0.999997 no TCONS_00004402 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 0 127.586 1.79769e+308 1.79769e+308 0.156742 0.402423 no TCONS_00004403 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 17.4871 39.5664 1.17798 -0.362489 0.716987 0.983148 no TCONS_00004404 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 150.589 357.933 1.24907 -1.55043 0.121039 0.336811 no TCONS_00004405 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 61.4119 155.802 1.34312 -0.817569 0.413603 0.741572 no TCONS_00004406 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 34.8907 64.4525 0.885391 -0.35688 0.721182 0.984819 no TCONS_00004407 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004408 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 6.56657 4.63048 -0.503976 0.0211657 0.983114 1 no TCONS_00004409 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 4.49564 0 -1.79769e+308 -1.79769e+308 0.478102 1 no TCONS_00004410 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 184.728 1600.17 3.11475 -5.19576 2.03882e-07 4.21288e-06 yes TCONS_00004411 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004412 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 0 114.728 1.79769e+308 1.79769e+308 0.199385 0.471788 no TCONS_00004413 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 7.68224 0 -1.79769e+308 -1.79769e+308 0.320546 1 no TCONS_00004414 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 7.05744 5.84858 -0.271059 0.0104872 0.991633 1 no TCONS_00004415 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 17.3205 39.9903 1.20717 -0.422974 0.672314 0.961699 no TCONS_00004416 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts OK 207.2 140.427 -0.561204 0.900067 0.368084 0.691131 no TCONS_00004417 XLOC_001407 - chr1:24171573-24194821 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004418 XLOC_001407 - chr1:24171573-24194821 iPS Fibroblasts NOTEST 0 2.14565 1.79769e+308 1.79769e+308 0.486747 1 no TCONS_00004419 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TCONS_00004420 XLOC_001409 - chr1:24292938-24306821 iPS Fibroblasts OK 869.644 156.955 -2.47008 1.65902 0.097111 0.286663 no TCONS_00004421 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts OK 177.784 1297.57 2.86761 -2.59373 0.00949397 0.0478597 yes TCONS_00004422 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts OK 1054.92 1010.81 -0.0616163 0.119599 0.9048 0.999997 no TCONS_00004423 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004424 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.452065 0 -1.79769e+308 -1.79769e+308 0.306327 1 no TCONS_00004425 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.798149 0 -1.79769e+308 -1.79769e+308 0.20295 1 no TCONS_00004426 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 1.49896 0 -1.79769e+308 -1.79769e+308 0.204218 1 no TCONS_00004427 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.347098 0 -1.79769e+308 -1.79769e+308 0.308557 1 no TCONS_00004428 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 6.64523 0 -1.79769e+308 -1.79769e+308 0.0070371 1 no TCONS_00004429 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 0.000273846 1.79769e+308 1.79769e+308 0.499753 1 no TCONS_00004430 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004431 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 3.57838 1.79769e+308 1.79769e+308 0.0328381 1 no TCONS_00004432 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0.000702974 1.79769e+308 1.79769e+308 0.498969 1 no TCONS_00004433 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts OK 81.6347 0 -1.79769e+308 -1.79769e+308 0.00038214 0.00313987 yes TCONS_00004434 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 4.07053 0.0773653 -5.71739 0.921483 0.356798 1 no TCONS_00004435 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0.0365025 1.79769e+308 1.79769e+308 0.447072 1 no TCONS_00004436 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 13.7311 0 -1.79769e+308 -1.79769e+308 0.43375 1 no TCONS_00004437 XLOC_001413 - chr1:24580829-24580859 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004438 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004439 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 11.5429 57.9985 2.32901 -1.06707 0.285942 0.602788 no TCONS_00004440 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 2.86176 13.0899 2.19347 -0.232413 0.816217 0.999997 no TCONS_00004441 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 141.615 205.765 0.539029 -0.835514 0.403428 0.730864 no TCONS_00004442 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 3.67923 1.79769e+308 1.79769e+308 0.435246 1 no TCONS_00004443 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 8.9548 15.7206 0.811925 -0.162795 0.87068 0.999997 no TCONS_00000001 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 10.9963 1.79769e+308 1.79769e+308 0.418712 1 no TCONS_00000002 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts NOTEST 0.347386 0 -1.79769e+308 -1.79769e+308 0.402261 1 no TCONS_00000003 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 5.15434 1.79769e+308 1.79769e+308 0.467848 1 no TCONS_00000004 XLOC_000002 OR4F5 chr1:69090-70008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000005 XLOC_000003 - chr1:321083-321114 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000006 XLOC_000004 - chr1:321145-321223 hESC Fibroblasts OK 697259 14237.7 -5.6139 1.7034 0.0884936 0.26853 no TCONS_00000007 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 358.383 29.2848 -3.61328 4.06337 4.83698e-05 0.000548629 yes TCONS_00000008 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 338.308 5.01291 -6.07655 3.00643 0.00264331 0.015898 yes TCONS_00000009 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 0.0127652 13.7589 10.0739 -0.389099 0.697203 0.974922 no TCONS_00000010 XLOC_000006 OR4F16 chr1:367658-368595 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000011 XLOC_000007 - chr1:420205-421839 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000012 XLOC_000008 - chr1:566461-568045 hESC Fibroblasts NOTEST 91983.2 69492.5 -0.404513 1.73369 0.0829724 1 no TCONS_00000013 XLOC_000009 - chr1:568148-568842 hESC Fibroblasts NOTEST 6464.44 26012.6 2.00862 -4.14783 3.35646e-05 1 no TCONS_00000014 XLOC_000010 - chr1:568843-568912 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000015 XLOC_000011 - chr1:569326-570349 hESC Fibroblasts OK 31401.9 37535.9 0.257423 -0.528984 0.596816 0.912495 no TCONS_00000016 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000017 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000018 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts OK 81.4928 60.0796 -0.439798 0.202126 0.839818 0.999997 no TCONS_00000019 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts OK 0 17.1018 1.79769e+308 1.79769e+308 0.44529 0.771221 no TCONS_00000020 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts OK 100.78 214.895 1.09242 -2.12293 0.0337597 0.129516 no TCONS_00000021 XLOC_000013 - chr1:791897-794579 hESC Fibroblasts OK 28.2795 74.5004 1.39749 -2.65054 0.00803632 0.0417209 yes TCONS_00000022 XLOC_000014 - chr1:846814-850328 hESC Fibroblasts OK 27.5823 0.58031 -5.57077 4.56368 5.0264e-06 7.54684e-05 yes TCONS_00000023 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000024 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 1.74761 3.81714 1.12711 -0.0206055 0.98356 1 no TCONS_00000025 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts OK 4.50533 34.9169 2.95422 -0.426077 0.670052 0.95993 no TCONS_00000026 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 180.736 138.131 -0.387843 0.65007 0.515647 0.834229 no TCONS_00000027 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 151.63 48.7092 -1.63829 0.903481 0.366271 0.691131 no TCONS_00000028 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 229.433 99.7819 -1.20123 1.4354 0.151172 0.393907 no TCONS_00000029 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 180.118 60.5379 -1.57304 0.973461 0.330324 0.651594 no TCONS_00000030 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 13.3791 5.90797 -1.17924 0.27379 0.784246 0.999997 no TCONS_00000031 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 9.40489 22.8971 1.28368 -1.26539 0.205732 0.481348 no TCONS_00000032 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 0 30.5047 1.79769e+308 1.79769e+308 0.0475585 0.166936 no TCONS_00000033 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts OK 987.18 3379.09 1.77525 -5.01809 5.21889e-07 1.01793e-05 yes TCONS_00000034 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts OK 1857.6 2553.38 0.458967 -1.27209 0.203343 0.47844 no TCONS_00000035 XLOC_000020 - chr1:995082-1001833 hESC Fibroblasts NOTEST 3.11297 5.82921 0.90501 -0.286702 0.774341 1 no TCONS_00000036 XLOC_000020 - chr1:995082-1001833 hESC Fibroblasts OK 28.951 64.5665 1.15717 -1.51509 0.129749 0.354431 no TCONS_00000037 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts NOTEST 1.64828 0 -1.79769e+308 -1.79769e+308 0.0567344 1 no TCONS_00000038 XLOC_000022 - chr1:1102483-1102578 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000039 XLOC_000023 - chr1:1103242-1103332 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000040 XLOC_000024 - chr1:1104384-1104467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000041 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts OK 9.72146 0 -1.79769e+308 -1.79769e+308 0.000106203 0.00106991 yes TCONS_00000042 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 0.00267487 0 -1.79769e+308 -1.79769e+308 0.497608 1 no TCONS_00000043 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 6.97279 0 -1.79769e+308 -1.79769e+308 0.00246227 1 no TCONS_00000044 XLOC_000026 B3GALT6 chr1:1167628-1170418 hESC Fibroblasts OK 276.214 1068.96 1.95235 -5.91507 3.3173e-09 9.35567e-08 yes TCONS_00000045 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 2.57257 9.60499 1.90058 -0.938807 0.34783 1 no TCONS_00000046 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 11.929 19.6908 0.723044 -0.698128 0.485097 0.802853 no TCONS_00000047 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 25.3683 15.2046 -0.738519 0.626755 0.53082 0.84758 no TCONS_00000048 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 4.36667 6.75717 0.629885 -0.298748 0.765132 1 no TCONS_00000049 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 30.4263 12.2197 -1.31611 0.621832 0.534052 0.84758 no TCONS_00000050 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 666.825 694.672 0.059023 -0.04098 0.967312 0.999997 no TCONS_00000051 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 108.47 160.99 0.569674 -0.121871 0.903001 0.999997 no TCONS_00000052 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 14.7123 15.8664 0.108956 -0.003982 0.996823 0.999997 no TCONS_00000053 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts OK 187.156 781.158 2.06137 -5.7929 6.91832e-09 1.82766e-07 yes TCONS_00000054 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts NOTEST 2.57898 4.31837 0.743686 -0.805548 0.420503 1 no TCONS_00000055 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts NOTEST 152.655 319.473 1.06541 -0.821583 0.411314 1 no TCONS_00000056 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts OK 92.5876 62.6627 -0.563211 0.136644 0.891312 0.999997 no TCONS_00000057 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts OK 308.066 185.591 -0.73111 0.411722 0.680543 0.966844 no TCONS_00000058 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts OK 59.0363 0 -1.79769e+308 -1.79769e+308 5.12217e-06 7.63569e-05 yes TCONS_00000059 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts OK 58.9274 29.8843 -0.979553 0.501649 0.615915 0.92719 no TCONS_00000060 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts OK 469.362 444.091 -0.079845 0.202495 0.83953 0.999997 no TCONS_00000061 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts OK 69.2663 15.5201 -2.15801 3.56653 0.000361735 0.00298396 yes TCONS_00000062 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 409.377 275.225 -0.572818 1.01836 0.308509 0.626038 no TCONS_00000063 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 111.183 43.4345 -1.35603 0.849522 0.395591 0.722461 no TCONS_00000064 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 138.44 154.302 0.156495 -0.183382 0.854498 0.999997 no TCONS_00000065 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 321.282 321.282 -2.94691e-06 3.41128e-06 0.999997 0.999997 no TCONS_00000066 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts OK 54.4924 39.157 -0.476786 0.141762 0.887268 0.999997 no TCONS_00000067 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 790.187 819.961 0.0533603 -0.103776 0.917347 1 no TCONS_00000068 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 542.034 1200.71 1.14743 -2.4716 0.0134509 1 no TCONS_00000069 XLOC_000036 - chr1:1447554-1470064 hESC Fibroblasts OK 25.8427 15.9237 -0.698582 0.0859995 0.931467 0.999997 no TCONS_00000070 XLOC_000037 - chr1:1535818-1543166 hESC Fibroblasts OK 10.6728 5.74721 -0.893003 0.807327 0.419478 0.746972 no TCONS_00000071 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 0.00352987 17.092 12.2414 -0.0977963 0.922094 0.999997 no TCONS_00000072 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 86.1128 316.769 1.87913 -3.37365 0.000741784 0.00545106 yes TCONS_00000073 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 4.48044 0 -1.79769e+308 -1.79769e+308 0.24101 1 no TCONS_00000074 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 100.346 66.3531 -0.596751 0.504202 0.61412 0.925392 no TCONS_00000075 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000076 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 37.6352 44.1025 0.228778 -0.14303 0.886266 0.999997 no TCONS_00000077 XLOC_000038 - chr1:1550883-1565984 hESC Fibroblasts OK 26.2154 16.9683 -0.627575 0.220163 0.825745 0.999997 no TCONS_00000078 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 3.88743 56.0751 3.85047 -2.07677 0.0378229 0.141717 no TCONS_00000079 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 100.348 45.3624 -1.14544 0.316453 0.751659 0.999997 no TCONS_00000080 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 0 30.3273 1.79769e+308 1.79769e+308 0.405843 0.733328 no TCONS_00000081 XLOC_000038 - chr1:1550883-1565984 hESC Fibroblasts OK 217.26 0 -1.79769e+308 -1.79769e+308 0.0174021 0.0766207 no TCONS_00000082 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts OK 33.88 6.12558 -2.46752 1.55482 0.11999 0.336133 no TCONS_00000083 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 23.6518 0 -1.79769e+308 -1.79769e+308 0.000240873 0.00213009 yes TCONS_00000084 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 0 13.8369 1.79769e+308 1.79769e+308 0.106259 0.308433 no TCONS_00000085 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 9.67624 6.24162 -0.632526 0.19623 0.84443 0.999997 no TCONS_00000086 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 73.9259 90.7454 0.295744 -0.016833 0.98657 0.999997 no TCONS_00000087 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 18.0861 2.78903 -2.69705 0.00199175 0.998411 0.999997 no TCONS_00000088 XLOC_000041 - chr1:1571099-1677431 hESC Fibroblasts OK 78.5208 84.1606 0.10007 -0.0119073 0.9905 0.999997 no TCONS_00000089 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts NOTEST 3.15678 11.254 1.83391 -1.49266 0.135527 1 no TCONS_00000090 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts OK 26.9908 1.08118 -4.64179 2.89373 0.003807 0.0216491 yes TCONS_00000091 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts OK 41.7053 0.393202 -6.72881 3.58001 0.000343586 0.00285683 yes TCONS_00000092 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 833.609 0 -1.79769e+308 -1.79769e+308 3.60688e-28 4.18198e-26 yes TCONS_00000093 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 0 45.4119 1.79769e+308 1.79769e+308 0.206902 0.482463 no TCONS_00000094 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000095 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 60.5588 0 -1.79769e+308 -1.79769e+308 0.0391281 0.145788 no TCONS_00000096 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 0 34.2875 1.79769e+308 1.79769e+308 0.311842 0.630024 no TCONS_00000097 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 3.07856 0 -1.79769e+308 -1.79769e+308 0.426846 1 no TCONS_00000098 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 14.6847 0 -1.79769e+308 -1.79769e+308 0.238827 0.533652 no TCONS_00000099 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 17.4198 0 -1.79769e+308 -1.79769e+308 0.133938 0.364443 no TCONS_00000100 XLOC_000045 - chr1:1981908-2139172 hESC Fibroblasts OK 54.9905 11.1992 -2.29579 0.310838 0.755924 0.999997 no TCONS_00000101 XLOC_000046 - chr1:1981908-2139172 hESC Fibroblasts OK 109.688 100.493 -0.126319 0.106377 0.915283 0.999997 no TCONS_00000102 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts OK 740.008 1645.91 1.15327 -3.57845 0.000345636 0.00286247 yes TCONS_00000103 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts OK 772.363 3798.35 2.29802 -6.08292 1.18015e-09 3.46897e-08 yes TCONS_00000104 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts OK 30.1072 143.247 2.25033 -0.995911 0.319293 0.638892 no TCONS_00000105 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 1.11603 0.769693 -0.536018 0.167195 0.867217 1 no TCONS_00000106 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000107 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 6.36609e-05 0.593027 13.1854 -0.00234077 0.998132 1 no TCONS_00000108 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000109 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 1.19958 1.27131 0.0837773 -0.047765 0.961904 1 no TCONS_00000110 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000111 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 0.103287 118.524 10.1643 -0.439385 0.660383 0.955769 no TCONS_00000112 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 1.72115 42.8167 4.63673 -2.22615 0.0260043 0.104367 no TCONS_00000113 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 0.4903 46.0527 6.55348 -4.10092 4.11513e-05 0.000479792 yes TCONS_00000114 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 0 650.706 1.79769e+308 1.79769e+308 0.000218799 0.00195142 yes TCONS_00000115 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 1.45201 29.4904 4.34412 -1.3719 0.170093 0.424116 no TCONS_00000116 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 431.86 616.77 0.514169 -1.08079 0.279791 0.595101 no TCONS_00000117 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 36.9813 5.26014 -2.81363 0.1606 0.872409 0.999997 no TCONS_00000118 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 327.266 561.382 0.778519 -1.55496 0.119955 0.336133 no TCONS_00000119 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000120 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 15.5461 21.4195 0.462373 -0.108914 0.913271 0.999997 no TCONS_00000121 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000122 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 46.1049 83.8728 0.863283 -0.552957 0.580293 0.893779 no TCONS_00000123 XLOC_000052 ACTRT2 chr1:2938045-2939465 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000124 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 4.52426 0 -1.79769e+308 -1.79769e+308 1.83109e-06 1 no TCONS_00000125 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0 7.0186 1.79769e+308 1.79769e+308 0.0148547 1 no TCONS_00000126 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0.770522 0 -1.79769e+308 -1.79769e+308 0.153883 1 no TCONS_00000127 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0 1.20838 1.79769e+308 1.79769e+308 0.348531 1 no TCONS_00000128 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000129 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 229.313 2.38434 -6.58758 4.64732 3.36281e-06 5.27683e-05 yes TCONS_00000130 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 60.5958 2.38281 -4.66848 2.49762 0.0125031 0.0601242 no TCONS_00000131 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 60.018 0.0183886 -11.6724 0.262029 0.793299 0.999997 no TCONS_00000132 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 11.6052 0 -1.79769e+308 -1.79769e+308 0.0890786 0.268652 no TCONS_00000133 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 5.86138 0 -1.79769e+308 -1.79769e+308 0.177621 1 no TCONS_00000134 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts OK 498.776 2676.03 2.42363 -7.46346 8.43769e-14 4.75932e-12 yes TCONS_00000135 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts OK 0 20.4274 1.79769e+308 1.79769e+308 0.439218 0.763873 no TCONS_00000136 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0.438492 1.79769e+308 1.79769e+308 0.352545 1 no TCONS_00000137 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts OK 63.3435 3.93866 -4.00742 4.24881 2.14913e-05 0.000275168 yes TCONS_00000138 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 5.31366 0 -1.79769e+308 -1.79769e+308 0.112078 1 no TCONS_00000139 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000140 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 4.94475 0 -1.79769e+308 -1.79769e+308 0.0476228 1 no TCONS_00000141 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.0344885 0 -1.79769e+308 -1.79769e+308 0.463424 1 no TCONS_00000142 XLOC_000056 - chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.585598 0 -1.79769e+308 -1.79769e+308 0.344411 1 no TCONS_00000143 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000144 XLOC_000056 - chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.923281 0.0133356 -6.11341 0.0831379 0.933742 1 no TCONS_00000145 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts NOTEST 2.99279 0.344217 -3.1201 1.59609 0.110469 1 no TCONS_00000146 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts OK 76.8718 58.9016 -0.38415 0.550115 0.582241 0.894798 no TCONS_00000147 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000148 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000149 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 4.80895 0 -1.79769e+308 -1.79769e+308 0.290423 1 no TCONS_00000150 XLOC_000059 CAD chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 5.63584 1.79769e+308 1.79769e+308 0.422464 1 no TCONS_00000151 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts OK 86.6597 101.804 0.23236 -0.429165 0.667803 0.959192 no TCONS_00000152 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000153 XLOC_000059 CAD chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000154 XLOC_000059 CAD chr1:3773844-3801992 hESC Fibroblasts NOTEST 5.5449 0 -1.79769e+308 -1.79769e+308 0.0624149 1 no TCONS_00000155 XLOC_000059 CAD chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000156 XLOC_000059 CAD chr1:3773844-3801992 hESC Fibroblasts OK 14.4431 4.99183 -1.53274 0.456673 0.647906 0.947048 no TCONS_00000157 XLOC_000059 DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 8.65205 4.32215 -1.00129 0.242434 0.808444 1 no TCONS_00000158 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts NOTEST 0.672575 1.74517 1.3756 -0.428534 0.668263 1 no TCONS_00000159 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts OK 14.4718 1.74564 -3.05142 1.94113 0.052243 0.178447 no TCONS_00000160 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts OK 9.81514 0.782057 -3.64966 1.47336 0.140654 0.375984 no TCONS_00000161 XLOC_000061 - chr1:4000676-4015322 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000162 XLOC_000062 - chr1:4472110-4484744 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000163 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts OK 24.6786 0.851814 -4.85658 3.11703 0.00182683 0.0116237 yes TCONS_00000164 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts OK 49.2798 0.414322 -6.8941 3.15151 0.00162429 0.0106601 yes TCONS_00000165 XLOC_000064 - chr1:4847557-4852182 hESC Fibroblasts OK 18.1722 0.154615 -6.87691 3.65907 0.000253135 0.00219948 yes TCONS_00000166 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 20.2988 68.4146 1.75291 -2.08929 0.0366819 0.138436 no TCONS_00000167 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 14.9138 1.91789 -2.95905 0.244121 0.807137 0.999997 no TCONS_00000168 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000169 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 95.0662 32.7443 -1.53769 1.32922 0.183774 0.445973 no TCONS_00000170 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0.784025 0 -1.79769e+308 -1.79769e+308 0.311292 1 no TCONS_00000171 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0.706557 0 -1.79769e+308 -1.79769e+308 0.345594 1 no TCONS_00000172 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000173 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 12.8983 4.63395 -1.47687 0.0936819 0.925362 0.999997 no TCONS_00000174 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 28.2454 35.0042 0.309513 -0.0471752 0.962374 0.999997 no TCONS_00000175 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 17.0218 10.1307 -0.748643 0.0103814 0.991717 0.999997 no TCONS_00000176 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 17.9047 18.1716 0.0213419 -0.000528226 0.999579 0.999997 no TCONS_00000177 XLOC_000067 C1orf211 chr1:6297870-6299490 hESC Fibroblasts OK 132.225 4.35392 -4.92453 5.20718 1.91728e-07 4.00137e-06 yes TCONS_00000178 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts OK 1431.61 0 -1.79769e+308 -1.79769e+308 3.8204e-30 4.69011e-28 yes TCONS_00000179 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 20.3609 0.205083 -6.63345 2.68397 0.00727531 0.038054 yes TCONS_00000180 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 157.325 0 -1.79769e+308 -1.79769e+308 1.3715e-14 7.95086e-13 yes TCONS_00000181 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0.605201 0 -1.79769e+308 -1.79769e+308 0.172281 1 no TCONS_00000182 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0.10991 8.05147e-05 -10.4148 0.000871698 0.999304 1 no TCONS_00000183 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0.536804 4.20431 2.9694 -0.86638 0.386282 1 no TCONS_00000184 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 0 1.29131 1.79769e+308 1.79769e+308 0.222308 1 no TCONS_00000185 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts OK 15.0088 40.46 1.43069 -0.967591 0.333248 0.654271 no TCONS_00000186 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts OK 78.4398 47.2474 -0.731349 0.665234 0.505901 0.823569 no TCONS_00000187 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts OK 147.658 126.765 -0.220104 0.340759 0.733285 0.993478 no TCONS_00000188 XLOC_000071 - chr1:6640055-6649339 hESC Fibroblasts OK 85.1502 38.1578 -1.15803 0.935662 0.349447 0.671953 no TCONS_00000189 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts OK 660.096 769.313 0.220895 -0.682623 0.494845 0.813183 no TCONS_00000190 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 126.801 402.426 1.66615 -1.31321 0.189111 0.454002 no TCONS_00000191 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 87.2395 129.652 0.571593 -0.200165 0.841351 0.999997 no TCONS_00000192 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 19.5526 26.3763 0.431881 -0.0541185 0.956841 0.999997 no TCONS_00000193 XLOC_000074 - chr1:6845383-7829763 hESC Fibroblasts OK 1433.01 3192.65 1.1557 -3.21614 0.00129927 0.00891965 yes TCONS_00000194 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 8.2803 3.72176 -1.1537 0.282169 0.777814 1 no TCONS_00000195 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts OK 26.1246 0 -1.79769e+308 -1.79769e+308 7.13423e-06 0.000103397 yes TCONS_00000196 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 1.97243 1.79769e+308 1.79769e+308 0.459719 1 no TCONS_00000197 XLOC_000074 - chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000198 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts OK 502.334 7098.44 3.82078 -10.9673 0 0 yes TCONS_00000199 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 7.32764 29.553 2.01189 -0.471492 0.63729 0.941276 no TCONS_00000200 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 0 17.4103 1.79769e+308 1.79769e+308 0.297441 0.616445 no TCONS_00000201 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 47.2457 0 -1.79769e+308 -1.79769e+308 2.18008e-07 1 no TCONS_00000202 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 7.06457 82.6263 3.54793 -3.95944 7.51259e-05 0.000812372 yes TCONS_00000203 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 53.7103 221.632 2.04489 -4.33846 1.43481e-05 0.000191952 yes TCONS_00000204 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 2.51904 7.31695 1.53837 -0.408281 0.683067 1 no TCONS_00000205 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 27.1603 17.1487 -0.663401 0.0118376 0.990555 0.999997 no TCONS_00000206 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 6020.73 13290.9 1.14243 -2.53564 0.0112242 0.054988 no TCONS_00000207 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 35.935 301.624 3.06929 -0.474812 0.634921 0.940085 no TCONS_00000208 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 2349.66 8031.84 1.77328 -3.09426 0.00197308 0.0124405 yes TCONS_00000209 XLOC_000077 - chr1:8021713-8045341 hESC Fibroblasts OK 14.3833 7.3862 -0.961486 0.0124712 0.99005 0.999997 no TCONS_00000210 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 29.7198 142.738 2.26388 -4.11985 3.79118e-05 0.000449556 yes TCONS_00000211 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 9.9298 69.3396 2.80384 -2.24691 0.0246456 0.10046 no TCONS_00000212 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000213 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000214 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts OK 93.0165 1112.18 3.57976 -10.6305 0 0 yes TCONS_00000215 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts OK 18.3153 201.501 3.45967 -4.34856 1.37033e-05 0.000185706 yes TCONS_00000216 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts OK 67.8157 674.909 3.315 -7.98693 1.33227e-15 1.15852e-13 yes TCONS_00000217 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts OK 207.722 258.098 0.313267 -0.583339 0.559665 0.875578 no TCONS_00000218 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts OK 21.5619 8.24063 -1.38766 0.253409 0.799953 0.999997 no TCONS_00000219 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts OK 171.51 257.242 0.58483 -1.32637 0.184718 0.447742 no TCONS_00000220 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts OK 230.871 73.4533 -1.65219 2.0622 0.0391888 0.145788 no TCONS_00000221 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 260.118 45.2674 -2.52262 0.296126 0.767134 0.999997 no TCONS_00000222 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 155.927 109.373 -0.511616 0.143442 0.885941 0.999997 no TCONS_00000223 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 25.5368 21.2442 -0.265513 0.0146868 0.988282 0.999997 no TCONS_00000224 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts OK 39.4422 319.369 3.01741 -7.86539 3.77476e-15 2.81354e-13 yes TCONS_00000225 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts OK 229.575 19.7819 -3.53672 4.71889 2.3714e-06 3.95929e-05 yes TCONS_00000226 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000227 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts OK 1102.07 1122.9 0.0270107 -0.0805157 0.935827 0.999997 no TCONS_00000228 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts OK 20.3244 40.3364 0.988869 -0.504286 0.61406 0.925392 no TCONS_00000229 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts NOTEST 0 6.69762 1.79769e+308 1.79769e+308 0.454062 1 no TCONS_00000230 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts NOTEST 4.50396 0 -1.79769e+308 -1.79769e+308 0.228983 1 no TCONS_00000231 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts OK 10.087 70.0715 2.79633 -0.330823 0.740778 0.996295 no TCONS_00000232 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts OK 10.3213 200.875 4.2826 -1.52984 0.126057 0.346614 no TCONS_00000233 XLOC_000088 - chr1:10270763-10441659 hESC Fibroblasts NOTEST 2.25564 3.63439 0.688179 -0.00491323 0.99608 1 no TCONS_00000234 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 196.401 864.235 2.13762 -5.4424 5.25668e-08 1.21897e-06 yes TCONS_00000235 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 346.933 143.712 -1.27147 1.6952 0.0900375 0.270372 no TCONS_00000236 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 1.09608 5.57672 2.34706 -0.211056 0.832844 1 no TCONS_00000237 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 3.19143 0 -1.79769e+308 -1.79769e+308 0.188503 1 no TCONS_00000238 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000239 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000240 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 87.5644 29.2168 -1.58355 0.566267 0.571213 0.883707 no TCONS_00000241 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts OK 6778.74 13482.1 0.991958 -2.46442 0.0137233 0.0642369 no TCONS_00000242 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000243 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts OK 402.424 483.083 0.263553 -0.0882514 0.929677 0.999997 no TCONS_00000244 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 2.2212 4.89393 1.13966 -0.00357404 0.997148 1 no TCONS_00000245 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 84.7865 99.6012 0.232329 -0.174717 0.861302 0.999997 no TCONS_00000246 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 0 21.9227 1.79769e+308 1.79769e+308 0.305287 0.622809 no TCONS_00000247 XLOC_000090 Cort chr1:10490158-10512208 hESC Fibroblasts OK 9.52176 3.73278 -1.35098 0.05825 0.95355 0.999997 no TCONS_00000248 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 138.152 526.06 1.92897 -4.10601 4.02546e-05 0.000471974 yes TCONS_00000249 XLOC_000090 CORT chr1:10490158-10512208 hESC Fibroblasts OK 27.3151 12.1268 -1.17149 0.17028 0.86479 0.999997 no TCONS_00000250 XLOC_000091 Pex14 chr1:10535002-10690813 hESC Fibroblasts OK 65.6226 523.392 2.99563 -1.0746 0.282554 0.597457 no TCONS_00000251 XLOC_000091 Pex14 chr1:10535002-10690813 hESC Fibroblasts OK 6.4866 19.6946 1.60226 -0.212764 0.831511 0.999997 no TCONS_00000252 XLOC_000091 Pex14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 7.51008 3.68586 -1.02683 0.0210874 0.983176 1 no TCONS_00000253 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts OK 598.647 1041.13 0.79837 -2.23395 0.0254863 0.102683 no TCONS_00000254 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000255 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000256 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts OK 0 44.4442 1.79769e+308 1.79769e+308 0.230648 0.520393 no TCONS_00000257 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000258 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts NOTEST 2365.52 2744.34 0.214303 -0.654613 0.512717 1 no TCONS_00000259 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts OK 35.6818 0 -1.79769e+308 -1.79769e+308 0.0268718 0.106416 no TCONS_00000260 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0.912846 10.571 3.5336 -0.48214 0.629707 1 no TCONS_00000261 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts OK 307.383 332.294 0.112423 -0.306558 0.75918 0.999997 no TCONS_00000262 XLOC_000095 - chr1:11539294-11597639 hESC Fibroblasts OK 12.7281 0 -1.79769e+308 -1.79769e+308 0.0731172 0.233254 no TCONS_00000263 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts OK 61.7115 0.546235 -6.81987 5.58169 2.38187e-08 5.78018e-07 yes TCONS_00000264 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts NOTEST 0 7.55415e-05 1.79769e+308 1.79769e+308 0.499931 1 no TCONS_00000265 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 18.7336 10.2274 -0.873192 0.243575 0.80756 0.999997 no TCONS_00000266 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 143.48 66.4903 -1.10963 0.441904 0.658558 0.954318 no TCONS_00000267 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 158.642 19.1948 -3.04699 1.92045 0.0548015 0.186139 no TCONS_00000268 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 59.0165 138.586 1.2316 -1.31165 0.189637 0.454388 no TCONS_00000269 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 131.185 183.066 0.480763 -0.713045 0.475818 0.796976 no TCONS_00000270 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts NOTEST 5.92521 8.07306 0.44625 -0.0732797 0.941584 1 no TCONS_00000271 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 42.0022 0 -1.79769e+308 -1.79769e+308 0.0732063 0.233254 no TCONS_00000272 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts OK 25.5712 363.317 3.82864 -8.06025 6.66134e-16 6.04444e-14 yes TCONS_00000273 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts OK 340.257 11.5677 -4.87845 6.10186 1.04843e-09 3.17113e-08 yes TCONS_00000274 XLOC_000099 - chr1:11782186-11785914 hESC Fibroblasts OK 209.081 6.38178 -5.03396 6.66245 2.69302e-11 1.00363e-09 yes TCONS_00000275 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 212.87 117.552 -0.856671 0.410535 0.681414 0.967189 no TCONS_00000276 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 48.0216 31.884 -0.590848 0.142863 0.886398 0.999997 no TCONS_00000277 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 1078.57 1331.71 0.304155 -0.7062 0.480064 0.798034 no TCONS_00000278 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 261.965 389.478 0.572168 -0.683188 0.494488 0.813183 no TCONS_00000279 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 9.26798 41.1964 2.15219 -0.489138 0.624744 0.933314 no TCONS_00000280 XLOC_000101 C1orf167 chr1:11824461-11826573 hESC Fibroblasts NOTEST 3.47934 1.86471 -0.899861 0.478603 0.632221 1 no TCONS_00000281 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 2.18711 0 -1.79769e+308 -1.79769e+308 0.240981 1 no TCONS_00000282 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 2.17987 8.96806 2.04055 -0.106286 0.915355 1 no TCONS_00000283 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0.995584 0 -1.79769e+308 -1.79769e+308 0.375688 1 no TCONS_00000284 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 7.96239 11.3029 0.50542 -0.0234305 0.981307 1 no TCONS_00000285 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 4.82023 2.44992 -0.976369 0.00623262 0.995027 1 no TCONS_00000286 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts OK 18.414 40.6369 1.14199 -0.22905 0.81883 0.999997 no TCONS_00000287 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts OK 325.683 514.96 0.660993 -1.99208 0.0463621 0.163719 no TCONS_00000288 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0.0955929 0 -1.79769e+308 -1.79769e+308 0.41022 1 no TCONS_00000289 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000290 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts OK 8.28757 16.145 0.962064 -0.0517317 0.958742 0.999997 no TCONS_00000291 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000292 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000293 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000294 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000295 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000296 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts OK 954.766 10325.2 3.43488 -7.71277 1.22125e-14 7.49629e-13 yes TCONS_00000297 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts OK 1.78544 116.452 6.02731 -0.524709 0.599786 0.916234 no TCONS_00000298 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts OK 790.606 2718.63 1.78185 -3.95454 7.66812e-05 0.000824916 yes TCONS_00000299 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts OK 151.46 152.885 0.0135117 -0.00212285 0.998306 0.999997 no TCONS_00000300 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts OK 1223.51 575.01 -1.08937 2.79975 0.00511417 0.0277228 yes TCONS_00000301 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts OK 413.544 4.49588 -6.52329 5.60132 2.12726e-08 5.34892e-07 yes TCONS_00000302 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts OK 18.4204 0.000474981 -15.2431 0.014826 0.988171 0.999997 no TCONS_00000303 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 9.03791 0 -1.79769e+308 -1.79769e+308 0.124497 1 no TCONS_00000304 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 0 4.00161 1.79769e+308 1.79769e+308 0.248371 1 no TCONS_00000305 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts OK 28.1716 1285.44 5.51187 -14.2054 0 0 yes TCONS_00000306 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts OK 5.69324 110.504 4.27871 -3.07036 0.00213802 0.0131624 yes TCONS_00000307 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000308 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000309 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 71.9285 191.792 1.41491 -2.32165 0.0202518 0.0861036 no TCONS_00000310 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 66.1936 94.7776 0.517853 -0.423606 0.671853 0.961699 no TCONS_00000311 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000312 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts OK 20.135 65.4483 1.70065 -1.27947 0.200731 0.473898 no TCONS_00000313 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 4.58204 2.38321 -0.943087 0.0241683 0.980718 1 no TCONS_00000314 XLOC_000110 SNORA59B chr1:12290112-12572096 hESC Fibroblasts OK 234.664 63.6142 -1.88318 0.060948 0.951401 0.999997 no TCONS_00000315 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts NOTEST 1.34969 0 -1.79769e+308 -1.79769e+308 0.0786442 1 no TCONS_00000316 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 1.92876 0 -1.79769e+308 -1.79769e+308 0.0423899 1 no TCONS_00000317 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 8.12602 0 -1.79769e+308 -1.79769e+308 2.89119e-07 1 no TCONS_00000318 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts NOTEST 0.698209 0 -1.79769e+308 -1.79769e+308 0.306735 1 no TCONS_00000319 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts NOTEST 0.592256 0 -1.79769e+308 -1.79769e+308 0.306735 1 no TCONS_00000320 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts NOTEST 0.853096 0 -1.79769e+308 -1.79769e+308 0.111514 1 no TCONS_00000321 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000322 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000323 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000324 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000325 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000326 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000327 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000328 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000329 XLOC_000123 PRAMEF10 chr1:13629937-13635298 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000330 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000331 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts NOTEST 0.330232 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TCONS_00000332 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000333 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts OK 816.633 40.2891 -4.34123 4.27331 1.92594e-05 0.000252795 yes TCONS_00000334 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts OK 879.809 70.7232 -3.63693 5.68362 1.3187e-08 3.39768e-07 yes TCONS_00000335 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 6.91549 0 -1.79769e+308 -1.79769e+308 0.25743 1 no TCONS_00000336 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000337 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000338 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000339 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 12.8679 27.8928 1.11612 -0.43767 0.661626 0.956241 no TCONS_00000340 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 9.21056 0 -1.79769e+308 -1.79769e+308 0.002687 1 no TCONS_00000341 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 20.5972 14.8538 -0.471616 0.311708 0.755262 0.999997 no TCONS_00000342 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 1.65694 0 -1.79769e+308 -1.79769e+308 0.351997 1 no TCONS_00000343 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 0 43.9125 1.79769e+308 1.79769e+308 0.250176 0.550391 no TCONS_00000344 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 111.179 358.942 1.69087 -4.62447 3.75564e-06 5.76326e-05 yes TCONS_00000345 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 0.921398 28.7964 4.96592 -0.56857 0.569648 0.882595 no TCONS_00000346 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000347 XLOC_000128 - chr1:14026734-14151572 hESC Fibroblasts NOTEST 0.709477 2.32779 1.71413 -0.0883342 0.929611 1 no TCONS_00000348 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 45.0754 3.19938 -3.81647 0.306723 0.759054 0.999997 no TCONS_00000349 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000350 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 9.84787 6.7035 -0.554897 0.164697 0.869182 0.999997 no TCONS_00000351 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 19.5662 29.388 0.586861 -0.332502 0.73951 0.996295 no TCONS_00000352 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 0 13.2968 1.79769e+308 1.79769e+308 0.307255 0.62499 no TCONS_00000353 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 0 205.94 1.79769e+308 1.79769e+308 0.0476009 0.166936 no TCONS_00000354 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 79.6627 208.608 1.38882 -1.44008 0.149845 0.391397 no TCONS_00000355 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 5.19027 10.0324 0.950785 -0.308976 0.75734 1 no TCONS_00000356 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts NOTEST 0.0170528 0 -1.79769e+308 -1.79769e+308 0.486701 1 no TCONS_00000357 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts NOTEST 68.8043 34.1487 -1.01067 0.573416 0.566363 1 no TCONS_00000358 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 17.2845 65.7759 1.92808 -1.31278 0.189258 0.454002 no TCONS_00000359 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 40.9662 359.502 3.13349 -4.09289 4.26037e-05 0.000493966 yes TCONS_00000360 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 105.307 254.61 1.27369 -2.0088 0.0445584 0.158422 no TCONS_00000361 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 6.18974 2.29329 -1.43246 1.29897 0.193955 1 no TCONS_00000362 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 1.79489 0.862567 -1.05719 0.402707 0.687164 1 no TCONS_00000363 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000364 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000365 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 0.429055 0.572031 0.414929 -0.0829553 0.933887 1 no TCONS_00000366 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000367 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts OK 468.604 2197 2.22909 -6.83631 8.12594e-12 3.53309e-10 yes TCONS_00000368 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000369 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts NOTEST 0 5.61806 1.79769e+308 1.79769e+308 0.0900461 1 no TCONS_00000370 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000371 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts NOTEST 1.27477 0 -1.79769e+308 -1.79769e+308 0.352721 1 no TCONS_00000372 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts OK 22.5422 18.3447 -0.297262 0.0733335 0.941541 0.999997 no TCONS_00000373 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts OK 106.224 279.288 1.39464 -3.44876 0.000563163 0.00430521 yes TCONS_00000374 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts NOTEST 24.4409 78.8225 1.68931 -1.96768 0.0491044 1 no TCONS_00000375 XLOC_000136 - chr1:15853351-15918872 hESC Fibroblasts NOTEST 1.81648 2.11882 0.222122 -0.0073207 0.994159 1 no TCONS_00000376 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts NOTEST 1.92594 0.922843 -1.06141 0.090458 0.927923 1 no TCONS_00000377 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts OK 268.762 310.347 0.207554 -0.358859 0.719701 0.984819 no TCONS_00000378 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000379 XLOC_000137 RSC1A1 chr1:15944069-15988216 hESC Fibroblasts OK 259.157 376.086 0.537237 -1.05298 0.292349 0.609522 no TCONS_00000380 XLOC_000138 - chr1:15992765-15995535 hESC Fibroblasts OK 304.42 236.84 -0.362149 0.869668 0.384482 0.708393 no TCONS_00000381 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts OK 779.207 2346.33 1.59033 -4.91682 8.79633e-07 1.6391e-05 yes TCONS_00000382 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts NOTEST 8.64356 9.3373 0.111381 -0.136942 0.891077 1 no TCONS_00000383 XLOC_000140 - chr1:16062808-16067885 hESC Fibroblasts NOTEST 0.000570561 4.66039 12.9958 -0.00854718 0.99318 1 no TCONS_00000384 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts OK 31.4534 0 -1.79769e+308 -1.79769e+308 1.02587e-11 4.36937e-10 yes TCONS_00000385 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 28.622 72.561 1.34207 -0.293535 0.769113 0.999997 no TCONS_00000386 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 821.848 2026.56 1.30209 -3.21364 0.00131065 0.00896827 yes TCONS_00000387 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000388 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 23.593 11.5775 -1.02703 0.0253242 0.979796 0.999997 no TCONS_00000389 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 85.4176 333.297 1.9642 -1.63546 0.101953 0.298424 no TCONS_00000390 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 241.251 293.864 0.284612 -0.622647 0.533517 0.84758 no TCONS_00000391 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 140.357 168.12 0.260386 -0.417583 0.676252 0.962974 no TCONS_00000392 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000393 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 6.02437 0 -1.79769e+308 -1.79769e+308 0.0207184 1 no TCONS_00000394 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000395 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 9.02387 0 -1.79769e+308 -1.79769e+308 0.0125139 1 no TCONS_00000396 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts OK 10.1766 0.308418 -5.04423 0.300035 0.764151 0.999997 no TCONS_00000397 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 4.34296 0 -1.79769e+308 -1.79769e+308 0.0840222 1 no TCONS_00000398 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 5.14419 0 -1.79769e+308 -1.79769e+308 0.207583 1 no TCONS_00000399 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 2.91986 0 -1.79769e+308 -1.79769e+308 0.309484 1 no TCONS_00000400 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000401 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts OK 52.0827 1.81089 -4.84603 0.655272 0.512293 0.830734 no TCONS_00000402 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 0 133.313 1.79769e+308 1.79769e+308 0.429997 0.757942 no TCONS_00000403 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 532.647 1857.43 1.80206 -2.59885 0.00935372 0.0472669 yes TCONS_00000404 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 574.155 1815.92 1.66119 -2.13321 0.0329076 0.126712 no TCONS_00000405 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 256.538 1504.54 2.55208 -3.35665 0.00078893 0.00569722 yes TCONS_00000406 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 0 218.793 1.79769e+308 1.79769e+308 0.205588 0.481348 no TCONS_00000407 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 519.227 3410.49 2.71554 -7.95824 1.77636e-15 1.42587e-13 yes TCONS_00000408 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 16.6368 100.612 2.59634 -1.0061 0.314367 0.633285 no TCONS_00000409 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000410 XLOC_000148 - chr1:16860385-16864669 hESC Fibroblasts OK 12.2273 1.32866 -3.20206 2.73483 0.00624132 0.0330659 yes TCONS_00000411 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 4.10051 0 -1.79769e+308 -1.79769e+308 0.191196 1 no TCONS_00000412 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 6.52829 0 -1.79769e+308 -1.79769e+308 0.076555 1 no TCONS_00000413 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 1.45662 6.5283 2.16409 -0.946299 0.343996 1 no TCONS_00000414 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 6.80472 3.089 -1.1394 0.543734 0.586625 1 no TCONS_00000415 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 3.75649 1.53504 -1.29111 0.284321 0.776164 1 no TCONS_00000416 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 0.00527233 0 -1.79769e+308 -1.79769e+308 0.494255 1 no TCONS_00000417 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts OK 63.0415 3.07999 -4.35531 2.39032 0.0168337 0.0747487 no TCONS_00000418 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts OK 33.4266 0.615404 -5.76332 1.73277 0.0831367 0.256287 no TCONS_00000419 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts NOTEST 4.93427 0 -1.79769e+308 -1.79769e+308 0.334821 1 no TCONS_00000420 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 428.259 98.6818 -2.11763 4.19792 2.69379e-05 0.000336643 yes TCONS_00000421 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 30.5389 3.8214 -2.99847 0.278725 0.780456 0.999997 no TCONS_00000422 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 100.239 17.1632 -2.54605 1.39725 0.162339 0.411115 no TCONS_00000423 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts OK 62.5679 49.7705 -0.330131 0.274991 0.783323 0.999997 no TCONS_00000424 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 1.50479 0 -1.79769e+308 -1.79769e+308 0.0372925 1 no TCONS_00000425 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 0.286309 0 -1.79769e+308 -1.79769e+308 0.333484 1 no TCONS_00000426 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000427 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 6.34529e-05 6.06956e-06 -3.38602 2.75938e-05 0.999978 1 no TCONS_00000428 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 2.33196 0.513935 -2.18188 1.11817 0.263496 1 no TCONS_00000429 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts NOTEST 12.671 0.32407 -5.28908 3.31366 0.000920822 1 no TCONS_00000430 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts NOTEST 1.38095 0 -1.79769e+308 -1.79769e+308 0.181472 1 no TCONS_00000431 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts NOTEST 3.11869 0 -1.79769e+308 -1.79769e+308 0.0140302 1 no TCONS_00000432 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts NOTEST 0.21117 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TCONS_00000433 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 55.941 9.97606 -2.48736 0.487379 0.62599 0.933446 no TCONS_00000434 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 64.0925 18.9462 -1.75825 0.826981 0.408248 0.735128 no TCONS_00000435 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 0 208.168 1.79769e+308 1.79769e+308 0.00509617 0.0276972 yes TCONS_00000436 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 479.078 35.3353 -3.76108 2.22709 0.0259415 0.104316 no TCONS_00000437 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 2.78634 5.30615 0.929294 -0.0441671 0.964771 1 no TCONS_00000438 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 25.6249 0 -1.79769e+308 -1.79769e+308 0.00259312 0.0156865 yes TCONS_00000439 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 5.26 0 -1.79769e+308 -1.79769e+308 0.184349 1 no TCONS_00000440 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 0 381.592 1.79769e+308 1.79769e+308 0.000456313 0.00366279 yes TCONS_00000441 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts NOTEST 5.36255 0 -1.79769e+308 -1.79769e+308 0.214661 1 no TCONS_00000442 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts OK 44.6171 14.6487 -1.60682 0.27939 0.779946 0.999997 no TCONS_00000443 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts OK 17.1125 6.95204 -1.29954 1.74086 0.0817088 0.252631 no TCONS_00000444 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts OK 398.742 0 -1.79769e+308 -1.79769e+308 7.73853e-22 8.07515e-20 yes TCONS_00000445 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts NOTEST 3.24727 0 -1.79769e+308 -1.79769e+308 0.455712 1 no TCONS_00000446 XLOC_000158 - chr1:18434239-18704976 hESC Fibroblasts OK 18.0164 0 -1.79769e+308 -1.79769e+308 0.0420629 0.153471 no TCONS_00000447 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts OK 209.176 0 -1.79769e+308 -1.79769e+308 1.57475e-32 2.05407e-30 yes TCONS_00000448 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts NOTEST 8.37135 0.745204 -3.48975 2.01068 0.0443595 1 no TCONS_00000449 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 7.1892e-05 0 -1.79769e+308 -1.79769e+308 0.499937 1 no TCONS_00000450 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000451 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 0.969259 0 -1.79769e+308 -1.79769e+308 0.0110943 1 no TCONS_00000452 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts OK 961.74 1651.61 0.780159 -2.37831 0.0173923 0.0766208 no TCONS_00000453 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 217.71 338.197 0.635456 -1.25085 0.210988 0.486728 no TCONS_00000454 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 0.0310775 25.1112 9.65824 -0.32266 0.746953 0.99993 no TCONS_00000455 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 28.45 68.4588 1.26681 -1.07728 0.281357 0.59674 no TCONS_00000456 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 16.3096 16.9445 0.0550959 -0.0139539 0.988867 0.999997 no TCONS_00000457 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 62.153 139.07 1.16191 -1.24407 0.213472 0.490657 no TCONS_00000458 XLOC_000163 C1orf151 chr1:19923466-19984945 hESC Fibroblasts OK 17.1755 91.329 2.41072 -0.183389 0.854493 0.999997 no TCONS_00000459 XLOC_000163 C1orf151 chr1:19923466-19984945 hESC Fibroblasts OK 618.381 1693.34 1.45331 -1.35329 0.175962 0.431532 no TCONS_00000460 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 162.125 8926.42 5.7829 -10.4499 0 0 yes TCONS_00000461 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 1.64141 3.52907 1.10436 -0.00223238 0.998219 1 no TCONS_00000462 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 0 30.6081 1.79769e+308 1.79769e+308 0.487077 0.804217 no TCONS_00000463 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 16.9244 1884.11 6.79864 -4.7867 1.69545e-06 2.94867e-05 yes TCONS_00000464 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts OK 22.3161 0 -1.79769e+308 -1.79769e+308 2.82075e-11 1.03279e-09 yes TCONS_00000465 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts OK 157.667 87.3998 -0.851179 2.02602 0.0427627 0.154672 no TCONS_00000466 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 2.12447 1.79769e+308 1.79769e+308 0.443361 1 no TCONS_00000467 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000468 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts OK 0.847143 147.21 7.44105 -5.14402 2.68921e-07 5.39653e-06 yes TCONS_00000469 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts NOTEST 0.361045 0 -1.79769e+308 -1.79769e+308 0.159889 1 no TCONS_00000470 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts OK 17.9074 0.492177 -5.18523 3.87498 0.000106632 0.00106991 yes TCONS_00000471 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts OK 11.844 0 -1.79769e+308 -1.79769e+308 3.79697e-07 7.54693e-06 yes TCONS_00000472 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 6.27626 0.000774709 -12.984 0.0257234 0.979478 1 no TCONS_00000473 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0.572137 1.79769e+308 1.79769e+308 0.114546 1 no TCONS_00000474 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 1.08334 0 -1.79769e+308 -1.79769e+308 0.116654 1 no TCONS_00000475 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000476 XLOC_000170 FAM43B chr1:20878931-20881512 hESC Fibroblasts OK 40.5541 1.55058 -4.70896 5.03446 4.79204e-07 9.43489e-06 yes TCONS_00000477 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts OK 133.245 232.113 0.800745 -1.49151 0.135826 0.368616 no TCONS_00000478 XLOC_000171 - chr1:20915443-20945398 hESC Fibroblasts NOTEST 1.59843 0 -1.79769e+308 -1.79769e+308 0.468868 1 no TCONS_00000479 XLOC_000171 - chr1:20915443-20945398 hESC Fibroblasts NOTEST 6.30992 0 -1.79769e+308 -1.79769e+308 0.189547 1 no TCONS_00000480 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 326.979 2213.85 2.75929 -7.37461 1.64757e-13 9.04863e-12 yes TCONS_00000481 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 114.96 832.083 2.8556 -3.29087 0.000998788 0.00699487 yes TCONS_00000482 XLOC_000173 - chr1:21543739-21672034 hESC Fibroblasts NOTEST 7.51557 3.33508 -1.17216 0.0473121 0.962264 1 no TCONS_00000483 XLOC_000174 - chr1:21761832-21762609 hESC Fibroblasts OK 12075.7 7652.6 -0.658091 0.637145 0.52403 0.844518 no TCONS_00000484 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 3.12392 50.1038 4.00349 -2.43896 0.0147297 0.0677113 no TCONS_00000485 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 37.3701 428.32 3.51873 -7.96305 1.77636e-15 1.42587e-13 yes TCONS_00000486 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 1.81796 15.9541 3.13353 -0.982008 0.326096 0.648016 no TCONS_00000487 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts NOTEST 17.0989 34.3555 1.00664 -0.499019 0.617766 1 no TCONS_00000488 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 4753.79 56.7111 -6.3893 9.33358 0 0 yes TCONS_00000489 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 40.1523 0 -1.79769e+308 -1.79769e+308 0.124082 0.343447 no TCONS_00000490 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 130.881 2.32536 -5.81466 0.572198 0.567188 0.882379 no TCONS_00000491 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 120.584 0 -1.79769e+308 -1.79769e+308 0.00451612 0.0251337 yes TCONS_00000492 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts NOTEST 0 7.78492 1.79769e+308 1.79769e+308 0.260295 1 no TCONS_00000493 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts OK 22.0415 16.2682 -0.438171 0.00162169 0.998706 0.999997 no TCONS_00000494 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts OK 10.8865 166.982 3.93909 -0.0310011 0.975269 0.999997 no TCONS_00000495 XLOC_000178 CELA3B chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000496 XLOC_000178 - chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000497 XLOC_000178 CELA3A chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000498 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts NOTEST 4.05105 6.30679 0.638608 -0.0500359 0.960094 1 no TCONS_00000499 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts OK 427.827 527.288 0.301564 -0.672565 0.501224 0.81915 no TCONS_00000500 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000501 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 9.59677 70.2619 2.87212 -0.172269 0.863226 0.999997 no TCONS_00000502 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 74.2264 668.209 3.1703 -1.96666 0.049222 0.170359 no TCONS_00000503 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 9.02759 0 -1.79769e+308 -1.79769e+308 0.202314 1 no TCONS_00000504 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 1520.88 9098.98 2.5808 -6.83982 7.92899e-12 3.52081e-10 yes TCONS_00000505 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 3.95557 0 -1.79769e+308 -1.79769e+308 0.298891 1 no TCONS_00000506 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 8.77177 55.0216 2.64906 -0.200338 0.841216 0.999997 no TCONS_00000507 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 5.74741 7.10626 0.306178 -0.134433 0.89306 1 no TCONS_00000508 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 115.94 203.748 0.813403 -2.20426 0.0275062 1 no TCONS_00000509 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts OK 76.4937 7.15473 -3.41837 1.4773 0.139596 0.374952 no TCONS_00000510 XLOC_000181 - chr1:22778343-22857650 hESC Fibroblasts OK 23.69 12.3722 -0.937171 0.165335 0.86868 0.999997 no TCONS_00000511 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts OK 69.3632 0 -1.79769e+308 -1.79769e+308 1.29473e-10 4.55253e-09 yes TCONS_00000512 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts OK 16.9383 0 -1.79769e+308 -1.79769e+308 1.00724e-07 2.16713e-06 yes TCONS_00000513 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000514 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000515 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000516 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000517 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000518 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000519 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 80.4755 73.628 -0.128295 0.06344 0.949416 1 no TCONS_00000520 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 37.3058 79.1362 1.08494 -0.69215 0.488843 1 no TCONS_00000521 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 183.879 794.32 2.11096 -4.77291 1.81587e-06 1 no TCONS_00000522 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000523 XLOC_000187 - chr1:23243782-23247347 hESC Fibroblasts OK 8.0467 18.4428 1.19659 -1.85611 0.0634381 0.209486 no TCONS_00000524 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts OK 3123.43 1754.94 -0.83171 2.29248 0.0218782 0.090956 no TCONS_00000525 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts OK 911.067 597.396 -0.608869 0.975473 0.329326 0.65024 no TCONS_00000526 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts OK 2.53326 73.0221 4.84926 -1.68463 0.0920605 0.274472 no TCONS_00000527 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts OK 4.45377 27.3759 2.61981 -1.45422 0.145886 0.385886 no TCONS_00000528 XLOC_000190 - chr1:23832921-23857713 hESC Fibroblasts NOTEST 0.939918 0 -1.79769e+308 -1.79769e+308 0.263534 1 no TCONS_00000529 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000530 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000531 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 6624.43 57034.4 3.10596 -3.74942 0.000177241 0.00162952 yes TCONS_00000532 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 1583.34 8804.01 2.47519 -1.07554 0.282132 0.597457 no TCONS_00000533 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 66407.9 56810.6 -0.225194 0.346736 0.728789 0.989492 no TCONS_00000534 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 191.396 86.3727 -1.14791 0.0267524 0.978657 0.999997 no TCONS_00000535 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts OK 523.425 1232.52 1.23556 -3.83604 0.000125032 0.00122508 yes TCONS_00000536 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts OK 1150.34 1578.13 0.456163 -1.32347 0.18568 0.449552 no TCONS_00000537 XLOC_000194 - chr1:24104875-24114720 hESC Fibroblasts OK 57.722 138.236 1.25994 -0.944357 0.344987 0.66481 no TCONS_00000538 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000539 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 366.517 138.908 -1.39975 1.25793 0.208416 0.484201 no TCONS_00000540 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 738.535 245.964 -1.58622 2.03902 0.041448 0.152292 no TCONS_00000541 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 1591.41 801.526 -0.989489 2.22078 0.0263661 0.105212 no TCONS_00000542 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts OK 1015.28 1795.17 0.822244 -2.59154 0.00955471 0.0480498 yes TCONS_00000543 XLOC_000197 - chr1:24526729-24538180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00000544 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts OK 24.5694 0 -1.79769e+308 -1.79769e+308 1.33233e-14 7.94452e-13 yes TCONS_00000545 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0.00104564 3.65658e-05 -4.83775 0.000265429 0.999788 1 no TCONS_00000546 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0 0.713246 1.79769e+308 1.79769e+308 0.156094 1 no TCONS_00000547 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts NOTEST 0.568882 2.27352 1.99873 -0.0101833 0.991875 1 no TCONS_00000548 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 55.217 181.782 1.71903 -0.831616 0.405626 0.733328 no TCONS_00000549 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 80.6785 1388.46 4.10515 -10.084 0 0 yes TCONS_00000550 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 4.01002 60.0129 3.90359 -0.948759 0.342743 0.664092 no TCONS_00000551 XLOC_000199 - chr1:24742244-24799472 hESC Fibroblasts NOTEST 5.64277 7.66113 0.441153 -0.0148822 0.988126 1 no TCONS_00000552 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 113.081 219.138 0.954477 -1.69115 0.0908078 0.271941 no TCONS_00000553 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 0 77.2898 1.79769e+308 1.79769e+308 0.243741 0.541156 no TCONS_00000554 XLOC_000200 - chr1:24829386-24862425 hESC Fibroblasts OK 11.8633 51.8532 2.12792 -0.560992 0.574803 0.887288 no TCONS_00000555 XLOC_000200 - chr1:24829386-24862425 hESC Fibroblasts OK 4.24998 46.3362 3.44661 -1.01887 0.308265 0.626038 no TCONS_00000556 XLOC_000200 - chr1:24829386-24862425 hESC Fibroblasts NOTEST 2.64685 8.94425 1.75668 -0.174617 0.861381 1 no TCONS_00000557 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts NOTEST 2.35713 0.128844 -4.19333 1.83747 0.0661412 1 no TCONS_00000558 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 805.739 789.315 -0.0297118 0.0660008 0.947377 0.999997 no TCONS_00000559 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 0 574.066 1.79769e+308 1.79769e+308 0.00172002 0.0111481 yes TCONS_00000560 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 47.1916 28.5028 -0.727426 0.120902 0.903768 0.999997 no TCONS_00000561 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 876.963 164.784 -2.41194 1.11813 0.263512 0.57108 no TCONS_00000562 XLOC_000202 - chr1:24969593-24999771 hESC Fibroblasts OK 66.4895 70.3113 0.0806295 -0.0199604 0.984075 0.999997 no TCONS_00003803 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 347.213 560.298 0.690375 -0.967644 0.333222 0.654271 no TCONS_00003804 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003805 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003806 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003807 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003808 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 1.80263 7.75088 2.10426 -0.180426 0.856818 1 no TCONS_00003809 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 102.706 173.783 0.758768 -0.720435 0.471257 0.793625 no TCONS_00003810 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 14.6077 21.7772 0.576094 -0.155621 0.876332 0.999997 no TCONS_00003811 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003812 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 13.2227 47.9895 1.8597 -1.4339 0.1516 0.394009 no TCONS_00003813 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 51.2562 0 -1.79769e+308 -1.79769e+308 2.76255e-06 4.53971e-05 yes TCONS_00003814 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 2.59699 0 -1.79769e+308 -1.79769e+308 0.403807 1 no TCONS_00003815 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003816 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 5.35614 0 -1.79769e+308 -1.79769e+308 0.279074 1 no TCONS_00003817 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 36.3642 0.0461934 -9.62062 0.140185 0.888514 0.999997 no TCONS_00003818 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 224.306 240.082 0.0980617 -0.0766303 0.938918 0.999997 no TCONS_00003819 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 95.223 76.652 -0.312987 0.208524 0.83482 0.999997 no TCONS_00003820 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 38.5776 16.2553 -1.24685 0.158191 0.874306 0.999997 no TCONS_00003821 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 122.62 228.081 0.895349 -0.82671 0.408402 1 no TCONS_00003822 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 27.8905 46.2659 0.730179 -0.178919 0.858001 0.999997 no TCONS_00003823 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003824 XLOC_001218 - chr1:34611-36081 hESC Fibroblasts OK 16.5503 4.32826 -1.935 1.77451 0.0759782 0.239889 no TCONS_00003825 XLOC_001219 - chr1:89294-237877 hESC Fibroblasts OK 2.45836 13.5604 2.46363 -1.44662 0.148004 0.389217 no TCONS_00003826 XLOC_001220 - chr1:89294-237877 hESC Fibroblasts OK 634.855 19.9712 -4.99044 5.58766 2.30155e-08 5.66805e-07 yes TCONS_00003827 XLOC_001221 OR4F16 chr1:621097-622034 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003828 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 18.7126 1.6027 -3.54544 0.420357 0.674225 0.962453 no TCONS_00003829 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 297.645 39.9694 -2.89662 4.4069 1.04861e-05 0.000145897 yes TCONS_00003830 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 191.32 22.9579 -3.05892 3.03496 0.0024057 0.0146376 yes TCONS_00003831 XLOC_001223 - chr1:661139-679736 hESC Fibroblasts OK 697259 14237.7 -5.6139 0.312732 0.754484 0.999997 no TCONS_00003832 XLOC_001224 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003833 XLOC_001225 - chr1:661139-679736 hESC Fibroblasts OK 697259 14237.7 -5.6139 0.312732 0.754484 0.999997 no TCONS_00003834 XLOC_001226 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003835 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 520.885 45.3238 -3.52262 1.77534 0.0758416 0.23982 no TCONS_00003836 XLOC_001227 - chr1:700236-714006 hESC Fibroblasts OK 235.71 50.5377 -2.22158 3.66287 0.000249408 0.00218704 yes TCONS_00003837 XLOC_001228 - chr1:761586-762902 hESC Fibroblasts OK 19.6665 39.9678 1.0231 -1.53129 0.125699 0.346086 no TCONS_00003838 XLOC_001229 FAM41C chr1:803452-812182 hESC Fibroblasts NOTEST 2.1691 7.41126 1.77262 -1.66954 0.0950099 1 no TCONS_00003839 XLOC_001230 - chr1:852952-854817 hESC Fibroblasts NOTEST 0 7.62477 1.79769e+308 1.79769e+308 0.121258 1 no TCONS_00003840 XLOC_001230 - chr1:852952-854817 hESC Fibroblasts NOTEST 4.38548 0 -1.79769e+308 -1.79769e+308 0.237503 1 no TCONS_00003841 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 100.448 55.7714 -0.848848 0.149951 0.880804 0.999997 no TCONS_00003842 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 547.174 646.349 0.240314 -0.383974 0.700998 0.976699 no TCONS_00003843 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 1090.31 1445.11 0.406434 -0.800099 0.423653 0.752161 no TCONS_00003844 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 97.2158 72.8474 -0.416314 0.0505344 0.959697 0.999997 no TCONS_00003845 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts OK 14.7182 36.2061 1.29863 -1.70988 0.087289 0.265945 no TCONS_00003846 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts NOTEST 0.517867 2.14049 2.04729 -0.62116 0.534494 1 no TCONS_00003847 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts OK 25.1834 29.4876 0.227636 -0.233649 0.815257 0.999997 no TCONS_00003848 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts OK 12.2395 4.13955 -1.564 0.40981 0.681945 0.967189 no TCONS_00003849 XLOC_001234 - chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 6.02886 1.79769e+308 1.79769e+308 0.405618 1 no TCONS_00003850 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 21.5806 22.7448 0.0758014 -0.0235876 0.981182 0.999997 no TCONS_00003851 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 11.9017 53.0677 2.15667 -1.10424 0.269491 0.580695 no TCONS_00003852 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 14.7307 0 -1.79769e+308 -1.79769e+308 0.00359575 0.0206163 yes TCONS_00003853 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 91.6026 59.219 -0.629328 0.452454 0.650942 0.949347 no TCONS_00003854 XLOC_001234 - chr1:1017197-1051736 hESC Fibroblasts NOTEST 3.76844 4.24905 0.173173 -0.0255213 0.979639 1 no TCONS_00003855 XLOC_001234 - chr1:1017197-1051736 hESC Fibroblasts OK 29.6027 39.2481 0.406894 -0.339298 0.734385 0.993944 no TCONS_00003856 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 6.807 19.7743 1.53854 -0.88478 0.376275 0.701775 no TCONS_00003857 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 0 21.0061 1.79769e+308 1.79769e+308 0.227237 0.514364 no TCONS_00003858 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts NOTEST 5.99833 0 -1.79769e+308 -1.79769e+308 5.83424e-06 1 no TCONS_00003859 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 10.3558 0 -1.79769e+308 -1.79769e+308 0.0150296 0.0686363 no TCONS_00003860 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 0 14.2685 1.79769e+308 1.79769e+308 0.0233543 0.0965817 no TCONS_00003861 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 24.8393 0.00130815 -14.2128 0.0113078 0.990978 0.999997 no TCONS_00003862 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003863 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts NOTEST 0 5.89401 1.79769e+308 1.79769e+308 0.0457148 1 no TCONS_00003864 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts NOTEST 1.21775 0 -1.79769e+308 -1.79769e+308 0.0797028 1 no TCONS_00003865 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 105.623 71.6823 -0.55924 0.101587 0.919085 0.999997 no TCONS_00003866 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 1473.6 8370.57 2.50599 -6.78692 1.14553e-11 4.68768e-10 yes TCONS_00003867 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 17.9039 539.303 4.91275 -2.37584 0.0175091 0.076817 no TCONS_00003868 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003869 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 5.79383 49.0895 3.08282 -0.218604 0.826958 0.999997 no TCONS_00003870 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 210.708 114.07 -0.885326 0.0437604 0.965095 0.999997 no TCONS_00003871 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts OK 41.9198 75.8216 0.854975 -1.29359 0.195806 0.465428 no TCONS_00003872 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 15.5986 27.9153 0.839645 -0.166774 0.867548 0.999997 no TCONS_00003873 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 27.7097 45.6069 0.718862 -0.246857 0.805019 0.999997 no TCONS_00003874 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 2.68872 1.79769e+308 1.79769e+308 0.491248 1 no TCONS_00003875 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 594.103 1659.15 1.48166 -3.9815 6.8482e-05 0.000744385 yes TCONS_00003876 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 37.5213 75.7217 1.013 -0.44564 0.655857 0.952775 no TCONS_00003877 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 18.384 85.2438 2.21315 -1.05854 0.289808 0.605435 no TCONS_00003878 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 21.3064 95.4488 2.16344 -1.05924 0.289493 0.605435 no TCONS_00003879 XLOC_001241 - chr1:1189293-1209234 hESC Fibroblasts OK 37.017 20.3727 -0.861555 0.348989 0.727098 0.988568 no TCONS_00003880 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 139.601 101.369 -0.461694 0.190777 0.8487 0.999997 no TCONS_00003881 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 113.499 86.9123 -0.385041 0.231308 0.817076 0.999997 no TCONS_00003882 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 181.357 810.457 2.1599 -3.18278 0.00145871 0.00972834 yes TCONS_00003883 XLOC_001242 - chr1:1227763-1260046 hESC Fibroblasts OK 117.46 131.616 0.164166 -0.0511625 0.959196 0.999997 no TCONS_00003884 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 94.0403 120.03 0.35204 -0.15234 0.878919 0.999997 no TCONS_00003885 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 1597.84 2355.04 0.559633 -1.07853 0.280797 0.596157 no TCONS_00003886 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 41.6009 16.3417 -1.34806 0.0699245 0.944254 0.999997 no TCONS_00003887 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 37.6829 23.1589 -0.702345 0.0500451 0.960086 0.999997 no TCONS_00003888 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 21.2906 3.63351 -2.55078 0.0158338 0.987367 0.999997 no TCONS_00003889 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003890 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003891 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 99.7638 74.3645 -0.423902 0.0734539 0.941445 0.999997 no TCONS_00003892 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 4.26182 3.66246 -0.218654 0.00159095 0.998731 1 no TCONS_00003893 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 45.4548 82.7322 0.864018 -0.195385 0.845091 0.999997 no TCONS_00003894 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 41.7594 7.63052 -2.45225 0.0302533 0.975865 0.999997 no TCONS_00003895 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 428.913 407.64 -0.0733879 0.0367134 0.970714 0.999997 no TCONS_00003896 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 131.639 14.441 -3.18835 0.14041 0.888336 0.999997 no TCONS_00003897 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 263.001 252.541 -0.058552 0.036739 0.970693 0.999997 no TCONS_00003898 XLOC_001244 DVL1L1 chr1:1270658-1284492 hESC Fibroblasts OK 31.5522 49.6575 0.654271 -0.0842715 0.932841 0.999997 no TCONS_00003899 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 674.206 1267.03 0.91019 -2.44157 0.0146234 0.067371 no TCONS_00003900 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 193.963 23.7193 -3.03165 1.07489 0.282422 0.597457 no TCONS_00003901 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 11.8645 95.5511 3.00962 -0.188674 0.850348 0.999997 no TCONS_00003902 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 0.00314546 2934.02 19.8312 -0.0832685 0.933638 0.999997 no TCONS_00003903 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 55.4345 2864.03 5.69112 -5.8971 3.69951e-09 1.0159e-07 yes TCONS_00003904 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 67.479 8407.76 6.96114 -12.6982 0 0 yes TCONS_00003905 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 18.5375 18.6477 0.00855196 -0.00014294 0.999886 0.999997 no TCONS_00003906 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 1941.94 3221.31 0.730149 -1.39541 0.162892 0.411115 no TCONS_00003907 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 185.125 358.847 0.954872 -0.455905 0.648458 0.947048 no TCONS_00003908 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 651.469 1592.97 1.28995 -1.78581 0.0741296 0.235477 no TCONS_00003909 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 881.639 1861.17 1.07795 -1.80283 0.0714156 0.228947 no TCONS_00003910 XLOC_001247 - chr1:1321090-1334718 hESC Fibroblasts OK 15.222 6.77005 -1.16892 0.0561435 0.955227 0.999997 no TCONS_00003911 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 110.19 134.515 0.287785 -0.246328 0.805429 0.999997 no TCONS_00003912 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 107.558 19.8352 -2.43898 0.349615 0.726628 0.988568 no TCONS_00003913 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 352.289 674.159 0.93633 -2.20399 0.0275247 0.10859 no TCONS_00003914 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 443.979 322.484 -0.461263 0.412727 0.679807 0.966456 no TCONS_00003915 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 96.9882 18.1877 -2.41484 0.35166 0.725093 0.987954 no TCONS_00003916 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 112.752 97.6848 -0.206951 0.114192 0.909086 0.999997 no TCONS_00003917 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts OK 4267.92 8706.81 1.02861 -2.90714 0.00364755 0.020799 yes TCONS_00003918 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts OK 88.7189 37.8673 -1.22829 0.123585 0.901644 0.999997 no TCONS_00003919 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts NOTEST 17.1724 85.2846 2.31219 -2.72557 0.00641901 1 no TCONS_00003920 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts OK 49.1286 0.00204697 -14.5508 0.0230681 0.981596 0.999997 no TCONS_00003921 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts OK 6.86284 15.6317 1.1876 -0.715645 0.47421 0.795561 no TCONS_00003922 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts OK 83.1162 233.834 1.49228 -2.91232 0.0035875 0.0206163 yes TCONS_00003923 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 3166.29 6236.3 0.977897 -2.76821 0.00563649 0.0301624 yes TCONS_00003924 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 11.4081 4.14556 -1.46042 0.0129999 0.989628 0.999997 no TCONS_00003925 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 235.83 430.732 0.869044 -0.957175 0.338479 0.66081 no TCONS_00003926 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 205.562 286.25 0.4777 -0.171403 0.863907 0.999997 no TCONS_00003927 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 123.643 186.844 0.595654 -0.180823 0.856507 0.999997 no TCONS_00003928 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 168.137 179.943 0.0979011 -0.0260476 0.979219 0.999997 no TCONS_00003929 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003930 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003931 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003932 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 22.1371 6.57877 -1.75058 0.0200491 0.984004 0.999997 no TCONS_00003933 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003934 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 109.837 182.067 0.729101 -0.266235 0.790058 0.999997 no TCONS_00003935 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 816.237 795.035 -0.0379698 0.00209118 0.998331 0.999997 no TCONS_00003936 XLOC_001253 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 251.238 440.918 0.811457 -0.158057 0.874412 0.999997 no TCONS_00003937 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 15.2497 8.02851 -0.925577 0.0127593 0.98982 0.999997 no TCONS_00003938 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 222.366 276.724 0.315512 -0.265379 0.790717 0.999997 no TCONS_00003939 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 80.1962 47.7522 -0.747968 0.195228 0.845214 0.999997 no TCONS_00003940 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 45.5718 234.425 2.36292 -1.86317 0.0624386 0.20783 no TCONS_00003941 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 231.222 216.993 -0.0916331 0.0702984 0.943956 0.999997 no TCONS_00003942 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 122.207 362.567 1.56892 -0.507466 0.611828 0.925392 no TCONS_00003943 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 37.3588 25.3689 -0.558391 0.0258941 0.979342 0.999997 no TCONS_00003944 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 110.433 19.8478 -2.47611 0.0648849 0.948266 0.999997 no TCONS_00003945 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 146.455 84.2667 -0.797423 0.0796776 0.936494 0.999997 no TCONS_00003946 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 98.0216 85.2622 -0.201194 0.0195514 0.984401 0.999997 no TCONS_00003947 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 204.998 293.354 0.517033 -0.314591 0.753073 0.999997 no TCONS_00003948 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 618 1043.7 0.75603 -0.829676 0.406722 0.734281 no TCONS_00003949 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 162.241 113.359 -0.517241 0.0910142 0.927481 0.999997 no TCONS_00003950 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 0 84.1064 1.79769e+308 1.79769e+308 0.427221 0.754962 no TCONS_00003951 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 38.1573 87.1897 1.1922 -0.0973919 0.922415 0.999997 no TCONS_00003952 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 21.7767 7.69268 -1.50123 0.00753701 0.993986 0.999997 no TCONS_00003953 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 1.12006 3.69003 1.72006 -0.00260586 0.997921 1 no TCONS_00003954 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 24.8037 114.365 2.20501 -0.208056 0.835186 0.999997 no TCONS_00003955 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 17.5163 91.7595 2.38916 -0.128746 0.897558 0.999997 no TCONS_00003956 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003957 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 12.0452 20.3251 0.754804 -0.00652746 0.994792 0.999997 no TCONS_00003958 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003959 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 127.494 113.042 -0.173575 0.033666 0.973143 0.999997 no TCONS_00003960 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003961 XLOC_001255 - chr1:1571099-1677431 hESC Fibroblasts OK 341.44 1014.62 1.57123 -2.19434 0.0282108 0.110877 no TCONS_00003962 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 274.135 431.974 0.656056 -0.303918 0.761191 0.999997 no TCONS_00003963 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 13.2843 1.85523 -2.84005 0.0468309 0.962648 0.999997 no TCONS_00003964 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 0 215.942 1.79769e+308 1.79769e+308 0.208575 0.484201 no TCONS_00003965 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 510.173 988.439 0.954164 -1.97956 0.047753 0.166936 no TCONS_00003966 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 332.932 0 -1.79769e+308 -1.79769e+308 4.29231e-10 1.37816e-08 yes TCONS_00003967 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 91.3616 2.79122 -5.03262 0.177031 0.859484 0.999997 no TCONS_00003968 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 210.14 43.7417 -2.26427 0.512149 0.608547 0.923533 no TCONS_00003969 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts OK 4816.83 16698 1.79352 -3.98485 6.75234e-05 0.000737808 yes TCONS_00003970 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts NOTEST 4.54411 10.8403 1.25433 -0.0056506 0.995491 1 no TCONS_00003971 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 212.131 0 -1.79769e+308 -1.79769e+308 1.03345e-14 6.5358e-13 yes TCONS_00003972 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 79.5862 23.4115 -1.7653 2.31352 0.0206939 0.0877808 no TCONS_00003973 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts NOTEST 2.02001 0 -1.79769e+308 -1.79769e+308 0.0595537 1 no TCONS_00003974 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts NOTEST 1.04698 0 -1.79769e+308 -1.79769e+308 0.120101 1 no TCONS_00003975 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0.932315 0 -1.79769e+308 -1.79769e+308 0.0219603 1 no TCONS_00003976 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003977 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003978 XLOC_001261 - chr1:1944651-1946969 hESC Fibroblasts NOTEST 8.18597 0 -1.79769e+308 -1.79769e+308 4.15702e-05 1 no TCONS_00003979 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts OK 33.574 27.1259 -0.307674 0.0564177 0.955009 0.999997 no TCONS_00003980 XLOC_001263 - chr1:1981908-2139172 hESC Fibroblasts OK 73.6555 137.693 0.902585 -0.899991 0.368125 0.691131 no TCONS_00003981 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts OK 0 40.4901 1.79769e+308 1.79769e+308 0.256401 0.558976 no TCONS_00003982 XLOC_001263 - chr1:1981908-2139172 hESC Fibroblasts OK 25.7926 78.7015 1.60943 -1.03773 0.299394 0.618774 no TCONS_00003983 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts OK 1775.08 2591.54 0.545928 -1.22892 0.219103 0.499747 no TCONS_00003984 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 66.6827 19.3469 -1.78521 0.795674 0.426222 0.754962 no TCONS_00003985 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts NOTEST 2.05545 0 -1.79769e+308 -1.79769e+308 0.40395 1 no TCONS_00003986 XLOC_001265 - chr1:2252695-2322993 hESC Fibroblasts OK 912.804 177.628 -2.36145 4.76147 1.92183e-06 3.26086e-05 yes TCONS_00003987 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 34.0396 64.133 0.91385 -0.631826 0.5275 0.846259 no TCONS_00003988 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 6.7722 19.0177 1.48964 -0.511357 0.609101 0.923533 no TCONS_00003989 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts OK 9.44927 23.7899 1.33208 -0.0608556 0.951474 0.999997 no TCONS_00003990 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts OK 452.417 893.546 0.981889 -0.968985 0.332553 0.654135 no TCONS_00003991 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts OK 361.252 500.991 0.47178 -1.29987 0.193646 0.461347 no TCONS_00003992 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003993 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts NOTEST 2.94754 0 -1.79769e+308 -1.79769e+308 0.0305867 1 no TCONS_00003994 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003995 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts NOTEST 0.47493 6.38716 3.74939 -0.929973 0.352385 1 no TCONS_00003996 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts NOTEST 7.33509e-05 0 -1.79769e+308 -1.79769e+308 0.499935 1 no TCONS_00003997 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts NOTEST 0.649192 9.83614 3.92137 -1.06153 0.288449 1 no TCONS_00003998 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00003999 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts OK 12.7571 3.38316 -1.91486 0.083474 0.933475 0.999997 no TCONS_00004000 XLOC_001271 - chr1:2976182-2980350 hESC Fibroblasts NOTEST 0 0.336145 1.79769e+308 1.79769e+308 0.220257 1 no TCONS_00004001 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no TCONS_00004002 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 41.8309 92.849 1.15032 -2.02047 0.0433352 0.155901 no TCONS_00004003 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 177.762 64.5702 -1.461 2.2504 0.0244238 0.0997504 no TCONS_00004004 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 319.493 402.167 0.33201 -0.681345 0.495653 0.81323 no TCONS_00004005 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 203.665 99.5061 -1.03334 0.870116 0.384237 0.708393 no TCONS_00004006 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 74.6828 18.6731 -1.99981 1.75926 0.0785333 0.245726 no TCONS_00004007 XLOC_001275 - chr1:3652549-3663886 hESC Fibroblasts OK 11.3698 30.0855 1.40386 -0.69898 0.484565 0.802853 no TCONS_00004008 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts OK 422.204 227.555 -0.891723 2.49181 0.0127093 0.0608356 no TCONS_00004009 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts OK 1345.43 1410.28 0.0679088 -0.214918 0.829831 0.999997 no TCONS_00004010 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 29.6392 85.1871 1.52313 -1.96714 0.0491672 0.170359 no TCONS_00004011 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 100.25 305.484 1.6075 -3.91697 8.96683e-05 0.000926424 yes TCONS_00004012 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 52.3176 177.709 1.76415 -1.48573 0.137352 0.371006 no TCONS_00004013 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts OK 538.523 1178.32 1.12965 -3.22964 0.00123946 0.0085654 yes TCONS_00004014 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts OK 12.5397 4.40735 -1.50852 0.111373 0.911321 0.999997 no TCONS_00004015 XLOC_001279 - chr1:5621768-5728315 hESC Fibroblasts NOTEST 0.669469 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TCONS_00004016 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 140.655 98.804 -0.509521 1.11568 0.26456 0.572755 no TCONS_00004017 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 32.7056 8.76607 -1.89953 1.12749 0.259536 0.563047 no TCONS_00004018 XLOC_001280 - chr1:5922869-6052531 hESC Fibroblasts NOTEST 9.30267 3.94762 -1.23666 0.251043 0.801781 1 no TCONS_00004019 XLOC_001280 - chr1:5922869-6052531 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004020 XLOC_001280 - chr1:5922869-6052531 hESC Fibroblasts NOTEST 3.48039 0 -1.79769e+308 -1.79769e+308 0.181852 1 no TCONS_00004021 XLOC_001280 - chr1:5922869-6052531 hESC Fibroblasts NOTEST 5.2451 3.61882 -0.535453 0.0305755 0.975608 1 no TCONS_00004022 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts NOTEST 3.24653 2.58654 -0.327873 0.275149 0.783202 1 no TCONS_00004023 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts NOTEST 0.766551 0.873718 0.188784 -0.0739284 0.941067 1 no TCONS_00004024 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts OK 13.8631 0.611774 -4.50211 1.97438 0.0483381 0.168417 no TCONS_00004025 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts NOTEST 4.78329 0 -1.79769e+308 -1.79769e+308 0.0316638 1 no TCONS_00004026 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts NOTEST 5.03226 0 -1.79769e+308 -1.79769e+308 0.0774087 1 no TCONS_00004027 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts OK 4302.07 7509.61 0.803709 -1.9798 0.047726 0.166936 no TCONS_00004028 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts OK 72.9481 2365.52 5.01914 -3.29646 0.000979105 0.00688011 yes TCONS_00004029 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts OK 1196.78 2319.74 0.954813 -2.64773 0.00810351 0.0418511 yes TCONS_00004030 XLOC_001283 - chr1:6266188-6296044 hESC Fibroblasts OK 137.374 288.283 1.06937 -0.94846 0.342895 0.664092 no TCONS_00004031 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts OK 174.868 498.6 1.51161 -3.36101 0.000776578 0.00564086 yes TCONS_00004032 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts OK 97.14 268.364 1.46605 -2.32155 0.0202573 0.0861036 no TCONS_00004033 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1356.8 2679.84 0 0 1 1 no TCONS_00004034 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 0 39.0287 0 0 1 1 no TCONS_00004035 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 93.6803 110.585 0 0 1 1 no TCONS_00004036 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1047.97 732.481 0 0 1 1 no TCONS_00004037 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 731.817 70.6091 0 0 1 1 no TCONS_00004038 XLOC_001285 - chr1:6324332-6453826 hESC Fibroblasts FAIL 4.72572 0 0 0 1 1 no TCONS_00004039 XLOC_001285 - chr1:6324332-6453826 hESC Fibroblasts FAIL 324.209 963.208 0 0 1 1 no TCONS_00004040 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 2.2157 0.48661 -2.18692 0.607064 0.543809 1 no TCONS_00004041 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 6.44393 1.41752 -2.18458 2.40309 0.016257 1 no TCONS_00004042 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0.707673 6.84793 3.27451 -0.307037 0.758815 1 no TCONS_00004043 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004044 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 42.3646 0.414166 -6.67651 0.580755 0.561406 0.87633 no TCONS_00004045 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004046 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 166.161 5.81123 -4.83759 0.787948 0.430727 0.757949 no TCONS_00004047 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004048 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004049 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 10.7434 0 -1.79769e+308 -1.79769e+308 0.18792 0.453341 no TCONS_00004050 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004051 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 112.149 11.3936 -3.29913 0.557768 0.577003 0.889781 no TCONS_00004052 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 35.8901 1.74109 -4.36552 0.469065 0.639023 0.941837 no TCONS_00004053 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 38.9511 2.5797 -3.91639 0.954185 0.33999 0.661902 no TCONS_00004054 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 62.1096 0 -1.79769e+308 -1.79769e+308 7.13666e-07 1.35402e-05 yes TCONS_00004055 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 73.921 0 -1.79769e+308 -1.79769e+308 8.90841e-06 0.000124778 yes TCONS_00004056 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 43.3127 34.905 -0.311353 0.350971 0.72561 0.987954 no TCONS_00004057 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004058 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 4.59064 0.024414 -7.55484 0.283452 0.776831 1 no TCONS_00004059 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 9.71361 0 -1.79769e+308 -1.79769e+308 0.151372 0.393907 no TCONS_00004060 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 51.9914 18.3016 -1.50631 1.47588 0.139975 0.375485 no TCONS_00004061 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004062 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 6.79791 3.95345 -0.781978 0.25367 0.799751 1 no TCONS_00004063 XLOC_001287 - chr1:6521220-6580069 hESC Fibroblasts OK 77.8501 12.5671 -2.63104 0.915797 0.359774 0.682753 no TCONS_00004064 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts OK 189.708 361.435 0.929955 -2.39855 0.01646 0.0735642 no TCONS_00004065 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts NOTEST 0 2.40754 1.79769e+308 1.79769e+308 0.466312 1 no TCONS_00004066 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 62.094 77.2985 0.315986 -0.329081 0.742094 0.996561 no TCONS_00004067 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 151.442 601.611 1.99006 -2.62421 0.00868508 0.0442092 yes TCONS_00004068 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 154.599 378.033 1.28998 -1.34626 0.178217 0.435017 no TCONS_00004069 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004070 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts OK 1331.6 1673.01 0.329287 -0.958209 0.337958 0.66041 no TCONS_00004071 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts OK 28.6342 29.7673 0.0559891 -0.0123245 0.990167 0.999997 no TCONS_00004072 XLOC_001290 - chr1:6684924-6761966 hESC Fibroblasts OK 12.0359 28.6155 1.24946 -0.26543 0.790678 0.999997 no TCONS_00004073 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004074 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0.950535 0 -1.79769e+308 -1.79769e+308 0.387454 1 no TCONS_00004075 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004076 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts NOTEST 0.267901 1.38187 2.36684 -1.03459 0.30086 1 no TCONS_00004077 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 442.172 2240.53 2.34116 -6.97387 3.08353e-12 1.46258e-10 yes TCONS_00004078 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 21.342 71.1003 1.73616 -0.530948 0.595455 0.911081 no TCONS_00004079 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 320.719 1692.19 2.39951 -5.93358 2.96391e-09 8.47353e-08 yes TCONS_00004080 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 23.9344 9.81398 -1.28618 0.102363 0.918469 0.999997 no TCONS_00004081 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 638.676 268.727 -1.24894 0.693084 0.488257 0.804256 no TCONS_00004082 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 0 47.6257 1.79769e+308 1.79769e+308 0.43296 0.759956 no TCONS_00004083 XLOC_001295 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004084 XLOC_001294 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 3.82252 6.13498 0.682535 -0.0101436 0.991907 1 no TCONS_00004085 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 211.161 181.074 -0.221768 0.0130283 0.989605 0.999997 no TCONS_00004086 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 29778.1 33570.6 0.172948 -0.401506 0.688047 0.96893 no TCONS_00004087 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 8898.81 12912.6 0.537098 -0.747692 0.454646 0.782571 no TCONS_00004088 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 54.1427 0 -1.79769e+308 -1.79769e+308 0.366732 0.691131 no TCONS_00004089 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 914.141 679.817 -0.427269 0.0661448 0.947263 0.999997 no TCONS_00004090 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 3.84797 0 -1.79769e+308 -1.79769e+308 0.485216 1 no TCONS_00004091 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 12561.6 24138 0.942283 -1.61323 0.106695 0.309268 no TCONS_00004092 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 8.52523 0 -1.79769e+308 -1.79769e+308 0.468181 1 no TCONS_00004093 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 210.717 150.373 -0.486761 0.012428 0.990084 0.999997 no TCONS_00004094 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts NOTEST 0.358204 0.725244 1.01768 -0.395685 0.692337 1 no TCONS_00004095 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0.000167835 7.16648 15.3819 -0.00350708 0.997202 1 no TCONS_00004096 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 2.90964 0 -1.79769e+308 -1.79769e+308 0.0125747 1 no TCONS_00004097 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts OK 0 51.3731 1.79769e+308 1.79769e+308 0.0696909 0.224799 no TCONS_00004098 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004099 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts OK 0 61.3688 1.79769e+308 1.79769e+308 0.0885587 0.26853 no TCONS_00004100 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 4.17775 1.79769e+308 1.79769e+308 0.478797 1 no TCONS_00004101 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004102 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts OK 5.68802 24.4065 2.10127 -1.32163 0.18629 0.450507 no TCONS_00004103 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts OK 50.5863 72.7269 0.523742 -0.698717 0.484729 0.802853 no TCONS_00004104 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts NOTEST 1.55989 1.42116 -0.134378 0.0491659 0.960787 1 no TCONS_00004105 XLOC_001299 - chr1:9164475-9189356 hESC Fibroblasts NOTEST 5.09214 1.26783 -2.00591 0.639329 0.522609 1 no TCONS_00004106 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts OK 212.722 69.3907 -1.61616 3.35287 0.00079978 0.00575566 yes TCONS_00004107 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0.589835 0 -1.79769e+308 -1.79769e+308 0.430197 1 no TCONS_00004108 XLOC_001302 - chr1:9711789-9884550 hESC Fibroblasts OK 230.865 61.7832 -1.90176 0.241221 0.809384 0.999997 no TCONS_00004109 XLOC_001303 - chr1:9711789-9884550 hESC Fibroblasts OK 145.676 695.497 2.25528 -0.858203 0.39078 0.718554 no TCONS_00004110 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 0 2515.79 1.79769e+308 1.79769e+308 0.0020398 0.0126698 yes TCONS_00004111 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 1063.01 1606.44 0.595713 -0.956392 0.338874 0.660963 no TCONS_00004112 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 521.539 26.3156 -4.30879 0.275837 0.782674 0.999997 no TCONS_00004113 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts NOTEST 124.662 95.0697 -0.390969 0.459487 0.645884 1 no TCONS_00004114 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts OK 531.034 414.727 -0.356642 0.91466 0.36037 0.682753 no TCONS_00004115 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 3.50582 7.08002 1.014 -0.0712022 0.943237 1 no TCONS_00004116 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts OK 164.494 674.732 2.03628 -4.3958 1.10363e-05 0.000150541 yes TCONS_00004117 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts OK 29.7283 335.17 3.49498 -4.45094 8.54944e-06 0.000121379 yes TCONS_00004118 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 0 5.13452 1.79769e+308 1.79769e+308 0.473347 1 no TCONS_00004119 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts OK 857.687 848.024 -0.0163463 0.0276474 0.977943 0.999997 no TCONS_00004120 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts OK 268.726 316.625 0.236642 -0.27655 0.782126 0.999997 no TCONS_00004121 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 21.1364 0.352429 -5.90625 1.75786 0.0787721 0.246104 no TCONS_00004122 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 37.729 1.6466 -4.51811 2.424 0.0153504 0.0694932 no TCONS_00004123 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 49.2697 6.07219 -3.02041 3.3287 0.000872536 0.00621496 yes TCONS_00004124 XLOC_001307 - chr1:10696667-10856707 hESC Fibroblasts NOTEST 1.40186 0 -1.79769e+308 -1.79769e+308 0.26695 1 no TCONS_00004125 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 0 0.00205508 1.79769e+308 1.79769e+308 0.498521 1 no TCONS_00004126 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 0.000964262 0.331458 8.42519 -0.0124787 0.990044 1 no TCONS_00004127 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 4.32713 0 -1.79769e+308 -1.79769e+308 0.000938408 1 no TCONS_00004128 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts OK 45.371 15.0124 -1.59562 2.48032 0.0131266 0.0622617 no TCONS_00004129 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 1.00455 0 -1.79769e+308 -1.79769e+308 0.342184 1 no TCONS_00004130 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts OK 11.1666 0 -1.79769e+308 -1.79769e+308 0.000253989 0.00219948 yes TCONS_00004131 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004132 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 432.981 3003.63 2.79433 -3.12328 0.00178846 1 no TCONS_00004133 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts OK 4481.12 7820.85 0.803466 -2.15713 0.0309952 0.120013 no TCONS_00004134 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts OK 1276.69 1601.03 0.32659 -1.0141 0.310537 0.629215 no TCONS_00004135 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts NOTEST 4.49163 7.79258 0.794862 -0.0524712 0.958153 1 no TCONS_00004136 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts OK 67.2406 33.2215 -1.01722 0.307072 0.758789 0.999997 no TCONS_00004137 XLOC_001312 - chr1:11166588-11322608 hESC Fibroblasts OK 135.175 170.948 0.338728 -0.316107 0.751921 0.999997 no TCONS_00004138 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts OK 892.477 636.873 -0.48681 1.45906 0.144548 0.383318 no TCONS_00004139 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts OK 1488.36 72.9584 -4.3505 3.70758 0.000209249 0.0018987 yes TCONS_00004140 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 7.02688 0 -1.79769e+308 -1.79769e+308 0.357358 1 no TCONS_00004141 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 4.06337 0 -1.79769e+308 -1.79769e+308 0.405482 1 no TCONS_00004142 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts OK 309.163 303.3 -0.0276232 0.0174444 0.986082 0.999997 no TCONS_00004143 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts OK 6448.41 2064.91 -1.64286 3.85001 0.000118112 0.00116825 yes TCONS_00004144 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 64.418 263.856 2.03421 -3.74537 0.000180125 1 no TCONS_00004145 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts OK 93.2442 277.975 1.57587 -3.25743 0.00112424 0.00784714 yes TCONS_00004146 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts OK 27.4533 108.763 1.98613 -0.970597 0.331749 0.653758 no TCONS_00004147 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004148 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts OK 10.2838 18.088 0.814661 -0.159931 0.872936 0.999997 no TCONS_00004149 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 7.22153 0 -1.79769e+308 -1.79769e+308 0.0228854 1 no TCONS_00004150 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts OK 657.437 1330.79 1.01736 -2.81118 0.00493606 0.0270382 yes TCONS_00004151 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts OK 97.0102 113.009 0.220233 -0.0969657 0.922754 0.999997 no TCONS_00004152 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 334.324 292.677 -0.191934 0.275888 0.782634 0.999997 no TCONS_00004153 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 302.602 457.869 0.597516 -1.26964 0.204213 0.479407 no TCONS_00004154 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 10.8508 0 -1.79769e+308 -1.79769e+308 0.165124 0.414709 no TCONS_00004155 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 28.066 1.34044 -4.38804 0.0352654 0.971868 0.999997 no TCONS_00004156 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 0 67.1677 1.79769e+308 1.79769e+308 0.479587 0.798034 no TCONS_00004157 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004158 XLOC_001321 - chr1:12907235-12908578 hESC Fibroblasts OK 2184.6 1951.16 -0.163037 0.462258 0.643896 0.944805 no TCONS_00004159 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004160 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004161 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004162 XLOC_001324 PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004163 XLOC_001324 PRAMEF5 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004164 XLOC_001324 PRAMEF5 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004165 XLOC_001325 - chr1:13182960-13183967 hESC Fibroblasts OK 275.825 207.399 -0.411345 0.794459 0.426928 0.754962 no TCONS_00004166 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004167 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004168 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004169 XLOC_001328 PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004170 XLOC_001328 PRAMEF13 chr1:13447413-13452656 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004171 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004172 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004173 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004174 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004175 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts NOTEST 8.16584 0 -1.79769e+308 -1.79769e+308 5.37334e-05 1 no TCONS_00004176 XLOC_001334 C1orf126 chr1:14925212-15478960 hESC Fibroblasts NOTEST 9.25388 0.859289 -3.42884 0.134917 0.892678 1 no TCONS_00004177 XLOC_001334 C1orf126 chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004178 XLOC_001335 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 3.71564 2.62025 -0.503903 0.414142 0.67877 1 no TCONS_00004179 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 32.8483 25.7553 -0.350951 0.33421 0.738221 0.995263 no TCONS_00004180 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 197.024 118.428 -0.734362 0.997412 0.318565 0.638659 no TCONS_00004181 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 132.595 55.404 -1.25896 1.03389 0.301189 0.619029 no TCONS_00004182 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 17.767 8.22122 -1.11178 0.244213 0.807066 0.999997 no TCONS_00004183 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004184 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 0 29.4638 1.79769e+308 1.79769e+308 0.209826 0.484983 no TCONS_00004185 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 51.7979 51.1746 -0.0174654 0.0151006 0.987952 0.999997 no TCONS_00004186 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts OK 115.866 43.2083 -1.42308 0.890662 0.373111 0.697684 no TCONS_00004187 XLOC_001338 - chr1:16133656-16134194 hESC Fibroblasts OK 16097 21049.2 0.386973 -1.17641 0.239429 0.534426 no TCONS_00004188 XLOC_001339 - chr1:16160709-16266950 hESC Fibroblasts OK 58.2932 39.9858 -0.543842 0.228732 0.819077 0.999997 no TCONS_00004189 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 259.204 560.414 1.11241 -2.96273 0.00304921 0.0180275 yes TCONS_00004190 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 6.42816 5.22855 -0.297994 0.0268404 0.978587 1 no TCONS_00004191 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 24.9031 48.555 0.963295 -0.664337 0.506475 0.82386 no TCONS_00004192 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 6.98597 0 -1.79769e+308 -1.79769e+308 0.0872004 1 no TCONS_00004193 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 2.7664 13.5911 2.29658 -0.391753 0.695241 0.974922 no TCONS_00004194 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 7.07875 9.63291 0.444477 -0.0573822 0.954241 1 no TCONS_00004195 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004196 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 8.33768 26.7081 1.67956 -0.336691 0.73635 0.994025 no TCONS_00004197 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 20.1751 2.23494 -3.17427 0.301325 0.763166 0.999997 no TCONS_00004198 XLOC_001341 - chr1:16317618-16317647 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004199 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 3.62862 235.204 6.01834 -5.42991 5.63836e-08 1.29311e-06 yes TCONS_00004200 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 0 16.7923 1.79769e+308 1.79769e+308 0.318334 0.638659 no TCONS_00004201 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 0 26.6845 1.79769e+308 1.79769e+308 0.277781 0.591561 no TCONS_00004202 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 0 60.3352 1.79769e+308 1.79769e+308 0.252071 0.553179 no TCONS_00004203 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 3.46957 397.66 6.84064 -5.90824 3.45785e-09 9.62204e-08 yes TCONS_00004204 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts NOTEST 4.46492 7.5659 0.760877 -0.0252848 0.979828 1 no TCONS_00004205 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts OK 21.4939 38.8477 0.853903 -0.372944 0.70919 0.979971 no TCONS_00004206 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts OK 573.472 923.073 0.686721 -2.03205 0.0421485 0.153515 no TCONS_00004207 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts NOTEST 2.16378 0 -1.79769e+308 -1.79769e+308 0.422369 1 no TCONS_00004208 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 324.019 132.515 -1.28992 2.16192 0.030624 0.119017 no TCONS_00004209 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 0 38.3291 1.79769e+308 1.79769e+308 0.209842 0.484983 no TCONS_00004210 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 678.385 8.10745 -6.38671 3.11931 0.00181275 0.0116237 yes TCONS_00004211 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts OK 53.4824 182.341 1.7695 -3.52638 0.000421284 0.00343445 yes TCONS_00004212 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 2.24339 15.5838 2.7963 -0.645033 0.518906 0.838201 no TCONS_00004213 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 8.45144 30.8971 1.8702 -0.603985 0.545854 0.860043 no TCONS_00004214 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 256.568 533.075 1.055 -2.88559 0.00390683 0.0221564 yes TCONS_00004215 XLOC_001347 - chr1:16576559-16678948 hESC Fibroblasts NOTEST 0.999115 0 -1.79769e+308 -1.79769e+308 0.247955 1 no TCONS_00004216 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0.168084 1.79769e+308 1.79769e+308 0.490269 1 no TCONS_00004217 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004218 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004219 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 48.5164 16.8693 -1.52407 2.33379 0.0196066 0.0843692 no TCONS_00004220 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 76.9358 33.8911 -1.18275 0.619138 0.535826 0.848458 no TCONS_00004221 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 47.6242 17.5001 -1.44433 0.677881 0.497847 0.815547 no TCONS_00004222 XLOC_001350 - chr1:16860385-16864669 hESC Fibroblasts OK 11.9908 0.8365 -3.84142 2.49241 0.012688 0.0608356 no TCONS_00004223 XLOC_001351 - chr1:16888922-16890082 hESC Fibroblasts OK 175.981 1764.52 3.32578 -9.06392 0 0 yes TCONS_00004224 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 109.231 592.825 2.44022 -5.49341 3.94255e-08 9.35012e-07 yes TCONS_00004225 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 120.904 551.679 2.18996 -2.52271 0.0116455 0.0569186 no TCONS_00004226 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 27.9922 232.03 3.05122 -2.09837 0.0358725 0.136617 no TCONS_00004227 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 2.13127 2.38008 0.159297 -0.00202641 0.998383 1 no TCONS_00004228 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 59.3019 99.1905 0.742125 -0.464654 0.642179 0.94396 no TCONS_00004229 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 1.71985 41.2295 4.58332 -1.39535 0.162909 0.411115 no TCONS_00004230 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 53.7943 198.126 1.88089 -1.87852 0.0603097 0.201722 no TCONS_00004231 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 39.2466 151.051 1.94439 -1.90523 0.0567506 0.191648 no TCONS_00004232 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 109.535 60.3527 -0.859901 0.799788 0.423834 0.752161 no TCONS_00004233 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 40.9893 22.2743 -0.879868 0.45655 0.647995 0.947048 no TCONS_00004234 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 148.568 44.2115 -1.74863 1.56891 0.116669 0.331728 no TCONS_00004235 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 154.311 73.4927 -1.07017 1.06756 0.285719 0.602788 no TCONS_00004236 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 32.3396 16.1259 -1.00393 0.402255 0.687497 0.96893 no TCONS_00004237 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 210.996 217.203 0.0418285 -0.0344889 0.972487 0.999997 no TCONS_00004238 XLOC_001354 ESPN chr1:17017712-17046652 hESC Fibroblasts OK 11.1097 0 -1.79769e+308 -1.79769e+308 2.90933e-06 4.7068e-05 yes TCONS_00004239 XLOC_001354 ESPNP chr1:17017712-17046652 hESC Fibroblasts NOTEST 3.47275 0 -1.79769e+308 -1.79769e+308 0.0482484 1 no TCONS_00004240 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts OK 38.162 1.55467 -4.61745 0.301429 0.763087 0.999997 no TCONS_00004241 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts NOTEST 3.25841 1.59851 -1.02744 0.0736512 0.941288 1 no TCONS_00004242 XLOC_001356 - chr1:17066767-17299474 hESC Fibroblasts OK 415.352 408.247 -0.0248921 0.0164278 0.986893 0.999997 no TCONS_00004243 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 4040.61 1960.36 -1.04346 2.49042 0.0127591 0.0609342 no TCONS_00004244 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 825.956 401.58 -1.04038 1.05611 0.290917 0.607143 no TCONS_00004245 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 0 31.938 1.79769e+308 1.79769e+308 0.416789 0.744725 no TCONS_00004246 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 0 11.7873 1.79769e+308 1.79769e+308 0.472296 0.793625 no TCONS_00004247 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 366.46 231.387 -0.66335 0.678151 0.497676 0.815547 no TCONS_00004248 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 537.876 177.11 -1.60263 2.86861 0.00412275 0.0232545 yes TCONS_00004249 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 472.669 205.856 -1.1992 2.13044 0.0331352 0.127354 no TCONS_00004250 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 12.3556 24.341 0.978227 -0.205997 0.836793 0.999997 no TCONS_00004251 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 22.7704 46.6117 1.03353 -0.289576 0.772141 0.999997 no TCONS_00004252 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 18.4495 0 -1.79769e+308 -1.79769e+308 0.137594 0.371006 no TCONS_00004253 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts OK 1548.47 5372.43 1.79473 -5.61323 1.98579e-08 5.05409e-07 yes TCONS_00004254 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts OK 62.6093 1.76593e-05 -21.7575 0.00095655 0.999237 0.999997 no TCONS_00004255 XLOC_001360 - chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0.887434 1.79769e+308 1.79769e+308 0.095774 1 no TCONS_00004256 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts NOTEST 3.49549 0 -1.79769e+308 -1.79769e+308 0.219199 1 no TCONS_00004257 XLOC_001361 - chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004258 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts NOTEST 4130.7 869.89 -2.24748 6.28248 3.33214e-10 1 no TCONS_00004259 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts OK 1326.29 178.175 -2.89603 3.79949 0.000144996 0.0013881 yes TCONS_00004260 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004261 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 218.303 130.588 -0.741314 1.047 0.295098 0.612805 no TCONS_00004262 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 13.708 0 -1.79769e+308 -1.79769e+308 0.374304 0.698723 no TCONS_00004263 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 420.478 406.234 -0.0497174 0.122932 0.902161 0.999997 no TCONS_00004264 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts OK 89.541 303.773 1.76237 -4.98216 6.28781e-07 1.20391e-05 yes TCONS_00004265 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 12.454 9.6791 -0.363665 0.0104485 0.991663 0.999997 no TCONS_00004266 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 50.0495 229.039 2.19416 -0.336772 0.736289 0.994025 no TCONS_00004267 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 92.8871 294.701 1.6657 -0.854576 0.392786 0.720971 no TCONS_00004268 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 22.9292 22.1323 -0.0510316 0.00276094 0.997797 0.999997 no TCONS_00004269 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 167.676 0 -1.79769e+308 -1.79769e+308 0.0104565 0.0519591 no TCONS_00004270 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 557.747 470.997 -0.243893 0.19825 0.84285 0.999997 no TCONS_00004271 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 426.519 243.59 -0.808154 0.389931 0.696588 0.974922 no TCONS_00004272 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 765.815 666.218 -0.201002 0.495133 0.620506 0.930313 no TCONS_00004273 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 5.33048 5.62521 0.0776413 -0.00113021 0.999098 1 no TCONS_00004274 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 192.593 171.68 -0.165827 0.0762327 0.939234 0.999997 no TCONS_00004275 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004276 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 4.71016 7.05837 0.583558 -0.0203922 0.98373 1 no TCONS_00004277 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 13.1602 6.73706 -0.965995 0.0239382 0.980902 0.999997 no TCONS_00004278 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 452.421 2042.6 2.17467 -5.58713 2.3085e-08 5.66805e-07 yes TCONS_00004279 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 27.296 57.4804 1.07438 -0.368103 0.712796 0.980323 no TCONS_00004280 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 112.439 247.27 1.13694 -0.681647 0.495462 0.81323 no TCONS_00004281 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 3.92853 15.2695 1.95859 -0.178634 0.858225 0.999997 no TCONS_00004282 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts OK 11.7019 10.5092 -0.155089 0.218303 0.827193 0.999997 no TCONS_00004283 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004284 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts OK 17.2325 15.2534 -0.176005 0.235969 0.813457 0.999997 no TCONS_00004285 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts OK 693.277 3035.54 2.13045 -5.22776 1.71577e-07 3.61699e-06 yes TCONS_00004286 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts OK 0 179.738 1.79769e+308 1.79769e+308 0.393924 0.721791 no TCONS_00004287 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts NOTEST 2.29939 3.31248 0.526662 -0.0044676 0.996435 1 no TCONS_00004288 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004289 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 69.4828 70.755 0.0261749 -0.00130635 0.998958 0.999997 no TCONS_00004290 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 5169.04 19294.6 1.90023 -4.86533 1.14265e-06 2.07366e-05 yes TCONS_00004291 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 8.25067 86.3183 3.38708 -0.201058 0.840653 0.999997 no TCONS_00004292 XLOC_001372 - chr1:19665273-19811992 hESC Fibroblasts OK 15.7099 16.6971 0.0879232 -0.00795373 0.993654 0.999997 no TCONS_00004293 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 36.9795 1.79769e+308 1.79769e+308 0.343647 0.664681 no TCONS_00004294 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 56.5465 464.48 3.03811 -7.27405 3.48832e-13 1.82003e-11 yes TCONS_00004295 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 1.29633 0 -1.79769e+308 -1.79769e+308 0.337923 1 no TCONS_00004296 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 73.4655 1.79769e+308 1.79769e+308 0.0896063 0.269464 no TCONS_00004297 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 9.20491 32.2829 1.8103 -0.727787 0.466744 0.792342 no TCONS_00004298 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 20.9118 1.79769e+308 1.79769e+308 0.418961 0.746688 no TCONS_00004299 XLOC_001374 RNF186 chr1:20140522-20141771 hESC Fibroblasts NOTEST 0.423276 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TCONS_00004300 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004301 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004302 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0.000482041 0.000476318 -0.0172311 3.13883e-06 0.999997 1 no TCONS_00004303 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts OK 35.1077 12.9515 -1.43867 1.68469 0.0920475 0.274472 no TCONS_00004304 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004305 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004306 XLOC_001377 - chr1:20438440-20446008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004307 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004308 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts NOTEST 0.74001 0 -1.79769e+308 -1.79769e+308 0.239739 1 no TCONS_00004309 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts NOTEST 0 2.56345 1.79769e+308 1.79769e+308 0.0741977 1 no TCONS_00004310 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts OK 6.4946 2654.04 8.67474 -4.40184 1.07335e-05 0.000147373 yes TCONS_00004311 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts OK 124.278 7835.73 5.97843 -13.8149 0 0 yes TCONS_00004312 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts OK 351.837 1509.04 2.10065 -6.42614 1.30882e-10 4.55253e-09 yes TCONS_00004313 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts OK 4971.96 12703.4 1.35333 -3.62662 0.000287153 0.00244607 yes TCONS_00004314 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004315 XLOC_001382 - chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004316 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts OK 19.3729 13.1454 -0.559486 0.00567096 0.995475 0.999997 no TCONS_00004317 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 3.5495 4.98873 0.491059 -0.064287 0.948742 1 no TCONS_00004318 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 11.229 82.6962 2.8806 -1.77325 0.0761872 0.240078 no TCONS_00004319 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 5.90044 11.7825 0.997751 -0.402083 0.687623 0.96893 no TCONS_00004320 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 48.9997 0 -1.79769e+308 -1.79769e+308 7.17472e-08 1 no TCONS_00004321 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 102.304 29.9178 -1.77378 1.82215 0.0684327 1 no TCONS_00004322 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 16.4694 89.3077 2.439 -2.2132 0.0268838 1 no TCONS_00004323 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 129.453 86.3601 -0.583993 0.646717 0.517815 1 no TCONS_00004324 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts OK 160.628 132.567 -0.276995 0.422247 0.672845 0.9618 no TCONS_00004325 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 56.1343 89.2902 0.66962 -0.183781 0.854185 0.999997 no TCONS_00004326 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 107.411 147.345 0.456065 -0.225706 0.82143 0.999997 no TCONS_00004327 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 183.91 97.5133 -0.915329 0.201298 0.840466 0.999997 no TCONS_00004328 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 25.9672 1021.61 5.29802 -4.67954 2.87516e-06 4.68786e-05 yes TCONS_00004329 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 56.9742 1426.22 4.64574 -7.17221 7.37854e-13 3.75586e-11 yes TCONS_00004330 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 494.915 1140.1 1.20391 -1.36518 0.172197 0.426304 no TCONS_00004331 XLOC_001385 - chr1:21069170-21113799 hESC Fibroblasts OK 12.355 12.8279 0.0541866 -0.00161536 0.998711 0.999997 no TCONS_00004332 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 19.1563 234.83 3.61572 -1.8954 0.0580393 0.19474 no TCONS_00004333 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 108.229 286.111 1.40249 -0.307009 0.758836 0.999997 no TCONS_00004334 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 6.37526 487.969 6.25816 -3.64198 0.00027055 0.00232361 yes TCONS_00004335 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 0 48.898 1.79769e+308 1.79769e+308 0.342931 0.664092 no TCONS_00004336 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 247.208 640.112 1.3726 -1.42732 0.153487 0.396445 no TCONS_00004337 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 0 233.937 1.79769e+308 1.79769e+308 0.156766 0.402423 no TCONS_00004338 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 265.087 347.572 0.390846 -0.484329 0.628152 0.934393 no TCONS_00004339 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004340 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 149.423 310.62 1.05575 -1.18154 0.237389 0.531579 no TCONS_00004341 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004342 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004343 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 39.0388 49.7966 0.351137 -0.0394027 0.968569 0.999997 no TCONS_00004344 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 5.98009 127.783 4.41738 -0.876867 0.380559 0.707867 no TCONS_00004345 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 28.0163 986.479 5.13795 -3.77317 0.000161186 1 no TCONS_00004346 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 95.1492 1395.64 3.8746 -2.06417 0.0390012 0.145609 no TCONS_00004347 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 4.34987 15.8926 1.86931 -0.0439447 0.964949 0.999997 no TCONS_00004348 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 419.192 3871.51 3.20721 -4.8217 1.42337e-06 2.51743e-05 yes TCONS_00004349 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 14.4148 87.2531 2.59766 -0.141923 0.887141 0.999997 no TCONS_00004350 XLOC_001388 - chr1:21543739-21672034 hESC Fibroblasts NOTEST 0.863796 0.547703 -0.657296 0.0105151 0.99161 1 no TCONS_00004351 XLOC_001389 - chr1:21749600-21754300 hESC Fibroblasts OK 59.716 526.991 3.14159 -7.90238 2.66454e-15 2.05959e-13 yes TCONS_00004352 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 23.4017 0 -1.79769e+308 -1.79769e+308 0.0365495 0.138294 no TCONS_00004353 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 67.9603 2.12746 -4.99749 5.88103 4.07718e-09 1.10508e-07 yes TCONS_00004354 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 64.0794 0.00165223 -15.2432 0.0473758 0.962214 1 no TCONS_00004355 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 23.1783 0 -1.79769e+308 -1.79769e+308 0.000624781 0.00470728 yes TCONS_00004356 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 49.6025 49.025 -0.0168938 0.00784538 0.99374 0.999997 no TCONS_00004357 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 512.56 1051.93 1.03724 -2.8573 0.00427263 0.024035 yes TCONS_00004358 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004359 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 26.2055 44.2579 0.756064 -0.366683 0.713855 0.980323 no TCONS_00004360 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 1.61711 0 -1.79769e+308 -1.79769e+308 0.410798 1 no TCONS_00004361 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 4.47726 1.54293 -1.53694 0.010587 0.991553 1 no TCONS_00004362 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 175.948 194.761 0.146552 -0.0653015 0.947934 0.999997 no TCONS_00004363 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 44.7452 182.168 2.02546 -0.903205 0.366417 0.691131 no TCONS_00004364 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 185.017 262.104 0.502481 -0.0269747 0.97848 0.999997 no TCONS_00004365 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 741.639 3722.7 2.32756 -3.12474 0.00177963 0.0114987 yes TCONS_00004366 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 124.328 771.12 2.6328 -1.7182 0.0857603 0.262437 no TCONS_00004367 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004368 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts OK 73.6692 0.00537242 -13.7432 0.163502 0.870123 0.999997 no TCONS_00004369 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts NOTEST 0 0.782392 1.79769e+308 1.79769e+308 0.106931 1 no TCONS_00004370 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts NOTEST 1.30651 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TCONS_00004371 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts OK 143.088 398.717 1.47846 -2.96973 0.00298059 0.0177222 yes TCONS_00004372 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts NOTEST 289.415 487.054 0.750943 -1.71015 0.0872386 1 no TCONS_00004373 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts NOTEST 3.29156 0 -1.79769e+308 -1.79769e+308 0.226695 1 no TCONS_00004374 XLOC_001396 HTR1D chr1:23518388-23521222 hESC Fibroblasts OK 138.505 0 -1.79769e+308 -1.79769e+308 1.57272e-23 1.72751e-21 yes TCONS_00004375 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 3.27082 0 -1.79769e+308 -1.79769e+308 0.438713 1 no TCONS_00004376 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 198.346 337.66 0.767552 -0.506655 0.612397 0.925392 no TCONS_00004377 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 1176.83 1348.2 0.196131 -0.191581 0.84807 0.999997 no TCONS_00004378 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 1344.32 2703.15 1.00776 -2.03931 0.0414187 0.152292 no TCONS_00004379 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 200.546 618.972 1.62594 -0.881537 0.378027 0.704413 no TCONS_00004380 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 2.65635 0 -1.79769e+308 -1.79769e+308 0.419546 1 no TCONS_00004381 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 3.70001 0 -1.79769e+308 -1.79769e+308 0.371514 1 no TCONS_00004382 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 90.6925 95.6502 0.0767851 -0.0176817 0.985893 0.999997 no TCONS_00004383 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts OK 18.4192 264.956 3.84647 -8.51191 0 0 yes TCONS_00004384 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts OK 0 121.81 1.79769e+308 1.79769e+308 0.0106634 0.0527359 no TCONS_00004385 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 1.36049 539.056 8.63017 -6.71755 1.84808e-11 7.21099e-10 yes TCONS_00004386 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 4.90057 75.1132 3.93805 -1.10557 0.268912 0.580418 no TCONS_00004387 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 0 147.495 1.79769e+308 1.79769e+308 0.158876 0.405844 no TCONS_00004388 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 0 12.5792 1.79769e+308 1.79769e+308 0.466455 0.792342 no TCONS_00004389 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 22.8075 97.6727 2.09845 -1.48348 0.137946 0.371476 no TCONS_00004390 XLOC_001400 - chr1:23755055-23811057 hESC Fibroblasts OK 92.1289 41.7841 -1.1407 0.636274 0.524598 0.844566 no TCONS_00004391 XLOC_001400 - chr1:23755055-23811057 hESC Fibroblasts OK 59.9998 61.9722 0.0466629 -0.0378668 0.969794 0.999997 no TCONS_00004392 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 557.63 591.657 0.0854519 -0.227671 0.819902 0.999997 no TCONS_00004393 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004394 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 24.2074 0 -1.79769e+308 -1.79769e+308 0.0805175 0.25006 no TCONS_00004395 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 5.93528 0 -1.79769e+308 -1.79769e+308 0.435254 1 no TCONS_00004396 XLOC_001401 - chr1:23755055-23811057 hESC Fibroblasts NOTEST 1.51415 0 -1.79769e+308 -1.79769e+308 0.321706 1 no TCONS_00004397 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts OK 95.4288 59.0676 -0.692058 1.38803 0.165129 0.414709 no TCONS_00004398 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts OK 3052.85 1179.44 -1.37205 3.45896 0.000542271 0.00419156 yes TCONS_00004399 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts OK 130.941 325.332 1.31299 -1.59588 0.110515 0.318131 no TCONS_00004400 XLOC_001404 - chr1:24069855-24104777 hESC Fibroblasts OK 77.4967 107.333 0.46989 -0.115729 0.907867 0.999997 no TCONS_00004401 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 38.3217 12.7034 -1.59295 0.271023 0.786373 0.999997 no TCONS_00004402 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 10.1974 127.586 3.6452 -1.78206 0.0747387 0.237051 no TCONS_00004403 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 17.3703 39.5664 1.18766 -0.515162 0.60644 0.922571 no TCONS_00004404 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 392.012 357.933 -0.13121 0.23084 0.817439 0.999997 no TCONS_00004405 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 43.8262 155.802 1.82985 -1.39777 0.162183 0.411115 no TCONS_00004406 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 51.369 64.4525 0.327337 -0.15706 0.875197 0.999997 no TCONS_00004407 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004408 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 9.86629 4.63048 -1.09135 0.0482376 0.961527 0.999997 no TCONS_00004409 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 5.43458 0 -1.79769e+308 -1.79769e+308 0.292274 1 no TCONS_00004410 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 286.755 1600.17 2.48033 -6.79361 1.09359e-11 4.56465e-10 yes TCONS_00004411 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004412 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 42.7613 114.728 1.42384 -0.798329 0.42468 0.753022 no TCONS_00004413 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 12.5886 0 -1.79769e+308 -1.79769e+308 0.0210085 0.088219 no TCONS_00004414 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 9.6936 5.84858 -0.728947 0.0287653 0.977052 0.999997 no TCONS_00004415 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 7.27536 39.9903 2.45856 -1.03353 0.301358 0.619029 no TCONS_00004416 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts OK 122.432 140.427 0.197841 -0.390637 0.696065 0.974922 no TCONS_00004417 XLOC_001407 - chr1:24171573-24194821 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004418 XLOC_001407 - chr1:24171573-24194821 hESC Fibroblasts OK 9.88427 2.14565 -2.20372 0.0507331 0.959538 0.999997 no TCONS_00004419 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004420 XLOC_001409 - chr1:24292938-24306821 hESC Fibroblasts OK 282.334 156.955 -0.847052 0.579291 0.562393 0.87656 no TCONS_00004421 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts OK 533.444 1297.57 1.2824 -2.47268 0.0134105 0.0633207 no TCONS_00004422 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts OK 767.195 1010.81 0.397849 -0.899756 0.36825 0.691131 no TCONS_00004423 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 1.19576 0 -1.79769e+308 -1.79769e+308 0.127659 1 no TCONS_00004424 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 1.77127 0 -1.79769e+308 -1.79769e+308 0.0132666 1 no TCONS_00004425 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0.363637 0 -1.79769e+308 -1.79769e+308 0.186004 1 no TCONS_00004426 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004427 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0.607421 0 -1.79769e+308 -1.79769e+308 0.0776478 1 no TCONS_00004428 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 1.45433 0 -1.79769e+308 -1.79769e+308 0.107539 1 no TCONS_00004429 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 5.55488 0.000273846 -14.3081 0.00613477 0.995105 1 no TCONS_00004430 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004431 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 0 3.57838 1.79769e+308 1.79769e+308 0.0328381 1 no TCONS_00004432 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts NOTEST 0 0.000702974 1.79769e+308 1.79769e+308 0.498969 1 no TCONS_00004433 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 44.0625 0 -1.79769e+308 -1.79769e+308 1.69034e-10 5.59957e-09 yes TCONS_00004434 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 24.4887 0.0773653 -8.30622 1.61767 0.105734 0.308194 no TCONS_00004435 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 12.9816 0.0365025 -8.47426 0.780855 0.434888 0.762058 no TCONS_00004436 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 125.353 0 -1.79769e+308 -1.79769e+308 0.000117086 0.00116361 yes TCONS_00004437 XLOC_001413 - chr1:24580829-24580859 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004438 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TCONS_00004439 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 7.16763 57.9985 3.01645 -2.31194 0.020781 0.0878412 no TCONS_00004440 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 10.1778 13.0899 0.363025 -0.159989 0.87289 0.999997 no TCONS_00004441 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 132.318 205.765 0.636993 -1.3057 0.191654 0.457644 no TCONS_00004442 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 3.67923 1.79769e+308 1.79769e+308 0.435246 1 no TCONS_00004443 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 2.3477 15.7206 2.74334 -0.71943 0.471876 0.793625 no cummeRbund/inst/extdata/isoforms.count_tracking0000644000175200017520000033651314516004263023115 0ustar00biocbuildbiocbuildtracking_id iPS_count iPS_count_variance iPS_count_uncertainty_var iPS_count_dispersion_var iPS_status hESC_count hESC_count_variance hESC_count_uncertainty_var hESC_count_dispersion_var hESC_status Fibroblasts_count Fibroblasts_count_variance Fibroblasts_count_uncertainty_var Fibroblasts_count_dispersion_var Fibroblasts_status TCONS_00000001 4.20334 1254 4.95385 120.155 OK 0 0 0 0 OK 13.8407 4550 7.91914 904.584 OK TCONS_00000002 7.10922 943 4.9949 203.221 OK 0.494996 4 0 3.78504 OK 0 0 0 0 OK TCONS_00000003 0.128355 4 0.25308 3.6691 OK 0 0 0 0 OK 6.23178 5966 7.91914 407.288 OK TCONS_00000004 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000005 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000006 0 0 0 0 OK 5.68056 5.68056 0 5.68056 OK 0.198315 0.198315 0 0.198315 OK TCONS_00000007 201.334 5988.24 170.21 4905.63 OK 982.546 22416.6 791.543 12154.5 OK 64.8609 1500.58 45.491 1065.72 OK TCONS_00000008 132.915 18345.7 176.224 3238.56 OK 1512.95 30205.6 791.594 18715.9 OK 18.124 640.385 29.198 297.794 OK TCONS_00000009 152.208 16140.1 189.715 3708.63 OK 0.0557642 1 0.111192 0.689827 OK 48.5902 1117 50.3921 798.379 OK TCONS_00000010 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000011 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000012 24241.4 24241.4 0 24241.4 OK 137527 137527 0 137527 OK 83353.1 1.81674e+08 0 1.81674e+08 OK TCONS_00000013 141.347 1615.47 0 1615.47 OK 3500.74 53138.7 0 53138.7 OK 10962.1 1.30181e+07 0 1.30181e+07 OK TCONS_00000014 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000015 2564.67 135356 0 135356 OK 28070.9 1.64e+06 0 1.64e+06 OK 26679.6 7.95059e+07 0 7.95059e+07 OK TCONS_00000016 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000017 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000018 0 0 0 0 OK 44.7498 142 29.8451 109.682 OK 26.4265 1539 30.9608 703.209 OK TCONS_00000019 5.65054 62 2.3655 31.6541 OK 0 0 0 0 OK 4.83062 1233 8.60603 128.542 OK TCONS_00000020 45.5531 261 2.3655 255.187 OK 145.585 390 29.8451 356.83 OK 250.93 6852 32.0294 6677.23 OK TCONS_00000021 9.27339 16.5672 0 16.5672 OK 75.4682 94.7225 0 94.7225 OK 160.21 3001.27 0 3001.27 OK TCONS_00000022 10.277 19.049 0 19.049 OK 84.3667 115.845 0 115.845 OK 1.42934 1.42934 0 1.42934 OK TCONS_00000023 11.9119 1068 8.69793 373.8 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000024 51.9052 2019 54.2737 1628.81 OK 4.42255 546 5.30023 84.8043 OK 7.81277 86041 11.7699 1943.57 OK TCONS_00000025 38.5161 2074 44.5253 1208.65 OK 9.31442 405 7.24329 178.608 OK 58.3927 62838 33.3498 14526.2 OK TCONS_00000026 62.5442 696 31.5484 638.109 OK 458.862 4084 380.975 3640.93 OK 282.997 12143 188.133 11055.9 OK TCONS_00000027 17.8183 202 8.31842 181.791 OK 124.584 1064 68.559 988.537 OK 32.1599 1563 26.9402 1256.4 OK TCONS_00000028 22.1346 342 28.267 225.828 OK 445.706 3956 364.421 3536.54 OK 156.376 7741 171.34 6109.17 OK TCONS_00000029 13.9608 199 4.17386 142.435 OK 185.361 1532 42.9102 1470.79 OK 50.0667 3033 16.6365 1955.97 OK TCONS_00000030 5.66027 7 0.000197978 6.82685 OK 31.6534 58 24.9548 32.6701 OK 11.2897 1128.64 19.3725 166.45 OK TCONS_00000031 0.000105872 1 0.000197978 0.000127692 OK 23.8138 49 24.9548 24.5787 OK 46.8338 895 48.6881 690.497 OK TCONS_00000032 0 0 0 0 OK 0 0 0 0 OK 55.5304 1107 50.4381 818.716 OK TCONS_00000033 109.513 1080.67 0 1080.67 OK 502.184 2296.71 0 2296.71 OK 1367.24 95380.1 0 95380.1 OK TCONS_00000034 480.802 11598.9 0 11598.9 OK 14167.9 517645 0 517645 OK 15728.2 1.48338e+07 0 1.48338e+07 OK TCONS_00000035 0.521883 1 0 0.567179 OK 1.64909 2 0.259871 1.64909 OK 2.48392 25 0.516888 24.0703 OK TCONS_00000036 6.54345 8 0 7.11137 OK 24.3319 25 0.259871 24.3319 OK 44.1142 463.237 0.516888 427.485 OK TCONS_00000037 0 0 0 0 OK 2.50523 2.50523 0 2.50523 OK 0 0 0 0 OK TCONS_00000038 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000039 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000040 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000041 0 0 0 0 OK 21.5966 34 9.73059 23.3281 OK 0 0 0 0 OK TCONS_00000042 0 0 0 0 OK 0.00599669 1 0.0118821 0.00647747 OK 0 0 0 0 OK TCONS_00000043 0 0 0 0 OK 14.3381 26 9.72406 15.4876 OK 0 0 0 0 OK TCONS_00000044 241.224 3870.14 0 3870.14 OK 768.285 4571.9 0 4571.9 OK 2400.81 257045 0 257045 OK TCONS_00000045 0 0 0 0 OK 7.89904 53 14.6552 19.8754 OK 23.7582 632 37.9232 398.537 OK TCONS_00000046 10.0751 14.6915 0.00194097 13.5351 OK 35.4322 152 52.0536 89.1537 OK 47.1084 875 59.8583 790.231 OK TCONS_00000047 0.000992404 1 0.00194097 0.00133321 OK 65.3049 259 82.9375 164.319 OK 31.5091 602 47.585 528.557 OK TCONS_00000048 0 0 0 0 OK 11.6787 61 21.175 29.3856 OK 14.5512 357.532 25.3537 244.092 OK TCONS_00000049 0 0 0 0 OK 76.369 285 85.0738 192.158 OK 24.6868 1281.87 38.8305 414.114 OK TCONS_00000050 111.178 5234 49.9088 4038.52 OK 750.069 19485 201.28 18783.1 OK 630.511 382451 237.786 275787 OK TCONS_00000051 33.8293 1382 44.7964 1228.84 OK 115.248 3255 186.654 2886.02 OK 138.005 195270 219.287 60363.6 OK TCONS_00000052 15.3384 1388 9.82185 557.164 OK 27.4502 1295 19.5185 687.404 OK 23.8915 204343 20.14 10450.2 OK TCONS_00000053 116.779 1180.53 0 1180.53 OK 400.73 1597.85 0 1597.85 OK 1352.09 93029.7 0 93029.7 OK TCONS_00000054 6.14209 7.30868 0 7.30868 OK 6.51564 6.51564 0 6.51564 OK 8.81552 19.8959 0 19.8959 OK TCONS_00000055 34.5492 2322 49.0295 1129.55 OK 254.478 4453 345.546 3844.23 OK 428.8 135914 332.795 91157 OK TCONS_00000056 55.9066 2136 32.604 1827.81 OK 139.771 2261 115.669 2111.43 OK 75.6115 46003 65.2744 16074 OK TCONS_00000057 67.0352 3264 57.5628 2191.64 OK 511.443 8283 372.05 7726.04 OK 248.121 91319 311.139 52747.1 OK TCONS_00000058 0.963422 0.963422 0 0.963422 OK 19.4653 19.4653 0 19.4653 OK 0 0 0 0 OK TCONS_00000059 4.77123 410 8.27839 74.5033 OK 123.152 7347.16 201.052 1020.07 OK 50.2538 3403 90.8214 2858.04 OK TCONS_00000060 217.503 3433 8.27839 3396.33 OK 1178.59 10629.2 201.052 9762.29 OK 898.494 54127 90.8214 51099.3 OK TCONS_00000061 18.9347 54.4857 0 54.4857 OK 271.704 849.392 0 849.392 OK 49.2598 398.908 0 398.908 OK TCONS_00000062 109.341 2941 100.681 2410.56 OK 982.411 11011 697.399 10281.7 OK 535.021 40248 488.747 37932.5 OK TCONS_00000063 56.1249 1496 60.9868 1237.35 OK 208.055 2298 112.535 2177.46 OK 65.7395 5061 46.1319 4660.87 OK TCONS_00000064 208.461 4812 153.277 4595.78 OK 367.111 8578.98 536.656 3842.11 OK 331.254 31408.7 421.139 23485.6 OK TCONS_00000065 14.6749 546.077 18.2542 323.527 OK 338.226 10162.9 392.665 3539.8 OK 273.779 20216 300.766 19410.7 OK TCONS_00000066 31.6321 1573 47.9681 846.902 OK 141.199 2571 243.681 2095.75 OK 82.0674 35735 144.914 15232.8 OK TCONS_00000067 444.847 14211.4 179.498 11910.1 OK 1925.75 30370 1573.8 28582.9 OK 1616.51 310537 1820.56 300046 OK TCONS_00000068 89.441 3001 144.119 2394.65 OK 1241.17 20035 1514.97 18422.1 OK 2223.83 447776 1841.34 412772 OK TCONS_00000069 18.6409 714 6.14264 499.082 OK 67.0945 1067 30.5032 995.848 OK 33.4401 35186 15.0678 6206.91 OK TCONS_00000070 1.00359 1.00359 0 1.00359 OK 9.95972 9.95972 0 9.95972 OK 4.172 8.48407 0 8.48407 OK TCONS_00000071 16.5057 214 25.1035 129.019 OK 0.011528 1 0.0229048 0.0882106 OK 45.0556 6288.23 87.1401 3333.89 OK TCONS_00000072 11.4648 150 18.8312 89.6157 OK 277.365 4018.78 394.732 2122.35 OK 823.51 65662 690.366 60935.6 OK TCONS_00000073 0 0 0 0 OK 14.5745 429.741 27.7203 111.522 OK 0 0 0 0 OK TCONS_00000074 34.0707 311 35.9187 266.317 OK 304.436 3106.54 412.411 2329.5 OK 162.457 16878 277.706 12021 OK TCONS_00000075 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000076 5.24282 85 7.74146 40.981 OK 110.295 2292.28 176.393 843.964 OK 104.314 11325 177.591 7718.7 OK TCONS_00000077 0.0404941 1 0.0805351 0.316526 OK 75.721 766 127.487 579.405 OK 39.5417 5895 72.0029 2925.89 OK TCONS_00000078 0 0 0 0 OK 12.9787 144 24.6344 99.311 OK 151.119 18194.7 256.419 11182 OK TCONS_00000079 0 0 0 0 OK 257.642 2374 372.798 1971.43 OK 93.9564 55252.7 170.146 6952.3 OK TCONS_00000080 10.6255 152 16.7051 83.0551 OK 0 0 0 0 OK 55.4155 54098.8 101.643 4100.47 OK TCONS_00000081 3.3817 100 4.47215 26.4334 OK 92.4544 1918.81 100.519 707.446 OK 0 0 0 0 OK TCONS_00000082 1.37738 4 2.09719 1.37738 OK 38.1758 80 31.1656 47.3626 OK 5.58246 36 5.78888 22.1967 OK TCONS_00000083 4.46221 7 2.29102 4.46221 OK 28.3586 66 29.6037 35.183 OK 0 0 0 0 OK TCONS_00000084 0 0 0 0 OK 0 0 0 0 OK 8.63718 48 7.78236 34.3427 OK TCONS_00000085 0.202063 1 0.382732 0.202063 OK 6.88776 35.3414 8.80003 8.54526 OK 3.59862 55 5.16655 14.3086 OK TCONS_00000086 0 0 0 0 OK 57.5863 2588 15.5853 1705.22 OK 55.7194 458013 2.63772 37704.9 OK TCONS_00000087 5.35927 197 0 196.548 OK 12.9405 1003 15.5853 383.188 OK 1.56786 2.16556e+06 2.63772 1060.96 OK TCONS_00000088 43.7732 2702 21.2785 1605.36 OK 135.959 4371 101.205 4025.95 OK 117.065 461793 68.3686 79217.1 OK TCONS_00000089 1.52548 1.52548 0 1.52548 OK 2.49503 2.49503 0 2.49503 OK 7.20104 16.8246 0 16.8246 OK TCONS_00000090 2.04736 2.04736 0 2.04736 OK 26.4657 26.4657 0 26.4657 OK 0.8344 0.8344 0 0.8344 OK TCONS_00000091 8.67116 12.3414 0 12.3414 OK 77.4887 98.9312 0 98.9312 OK 0.594944 0.594944 0 0.594944 OK TCONS_00000092 177.355 4295 103.393 4141.68 OK 1904.57 30294 351.049 29870.8 OK 0 0 0 0 OK TCONS_00000093 0 0 0 0 OK 0 0 0 0 OK 75.1929 8466 70.9148 6871.54 OK TCONS_00000094 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000095 71.6222 2280 98.1028 1672.56 OK 117.97 4488.22 220.649 1850.21 OK 0 0 0 0 OK TCONS_00000096 0 0 0 0 OK 0 0 0 0 OK 45.8921 8749 62.8905 4193.87 OK TCONS_00000097 2.22725 846 1.45778 52.0118 OK 3.39035 338 2.63341 53.1733 OK 0 0 0 0 OK TCONS_00000098 0 0 0 0 OK 26.0943 1350.44 45.7397 409.257 OK 0 0 0 0 OK TCONS_00000099 4.99777 770 5.76468 116.71 OK 31.1416 790 36.5946 488.417 OK 0 0 0 0 OK TCONS_00000100 13.1172 548 4.41275 306.319 OK 111.874 1879 29.1858 1754.6 OK 18.3484 8773 10.5313 1676.78 OK TCONS_00000101 48.2932 1128 0 1127.77 OK 205.951 3231 0 3230.08 OK 151.982 13889 0 13889 OK TCONS_00000102 562.295 14778.4 0 14778.4 OK 4366.32 75900.2 0 75900.2 OK 7849.78 2.82964e+06 0 2.82964e+06 OK TCONS_00000103 963.648 38031 115.956 36589.9 OK 2400.16 36245 385.516 35774.5 OK 9526.5 5.65204e+06 980.382 5.34248e+06 OK TCONS_00000104 41.8689 3124 67.2053 1589.77 OK 97.1207 1641 164.205 1447.59 OK 372.87 316861 648.315 209106 OK TCONS_00000105 0 0 0 0 OK 5.55836 11 4.73147 5.55836 OK 3.09879 44 3.54435 11.5284 OK TCONS_00000106 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000107 0 0 0 0 OK 0.000256118 1 0.000493478 0.000256118 OK 1.92845 51 2.989 7.17441 OK TCONS_00000108 4.43026e-05 1 7.99437e-05 4.43026e-05 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000109 2.41496 4 0.980589 2.41496 OK 6.90633 12 4.73149 6.90633 OK 5.9212 43 4.27922 22.0286 OK TCONS_00000110 1.03732 3 0.98055 1.03732 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000111 4.71461 74 5.35657 24.3839 OK 0.0625481 1 0.121776 0.0625481 OK 53.8467 4355 75.1567 3492.94 OK TCONS_00000112 2.76045 34 2.14055 14.277 OK 2.76246 5 1.44225 2.76246 OK 54.6291 4265 44.5695 3543.7 OK TCONS_00000113 3.57746 27 1.80702 18.5026 OK 2.24864 4 1.19073 2.24864 OK 169.783 12565 79.7957 11013.5 OK TCONS_00000114 12.7745 101 6.48593 66.0696 OK 0 0 0 0 OK 848.815 58271 225.611 55061.1 OK TCONS_00000115 0 0 0 0 OK 2.18237 5 1.92331 2.18237 OK 34.8091 4565 62.2576 2258.01 OK TCONS_00000116 232.891 9485.75 215.062 5450.8 OK 1164.84 15926.5 1090.71 13841.6 OK 1343.5 175085 1335.03 166251 OK TCONS_00000117 0 0 0 0 OK 101.888 1522 181.304 1210.72 OK 11.7033 20178 22.1215 1448.22 OK TCONS_00000118 152.263 6013.24 194.072 3563.73 OK 871.534 11542 1029.96 10356.3 OK 1207.29 153392 1320.97 149396 OK TCONS_00000119 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000120 20.6618 617 38.3836 483.589 OK 40.1378 630 74.9869 476.951 OK 44.6564 16488 85.6683 5525.98 OK TCONS_00000121 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000122 47.5642 1800 84.3848 1113.24 OK 117.53 1664 212.234 1396.58 OK 172.684 31328 313.178 21368.7 OK TCONS_00000123 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000124 2.05466 4 1.71916 2.05466 OK 40.9974 78.4168 11.9329 40.9974 OK 0 0 0 0 OK TCONS_00000125 0.0035957 1 0.00713731 0.0035957 OK 0 0 0 0 OK 51.7198 566 15.194 482.178 OK TCONS_00000126 1.46952 4 1.71636 1.46952 OK 6.98469 46.8987 11.9329 6.98469 OK 0 0 0 0 OK TCONS_00000127 0.00257746 1 0.00511581 0.00257746 OK 0 0 0 0 OK 8.90761 523.574 15.194 83.0447 OK TCONS_00000128 0.00230678 1 0.00457836 0.00230678 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000129 152.408 2099 31.5328 1997.17 OK 665.608 5015.23 344.755 4529.15 OK 5.60754 30 4.19539 15.676 OK TCONS_00000130 0 0 0 0 OK 130.995 1309.99 214.619 891.361 OK 4.18034 28 4.19541 11.6863 OK TCONS_00000131 19.4773 595.934 30.7617 255.232 OK 130.263 1140 209.06 886.38 OK 0.0323877 1 0.0642745 0.0905408 OK TCONS_00000132 4.10372 178 1.08715 53.7754 OK 15.1737 127 4.39457 103.25 OK 0 0 0 0 OK TCONS_00000133 0 0 0 0 OK 10.2111 122 19.6593 69.4818 OK 0 0 0 0 OK TCONS_00000134 507.179 12810 0 12809.8 OK 1193.68 9366 0 9365.61 OK 5169.1 1.1781e+06 66.8023 1.17243e+06 OK TCONS_00000135 0 0 0 0 OK 0 0 0 0 OK 36.3241 56399 66.8023 8238.88 OK TCONS_00000136 2.94871 12 3.5244 4.27577 OK 0 0 0 0 OK 0.655508 3 1.17964 2.19719 OK TCONS_00000137 5.84488 13 3.65959 8.47537 OK 180.111 497 32.2617 459.587 OK 9.08328 34 1.2145 30.4462 OK TCONS_00000138 0.892741 2 0.649688 1.29452 OK 7.9709 43 10.1435 20.3392 OK 0 0 0 0 OK TCONS_00000139 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000140 0 0 0 0 OK 13.4507 65 21.3259 34.3219 OK 0 0 0 0 OK TCONS_00000141 0 0 0 0 OK 0.0918113 1 0.181837 0.234273 OK 0 0 0 0 OK TCONS_00000142 1.39339 3 0.585492 2.02048 OK 0.566327 2 0.141665 1.44509 OK 0 0 0 0 OK TCONS_00000143 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000144 0 0 0 0 OK 1.68685 111 2.42212 4.30432 OK 0.0197686 1 0.0392145 0.0662621 OK TCONS_00000145 0.481711 0.481711 0 0.481711 OK 6.44423 6.44423 0 6.44423 OK 0.594944 0.594944 0 0.594944 OK TCONS_00000146 4.45592 4.45592 0 4.45592 OK 29.9302 29.9302 0 29.9302 OK 17.9248 64.5406 0 64.5406 OK TCONS_00000147 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000148 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000149 0 0 0 0 OK 3.9569 51.3563 5.67976 14.7279 OK 0 0 0 0 OK TCONS_00000150 0 0 0 0 OK 0 0 0 0 OK 13.9245 5068.1 26.0126 374.964 OK TCONS_00000151 74.0036 653 19.3561 597.784 OK 262.881 1113 127.476 978.465 OK 249.588 7770.21 62.2085 6721 OK TCONS_00000152 7.85321 188 13.3432 63.4364 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000153 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000154 4.36462 254.796 7.30947 35.2564 OK 17.5561 130.841 30.5682 65.3452 OK 0 0 0 0 OK TCONS_00000155 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000156 0 0 0 0 OK 46.4256 271 73.0468 172.8 OK 12.9678 889 23.0082 349.201 OK TCONS_00000157 0.00771084 1 0.0152962 0.0622864 OK 26.9136 157 46.6069 100.175 OK 10.8656 942 20.4768 292.592 OK TCONS_00000158 3.85714 5 0.180833 3.85714 OK 1.26253 6.30392 1.44684 1.26253 OK 2.65123 7 1.22074 3.79508 OK TCONS_00000159 0.00457808 1 0.00904474 0.00457808 OK 16.7792 19 1.44684 16.7792 OK 1.6368 3 1.22074 2.34297 OK TCONS_00000160 0.594197 1 0.172438 0.594197 OK 9.02087 10 0 9.02087 OK 0.594944 1 0 0.851625 OK TCONS_00000161 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000162 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000163 20.293 416.428 22.393 216.354 OK 49.7154 345.025 55.5506 122.328 OK 1.39567 2 0.523622 1.96498 OK TCONS_00000164 89.2979 1059 22.393 952.049 OK 144.193 551.561 55.5506 354.794 OK 0.98411 2.20098 0.523622 1.38555 OK TCONS_00000165 68.8854 578.354 0 578.354 OK 86.3464 120.977 0 120.977 OK 0.594944 0.594944 0 0.594944 OK TCONS_00000166 9.3942 184 15.7115 77.9143 OK 63.8882 381 100.067 256.351 OK 173.571 7376.75 108.342 4424.07 OK TCONS_00000167 4.30283 75 2.3124 35.6871 OK 35.1537 175 25.714 141.054 OK 3.63919 933 3.16868 92.7577 OK TCONS_00000168 5.7068 245.07 10.4246 47.3315 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000169 59.4407 592 34.5805 492.994 OK 299.305 1334 121.805 1200.96 OK 83.101 4337.38 107.161 2118.13 OK TCONS_00000170 5.49561 261.41 8.53379 45.5799 OK 2.82742 33 4.63406 11.345 OK 0 0 0 0 OK TCONS_00000171 5.24019 286.719 8.36309 43.4615 OK 2.44878 38 3.88294 9.82571 OK 0 0 0 0 OK TCONS_00000172 1.30489 11 2.5276 10.8226 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000173 5.21177 293 0.858405 292.135 OK 15.3704 507 1.94317 351.121 OK 4.39406 2264 0.50157 2263.31 OK TCONS_00000174 59.2928 6194 4.17201 3323.54 OK 114.048 3027 20.8058 2605.31 OK 113.965 265590 19.5069 58701.7 OK TCONS_00000175 7.81288 3207 1.21321 437.935 OK 22.275 1045 8.0543 508.849 OK 10.6386 282551 3.79686 5479.79 OK TCONS_00000176 6.64588 3401 2.2788 372.521 OK 23.6989 1076 15.2209 541.377 OK 19.2162 288899 16.8003 9897.93 OK TCONS_00000177 25.0095 74.6717 0 74.6717 OK 150.34 309.521 0 309.521 OK 3.93254 6.43363 0 6.43363 OK TCONS_00000178 92.1693 801.958 0 801.958 OK 762.203 4511.79 0 4511.79 OK 0 0 0 0 OK TCONS_00000179 10.6588 36 6.05186 24.504 OK 72.8803 582.005 62.7498 273.548 OK 0.594944 1 0 0.594944 OK TCONS_00000180 7.96795 31 6.05186 18.3179 OK 285.988 1412.33 62.7498 1073.42 OK 0 0 0 0 OK TCONS_00000181 1.58899 3 1.26328 1.58899 OK 1.63712 3 0.874879 1.63712 OK 0 0 0 0 OK TCONS_00000182 1.45799 3 1.26121 1.45799 OK 0.207346 1 0.367865 0.207346 OK 0.000120751 1 0.00022661 0.000228083 OK TCONS_00000183 0 0 0 0 OK 0.640365 2 0.732123 0.640365 OK 3.9566 12 1.87371 7.4735 OK TCONS_00000184 0.00397896 1 0.00785548 0.00397896 OK 0 0 0 0 OK 2.41731 10 1.8737 4.56598 OK TCONS_00000185 59.3116 922 68.0152 723.13 OK 33.2394 274 60.1097 194.821 OK 72.2617 4190 113.525 2629.15 OK TCONS_00000186 53.6012 916.206 64.6703 653.508 OK 180.404 1476.02 239.653 1057.38 OK 87.652 4113 127.935 3189.11 OK TCONS_00000187 24.6206 511 39.894 300.176 OK 328.257 2245 298.198 1923.97 OK 227.299 9280 197.11 8270 OK TCONS_00000188 22.4395 449 13.0602 273.584 OK 208.975 1379 149.742 1224.83 OK 75.5738 4023 60.7863 2749.66 OK TCONS_00000189 400.713 8852.95 0 8852.95 OK 2457.98 30132.5 0 30132.5 OK 2311.86 242240 0 242240 OK TCONS_00000190 34.1028 2411 17.8221 1175.46 OK 159.672 3411 122.441 2958.72 OK 407.454 106189 193.543 93927.3 OK TCONS_00000191 12.4772 1397 16.5241 430.066 OK 101.157 2097 116.787 1874.45 OK 120.844 54221 181.578 27857.4 OK TCONS_00000192 5.72045 1758 8.23824 197.174 OK 39.859 1106 55.7757 738.588 OK 43.4458 56440 63.127 10015.2 OK TCONS_00000193 284.805 5529 0.711388 5528.98 OK 813.567 5849 6.11575 5834.4 OK 1458.82 113225 1.72965 107848 OK TCONS_00000194 16.2161 393 13.3375 314.806 OK 73.113 614 73.8457 524.321 OK 26.5411 5577 12.2455 1962.15 OK TCONS_00000195 19.2286 796 14.526 373.289 OK 146.203 1135 67.73 1048.48 OK 0 0 0 0 OK TCONS_00000196 0 0 0 0 OK 0 0 0 0 OK 8.45779 6993 10.5158 625.273 OK TCONS_00000197 2.76816 952 4.86346 53.7389 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000198 1254.27 50600.6 0 50600.6 OK 1083.92 8011.86 0 8011.86 OK 12340.2 7.84133e+06 0 7.84133e+06 OK TCONS_00000199 30.3477 1638 39.1988 834.505 OK 10.534 95 13.3683 55.017 OK 33.8075 9020 53.0004 3089.35 OK TCONS_00000200 18.1116 1426.03 33.1775 498.036 OK 0 0 0 0 OK 50.0687 8865 92.6658 4575.3 OK TCONS_00000201 35.7911 4151.04 62.6464 984.19 OK 163.486 1047 178.557 853.86 OK 0 0 0 0 OK TCONS_00000202 107.357 3953 168.785 2952.13 OK 45.8788 338 82.9615 239.617 OK 432.46 42116 626.037 39518.4 OK TCONS_00000203 352.206 13486.5 247.764 9685.03 OK 350.355 2063 228.293 1829.84 OK 1165.2 122098 713.607 106476 OK TCONS_00000204 36.4692 2107.58 65.0075 1002.84 OK 16.5878 222.579 31.1267 86.6349 OK 38.8344 9067 74.1969 3548.71 OK TCONS_00000205 31.0014 1687 18.5577 1265.29 OK 37.4466 1012 22.6854 842.061 OK 19.0294 546160 11.3737 13650.9 OK TCONS_00000206 1182.11 49083 316.306 48246.6 OK 4591.59 105705 2287.89 103251 OK 8168.86 6.17354e+06 5740.99 5.86001e+06 OK TCONS_00000207 9.57616 2052 12.0404 390.842 OK 25.1584 1149 41.0688 565.736 OK 169.518 524757 304.278 121606 OK TCONS_00000208 202.119 10241 300.919 8249.31 OK 1938.52 49675.6 2266.02 43591.4 OK 5337.25 4.11842e+06 5642.45 3.82873e+06 OK TCONS_00000209 23.065 1641 2.6797 941.377 OK 32.8638 981 5.59248 739.007 OK 13.6091 528738 2.67901 9762.63 OK TCONS_00000210 1.65948 4 1.98312 1.93428 OK 70.3232 123 24.968 97.2746 OK 272.319 8914 126.154 8637.4 OK TCONS_00000211 6.28893 10 1.98312 7.33035 OK 16.6609 52 24.968 23.0463 OK 93.694 4923.17 126.154 2971.78 OK TCONS_00000212 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000213 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000214 507.14 12966.8 0 12966.8 OK 888.348 5831.28 0 5831.28 OK 8578.29 3.46542e+06 0 3.46542e+06 OK TCONS_00000215 85.6365 867 31.9082 787.063 OK 57.3943 272 85.6327 173.32 OK 509.687 57551 744.403 49684.9 OK TCONS_00000216 19.8614 294 31.9082 182.541 OK 201.354 698 85.6327 608.05 OK 1617.23 171445 744.403 157649 OK TCONS_00000217 115.011 1135 0 1134.55 OK 283.437 2289.63 52.8314 977.175 OK 284.224 8891 17.4809 8213.71 OK TCONS_00000218 0 0 0 0 OK 31.1712 2272.9 52.8314 107.465 OK 9.61652 1116 17.4809 277.905 OK TCONS_00000219 103.497 1529 19.4864 1390.51 OK 671.349 6470 228.994 6199.55 OK 814.662 52465 100.913 50224 OK TCONS_00000220 80.2409 1196 19.4864 1078.06 OK 876.094 8371 228.994 8090.26 OK 225.318 15103 100.913 13890.9 OK TCONS_00000221 91.98 5760.75 140.728 3696.97 OK 1453.16 48246 1161.98 46212.3 OK 204.207 1.45298e+06 299.227 244506 OK TCONS_00000222 283.269 12841 172.96 11385.5 OK 858.756 28576 1099.32 27309.6 OK 486.395 1.43681e+06 361.554 582383 OK TCONS_00000223 37.4295 1714 62.5846 1504.41 OK 144.637 5231 244.298 4599.67 OK 97.1528 1.47975e+06 155.961 116325 OK TCONS_00000224 91.6094 881.483 0 881.483 OK 151.513 311.808 0 311.808 OK 990.476 56044 0 56044 OK TCONS_00000225 22.8015 67 0 66.2587 OK 114.914 195 0 194.183 OK 7.9194 16 0 15.5536 OK TCONS_00000226 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000227 1138.12 43310 158.716 43032.2 OK 6278.01 139687 317.852 138942 OK 5168 1.34947e+06 999.497 1.31212e+06 OK TCONS_00000228 36.6705 1521 63.4934 1386.5 OK 124.195 3076 221.29 2748.62 OK 199.139 65355 355.524 50560 OK TCONS_00000229 0 0 0 0 OK 0 0 0 0 OK 31.0151 72226 60.0343 7874.53 OK TCONS_00000230 0 0 0 0 OK 25.1035 1144 48.0149 555.576 OK 0 0 0 0 OK TCONS_00000231 60.8936 2985 91.2784 2302.38 OK 9.13019 651 16.0953 202.064 OK 50.9937 68955 96.3179 12947 OK TCONS_00000232 6.03788 2179 9.84271 228.291 OK 20.412 1040.13 36.449 451.748 OK 320.653 130443 543.063 81411.6 OK TCONS_00000233 1.97293 10518 2.89102 117.406 OK 3.34443 772 3.70593 72.6774 OK 4.33126 175532 5.30645 1438.05 OK TCONS_00000234 1297.7 80550 418.159 77224.3 OK 1570.15 34786 536.658 34120.8 OK 5580.58 1.86887e+06 487.406 1.85284e+06 OK TCONS_00000235 1767.23 108738 738.274 105165 OK 3855.27 85422 1618.7 83778.4 OK 1290.54 440586 740.175 428480 OK TCONS_00000236 0 0 0 0 OK 12.2833 1965 24.4294 266.927 OK 50.5024 118324 97.8315 16767.6 OK TCONS_00000237 0 0 0 0 OK 28.9381 1073 54.9178 628.851 OK 0 0 0 0 OK TCONS_00000238 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000239 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000240 271.164 36861.2 428.001 16136.6 OK 797.356 18864 1226.74 17327.3 OK 214.961 172245 357.269 71370.6 OK TCONS_00000241 971.972 34032 97.1401 33736.1 OK 12666.7 448726 1338.06 446239 OK 20382.6 3.11771e+07 1331.56 2.93949e+07 OK TCONS_00000242 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000243 51.8246 2571 90.1963 1798.78 OK 723.532 28037 1331.03 25489.5 OK 702.71 2.08946e+06 1318.71 1.01342e+06 OK TCONS_00000244 4.32495 2240 7.65597 150.114 OK 4.42418 2283 7.85602 155.86 OK 7.88488 3.02991e+06 13.7406 11371.2 OK TCONS_00000245 29.2916 382 31.0605 325.426 OK 94.8318 397 61.0887 328.062 OK 90.0913 6537 109.539 4143.52 OK TCONS_00000246 3.35527 232 5.11904 37.2767 OK 0 0 0 0 OK 24.199 2258 27.1288 1112.97 OK TCONS_00000247 2.64713 268 3.83877 29.4093 OK 12.3578 81 16.0961 42.7507 OK 3.89813 3919 6.11275 179.284 OK TCONS_00000248 89.0398 1045 28.9547 989.224 OK 183.153 694 54.0553 633.599 OK 562.635 27018 99.694 25876.9 OK TCONS_00000249 14.0019 240 4.6135 155.56 OK 29.1796 111 7.84449 100.944 OK 10.384 2438 9.66669 477.586 OK TCONS_00000250 1.56596 19 0 18.1006 OK 8.642 108 2.02071 65.6403 OK 54.3208 6750 24.6962 4453.48 OK TCONS_00000251 11.8828 138 0 137.35 OK 6.59081 51 0.207571 50.0605 OK 16.041 6709 1.34577 1315.12 OK TCONS_00000252 7.04028 144 4.61609 81.3771 OK 7.47845 115 2.89896 56.8026 OK 2.97005 10031 2.16463 243.5 OK TCONS_00000253 125.113 1470 4.61609 1446.15 OK 1111.15 8472 5.03005 8439.75 OK 1561.78 132939 130.512 128043 OK TCONS_00000254 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000255 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000256 0 0 0 0 OK 0 0 0 0 OK 61.6863 7011 107.396 5057.35 OK TCONS_00000257 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000258 3153.6 184178 87.5904 184031 OK 10176.3 309773 284.279 309042 OK 9554.82 4.42784e+06 0 4.42784e+06 OK TCONS_00000259 48.1068 3598 87.5904 2807.32 OK 147.255 5828 284.279 4471.94 OK 0 0 0 0 OK TCONS_00000260 21.5572 1054 0 1053.69 OK 2.0001 54 0 53.428 OK 18.6975 4303 0 4302.79 OK TCONS_00000261 514.64 12989.4 0 12989.4 OK 1138.82 8677.44 0 8677.44 OK 995.51 57405.1 0 57405.1 OK TCONS_00000262 5.45951 31 0 30.1048 OK 7.68835 28 0.27148 27.6558 OK 0 0 0 0 OK TCONS_00000263 30.5679 193 14.755 168.557 OK 331.732 1194 0.27148 1193.27 OK 2.3796 4 0.000329766 3.35028 OK TCONS_00000264 13.5498 135 14.755 74.7159 OK 0 0 0 0 OK 0.000173876 1 0.000329766 0.000244803 OK TCONS_00000265 0 0 0 0 OK 55.0225 1011 98.9012 842.229 OK 24.2442 3433 43.8802 1337.78 OK TCONS_00000266 10.3073 431 8.4434 204.207 OK 91.2082 1626 67.2716 1396.12 OK 33.7865 3235 47.458 1864.33 OK TCONS_00000267 96.6105 2327 56.5386 1914.03 OK 531.424 8896 533.486 8134.51 OK 51.9005 3173 83.7343 2863.85 OK TCONS_00000268 0 0 0 0 OK 174.218 6873.45 293.952 2666.75 OK 330.161 21489 372.15 18218.2 OK TCONS_00000269 60.274 1601 55.9462 1194.14 OK 369.735 9157.03 483.735 5659.53 OK 416.403 26256.5 382.984 22976.9 OK TCONS_00000270 0 0 0 0 OK 17.3072 2390.12 33.511 264.922 OK 19.0307 3563 34.837 1050.11 OK TCONS_00000271 0.00734912 1 0.0145769 0.1456 OK 112.347 5984.08 197.789 1719.69 OK 0 0 0 0 OK TCONS_00000272 43.9978 219.285 0 219.285 OK 37.0478 37.0478 0 37.0478 OK 425.483 14738.3 0 14738.3 OK TCONS_00000273 132.594 1435.67 0 1435.67 OK 577.571 2882.6 0 2882.6 OK 15.9475 75.9065 0 75.9065 OK TCONS_00000274 203.367 3003.69 0 3003.69 OK 791.077 4804.87 0 4804.87 OK 19.5788 102.199 0 102.199 OK TCONS_00000275 48.9319 2777.05 74.7002 925.696 OK 248.707 2839 344.892 2467.29 OK 110.369 24925.1 175.401 8663.95 OK TCONS_00000276 33.8297 2692.01 56.0472 639.993 OK 55.035 771 101.279 545.972 OK 29.3503 6860 55.2575 2304 OK TCONS_00000277 135.448 4803.92 139.82 2562.41 OK 1148.33 12084 660.052 11392 OK 1138.89 103711 634.102 89402.6 OK TCONS_00000278 96.7385 2212 122.683 1830.11 OK 273.064 3188 419.003 2708.92 OK 325.942 31259 495.044 25586.5 OK TCONS_00000279 0 0 0 0 OK 9.31425 276 16.4138 92.4015 OK 33.2104 6750 60.7753 2607.02 OK TCONS_00000280 1.04377 1.04377 0 1.04377 OK 2.0001 2.0001 0 2.0001 OK 0.8344 0.8344 0 0.8344 OK TCONS_00000281 0 0 0 0 OK 5.79833 68 3.82547 46.3227 OK 0 0 0 0 OK TCONS_00000282 1.13454 24 0.25802 23.0051 OK 3.60808 87 3.4876 28.8248 OK 11.9147 24191 4.80797 1799.61 OK TCONS_00000283 9.4189 291 1.00115 163.591 OK 1.09751 12 0.194374 11.6831 OK 0 0 0 0 OK TCONS_00000284 0 0 0 0 OK 7.56596 134 8.95267 80.5405 OK 8.62721 16465 11.0807 974.596 OK TCONS_00000285 1.74123 980 2.42446 30.2423 OK 4.39423 165 5.57055 46.777 OK 1.79282 37870 2.38484 202.531 OK TCONS_00000286 6.06649 398 7.27972 105.365 OK 19.7722 380 24.3793 210.477 OK 35.1308 13540 43.7192 3968.64 OK TCONS_00000287 244.292 4276 10.1808 4242.96 OK 1899.76 20266 38.5463 20223.1 OK 2426.25 278333 56.3722 274088 OK TCONS_00000288 0.0953662 2 0.190224 1.65635 OK 0.555983 6 1.11044 5.9185 OK 0 0 0 0 OK TCONS_00000289 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000290 0 0 0 0 OK 5.6427 61 0.188334 60.0671 OK 8.90946 13038 1.23065 1006.48 OK TCONS_00000291 1.0242 18 0.613726 17.7886 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000292 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000293 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000294 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000295 1.02378 18 0.50763 17.7813 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000296 990.869 46380.5 35.4751 35782.5 OK 2876.1 39020 10.2612 38840.5 OK 25050.4 5.68373e+07 542.878 5.45304e+07 OK TCONS_00000297 19.5999 11991.7 35.4751 707.798 OK 5.64687 285 10.2612 76.2586 OK 296.724 4.79477e+06 542.878 645916 OK TCONS_00000298 1075.12 55425.7 209.721 40125.2 OK 3796.04 71110.8 1144.97 67176.5 OK 10544.7 1.02972e+07 1041.36 5.81229e+06 OK TCONS_00000299 123.898 23647.7 209.721 4624.08 OK 703.757 13926 1144.97 12454 OK 573.838 6.39998e+06 1041.36 316303 OK TCONS_00000300 293.932 5326 0 5326 OK 1830.86 18761.3 0 18761.3 OK 695.807 32506.4 0 32506.4 OK TCONS_00000301 258.886 5002 54.9873 4678.37 OK 1547.14 14997 156.504 14803.1 OK 13.636 120 7.23482 88.0541 OK TCONS_00000302 27.3029 1407.12 47.5483 493.396 OK 67.1251 797 118.738 642.251 OK 0.00140322 1 0.00275525 0.00906126 OK TCONS_00000303 0 0 0 0 OK 21.005 332 41.1473 200.975 OK 0 0 0 0 OK TCONS_00000304 5.25454 531 9.24541 94.9558 OK 0 0 0 0 OK 6.83016 101 7.23359 44.1056 OK TCONS_00000305 0 0 0 0 OK 105.171 228 33.5198 191.574 OK 3865.56 772846 578.07 757275 OK TCONS_00000306 0.000607993 1 0.00118416 0.00158231 OK 20.6415 80 33.5198 37.5994 OK 322.743 77630 578.07 63226.4 OK TCONS_00000307 21.4762 56.8239 0.00118416 55.8922 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000308 85.7274 7561.2 164.556 4367.32 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000309 2094.51 107830 388.062 106703 OK 1235.57 16665.7 1069.07 14797.2 OK 2662.85 1.18793e+06 1729.11 495496 OK TCONS_00000310 110.874 8118 198.738 5648.4 OK 973.86 12777 1059.28 11662.9 OK 1127.01 894896 1554.59 209712 OK TCONS_00000311 64.2149 5276 51.4446 3271.38 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000312 0 0 0 0 OK 118.028 1683 206.536 1413.5 OK 309.993 69959 505.362 57682.8 OK TCONS_00000313 0 0 0 0 OK 19.7384 335 37.3804 236.387 OK 8.29527 50282 15.2946 1543.57 OK TCONS_00000314 1.00359 52 0 51.1274 OK 1.00129 12 0 11.9915 OK 0.420531 79 0 78.2514 OK TCONS_00000315 0.521883 0.521883 0 0.521883 OK 2.0001 2.0001 0 2.0001 OK 0 0 0 0 OK TCONS_00000316 13.3225 182 21.5926 116.472 OK 7.513 19 11.324 7.513 OK 0 0 0 0 OK TCONS_00000317 76.1187 702 21.5926 665.466 OK 33.5299 45 11.324 33.5299 OK 0 0 0 0 OK TCONS_00000318 0.521865 1 3.16041e-05 0.521865 OK 0.505127 1 0 0.505127 OK 0 0 0 0 OK TCONS_00000319 1.85458e-05 1 3.16041e-05 1.85458e-05 OK 0.505127 1 0 0.505127 OK 0 0 0 0 OK TCONS_00000320 2.40856 2.40856 0 2.40856 OK 1.48478 1.48478 0 1.48478 OK 0 0 0 0 OK TCONS_00000321 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000322 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000323 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000324 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000325 0.21677 0.21677 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000326 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000327 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000328 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000329 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000330 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000331 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TCONS_00000332 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000333 756.357 32624 638.781 31385.4 OK 2284.69 50144.6 2137.73 41886.6 OK 91.2116 4045.31 105.122 2403.94 OK TCONS_00000334 655.968 29312 638.781 27219.7 OK 2467 56999.2 2142.76 45229.1 OK 160.474 4825 105.122 4229.4 OK TCONS_00000335 0 0 0 0 OK 18.5703 813 33.0112 340.461 OK 0 0 0 0 OK TCONS_00000336 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000337 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000338 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000339 0 0 0 0 OK 34.4579 316 44.1913 243.544 OK 60.418 10434 65.2295 6095.19 OK TCONS_00000340 142.355 4801 200.238 3970.31 OK 71.6232 662 129.844 506.224 OK 0 0 0 0 OK TCONS_00000341 47.5611 1633 68.5816 1326.49 OK 171.146 1510 241.991 1209.64 OK 99.6707 10414 167.559 10055.1 OK TCONS_00000342 0 0 0 0 OK 3.44044 82 4.77588 24.3166 OK 0 0 0 0 OK TCONS_00000343 3.04983 1991 5.95064 85.0606 OK 0 0 0 0 OK 69.2059 10545 112.029 6981.74 OK TCONS_00000344 437.986 13008 223.151 12215.5 OK 723.799 5429 276.18 5115.72 OK 1886.33 191677 207.596 190300 OK TCONS_00000345 0 0 0 0 OK 2.0731 141 3.07357 14.6524 OK 52.3835 10545 64.2195 5284.64 OK TCONS_00000346 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000347 5.00656 140 0.577645 139.634 OK 2.92094 21 0.814651 20.6448 OK 7.75668 10737 1.98603 782.522 OK TCONS_00000348 75.3444 813 22.1418 785.958 OK 179.22 1238 225.28 990.51 OK 10.2586 7824 19.6415 777.184 OK TCONS_00000349 4.24721 187 7.17126 44.3049 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000350 0 0 0 0 OK 61.447 441 78.6194 339.603 OK 33.7577 6082 42.4432 2557.47 OK TCONS_00000351 3.02588 228 4.83958 31.5645 OK 76.4782 614.55 121.106 422.677 OK 92.6279 11940 156.346 7017.46 OK TCONS_00000352 0 0 0 0 OK 0 0 0 0 OK 39.6221 6189 73.4387 3001.75 OK TCONS_00000353 8.18816 189.013 12.9179 85.4151 OK 0 0 0 0 OK 615.45 136049 635.731 46626.3 OK TCONS_00000354 0 0 0 0 OK 273.142 1784 247.318 1509.59 OK 576.499 140567 629.137 43675.4 OK TCONS_00000355 13.8206 230 11.5951 144.17 OK 24.1109 203 33.9388 133.255 OK 37.5263 5915 31.4784 2842.98 OK TCONS_00000356 11.2309 255 19.5331 111.038 OK 0.033343 1 0.0664224 0.14014 OK 0 0 0 0 OK TCONS_00000357 21.3119 333 32.2549 210.706 OK 129.185 728 164.446 542.963 OK 51.5742 3854 92.0531 3123.42 OK TCONS_00000358 0 0 0 0 OK 31.2718 202 55.629 131.435 OK 95.7449 7607 168.517 5798.47 OK TCONS_00000359 48.6021 599 50.3741 480.519 OK 75.5404 455 120.391 317.494 OK 533.305 57416.1 519.422 32297.8 OK TCONS_00000360 25.0342 322 37.2268 247.508 OK 202.344 1077 205.49 850.446 OK 393.801 25875 486.991 23849.2 OK TCONS_00000361 7.30215 12 0.700594 11.2865 OK 32.4763 35 2.12092 32.7463 OK 9.71379 52 2.57172 38.5082 OK TCONS_00000362 3.05482 5 0.700594 4.72165 OK 6.37886 8 1.38817 6.43189 OK 2.46991 19 1.77188 9.79143 OK TCONS_00000363 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000364 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000365 0 0 0 0 OK 0.53115 1 0.0493654 0.535565 OK 0.594944 3 0 2.35852 OK TCONS_00000366 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000367 306.218 5761.87 0 5761.87 OK 1118.9 8437.14 0 8437.14 OK 4236.07 795691 0 795691 OK TCONS_00000368 9.89142e-06 1 1.59161e-05 9.89142e-06 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000369 0.521874 1 1.59161e-05 0.521874 OK 0 0 0 0 OK 2.68094 4 0 3.30449 OK TCONS_00000370 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000371 0 0 0 0 OK 1.00006 7 0 6.30426 OK 0 0 0 0 OK TCONS_00000372 95.8687 3814 126.908 3378.02 OK 51.2132 482 75.4581 385.134 OK 33.6018 8706 53.2527 3014.74 OK TCONS_00000373 639.043 23350 393.075 22517.3 OK 662.899 5300 293.2 4985.15 OK 1407.62 131779 628.988 126291 OK TCONS_00000374 215.348 8897 319.476 7587.98 OK 147.689 1717.29 240.079 1110.65 OK 384.658 40748 593.884 34511.3 OK TCONS_00000375 7.60925 1462 6.16659 268.119 OK 5.3232 65 4.59245 40.0316 OK 4.9999 11000 4.66992 448.589 OK TCONS_00000376 24.2865 864 20.7964 702.504 OK 2.62711 64 2.22785 17.4637 OK 1.00984 58 0.827306 57.6263 OK TCONS_00000377 287.095 8951 51.9109 8304.44 OK 451.441 3046 41.1225 3000.95 OK 419.443 25646 39.5501 23935.5 OK TCONS_00000378 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000379 370.698 11346 31.1146 10722.7 OK 460.458 3119 38.8947 3060.9 OK 538.827 32040 38.7227 30748.2 OK TCONS_00000380 270.287 4675.89 0 4675.89 OK 839.998 5295.8 0 5295.8 OK 527.272 21076 0 21076 OK TCONS_00000381 591.643 16261 0 16261 OK 3276.8 47768.8 0 47768.8 OK 7970.37 2.91049e+06 0 2.91049e+06 OK TCONS_00000382 7.65209 12 2.02641 9.29398 OK 26.5667 27 0.00185466 26.5667 OK 23.2402 151 8.32475 123.616 OK TCONS_00000383 1.34009 4.07874 2.02641 1.62764 OK 0.000948845 1 0.00185466 0.000948845 OK 6.23544 74 8.32475 33.1666 OK TCONS_00000384 6.42293 7.18464 0 7.18464 OK 44.9207 44.9207 0 44.9207 OK 0 0 0 0 OK TCONS_00000385 24.5385 1424 44.9178 876.804 OK 101.2 3175.38 184.561 1441.45 OK 206.746 416040 377.378 70332.3 OK TCONS_00000386 741.443 27778 427.452 26493.1 OK 2779.16 40240 622.121 39585.2 OK 5521.91 2.24615e+06 1582.79 1.87849e+06 OK TCONS_00000387 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000388 30.7946 2721.11 31.577 1100.35 OK 33.7213 649 44.3182 480.312 OK 13.2662 138973 17.8651 4513.01 OK TCONS_00000389 276.553 10364 382.928 9881.71 OK 238.017 3850 428.177 3390.22 OK 747.571 349323 1279.22 254314 OK TCONS_00000390 725.589 25339 292.217 24839 OK 3106.71 132571 2203.67 58803.4 OK 3057.18 809868 2140.79 697239 OK TCONS_00000391 194.986 7262.63 292.217 6674.92 OK 1758.36 132209 2203.67 33282.1 OK 1701.49 417033 2140.79 388052 OK TCONS_00000392 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000393 1.59257 975 1.58485 31.5091 OK 18.5774 83 20.6585 57.3483 OK 0 0 0 0 OK TCONS_00000394 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000395 0 0 0 0 OK 22.7434 103 27.0151 70.2088 OK 0 0 0 0 OK TCONS_00000396 2.65242 573 1.83447 52.4783 OK 24.2746 112 28.7596 74.9355 OK 0.594944 48 0 47.249 OK TCONS_00000397 5.84526 501 5.92521 115.649 OK 10.9416 63 13.786 33.7768 OK 0 0 0 0 OK TCONS_00000398 0.472119 10 0.679166 9.34089 OK 3.99187 24 4.66265 12.3229 OK 0 0 0 0 OK TCONS_00000399 0 0 0 0 OK 2.85685 33 3.61188 8.81909 OK 0 0 0 0 OK TCONS_00000400 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000401 10.2113 413 5.92521 202.032 OK 108.494 350 13.786 334.921 OK 3.03643 242 0 241.146 OK TCONS_00000402 22.3971 2205 42.8368 983.836 OK 0 0 0 0 OK 150.583 728851 291.116 127014 OK TCONS_00000403 573.342 27463.3 718.467 25185.2 OK 1933.31 38714 2217.62 36338.9 OK 5448.72 6.55079e+06 6542.85 4.59591e+06 OK TCONS_00000404 594.196 43052.6 735.996 26101.2 OK 2082.16 65319.8 2270.95 39136.7 OK 5322.26 7.82623e+06 6524.21 4.48924e+06 OK TCONS_00000405 502.377 45955.7 664.163 22067.9 OK 944.839 57768.8 1422.63 17759.4 OK 4478.43 4.27242e+06 5848.06 3.77748e+06 OK TCONS_00000406 0 0 0 0 OK 0 0 0 0 OK 217.186 69840 408.889 57015.4 OK TCONS_00000407 213.793 5806 215.562 5135.77 OK 1049.83 7819 57.7335 7743.73 OK 5562.06 1.51114e+06 680.356 1.46014e+06 OK TCONS_00000408 0 0 0 0 OK 32.2826 380 57.7335 238.121 OK 157.433 70264 291.611 41329 OK TCONS_00000409 227.271 5774 215.562 5459.53 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000410 7.78452 43 2.54338 27.7281 OK 29.111 44 11.898 30.9641 OK 2.56764 4 0.281855 3.69546 OK TCONS_00000411 1.79988 4 0.364442 3.60486 OK 5.31328 37 7.96033 15.9569 OK 0 0 0 0 OK TCONS_00000412 0.00070924 1 0.00138112 0.00142049 OK 9.79421 47 11.6171 29.414 OK 0 0 0 0 OK TCONS_00000413 0 0 0 0 OK 3.8209 30 6.36185 11.4749 OK 13.7851 87 8.23904 66.5462 OK TCONS_00000414 0 0 0 0 OK 8.86246 47 9.38673 26.6157 OK 3.25371 16 0.755642 15.707 OK TCONS_00000415 1.61867 19 1.76115 3.24193 OK 6.28606 47 8.6935 18.8783 OK 2.06012 37 1.77542 9.94506 OK TCONS_00000416 0 0 0 0 OK 0.0144016 1 0.0286273 0.0432509 OK 0 0 0 0 OK TCONS_00000417 7.20195 21 3.16445 14.4243 OK 150.449 539 77.6855 451.828 OK 5.91643 55 6.27131 28.561 OK TCONS_00000418 1.42211 4 1.94858 2.84825 OK 65.927 277 73.7656 197.992 OK 0.975769 5 1.83285 4.71044 OK TCONS_00000419 1.42205 1490 1.82542 28.0482 OK 7.79711 334 8.47253 130.214 OK 0 0 0 0 OK TCONS_00000420 73.3883 1598 92.2149 1447.49 OK 2962.13 65723.8 1088.33 49468.3 OK 551.431 34898.4 231.975 27859.4 OK TCONS_00000421 47.9224 1188 43.5204 945.211 OK 79.2235 3561.68 130.3 1323.05 OK 7.99399 3517 12.673 403.873 OK TCONS_00000422 161.762 3417 76.8116 3190.56 OK 637.685 22418.4 835.27 10649.5 OK 88.2041 11982.3 135.617 4456.25 OK TCONS_00000423 14.7839 425 16.8329 291.595 OK 149.569 2871 204.325 2497.84 OK 95.9739 5196 119.715 4848.8 OK TCONS_00000424 4.23664 33 4.45887 12.6453 OK 5.91357 11 4.17494 5.91357 OK 0 0 0 0 OK TCONS_00000425 5.26799 32 6.5225 15.7236 OK 0.745322 3 1.35831 0.745322 OK 0 0 0 0 OK TCONS_00000426 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000427 6.99478 37 6.73337 20.8776 OK 0.000155301 1 0.000295258 0.000155301 OK 1.17908e-05 1 1.97244e-05 1.17908e-05 OK TCONS_00000428 0 0 0 0 OK 4.78545 9 4.14697 4.78545 OK 0.834388 1 1.97244e-05 0.834388 OK TCONS_00000429 10.7182 21.9841 0 21.9841 OK 40.8185 42.6001 0 42.6001 OK 0.8344 0.8344 0 0.8344 OK TCONS_00000430 0 0 0 0 OK 2.03431 5 2.12664 2.03431 OK 0 0 0 0 OK TCONS_00000431 3.53267 4 0 3.53267 OK 6.94576 10 2.12664 6.94576 OK 0 0 0 0 OK TCONS_00000432 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TCONS_00000433 83.5249 2311 119.125 1972.11 OK 208.227 3162 318.464 2786.33 OK 29.9464 11157 52.4852 3008.48 OK TCONS_00000434 51.1217 1793 80.8034 1207.04 OK 295.164 4528.01 482.282 3949.64 OK 70.4127 10510 129.527 7073.81 OK TCONS_00000435 0 0 0 0 OK 0 0 0 0 OK 731.713 81110 881.197 73509.5 OK TCONS_00000436 267.146 6620 190.95 6307.61 OK 2079.15 28762 922.097 27821.5 OK 123.746 20881 231.089 12431.8 OK TCONS_00000437 0 0 0 0 OK 5.43689 270 8.83299 72.7521 OK 8.33178 14131 13.995 837.028 OK TCONS_00000438 45.361 1776 58.1454 1071.02 OK 120.908 1871 184.862 1617.89 OK 0 0 0 0 OK TCONS_00000439 0 0 0 0 OK 18.5316 425 33.8043 247.975 OK 0 0 0 0 OK TCONS_00000440 0 0 0 0 OK 0 0 0 0 OK 1153.45 120984 928.304 115878 OK TCONS_00000441 2.6521 1345 4.22222 62.6189 OK 16.5597 439 30.8508 221.589 OK 0 0 0 0 OK TCONS_00000442 10.9447 590 6.49151 258.416 OK 98.9274 1423 86.3128 1323.77 OK 26.1736 10787 27.4182 2629.45 OK TCONS_00000443 6.66397 8.52878 0 8.52878 OK 30.5271 30.5271 0 30.5271 OK 10.0054 23.5232 0 23.5232 OK TCONS_00000444 42.5442 215 2.69788 208.919 OK 748.514 6166.83 6.72838 4465.76 OK 0 0 0 0 OK TCONS_00000445 1.93503 69 2.69788 9.50224 OK 5.88741 2801 6.72838 35.1253 OK 0 0 0 0 OK TCONS_00000446 0.521883 3 0 2.56278 OK 17.9499 108 0 107.092 OK 0 0 0 0 OK TCONS_00000447 211.555 3434 0 3433.85 OK 1087.97 8475.12 66.977 8281.11 OK 0 0 0 0 OK TCONS_00000448 0 0 0 0 OK 34.9264 986.769 66.977 265.842 OK 2.5032 4 0 3.63915 OK TCONS_00000449 4.39184e-05 1 8.17452e-05 4.39184e-05 OK 0.000157973 1 0.000298989 0.000157973 OK 0 0 0 0 OK TCONS_00000450 5.6546e-05 1 0.000105546 5.6546e-05 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000451 1.44503 2 0.000187273 1.44503 OK 6.05116 7 0.000298989 6.05116 OK 0 0 0 0 OK TCONS_00000452 669.417 19138.8 0 19138.8 OK 2143.61 24185.8 0 24185.8 OK 2976.89 411506 0 411506 OK TCONS_00000453 49.8382 1050.02 56.5349 532.735 OK 395.218 2235 224.826 1986.43 OK 495.431 26923 378.514 25744.1 OK TCONS_00000454 4.13961 199 6.93376 44.2495 OK 0.0483646 1 0.0963799 0.243089 OK 31.5149 2955 58.0915 1637.61 OK TCONS_00000455 24.2455 697.354 32.7329 259.168 OK 62.9036 429 92.3298 316.164 OK 122.184 8300 169.845 6349.07 OK TCONS_00000456 0 0 0 0 OK 24.8246 198 36.5818 124.773 OK 20.8081 3104 37.4649 1081.25 OK TCONS_00000457 51.7224 702 53.7021 552.876 OK 103.265 692 153.709 519.029 OK 186.38 12303.8 266.873 9684.85 OK TCONS_00000458 2.87275 1823 4.6397 80.9955 OK 38.7276 490 53.5647 416.834 OK 166.521 2.29308e+06 254.164 249965 OK TCONS_00000459 245.478 7674 4.6397 6921.11 OK 1586.74 17250 119.774 17078.5 OK 3513.78 6.75658e+06 503.659 5.27456e+06 OK TCONS_00000460 0 0 0 0 OK 319.339 3601 126.483 3437.12 OK 14192.4 2.25244e+07 5004.23 2.13044e+07 OK TCONS_00000461 0 0 0 0 OK 3.27781 238 5.51527 35.2799 OK 5.7005 3.82011e+06 10.5607 8557.06 OK TCONS_00000462 0 0 0 0 OK 0 0 0 0 OK 50.341 2.4143e+06 91.3682 75567.3 OK TCONS_00000463 352.266 9932 0 9931.95 OK 33.1976 512 52.0189 357.313 OK 2989.71 4.51069e+06 4659.94 4.48788e+06 OK TCONS_00000464 2.52907 2.52907 0 2.52907 OK 42.941 42.941 0 42.941 OK 0 0 0 0 OK TCONS_00000465 387.508 8290.68 0 8290.68 OK 1065.12 7793.15 0 7793.15 OK 477.077 17737.6 0 17737.6 OK TCONS_00000466 6.98608e-05 1 0.000128528 6.98608e-05 OK 0 0 0 0 OK 4.79918 1135 4.76989 137.966 OK TCONS_00000467 0.481641 1 0.000128528 0.481641 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000468 0 0 0 0 OK 1.51538 2 0 1.51538 OK 218.008 6388 4.76989 6267.29 OK TCONS_00000469 0 0 0 0 OK 0.989851 0.989851 0 0.989851 OK 0 0 0 0 OK TCONS_00000470 14.2508 30.939 0 30.939 OK 53.4059 56.7037 0 56.7037 OK 1.18989 1.18989 0 1.18989 OK TCONS_00000471 2.69618 4 0.975768 2.69618 OK 45.0559 83 23.9368 57.2746 OK 0 0 0 0 OK TCONS_00000472 2.32172 4 0.975847 2.32172 OK 28.7743 64 25.8475 36.5777 OK 0.00285822 1 0.00563405 0.0037126 OK TCONS_00000473 6.57819e-05 1 0.000120836 6.57819e-05 OK 0 0 0 0 OK 2.08314 3 0.00563405 2.70584 OK TCONS_00000474 0 0 0 0 OK 3.15343 7 2.88194 4.00861 OK 0 0 0 0 OK TCONS_00000475 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000476 1.96702 1.96702 0 1.96702 OK 103.623 163.729 0 163.729 OK 3.21417 4.18493 0 4.18493 OK TCONS_00000477 71.9411 561 5.35869 525.99 OK 110.565 203 7.901 194.041 OK 152.599 2838 0 2837.72 OK TCONS_00000478 0 0 0 0 OK 1.53471 386 2.05559 2.6934 OK 0 0 0 0 OK TCONS_00000479 4.3723 73 5.35869 31.9676 OK 4.12553 22 5.98771 7.24028 OK 0 0 0 0 OK TCONS_00000480 655.455 19724.7 0 19642.6 OK 864.816 6535 267.022 6254.33 OK 4717.66 1.30252e+06 1530.6 1.23673e+06 OK TCONS_00000481 0 0 0 0 OK 180.989 1648 267.022 1308.91 OK 1052.67 345126 1530.6 275956 OK TCONS_00000482 2.04741 48 0 47.0509 OK 18.0315 248 0 247.92 OK 6.43574 12183 0 12182.3 OK TCONS_00000483 0 0 0 0 OK 6.44423 6.44423 0 6.44423 OK 5.89881 12.4355 0 12.4355 OK TCONS_00000484 16.8687 300 28.3012 190.924 OK 11.9448 75 22.2295 34.584 OK 154.535 18362 279.531 14633.5 OK TCONS_00000485 117.298 1446 36.8519 1327.6 OK 164.072 578 97.8942 475.041 OK 1517.1 166503 483.911 143660 OK TCONS_00000486 0 0 0 0 OK 6.88497 42 10.2783 19.9342 OK 48.7025 9502 84.7565 4611.83 OK TCONS_00000487 6.8086 179 11.9297 77.0612 OK 61.5295 274 85.2242 178.148 OK 99.7204 18722 184.22 9442.92 OK TCONS_00000488 877.454 29525 121.164 29396.1 OK 12239.9 439270 1229.61 421422 OK 117.176 3051 33.7966 2679.79 OK TCONS_00000489 13.895 1375 25.3858 465.504 OK 101.623 7743.86 191.734 3498.92 OK 0 0 0 0 OK TCONS_00000490 43.7493 4440.36 79.8431 1465.67 OK 313.921 12259 599.249 10808.4 OK 4.4726 990 8.63072 102.288 OK TCONS_00000491 12.4734 1416 23.2484 417.879 OK 274.274 11036 505.768 9443.32 OK 0 0 0 0 OK TCONS_00000492 0 0 0 0 OK 0 0 0 0 OK 15.8279 607 27.2263 361.982 OK TCONS_00000493 17.1811 936 11.663 515.022 OK 90.1891 3897 66.8818 3244.94 OK 53.6278 1.00873e+08 46.0022 530227 OK TCONS_00000494 3.95144 1216 3.06353 118.449 OK 9.4136 1461 7.20227 338.695 OK 113.553 9.98063e+07 135.897 1.12271e+06 OK TCONS_00000495 0.481711 1 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000496 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000497 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000498 10.417 229 16.7251 143.293 OK 3.95315 59 6.84927 15.5263 OK 4.93896 1817 8.10924 163.227 OK TCONS_00000499 166.217 2478 16.7251 2286.42 OK 388.006 1537 6.84927 1523.92 OK 383.719 12719 8.10924 12681.4 OK TCONS_00000500 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000501 7.19384 3462 2.48174 408.154 OK 13.5789 223 9.69836 199.939 OK 80.1788 850762 45.2467 73479.8 OK TCONS_00000502 296.92 22907.7 494.435 16846.2 OK 167.019 2977 283.368 2459.23 OK 1214.75 1.68483e+06 2025.99 1.11325e+06 OK TCONS_00000503 199.848 67447.4 367.856 11338.7 OK 19.0953 525 37.6807 281.163 OK 0 0 0 0 OK TCONS_00000504 2371.9 206370 827.201 134573 OK 3098.24 46042 369.478 45619.2 OK 14975.7 1.42649e+07 2216.05 1.37244e+07 OK TCONS_00000505 9.92793 4378 18.5638 563.277 OK 8.93801 287 16.6275 131.605 OK 0 0 0 0 OK TCONS_00000506 35.249 3477 62.5055 1999.91 OK 20.2053 508 36.2289 297.508 OK 102.405 867901 180.986 93849.3 OK TCONS_00000507 7.1354 591 13.0245 143.746 OK 54.047 797 100.059 591.212 OK 54.0678 6488 99.5618 4242.26 OK TCONS_00000508 286.069 6087.5 67.1459 5763.02 OK 1054.54 12517 860.79 11535.5 OK 1499.47 121792 210.182 117651 OK TCONS_00000509 19.6237 1361.39 35.7949 395.33 OK 668.267 8251 825.759 7310.08 OK 50.576 6533 96.6913 3968.29 OK TCONS_00000510 34.4161 816 23.6678 693.331 OK 49.6281 593 40.7835 542.875 OK 21.0118 6709 23.0907 1648.63 OK TCONS_00000511 21.127 71 2.63334 66.4835 OK 123.554 382 36.1644 338.542 OK 0 0 0 0 OK TCONS_00000512 5.40797 26 2.63334 17.0181 OK 87.2892 282 36.1644 239.176 OK 0 0 0 0 OK TCONS_00000513 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000514 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000515 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000516 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000517 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000518 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000519 0.0224444 1 0.044667 0.215563 OK 331.171 3503 484.135 2930.62 OK 245.167 116186 451.082 58562.4 OK TCONS_00000520 0 0 0 0 OK 186.847 2003 315.662 1653.46 OK 320.731 115533 573.988 76612.1 OK TCONS_00000521 112.782 1084 0.044667 1083.19 OK 920.401 10206.5 641.459 8144.88 OK 3217.28 848092 945.47 768504 OK TCONS_00000522 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000523 2.44873 2.44873 0 2.44873 OK 29.0321 29.0321 0 29.0321 OK 53.8757 479.607 0 479.607 OK TCONS_00000524 2439.11 142011 933.705 140923 OK 9510.49 323123 3830.95 318730 OK 4313.73 1.11029e+06 2031.9 1.1035e+06 OK TCONS_00000525 674.388 53419.6 933.705 38963.5 OK 2844.89 109776 3830.95 95342.2 OK 1505.56 393547 2031.9 385139 OK TCONS_00000526 1.99401 263 1.13364 26.603 OK 1.94154 4 1.84071 2.91511 OK 43.4993 5525 21.1656 3219.96 OK TCONS_00000527 9.69364 178 3.78359 129.328 OK 12.5341 21 1.84071 18.8192 OK 62.0897 5496 32.4515 4596.08 OK TCONS_00000528 6.34259 31 0 30.0098 OK 2.0001 10 0 9.28648 OK 0 0 0 0 OK TCONS_00000529 4.33935e-05 1 7.8269e-05 4.33935e-05 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000530 0.52184 1 7.8269e-05 0.52184 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000531 1217 115613 1997.96 106332 OK 2977.04 199934 5259.31 192996 OK 20415.5 1.28013e+08 21205.9 8.04939e+07 OK TCONS_00000532 128.01 15766 245.854 11184.5 OK 706.47 51374 1350.02 45799.1 OK 3128.36 2.38954e+07 5681.58 1.23345e+07 OK TCONS_00000533 6390.33 560661 2190.21 558336 OK 28920.8 1.89206e+06 6461.1 1.87488e+06 OK 19695.1 7.77334e+07 21184.4 7.76534e+07 OK TCONS_00000534 168.642 15148 34.587 14734.6 OK 366.651 24985 123.51 23769.3 OK 132.842 1.5607e+07 37.1591 523766 OK TCONS_00000535 1488.11 63123.9 8.82559 61311.6 OK 2660.48 35024 69.0652 34815.6 OK 5063.6 1.15113e+06 95.2926 1.1353e+06 OK TCONS_00000536 614.881 17689.5 43.4786 17197 OK 1758.73 18322 153.91 18144.1 OK 1951.16 194744 288.35 188718 OK TCONS_00000537 24.6487 860 43.4786 689.376 OK 85.5536 1164 153.91 882.624 OK 165.613 19095 288.35 16018.3 OK TCONS_00000538 37.8324 1694 69.1408 1049.86 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000539 68.7804 2422 106.931 1908.68 OK 603.177 11210 845.042 10112.7 OK 185.236 19355 283.071 14734.6 OK TCONS_00000540 434.856 13038.4 251.316 12067.4 OK 1131.7 20676 1610.91 18973.8 OK 305.452 25622 476.198 24297.2 OK TCONS_00000541 88.2262 3243 148.028 2448.31 OK 2384.1 42107 1896.75 39971.3 OK 973.222 83324.7 617.413 77414.8 OK TCONS_00000542 1876.88 85755.8 0 85755.8 OK 2408.87 29578 0 29578 OK 3447.05 514118 0 514118 OK TCONS_00000543 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00000544 12.6475 55 10.8264 34.8156 OK 68.5467 81.0564 0.00553655 80.9083 OK 0 0 0 0 OK TCONS_00000545 9.75094 46 10.826 26.8421 OK 0.00280556 1 0.00553655 0.00331151 OK 7.91867e-05 1 0.00014651 7.91867e-05 OK TCONS_00000546 0.00170504 1 0.00335251 0.00469359 OK 0 0 0 0 OK 1.42926 2 0.00014651 1.42926 OK TCONS_00000547 3.88714 1858 3.55284 139.399 OK 0.987408 5 0.960639 4.96317 OK 3.17857 186949 3.01535 1076.9 OK TCONS_00000548 65.4005 2637 79.8249 2345.37 OK 91.0684 564 89.8921 457.752 OK 241.408 115676 313.582 81789.1 OK TCONS_00000549 736.76 27595 80.0852 26421.4 OK 451.667 2413 122.51 2270.29 OK 6277.36 2.67154e+06 805.337 2.12678e+06 OK TCONS_00000550 0 0 0 0 OK 22.9224 196.384 41.9406 115.219 OK 277.032 595521 516.645 93858.7 OK TCONS_00000551 23.3778 1269 4.13499 838.364 OK 15.3595 86 3.3618 77.2042 OK 16.8108 119205 5.88657 5695.52 OK TCONS_00000552 204.779 3365 36.6038 3151.38 OK 182.052 499 31.6392 465.881 OK 284.362 11158 199.193 10649.8 OK TCONS_00000553 10.5827 300 19.9646 162.859 OK 0 0 0 0 OK 81.2758 13702.6 129.314 3043.9 OK TCONS_00000554 7.09152 336 12.5807 109.133 OK 13.6769 64 21.2344 35 OK 48.0574 15174.9 77.8781 1799.82 OK TCONS_00000555 0 0 0 0 OK 4.91514 43 8.54669 12.5781 OK 43.0306 6884.41 75.8642 1611.56 OK TCONS_00000556 4.03785 432 6.83119 62.1393 OK 2.57014 32 4.06706 6.57711 OK 6.95862 2120 12.7958 260.61 OK TCONS_00000557 2.04736 2.04736 0 2.04736 OK 9.49539 9.49539 0 9.49539 OK 0.4172 0.4172 0 0.4172 OK TCONS_00000558 1268.69 56803.8 468.959 55343.4 OK 3227.94 67640 1971.74 65441.1 OK 2554.33 592924 2263.07 545478 OK TCONS_00000559 0.0310473 2 0.0618451 1.35436 OK 0 0 0 0 OK 1875.65 411086 2227.62 400547 OK TCONS_00000560 38.2085 2029 67.5398 1666.75 OK 111.353 12443.1 205.555 2257.49 OK 54.2757 48279 94.0161 11590.6 OK TCONS_00000561 335.29 15382 435.389 14626.2 OK 2179.26 54832.9 2007.46 44181 OK 330.48 242908 578.079 70574 OK TCONS_00000562 45.6995 4062 65.4115 1993.52 OK 92.7543 2129 134.258 1880.44 OK 78.8765 47235 126.89 16844.1 OK TCONS_00003803 0.0119528 1 0.0237713 0.341677 OK 244.191 2029 141.77 1867.23 OK 317.7 21250 177.722 20763.8 OK TCONS_00003804 18.7048 942 34.5072 534.686 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003805 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003806 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003807 70.4255 2543 95.9646 2013.15 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003808 6.73244 1150 10.0994 192.451 OK 2.99913 124 4.96526 22.9332 OK 10.449 5630 18.2019 682.914 OK TCONS_00003809 39.057 1769 63.471 1116.47 OK 173.468 2356.6 261.875 1326.44 OK 237.778 25703.9 328.838 15540.4 OK TCONS_00003810 26.8355 835 21.7544 767.108 OK 22.6382 241 21.4158 173.105 OK 27.2621 4544 30.1121 1781.76 OK TCONS_00003811 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003812 48.2073 1786.15 71.2759 1378.03 OK 42.3192 457 71.4629 323.599 OK 124.228 8534 75.5071 8119.11 OK TCONS_00003813 103.271 3308 106.972 2952.06 OK 182.432 1612 174.563 1394.99 OK 0 0 0 0 OK TCONS_00003814 1.67608 2678 2.27375 47.9118 OK 2.77638 130 4.45191 21.2299 OK 0 0 0 0 OK TCONS_00003815 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003816 4.81346 1297 7.02786 137.595 OK 5.39892 85 9.17974 41.2834 OK 0 0 0 0 OK TCONS_00003817 0 0 0 0 OK 35.1933 402 62.7913 269.11 OK 0.0364137 3 0.0725517 2.37988 OK TCONS_00003818 37.1139 1737 47.9138 1060.92 OK 126.532 1185 144.028 967.538 OK 110.291 8670 125.986 7208.23 OK TCONS_00003819 277.165 8852 135.713 7922.91 OK 141.109 1266 131.171 1079 OK 92.2326 8667 86.9419 6028.01 OK TCONS_00003820 6.74299 1202 11.4654 192.752 OK 39.4637 627.194 68.8976 301.764 OK 13.5322 5392 25.6152 884.418 OK TCONS_00003821 14.7317 983 26.8566 421.114 OK 108.803 1040 152.951 831.972 OK 165.072 12962 187.865 10788.5 OK TCONS_00003822 0 0 0 0 OK 18.232 181 17.0531 139.413 OK 24.6818 4543 24.6654 1613.12 OK TCONS_00003823 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003824 5.41934 5.76632 0 5.76632 OK 16.9193 16.9193 0 16.9193 OK 3.56966 6.52646 0 6.52646 OK TCONS_00003825 11.6418 157 0 156.388 OK 5.74775 36 0 35.6669 OK 25.5311 198 0 197.604 OK TCONS_00003826 171.761 2308 0 2307.33 OK 816.411 5067 0 5066.14 OK 20.6384 160 0 159.736 OK TCONS_00003827 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003828 26.7025 4090.81 47.0508 676.165 OK 81.7376 1216 143.304 1042.07 OK 5.64933 1085 10.4148 145.558 OK TCONS_00003829 274.378 14416 208.955 6947.83 OK 1307.41 17773 974.82 16668.1 OK 141.699 3959 101.389 3650.95 OK TCONS_00003830 185.299 6865.13 206.782 4692.18 OK 946.303 13208.9 1013.62 12064.4 OK 91.643 3975.16 106.435 2361.23 OK TCONS_00003831 0 0 0 0 OK 5.68056 73 0 72.4215 OK 0.198315 6 0 5.10967 OK TCONS_00003832 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003833 0 0 0 0 OK 5.68056 73 0 72.4215 OK 0.198315 6 0 5.10967 OK TCONS_00003834 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003835 35.6549 1258 9.35437 902.859 OK 276.692 3670 69.1792 3527.54 OK 18.9922 665 7.86109 489.343 OK TCONS_00003836 116.658 1146.43 0 1146.43 OK 284.696 913.288 0 913.288 OK 49.0071 397.41 0 397.41 OK TCONS_00003837 13.6891 25.3656 0 25.3656 OK 23.5573 23.5573 0 23.5573 OK 38.77 258.572 0 258.572 OK TCONS_00003838 10.9592 15.7953 0 15.7953 OK 3.50528 3.50528 0 3.50528 OK 9.64992 23.8695 0 23.8695 OK TCONS_00003839 0 0 0 0 OK 0 0 0 0 OK 2.02429 3 0 2.02429 OK TCONS_00003840 0 0 0 0 OK 1.01025 2 0 1.01025 OK 0 0 0 0 OK TCONS_00003841 61.1304 3045 62.0216 1918.3 OK 439.671 9237 471.445 8430.88 OK 197.537 598911 213.801 49140.9 OK TCONS_00003842 355.958 11817 331.237 11170.1 OK 1526.78 31758 2058.37 29276.7 OK 1460.3 372265 2021.92 363275 OK TCONS_00003843 279.201 9954 322.689 8761.44 OK 3059.77 61165 2233.39 58672.4 OK 3283.7 1.26637e+06 2129.72 816879 OK TCONS_00003844 13.0069 1043 8.11551 408.162 OK 74.0776 1807 35.1224 1420.47 OK 44.5354 64021 38.4814 11079 OK TCONS_00003845 4.05455 5 0 4.05455 OK 16.3542 18 1.11094 16.3542 OK 32.0095 215 3.64119 206.029 OK TCONS_00003846 0 0 0 0 OK 1.58548 8.38045 1.11094 1.58548 OK 5.26949 52.3509 3.64119 33.917 OK TCONS_00003847 17.4227 48 0 47.7638 OK 21.0963 33 11.8526 21.0963 OK 19.3507 143 4.51561 110.47 OK TCONS_00003848 0 0 0 0 OK 11.2982 24 11.8526 11.2982 OK 2.99294 61 4.51561 17.0862 OK TCONS_00003849 0 0 0 0 OK 0 0 0 0 OK 8.74922 1342 16.0029 272.681 OK TCONS_00003850 6.47819 147.234 11.5789 49.4399 OK 35.902 210 63.0145 136.201 OK 30.6583 4510.59 54.8463 955.503 OK TCONS_00003851 0.00128044 1 0.00251115 0.00977196 OK 19.6848 143 36.6188 74.6781 OK 71.113 7401.9 106.564 2216.33 OK TCONS_00003852 17.1649 228.091 22.9721 130.998 OK 40.1381 223 53.4299 152.271 OK 0 0 0 0 OK TCONS_00003853 37.5935 346 31.9692 286.904 OK 174.888 831 157.228 663.471 OK 91.5594 7564.45 127.029 2853.56 OK TCONS_00003854 0 0 0 0 OK 8.78436 76 14.0876 33.3251 OK 8.01562 1358 13.9195 249.817 OK TCONS_00003855 0 0 0 0 OK 65.9118 361 97.0383 250.048 OK 70.7654 3044 101.953 2205.49 OK TCONS_00003856 19.6515 189 25.8348 149.975 OK 18.2807 117 30.2768 69.3512 OK 42.9597 2035 51.8773 1338.89 OK TCONS_00003857 0 0 0 0 OK 0 0 0 0 OK 34.7548 2159 61.0125 1083.18 OK TCONS_00003858 0.481711 1 0 0.481711 OK 21.4756 24 0 23.1974 OK 0 0 0 0 OK TCONS_00003859 0.766692 2 0.258727 0.766692 OK 9.70144 20 10.1912 9.70144 OK 0 0 0 0 OK TCONS_00003860 0.717547 1 0.260061 0.717547 OK 0 0 0 0 OK 12.2606 38 0.00224839 37.7104 OK TCONS_00003861 0.00106706 1 0.00208632 0.00106706 OK 26.7954 37 10.1912 26.7954 OK 0.00114782 1 0.00224839 0.00353038 OK TCONS_00003862 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003863 0.481711 1 0 0.481711 OK 0 0 0 0 OK 4.46577 7 0 6.06008 OK TCONS_00003864 0 0 0 0 OK 1.9899 2 0 1.9899 OK 0 0 0 0 OK TCONS_00003865 84.2784 2758 39.6271 2570.44 OK 378.524 5879 168.939 5693.71 OK 207.578 625615 108.281 163878 OK TCONS_00003866 631.105 19896 92.4222 19248.3 OK 2887.83 43798 284.584 43438.5 OK 13253.9 1.05842e+07 1706.16 1.04637e+07 OK TCONS_00003867 32.0919 2074 53.589 978.784 OK 37.31 746 64.7122 561.212 OK 907.941 1.25171e+06 1486.83 716801 OK TCONS_00003868 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003869 0 0 0 0 OK 12.1749 271 21.329 183.133 OK 83.3087 650462 156.036 65770.6 OK TCONS_00003870 7.91371 970 2.49209 241.364 OK 132.463 2164 41.7812 1992.5 OK 56.8912 636081 35.37 44914.5 OK TCONS_00003871 6.06174 6.24262 0 6.24262 OK 38.3949 38.3949 0 38.3949 OK 55.9469 575.399 0 575.399 OK TCONS_00003872 14.6397 629 21.6114 342.756 OK 34.5496 423 52.9287 341.378 OK 50.0534 29623 81.1062 8374.85 OK TCONS_00003873 20.0883 613 34.4412 470.324 OK 64.8358 850 108.254 640.63 OK 86.3988 28904 144.962 14456.1 OK TCONS_00003874 4.76405 899 7.51825 111.54 OK 0 0 0 0 OK 4.92422 50376 8.99885 823.913 OK TCONS_00003875 359.413 9738.81 98.3536 8414.88 OK 1313.64 16637.2 393.475 12979.9 OK 2970.02 501865 894.15 496939 OK TCONS_00003876 23.2303 1594.4 33.7941 543.886 OK 88.1474 5249.79 143.274 870.968 OK 143.984 37459.5 243.928 24091.2 OK TCONS_00003877 0 0 0 0 OK 38.1021 1023.76 62.5765 376.48 OK 142.889 28482 241.046 23908 OK TCONS_00003878 9.20877 699 14.0293 215.603 OK 49.8971 640 83.6395 493.024 OK 180.927 57194 303.064 30272.4 OK TCONS_00003879 23.8452 559 0 558.284 OK 131.895 1304 0 1303.23 OK 58.6426 9812 0 9811.98 OK TCONS_00003880 11.7405 1652 19.7426 426.472 OK 451.343 12037 554.072 11302.4 OK 264.838 193219 429.901 115841 OK TCONS_00003881 54.9376 2713 58.686 1995.6 OK 623.646 16250 571.23 15617.2 OK 385.917 192054 457.546 168801 OK TCONS_00003882 137.959 5235 77.4115 5011.34 OK 692.77 18254 757.473 17348.2 OK 2501.42 1.14647e+06 917.832 1.09413e+06 OK TCONS_00003883 19.0877 1378 13.6472 693.358 OK 220.966 6180 121.707 5533.39 OK 199.748 192319 150.343 87370.2 OK TCONS_00003884 88.9312 3981 68.884 3230.41 OK 270.968 7514 235.285 6785.53 OK 279.235 192075 243.771 122138 OK TCONS_00003885 477.703 18179 186.544 17352.4 OK 3328.87 84906 1202.82 83360.9 OK 3961.88 1.9102e+06 1022.6 1.73294e+06 OK TCONS_00003886 15.6588 1520 22.8703 568.801 OK 107.71 3257 164.271 2697.26 OK 34.1722 208195 52.9503 14947 OK TCONS_00003887 11.28 1645 17.9167 409.742 OK 93.6246 2619 158.688 2344.53 OK 46.4599 203616 72.0591 20321.7 OK TCONS_00003888 0 0 0 0 OK 37.4683 1423.04 66.2173 938.275 OK 5.1596 331911 9.11692 2256.82 OK TCONS_00003889 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003890 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003891 16.4885 1472 20.2827 598.943 OK 184.781 5135 260.357 4627.25 OK 111.151 195831 160.418 48617.9 OK TCONS_00003892 22.0194 1498 40.9888 799.851 OK 8.57915 876 16.3113 214.838 OK 5.95113 320984 11.2891 2603.04 OK TCONS_00003893 0 0 0 0 OK 99.8923 3323 178.912 2501.48 OK 146.822 195352 252.824 64220.1 OK TCONS_00003894 2.35724 3407 3.57754 85.6261 OK 61.8339 1980 95.2758 1548.43 OK 9.07257 259791 14.5225 3968.36 OK TCONS_00003895 42.0408 2801 55.1669 1527.12 OK 421.163 11320 433.263 10546.7 OK 321.699 192073 323.218 140712 OK TCONS_00003896 71.3193 3938 29.8919 2590.66 OK 323.569 8659 197.812 8102.76 OK 28.5587 201984 23.7434 12491.6 OK TCONS_00003897 52.7503 2009.01 73.1943 997.763 OK 561.145 29351 726.415 8482.22 OK 435.528 213798 650.74 72774.4 OK TCONS_00003898 6.74646 496 10.2855 127.608 OK 67.7048 27771.2 97.611 1023.42 OK 86.1044 169795 140.971 14387.6 OK TCONS_00003899 196.855 4142.49 98.0686 3723.47 OK 1973.02 30972 1087.45 29824 OK 2996.98 528250 799.358 500778 OK TCONS_00003900 52.8372 1084 48.5841 999.405 OK 874.448 13948 705.844 13218.1 OK 86.4379 28419 89.9626 14443.3 OK TCONS_00003901 4.61502 3087 8.11581 191.429 OK 23.0822 147 38.5466 82.1844 OK 149.926 2.74172e+06 277.405 245317 OK TCONS_00003902 75.2445 3580 127.136 3121.1 OK 0.00605773 1 0.0120056 0.0215686 OK 4557.93 8.03793e+06 7012.61 7.45795e+06 OK TCONS_00003903 185.939 37802.6 283.978 7712.64 OK 107.319 523 134.198 382.111 OK 4471.31 8.03836e+06 7016.93 7.31622e+06 OK TCONS_00003904 629.734 59535.7 362.322 26121.1 OK 152.486 709 155.659 542.928 OK 15331.4 2.6771e+07 11171.5 2.50861e+07 OK TCONS_00003905 2.34525 4559 3.63881 97.2799 OK 50.394 261 70.7722 179.428 OK 40.9182 2.87926e+06 63.6372 66952.7 OK TCONS_00003906 369.932 17302.2 309.081 10950.1 OK 1234.87 17061 1150.43 15744.2 OK 1651.92 328431 1783.32 315371 OK TCONS_00003907 9.73977 1176 18.1641 288.299 OK 124.039 1918 226.425 1581.45 OK 193.933 74579 358.898 37024.2 OK TCONS_00003908 97.4945 13586.7 140.179 2885.86 OK 503.358 7153 689.126 6417.65 OK 993.324 219493 1272.45 189638 OK TCONS_00003909 238.398 9230.58 255.062 7056.65 OK 757.432 10620 854.458 9657 OK 1291.16 255495 1402.42 246499 OK TCONS_00003910 6.12172 2115 8.08546 237.409 OK 44.3574 1114 67.0169 826.469 OK 15.9153 52610 23.2487 3362.36 OK TCONS_00003911 198.039 9274 315.045 7680.22 OK 491.8 10065 829.329 9163.23 OK 484.65 144259 834.442 102390 OK TCONS_00003912 7.44983 2104 11.7985 288.915 OK 308.091 48678.2 504.536 5740.37 OK 45.8367 48049 85.9717 9683.75 OK TCONS_00003913 734.121 29916 549.825 28470.2 OK 1914.14 37692 1850.16 35664.2 OK 2957.75 668601 1871.23 624873 OK TCONS_00003914 209.436 9160 269.253 8122.22 OK 1389.34 62775.7 1601.96 25886.2 OK 814.254 376310 1122.01 172024 OK TCONS_00003915 20.8576 1704 35.7634 808.887 OK 304.952 6528 536.102 5681.88 OK 46.141 48085 87.9795 9748.03 OK TCONS_00003916 127.88 6246 220.008 4959.36 OK 440.178 9010 763.305 8201.4 OK 307.79 145088 555.297 65025.5 OK TCONS_00003917 691.291 22825 26.7139 22601 OK 2474.84 37561 55.3715 37385.8 OK 4081.08 899642 30.6485 867581 OK TCONS_00003918 43.2947 2152 24.6 1415.47 OK 90.9606 1554 46.0648 1374.08 OK 31.3488 46456 16.1767 6664.32 OK TCONS_00003919 25.5983 100 6.16711 91.799 OK 23.2246 76 34.0263 36.5805 OK 93.8913 1806 29.1163 1658.89 OK TCONS_00003920 0.00230519 1 0.00454289 0.00826672 OK 67.4544 151 41.9114 106.246 OK 0.00228718 1 0.00450719 0.0404103 OK TCONS_00003921 5.02912 48.2776 6.16366 18.0351 OK 13.3978 42 16.1276 21.1026 OK 24.7841 669 29.1132 437.889 OK TCONS_00003922 12.3243 26.2426 0 26.2426 OK 83.2646 117.1 0 117.1 OK 186.689 3807.84 0 3807.84 OK TCONS_00003923 907.773 37090 70.8698 36105.2 OK 3771.33 66973 141.832 66621.9 OK 5985.31 1.9792e+06 172.482 1.88576e+06 OK TCONS_00003924 9.28183 1843 8.45647 369.169 OK 16.0034 325 13.8944 282.706 OK 4.67455 132470 3.62831 1472.78 OK TCONS_00003925 470.353 20127 63.514 18707.5 OK 702.183 12797 128.867 12404.3 OK 1034.55 396113 169.078 325949 OK TCONS_00003926 20.2909 1446 21.9975 744.157 OK 317.277 12789.2 426.539 9395.05 OK 357.455 460600 470.435 241887 OK TCONS_00003927 0 0 0 0 OK 247.046 8091 385.184 7315.41 OK 301.494 461855 459.684 204019 OK TCONS_00003928 6.55916 1977 10.589 240.554 OK 304.139 9843.41 426.596 9006.01 OK 263.123 462533 401.491 178053 OK TCONS_00003929 9.78627 1773 16.7838 358.906 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003930 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003931 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003932 0 0 0 0 OK 53.1275 1865 97.005 1573.18 OK 12.7617 596435 24.3745 8635.77 OK TCONS_00003933 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003934 22.7995 1440 26.6602 836.159 OK 271.704 8975 411.197 8045.57 OK 363.85 460930 535.391 246215 OK TCONS_00003935 2.75655 102 0 101.095 OK 64.5415 2551 3.55058 1911.17 OK 53.8828 458101 2.74575 36462.1 OK TCONS_00003936 5.39263 198 0 197.772 OK 39.9337 1183 0 1182.5 OK 56.7623 38411 0 38410.7 OK TCONS_00003937 17.0067 1437 14.4523 623.711 OK 33.4626 1835 31.724 990.878 OK 14.2321 511775 12.0555 9630.78 OK TCONS_00003938 118.874 5505 150.445 4359.64 OK 1177.49 37111 1431.5 34867.2 OK 1185.88 917421 1512.47 802478 OK TCONS_00003939 101.447 4142 145.335 3720.49 OK 534.412 17027 852.891 15824.7 OK 257.446 463466 452.021 174212 OK TCONS_00003940 101.72 4144 147.443 3730.51 OK 283.308 9052 516.111 8389.18 OK 1179.12 917582 1577.24 797901 OK TCONS_00003941 50.1584 2878 85.5438 1839.53 OK 1415.92 44053 1624.12 41927.6 OK 1075.05 918068 1516.06 727481 OK TCONS_00003942 21.0024 1453 24.8328 770.252 OK 136.028 4441 153.586 4027.99 OK 325.103 460013 321.259 219995 OK TCONS_00003943 18.3622 1387 10.3138 673.423 OK 83.6889 2614 51.138 2478.15 OK 45.8808 469528 28.3265 31047.2 OK TCONS_00003944 3.10043 2913 4.97466 113.706 OK 187.651 6241 237.981 5556.62 OK 27.188 517069 48.2347 18397.9 OK TCONS_00003945 12.9154 1619 19.843 473.665 OK 214.293 7243 361.48 6345.53 OK 99.4505 474399 185.804 67297.5 OK TCONS_00003946 11.9998 1564 14.1996 440.085 OK 137.965 4513 214.164 4085.34 OK 96.6781 473322 164.576 65421.4 OK TCONS_00003947 9.9968 1781 17.7966 366.627 OK 527.427 17056 856.656 15617.9 OK 609.74 459693 999.927 412607 OK TCONS_00003948 45.0955 2801 48.7085 1653.85 OK 1609.9 49798 1441.6 47671.5 OK 2196.51 1.83206e+06 1645.65 1.48636e+06 OK TCONS_00003949 7.83894 1714 9.47521 287.489 OK 308.229 9812 432.67 9127.12 OK 173.868 465972 289.13 117655 OK TCONS_00003950 0 0 0 0 OK 0 0 0 0 OK 125.666 469225 207.271 85037.3 OK TCONS_00003951 4.64737 2014 5.58177 170.44 OK 44.4536 1847 61.0159 1316.34 OK 81.7805 475257 131.917 55340.3 OK TCONS_00003952 0 0 0 0 OK 21.3517 953 28.8826 632.255 OK 6.08731 706236 9.62959 4119.24 OK TCONS_00003953 0.0501395 2 0.099851 1.83884 OK 1.11595 85279 2.19879 33.045 OK 2.96069 1.23468e+06 5.87145 2003.48 OK TCONS_00003954 3.25714 2763 5.08592 119.454 OK 25.5145 936 34.6496 755.522 OK 94.7563 471632 141.497 64120.9 OK TCONS_00003955 0.837518 31 1.59594 30.7155 OK 13.1002 1046 20.2729 387.918 OK 55.1503 484694 91.364 37319.8 OK TCONS_00003956 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003957 5.42345 1944 6.90692 198.902 OK 7.04693 1086 7.00118 208.67 OK 9.51839 580066 12.0077 6441.03 OK TCONS_00003958 1.76412 5685 3.04286 64.6982 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003959 75.9165 4028 38.5349 2784.2 OK 267.187 8707 185.284 7911.82 OK 191.036 461642 176.024 129273 OK TCONS_00003960 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003961 380.85 14417 21.2785 13967.5 OK 1333.14 39925 101.205 39476.4 OK 3195.71 2.28628e+06 68.3686 2.16251e+06 OK TCONS_00003962 49.6904 2738 38.8805 1822.37 OK 363.563 11280 235.792 10765.6 OK 461.525 458705 342.301 312311 OK TCONS_00003963 11.9599 867 20.3772 316.702 OK 40.2219 723 72.4004 597.746 OK 4.5397 36407 8.23207 633.513 OK TCONS_00003964 0 0 0 0 OK 0 0 0 0 OK 548.258 456591 903.046 76509.1 OK TCONS_00003965 417.808 11909.6 187.622 11063.7 OK 1657.61 26296 1552.03 24634.1 OK 2595.99 687762 961.066 362269 OK TCONS_00003966 46.9582 4252.41 82.9559 1243.47 OK 1054.66 29565.1 1385.95 15673.6 OK 0 0 0 0 OK TCONS_00003967 67.1219 2187 93.7061 1777.41 OK 337.684 12804.2 485.18 5018.39 OK 8.33846 26989 13.4197 1163.63 OK TCONS_00003968 29.7458 1476 28.5239 787.679 OK 279.266 4663 295.189 4150.23 OK 46.9284 20550 69.6007 6548.82 OK TCONS_00003969 5209.13 383659 28.6925 382851 OK 15148.7 586836 24.0322 579554 OK 42373.8 1.70165e+08 47.6072 1.59588e+08 OK TCONS_00003970 15.397 6624 28.6925 1131.62 OK 13.5838 1797 24.0322 519.687 OK 26.1358 1.61651e+07 47.6072 98432.2 OK TCONS_00003971 30.5683 157 10.8489 131.643 OK 211.212 763 89.6659 665.284 OK 0 0 0 0 OK TCONS_00003972 7.56834 72 10.8489 32.5932 OK 65.6798 307 89.6659 206.88 OK 15.4833 50 0 49.766 OK TCONS_00003973 0 0 0 0 OK 4.12349 7 2.47122 4.12349 OK 0 0 0 0 OK TCONS_00003974 0 0 0 0 OK 2.87688 6 2.47122 2.87688 OK 0 0 0 0 OK TCONS_00003975 1.0923 2 0.492327 1.0923 OK 4.50533 5 0 4.50533 OK 0 0 0 0 OK TCONS_00003976 0.43318 1 0.492327 0.43318 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003977 0.521883 1 0 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003978 3.1313 3.1313 0 3.1313 OK 15.4855 15.4855 0 15.4855 OK 0 0 0 0 OK TCONS_00003979 5.87104 655 4.41275 137.103 OK 38.4374 743 29.1573 602.843 OK 24.8876 8539 10.5313 2274.36 OK TCONS_00003980 37.5687 1093 22.5572 877.323 OK 170.116 2931 143.07 2668.05 OK 256.607 25150 248.484 23450.2 OK TCONS_00003981 0 0 0 0 OK 0 0 0 0 OK 70.8957 11734 121.763 6478.84 OK TCONS_00003982 6.02928 678 5.44401 140.799 OK 57.3085 1011 67.6298 898.812 OK 141.074 16873 143.152 12892.1 OK TCONS_00003983 85.2588 2106 12.9511 1991.01 OK 1027.8 16173 51.3213 16119.8 OK 1206.74 115777 116.603 110279 OK TCONS_00003984 3.43098 81 4.35339 24.6213 OK 103.977 1249 54.5936 1186.44 OK 24.256 1355 29.4562 864.199 OK TCONS_00003985 0.888912 7 0.714721 6.37899 OK 3.60629 220 4.97669 41.1497 OK 0 0 0 0 OK TCONS_00003986 46.4864 334 0 333.595 OK 2013.39 22974 0 22973.9 OK 316.695 11284 0 11283.3 OK TCONS_00003987 19.5172 189 5.73978 140.059 OK 42.1662 689 50.9807 481.141 OK 64.0052 2530 35.536 2280.4 OK TCONS_00003988 4.22342 50 1.19132 30.308 OK 9.73597 134 6.36221 111.093 OK 22.0155 1291 11.3343 784.376 OK TCONS_00003989 0 0 0 0 OK 19.0416 525 33.4392 283.815 OK 38.697 342548 68.2042 21701.3 OK TCONS_00003990 219.978 8486 53.0116 8352.6 OK 882.719 13536 262.918 13156.9 OK 1407.26 942589 407.728 789195 OK TCONS_00003991 177.998 2342 0 2341.89 OK 948.601 6446 0 6445.66 OK 1062.64 63378 0 63377.8 OK TCONS_00003992 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003993 2.97061 2.97061 0 2.97061 OK 3.50528 3.50528 0 3.50528 OK 0 0 0 0 OK TCONS_00003994 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003995 0.757876 4 0.258585 3.91972 OK 1.01009 2 0.000311074 1.01009 OK 11.1023 721 0.965892 720.186 OK TCONS_00003996 0 0 0 0 OK 0.000163379 1 0.000311074 0.000163379 OK 0 0 0 0 OK TCONS_00003997 1.42892 8 0.45301 7.39037 OK 2.19856 3 0.373206 2.19856 OK 26.5655 4189 3.95285 1723.26 OK TCONS_00003998 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00003999 1.04769 25 0.087877 24.5211 OK 37.0717 532 8.09863 440.517 OK 7.93134 15880 1.43979 981.461 OK TCONS_00004000 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0.594944 0.594944 0 0.594944 OK TCONS_00004001 0 0 0 0 OK 0 0 0 0 OK 3.51534 5.28145 0 5.28145 OK TCONS_00004002 181.51 4964 123.339 4279.95 OK 281.228 3209 427.023 2713.72 OK 503.729 29221 387.873 28742.4 OK TCONS_00004003 131.016 3349 123.339 3089.32 OK 1377.62 13788 427.023 13293.3 OK 403.94 31856.7 387.873 23048.5 OK TCONS_00004004 112.714 1933 59.1645 1674.25 OK 515.034 4813 375.516 4390.19 OK 524.703 26413 199.523 25866.2 OK TCONS_00004005 47.8546 1062.22 54.0048 710.83 OK 403.103 3836 358.896 3436.09 OK 159.317 16599.8 187.664 7853.81 OK TCONS_00004006 52.7556 838 10.6376 783.63 OK 442.191 3861 75.0196 3769.27 OK 89.3345 4797 19.6573 4403.91 OK TCONS_00004007 0 0 0 0 OK 38.1453 778 56.6726 508.458 OK 81.4316 9306 135.806 5434.41 OK TCONS_00004008 514.963 12901 0 12900.1 OK 2785 37200 56.6726 37122.7 OK 1213.21 83504 135.806 80964.7 OK TCONS_00004009 886.334 28798.7 0 28798.7 OK 3538.15 54073.2 0 54073.2 OK 2996.18 391842 0 391842 OK TCONS_00004010 39.2472 1233 65.4649 939.041 OK 198.729 1626 287.4 1327.69 OK 461.546 52589 676.3 47125.4 OK TCONS_00004011 329.42 8405 151.985 7881.83 OK 611.45 4551.28 374.496 4085.03 OK 1505.61 155836 915.576 153728 OK TCONS_00004012 93.6102 2937 107.559 2239.75 OK 112.907 1237.06 160.212 754.316 OK 309.534 55605 424.342 31604.5 OK TCONS_00004013 289.968 5551 17.1466 5377.5 OK 848.199 5531 32.2972 5493.48 OK 1494.12 114059 9.83336 110858 OK TCONS_00004014 15.2853 372 17.1466 283.469 OK 31.0658 256 32.2972 201.202 OK 8.80687 6816 9.83336 653.435 OK TCONS_00004015 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TCONS_00004016 75.9013 838 24.6824 757.455 OK 723.948 4967 114.019 4833.17 OK 411.052 15330 36.7019 14878.3 OK TCONS_00004017 21.4962 284 7.11415 214.521 OK 146.3 1044 54.791 976.717 OK 31.6717 1319 17.9299 1146.38 OK TCONS_00004018 13.906 251.753 17.3667 138.775 OK 34.2132 333 42.613 228.412 OK 11.7374 1567 15.9357 424.841 OK TCONS_00004019 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004020 0 0 0 0 OK 9.61287 112 15.28 64.1768 OK 0 0 0 0 OK TCONS_00004021 0.65654 7 0.340037 6.55193 OK 6.46378 94 3.70994 43.153 OK 3.61292 1894 3.07225 130.772 OK TCONS_00004022 0 0 0 0 OK 21.3875 102 34.008 53.7744 OK 13.7639 87 10.0446 65.2525 OK TCONS_00004023 11.5342 110 15.244 55.4897 OK 6.19164 47 10.9549 15.5676 OK 5.70189 62 8.17015 27.0317 OK TCONS_00004024 26.967 173 17.7061 129.735 OK 140.322 424 68.3923 352.81 OK 5.0034 62 6.39921 23.7203 OK TCONS_00004025 5.11488 69 7.54567 24.6071 OK 16.917 83 26.7809 42.5343 OK 0 0 0 0 OK TCONS_00004026 0.100595 1 0.199073 0.483951 OK 10.8351 58 16.697 27.2426 OK 0 0 0 0 OK TCONS_00004027 1751.14 81414 284.449 80744.4 OK 8717.87 253909 262.782 235584 OK 12276 1.14287e+07 5777.57 1.10945e+07 OK TCONS_00004028 163.554 12719.8 284.449 7541.39 OK 146.651 17966.3 262.782 3962.97 OK 3832.24 4.08896e+06 5777.57 3.4634e+06 OK TCONS_00004029 2368.56 136588 756.148 132765 OK 5918.29 136405 1170.52 135197 OK 9269.09 5.03345e+06 1991.39 4.77436e+06 OK TCONS_00004030 477.595 28678 756.148 26770.6 OK 695.051 17190 1170.52 15877.7 OK 1178.57 798935 1991.06 607062 OK TCONS_00004031 83.653 962 6.87781 859.072 OK 472.416 2774 37.9765 2730.38 OK 1088.36 100394 88.3439 96139.7 OK TCONS_00004032 38.3444 489 6.87781 393.777 OK 254.26 1532 37.9765 1469.52 OK 567.742 54120 88.3439 50151.1 OK TCONS_00004033 122.501 3799 178.211 3027.76 OK 1775.09 35935 2121.13 33515.2 FAIL 2848.54 868233 2232.54 839507 FAIL TCONS_00004034 0 0 0 0 OK 0 0 0 0 FAIL 42.0223 94296 78.9541 12384.6 FAIL TCONS_00004035 75.8548 2563 110.94 1874.85 OK 143.701 3372 238.468 2713.19 FAIL 137.715 88566 220.161 40586.6 FAIL TCONS_00004036 213.669 6162 221.2 5281.1 OK 1238.18 25425 1728.77 23377.9 FAIL 703.138 601575 1176.53 207225 FAIL TCONS_00004037 90.7557 2557.34 117.69 2243.14 OK 1263.22 25725 1712.87 23850.6 FAIL 98.9358 89948 191.952 29157.9 FAIL TCONS_00004038 0 0 0 0 OK 8.52587 479 14.9973 160.975 FAIL 0 0 0 0 FAIL TCONS_00004039 0 0 0 0 OK 558.938 11840 958.109 10553.2 FAIL 1347.95 842749 1609.87 397262 FAIL TCONS_00004040 0 0 0 0 OK 2.47463 3 0 2.47463 OK 0.4172 1 0 0.747942 OK TCONS_00004041 9.99577 14.1364 0 13.1442 OK 28.0321 29 0 28.0321 OK 4.99901 9 0 8.96205 OK TCONS_00004042 0 0 0 0 OK 0.667478 8 1.32954 7.46362 OK 5.22064 1000 5.17856 142.912 OK TCONS_00004043 2.77756 418 3.83255 39.7584 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004044 0 0 0 0 OK 57.2089 856.437 88.622 639.7 OK 0.453405 13 0.880928 12.4117 OK TCONS_00004045 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004046 13.7474 416 6.09458 196.783 OK 253.899 2989 135.663 2839.05 OK 7.19458 935 7.63046 196.948 OK TCONS_00004047 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004048 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004049 0 0 0 0 OK 16.7348 357.091 29.0468 187.125 OK 0 0 0 0 OK TCONS_00004050 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004051 6.67825 219 3.46529 95.5933 OK 85.2155 1092 52.0275 952.864 OK 7.01167 819 3.35391 191.941 OK TCONS_00004052 18.5213 728.776 25.8876 265.116 OK 134.736 1829 194.986 1506.6 OK 5.27916 1157 7.95901 144.514 OK TCONS_00004053 4.14314 371 7.1487 59.3054 OK 202.253 2602 304.541 2261.56 OK 10.8193 940 17.6709 296.172 OK TCONS_00004054 26.8022 798.366 43.9187 383.65 OK 301.698 3916 471.372 3373.53 OK 0 0 0 0 OK TCONS_00004055 0 0 0 0 OK 356.933 6920.4 534.032 3991.16 OK 0 0 0 0 OK TCONS_00004056 33.0046 675 51.6809 472.432 OK 209.928 6001.5 352.138 2347.37 OK 136.657 4518 118.614 3740.91 OK TCONS_00004057 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004058 47.5352 868 66.6221 680.426 OK 21.8964 1078.74 42.195 244.842 OK 0.0940643 3 0.187631 2.57496 OK TCONS_00004059 0 0 0 0 OK 47.7861 2150.06 91.2102 534.336 OK 0 0 0 0 OK TCONS_00004060 0.0103079 1 0.0204769 0.147549 OK 254.545 3647.25 413.636 2846.28 OK 72.3805 2327 100.272 1981.38 OK TCONS_00004061 30.1906 678 44.4761 432.152 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004062 0 0 0 0 OK 31.5888 572 54.5716 353.221 OK 14.838 879 24.2073 406.183 OK TCONS_00004063 17.2687 445 17.3417 247.186 OK 113.729 1518 120.516 1271.7 OK 14.7919 842 18.5048 404.921 OK TCONS_00004064 553.019 14392 0 14391.8 OK 535.65 2587.66 0 2564.78 OK 825.178 43037 10.2185 41927.8 OK TCONS_00004065 0 0 0 0 OK 0 0 0 0 OK 5.56202 4328 10.2185 282.609 OK TCONS_00004066 277.99 10499.7 155.917 6591.53 OK 407.023 4444 441.759 3914.28 OK 409.48 69778 507.483 62282.4 OK TCONS_00004067 183.059 9597.53 155.917 4340.6 OK 532.232 5776 622.867 5118.4 OK 1707.87 746455 1468.49 259769 OK TCONS_00004068 0 0 0 0 OK 710.515 7619 722.054 6832.92 OK 1403.73 839472 1490.17 213510 OK TCONS_00004069 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004070 936.611 32346 43.5977 32283.3 OK 4420.63 82462 276.528 81914.3 OK 4489.5 1.05855e+06 318.536 1.03493e+06 OK TCONS_00004071 14.5196 1444 26.6021 500.465 OK 90.2966 2212 165.273 1673.2 OK 75.8599 55500 141.285 17487.4 OK TCONS_00004072 6.18289 1878 11.3271 213.113 OK 39.0147 1152 72.3326 722.944 OK 74.9524 55557 140.982 17278.2 OK TCONS_00004073 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004074 0.473762 14 0.0155155 13.0276 OK 0.495301 3 0 2.58687 OK 0 0 0 0 OK TCONS_00004075 0.00794891 1 0.0155155 0.21858 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004076 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 2.02429 2.02429 0 2.02429 OK TCONS_00004077 782.952 27093 137.209 26096.7 OK 1388.68 12363 48.3751 12298 OK 5682.94 1.54164e+06 101.978 1.50715e+06 OK TCONS_00004078 112.488 4538 137.209 3749.34 OK 44.8931 491.57 48.3751 397.569 OK 120.499 71051 101.978 31957.2 OK TCONS_00004079 3.56552 1741 6.04179 104.39 OK 2098.11 54999 2820.95 51830.3 OK 8941.35 5.28271e+06 2614.9 5.14078e+06 OK TCONS_00004080 54.196 1816 97.0768 1586.72 OK 204.867 5739 388.017 5060.89 OK 67.8633 348702 130.701 39017.6 OK TCONS_00004081 552.33 16762 184.686 16170.9 OK 5340.37 135383 3015.85 131925 OK 1815.24 5.12522e+06 2535.04 1.04366e+06 OK TCONS_00004082 0 0 0 0 OK 0 0 0 0 OK 98.6868 341626 171.982 56739.4 OK TCONS_00004083 3.4925 103 0 102.252 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004084 89.9347 3510 100.145 2633.07 OK 10.3127 711 11.5072 254.758 OK 13.3577 386938 15.3184 7679.96 OK TCONS_00004085 383.82 54349 549.072 44524 OK 469.299 64337 678.332 59303.5 OK 325.524 1.47206e+07 470.43 1.24361e+06 OK TCONS_00004086 13130.4 1.53755e+06 2564.15 1.52316e+06 OK 51684.2 1.00465e+07 40244.5 6.53114e+06 OK 47140 1.89738e+08 44747.9 1.8009e+08 OK TCONS_00004087 0 0 0 0 OK 15340.5 5.37901e+06 25101.4 1.93852e+06 OK 18009.1 7.29945e+07 28781.2 6.88009e+07 OK TCONS_00004088 0 0 0 0 OK 90.5971 70784.3 169.89 11448.4 OK 0 0 0 0 OK TCONS_00004089 0 0 0 0 OK 1460.5 2.26845e+06 2867.47 184558 OK 878.669 1.46569e+07 1739.27 3.35681e+06 OK TCONS_00004090 5.87927 22149 10.7094 682.009 OK 5.99165 26128 10.9558 757.143 OK 0 0 0 0 OK TCONS_00004091 1152.37 155989 2076.64 133677 OK 16983.3 4.96764e+06 25822 2.14611e+06 OK 26392.2 1.02179e+08 34969.7 1.00827e+08 OK TCONS_00004092 5.29683 22115 8.66264 614.444 OK 11.4897 20708 19.9859 1451.91 OK 0 0 0 0 OK TCONS_00004093 159.396 26850 53.8234 18490.3 OK 244.814 31888 129.337 30936.2 OK 141.343 1.47134e+07 83.733 539978 OK TCONS_00004094 0 0 0 0 OK 0.505127 0.505127 0 0.505127 OK 0.8344 0.8344 0 0.8344 OK TCONS_00004095 0 0 0 0 OK 0.000328935 1 0.000632743 0.000328935 OK 11.1897 1398 19.4752 370.732 OK TCONS_00004096 0 0 0 0 OK 5.48466 6 0.000632743 5.48466 OK 0 0 0 0 OK TCONS_00004097 0.00400899 1 0.00792014 0.00400899 OK 0 0 0 0 OK 99.0435 4490 109.829 3281.45 OK TCONS_00004098 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004099 3.29242 4 0.239887 3.29242 OK 0 0 0 0 OK 116.988 7513.13 111.848 3875.99 OK TCONS_00004100 0.71795 1 0.232527 0.71795 OK 0 0 0 0 OK 2.57164 2339 3.3547 85.2022 OK TCONS_00004101 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004102 3.62848 17 2.33579 8.88066 OK 5.91706 11 4.3798 6.69297 OK 20.3272 372 17.2375 220.865 OK TCONS_00004103 5.37675 20 3.01834 13.1595 OK 41.9764 55 6.56798 47.4808 OK 48.389 559 17.8643 525.77 OK TCONS_00004104 1.8064 5 0.535822 4.42115 OK 4.57288 6 1.11527 5.17253 OK 3.34738 37 0.963326 36.3709 OK TCONS_00004105 8.8589 28 1.99213 21.6821 OK 12.0115 16 1.72442 13.5866 OK 2.41781 27 0.304223 26.2707 OK TCONS_00004106 148.894 1762.49 0 1762.49 OK 851.217 5456.86 0 5456.86 OK 224.353 5239.76 0 5239.76 OK TCONS_00004107 0 0 0 0 OK 1.01031 33 0 32.1292 OK 0 0 0 0 OK TCONS_00004108 27.6993 1114 0 1113.33 OK 188.867 6007 0 6006.23 OK 40.3228 48281 0 48280.3 OK TCONS_00004109 3.2571 3476 5.4269 130.914 OK 318.968 11487 577.788 10143.6 OK 1228.48 4.83701e+06 2091.13 1.47092e+06 OK TCONS_00004110 0 0 0 0 OK 0 0 0 0 OK 10874.2 1.43366e+07 9187.99 1.30202e+07 OK TCONS_00004111 700.623 28755 373.127 28160.3 OK 5654.61 184036 3765.21 179824 OK 6901.99 8.60558e+06 8681.01 8.26406e+06 OK TCONS_00004112 275.665 13143 370.777 11079.9 OK 2759.25 91799 3567.76 87747.9 OK 112.446 1.48218e+06 219.656 134637 OK TCONS_00004113 84.4556 2863 139.206 2202.5 OK 374.302 4614 583.255 3986 OK 230.4 16717 364.004 14765 OK TCONS_00004114 468.422 12579 139.206 12215.9 OK 1575.3 17445 583.255 16775.6 OK 992.908 65083 364.004 63629.8 OK TCONS_00004115 6.80602 188 5.49225 87.6525 OK 4.3242 29 2.66159 13.5434 OK 7.02481 4732 6.741 431.498 OK TCONS_00004116 119.016 1769 65.3045 1532.77 OK 230.475 789 59.2377 721.848 OK 762.274 51275.4 465.78 46822.6 OK TCONS_00004117 46.6359 695 63.0085 600.608 OK 39.7714 192 57.3886 124.564 OK 361.199 22812 460.823 22186.6 OK TCONS_00004118 0 0 0 0 OK 0 0 0 0 OK 5.27717 6230 8.83853 324.149 OK TCONS_00004119 372.752 12005 250.455 11379.2 OK 1696.69 31937.2 745.531 21619.9 OK 1352.77 287042 690.12 135860 OK TCONS_00004120 396.323 12912 250.455 12098.8 OK 921.111 23755.1 745.531 11737.2 OK 876.103 248532 690.12 87988.3 OK TCONS_00004121 27.9265 162 11.1584 142.94 OK 174.963 959 126.866 810.422 OK 2.35865 30 2.03346 10.8298 OK TCONS_00004122 2.12215 106 3.86815 10.8621 OK 170.115 964 167.049 787.963 OK 5.99978 58.8864 6.40174 27.5481 OK TCONS_00004123 11.3528 80 9.57204 58.1088 OK 161.328 907 142.276 747.263 OK 16.0564 93 6.74953 73.7233 OK TCONS_00004124 1.79371 44 1.42394 9.18105 OK 3.11032 25 2.21196 14.4069 OK 0 0 0 0 OK TCONS_00004125 1.44439 2 0.00144115 1.44439 OK 0 0 0 0 OK 0.00370839 1 0.00728655 0.00370839 OK TCONS_00004126 0 0 0 0 OK 0.00213681 1 0.00420887 0.00213681 OK 0.591235 1 0.00728655 0.591235 OK TCONS_00004127 0.000739743 1 0.00144115 0.000739743 OK 9.93718 10.2157 0.00420887 9.93718 OK 0 0 0 0 OK TCONS_00004128 64.0257 445 0.0787621 444.993 OK 109.557 210 1.32763 206.34 OK 29.2361 155 0 154.83 OK TCONS_00004129 0 0 0 0 OK 0.574893 2 0.137086 1.08275 OK 0 0 0 0 OK TCONS_00004130 5.6233 40 0.0787621 39.0832 OK 23.8338 47 1.2445 44.8884 OK 0 0 0 0 OK TCONS_00004131 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004132 314.827 10255 292.992 9610.53 OK 295.597 6714 537.386 5924.17 OK 1660.33 848345 2407.94 763799 OK TCONS_00004133 454.286 19685.3 292.992 13867.7 OK 5187.24 104723 537.386 103959 OK 7339.82 3.38122e+06 2407.94 3.37652e+06 OK TCONS_00004134 1454.13 61820 107.337 60934.3 OK 3570.32 57051 221.75 56752.8 OK 3619.72 594265 110.756 583591 OK TCONS_00004135 0 0 0 0 OK 12.2018 310 23.3093 193.957 OK 17.1112 31672 32.869 2758.77 OK TCONS_00004136 94.2818 5385 107.337 3950.82 OK 179.726 3329 199.842 2856.88 OK 71.7589 26618 78.6489 11569.4 OK TCONS_00004137 93.8168 4888 132.071 4585.64 OK 553.953 16125 929.174 14797.5 OK 566.052 159929 886.862 130264 OK TCONS_00004138 2045.4 100768 132.071 99976.3 OK 8147.42 218665 929.174 217639 OK 4699.1 1.10827e+06 886.862 1.08139e+06 OK TCONS_00004139 169.704 3730 1.93775 3362.14 OK 2150.54 33092 22.5988 32918.3 OK 84.3335 4654 0.228805 4653.49 OK TCONS_00004140 0 0 0 0 OK 10.2158 781.084 17.3596 156.373 OK 0 0 0 0 OK TCONS_00004141 2.47313 625 1.93775 48.9973 OK 4.35154 331 4.71043 66.609 OK 0 0 0 0 OK TCONS_00004142 73.7781 27048.8 83.579 3348.28 OK 543.326 13544 579.27 12888.6 OK 430.459 214727 440.097 43174.3 OK TCONS_00004143 1763.15 80657 83.579 80017.1 OK 6649.52 158508 579.27 157737 OK 1717.57 247507 440.097 172270 OK TCONS_00004144 35.5968 893 62.4951 721.798 OK 482.051 4421 558.965 3851.09 OK 1595.64 312406 1617.62 241006 OK TCONS_00004145 283.187 5936 64.5155 5742.2 OK 689.493 6245.71 560.335 5508.34 OK 1661.08 274007 1618.22 250891 OK TCONS_00004146 34.1494 787 2.33551 692.451 OK 35.862 345 5.69532 286.5 OK 114.168 22726 18.3016 17244 OK TCONS_00004147 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004148 0.963422 17 0 16.7331 OK 7.46469 80 0 79.4624 OK 10.246 1158 0 1157.46 OK TCONS_00004149 167.837 2748.29 0 2748.29 OK 3.99001 3.99001 0 3.99001 OK 0 0 0 0 OK TCONS_00004150 480.022 14079 166.902 13218.3 OK 1513.33 15532 345.801 15119.4 OK 2478.89 344992 324.303 344253 OK TCONS_00004151 132.734 4996.21 166.902 3655.1 OK 243.475 2899 345.801 2432.53 OK 229.581 128055 324.303 31882.9 OK TCONS_00004152 326.702 10388 309.42 10039.5 OK 421.253 3365 395.279 2937.76 OK 298.47 19026 353.381 16732.2 OK TCONS_00004153 424.422 14095 331.516 13042.4 OK 522.728 4104 427.009 3645.43 OK 640.135 37450 355.388 35885.8 OK TCONS_00004154 15.5768 1036 16.4899 478.672 OK 12.4683 164 13.4904 86.9525 OK 0 0 0 0 OK TCONS_00004155 12.6539 1036 10.9509 388.853 OK 31.0617 290 24.9496 216.62 OK 1.1983 10681 1.20332 67.1766 OK TCONS_00004156 0.55874 18 0.152663 17.17 OK 0 0 0 0 OK 3.65544 5099 4.09438 204.923 OK TCONS_00004157 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004158 55.5587 324 0 323.913 OK 1891.46 19933 0 19932.8 OK 1375.98 102607 0 102606 OK TCONS_00004159 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004160 0.120428 0.120428 0 0.120428 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004161 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004162 0.21677 1 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004163 0.216684 1 0.000159401 0.216684 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004164 8.58428e-05 1 0.000159401 8.58428e-05 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004165 7.66739 9.29871 0 9.29871 OK 240.308 693.118 0 693.118 OK 146.188 2496.11 0 2496.11 OK TCONS_00004166 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004167 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004168 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004169 0.160097 1 0.000913431 0.160097 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004170 0.000472956 1 0.000913431 0.000472956 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004171 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004172 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004173 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004174 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004175 4.9778 4.9778 0 4.9778 OK 15.0008 15.0008 0 15.0008 OK 0 0 0 0 OK TCONS_00004176 22.628 320 11.5965 236.045 OK 67.2598 422 41.9354 371.729 OK 5.03478 7864 4.81586 381.433 OK TCONS_00004177 0.00140532 1 0.00276146 0.0146597 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004178 0.521884 1 0 0.806644 OK 11.5755 13 0.705696 11.6717 OK 6.62983 27 0.799834 26.2825 OK TCONS_00004179 129.156 2613 68.3266 2522.8 OK 145.121 1052 106.018 914.831 OK 91.86 4049 69.0064 3368.24 OK TCONS_00004180 0 0 0 0 OK 379.38 2771 353.205 2391.58 OK 183.922 8159 197.39 6743.88 OK TCONS_00004181 81.7187 1938 82.392 1596.2 OK 191.546 1493 235.634 1207.49 OK 64.4708 2792 95.6831 2363.96 OK TCONS_00004182 0 0 0 0 OK 35.3163 567.257 60.3932 222.631 OK 13.1771 1650 22.7484 483.165 OK TCONS_00004183 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004184 0 0 0 0 OK 0 0 0 0 OK 43.6456 2924.87 71.4123 1600.36 OK TCONS_00004185 116.255 2684 105.043 2270.79 OK 89.2316 735 152.452 562.508 OK 71.1201 2784 110.939 2607.77 OK TCONS_00004186 101.965 3593 0 3592.82 OK 248.768 1871 0.0151021 1870.79 OK 74.9987 6729 0.148077 6728.85 OK TCONS_00004187 1176.82 43435.6 0 43435.6 OK 6129.63 133968 0 133968 OK 6380.34 1.97115e+06 0 1.97115e+06 OK TCONS_00004188 72.6602 2488 0 2487.37 OK 158.544 3001 0 3000.9 OK 87.8318 20032 0 20031.4 OK TCONS_00004189 112.709 1709 61.616 1495.78 OK 710.165 4752 193.629 4525.78 OK 1239.81 89629 260.037 87970 OK TCONS_00004190 0 0 0 0 OK 16.3402 207 30.0428 104.134 OK 10.729 6728 20.0984 761.273 OK TCONS_00004191 37.9101 769 55.4393 503.113 OK 68.7895 580 119.648 438.385 OK 108.297 10410 192.421 7684.19 OK TCONS_00004192 0 0 0 0 OK 19.1115 198 36.3382 121.795 OK 0 0 0 0 OK TCONS_00004193 0.029182 1 0.0580152 0.38728 OK 5.05473 63.964 7.25388 32.213 OK 20.0031 5605 26.0352 1419.31 OK TCONS_00004194 7.2975 206 7.16494 96.8466 OK 13.1977 132 13.9239 84.1071 OK 14.4551 5865 19.0195 1025.66 OK TCONS_00004195 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004196 4.85364 236 5.19391 64.4137 OK 8.73586 89 8.23026 55.6723 OK 22.4748 5450 24.9583 1594.69 OK TCONS_00004197 4.68216 63 0.412613 62.1379 OK 15.6116 105 1.20089 99.4901 OK 1.3543 97 0.327498 96.0937 OK TCONS_00004198 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004199 112.297 2338 91.3533 2221.81 OK 10.5517 47 4.4677 32.5732 OK 549.747 50802 668.61 43659.6 OK TCONS_00004200 13.9552 465 24.8655 276.104 OK 0 0 0 0 OK 39.0293 6827 73.8845 3099.61 OK TCONS_00004201 9.03838 512 15.2604 178.825 OK 0 0 0 0 OK 62.6462 11295.4 115.911 4975.21 OK TCONS_00004202 0 0 0 0 OK 0 0 0 0 OK 141.803 45064.9 245.445 11261.7 OK TCONS_00004203 66.1961 1663.05 79.1616 1309.69 OK 8.34645 32 4.4677 25.7655 OK 765.483 108233 700.066 60792.8 OK TCONS_00004204 2.20768 619 1.52071 43.6792 OK 3.42954 23 3.20024 10.587 OK 4.5953 9146 4.78419 364.948 OK TCONS_00004205 3.83413 447 1.52071 75.8586 OK 34.9605 114 3.20024 107.923 OK 50.7667 6251 4.78419 4031.77 OK TCONS_00004206 366.052 8146 23.5007 7751.79 OK 2302.63 27375 5.6248 27339.4 OK 3001.55 447835 0 447834 OK TCONS_00004207 13.3855 2053.66 23.5007 283.461 OK 3.32921 289 5.6248 39.5281 OK 0 0 0 0 OK TCONS_00004208 12.8817 233 23.2341 180.792 OK 631.131 9088 854.031 8177.03 OK 208.069 6417 94.1801 5603.28 OK TCONS_00004209 0 0 0 0 OK 0 0 0 0 OK 59.3672 5412.26 82.1696 1598.76 OK TCONS_00004210 184.224 2773 23.2341 2585.54 OK 2062.08 27664 854.031 26716.7 OK 19.887 794 27.5182 535.555 OK TCONS_00004211 16.0977 32.2129 0 32.2129 OK 78.8205 104.945 0 104.945 OK 215.616 4838.83 0 4838.83 OK TCONS_00004212 21.1607 1102 29.0307 466.224 OK 5.48041 104 6.90222 33.4002 OK 30.7307 5257 40.3374 2154.86 OK TCONS_00004213 13.2914 765.527 21.8627 292.844 OK 25.9048 257 41.4174 157.876 OK 76.4537 24687.5 125.275 5360.98 OK TCONS_00004214 338.451 7951 61.8464 7456.93 OK 764.698 4738 48.7684 4660.44 OK 1282.23 92267 161.192 89910.5 OK TCONS_00004215 31.1584 965 13.7187 686.499 OK 2.96814 19 0.922302 18.0893 OK 0 0 0 0 OK TCONS_00004216 0 0 0 0 OK 0 0 0 0 OK 0.502332 424 0.170259 423.709 OK TCONS_00004217 0.957894 43 0 42.0774 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004218 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004219 84.2729 706 1.63121 688.727 OK 268.776 1055 64.4508 981.75 OK 75.4399 1083 18.0909 1041.33 OK TCONS_00004220 0 0 0 0 OK 31.0402 144 23.5483 113.38 OK 11.0828 197 7.44316 152.981 OK TCONS_00004221 3.02014 79 1.63121 24.6823 OK 47.7827 233 40.9025 174.534 OK 14.0086 408 10.6477 193.368 OK TCONS_00004222 22.0823 86 2.54338 78.6562 OK 29.4125 44 11.898 31.2848 OK 1.65868 3 0.281855 2.38724 OK TCONS_00004223 90.4847 780.57 0 780.57 OK 183.038 431.934 0 431.934 OK 1470.59 112008 0 112008 OK TCONS_00004224 258.816 7336 72.677 6772.98 OK 476.395 3634 235.985 3348.02 OK 2088.22 343584 911.859 340038 OK TCONS_00004225 0 0 0 0 OK 170.517 2696.62 178.432 1198.36 OK 628.525 106395 741.206 102347 OK TCONS_00004226 36.0288 1627.21 50.5291 942.842 OK 39.4934 387 67.8122 277.553 OK 264.366 53657 422.941 43048.4 OK TCONS_00004227 2.25002 2244 4.09386 58.8812 OK 4.60949 81 8.44737 32.3946 OK 4.1616 51354 7.35208 677.66 OK TCONS_00004228 103.602 3322 15.7636 2711.17 OK 156.956 1183 35.0976 1103.06 OK 211.861 52855 42.4602 34498.6 OK TCONS_00004229 9.56692 876 15.0207 250.358 OK 5.21555 69 8.18384 36.654 OK 101.135 27076 141.1 16468.5 OK TCONS_00004230 124.642 3333 31.6574 3261.78 OK 144.176 1060 40.4825 1013.25 OK 429.402 79410 206.113 69922.2 OK TCONS_00004231 74.3615 1478 52.9057 1169.74 OK 51.1689 557 87.8509 405.419 OK 158.281 7207 142.473 6706.45 OK TCONS_00004232 20.6022 558 30.1577 324.082 OK 232.743 2130 250.457 1844.05 OK 103.385 5516 133.421 4380.48 OK TCONS_00004233 0 0 0 0 OK 78.0404 811 122.563 618.325 OK 34.1696 1928 59.3102 1447.78 OK TCONS_00004234 66.7164 1240 54.9385 1049.48 OK 406.819 3524 279.474 3223.29 OK 97.6583 5489 106.726 4137.84 OK TCONS_00004235 42.5504 733 25.5938 669.338 OK 284.932 2502 185.154 2257.56 OK 109.314 5401 82.5636 4631.69 OK TCONS_00004236 12.4165 250 6.27524 195.318 OK 63.6415 603 41.4456 504.241 OK 25.6022 1864 21.1689 1084.78 OK TCONS_00004237 16.1072 473 1.78959 253.374 OK 93.2586 796 23.3592 738.901 OK 75.7614 3531 13.9094 3210.05 OK TCONS_00004238 1.56565 2 0 1.56565 OK 21.7389 23 0.366626 21.7389 OK 0 0 0 0 OK TCONS_00004239 0 0 0 0 OK 3.71652 5 0.366626 3.71652 OK 0 0 0 0 OK TCONS_00004240 23.4616 758 4.99532 462.752 OK 162.545 2910 20.552 2714.55 OK 5.35099 3225 4.10921 270.343 OK TCONS_00004241 3.3144 757 4.99532 65.3725 OK 14.6653 311 20.552 244.914 OK 5.81345 3111 4.10921 293.707 OK TCONS_00004242 10.3168 204 0 203.486 OK 78.8307 1317 0 1316.49 OK 56.7096 2866 0 2865.09 OK TCONS_00004243 621.551 19525.4 193.455 18664.3 OK 3946.93 118390 1214 72262.7 OK 1554.91 185548 524.044 173419 OK TCONS_00004244 120.026 4699 193.455 3604.21 OK 803.693 59566.7 1214 14714.5 OK 317.471 37697 490.54 35407.6 OK TCONS_00004245 0 0 0 0 OK 0 0 0 0 OK 24.8006 13932 40.1453 2766.01 OK TCONS_00004246 0 0 0 0 OK 0 0 0 0 OK 9.12287 17231 16.1454 1017.48 OK TCONS_00004247 28.854 2000.8 45.1316 673.072 OK 406.175 7920 586.656 7292.8 OK 206.565 17567 259.451 15724 OK TCONS_00004248 197.255 6846.72 209.672 4601.33 OK 2190.51 61540.5 2148.49 39330.3 OK 582.691 46561 679.855 44355.2 OK TCONS_00004249 198.057 4929 210.277 4620.03 OK 1917.4 36866 2108.15 34426.6 OK 674.606 64714 713.911 51351.9 OK TCONS_00004250 6.40198 832 11.6441 149.338 OK 46.3295 20886.1 84.8832 831.839 OK 73.7189 5999 134.78 5611.57 OK TCONS_00004251 0 0 0 0 OK 21.7148 704 25.4767 389.886 OK 35.7681 5920 22.7894 2722.71 OK TCONS_00004252 15.7486 583 15.0355 367.364 OK 28.6217 688 37.1587 513.898 OK 0 0 0 0 OK TCONS_00004253 622.652 17272.2 0 17272.2 OK 1579.1 14771.3 0 14771.3 OK 4419.26 843537 0 843537 OK TCONS_00004254 43.8184 247 3.33234 228.88 OK 279.554 911 9.23112 897.406 OK 6.34268e-05 1 0.000116247 0.000101784 OK TCONS_00004255 0 0 0 0 OK 0 0 0 0 OK 2.92034 5 0.000116247 4.6864 OK TCONS_00004256 3.63178 33 3.33234 18.9702 OK 5.36867 48 9.23112 17.2341 OK 0 0 0 0 OK TCONS_00004257 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004258 3820.8 313161 2041.54 288924 OK 16630.2 881307 8093.68 823877 OK 2829.68 466812 961.216 440467 OK TCONS_00004259 1449.99 115123 2041.54 109646 OK 5539.63 284839 8093.68 274439 OK 601.309 97570 961.216 93599.6 OK TCONS_00004260 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004261 108.685 2419 144.323 2153.44 OK 712.623 9161 943.822 8127.52 OK 344.324 26417 521.12 24881 OK TCONS_00004262 13.3827 465 22.3367 265.16 OK 31.9579 9944.13 52.7779 364.482 OK 0 0 0 0 OK TCONS_00004263 216.385 4654 152.465 4287.38 OK 1435.5 25734 963.25 16371.9 OK 1120.35 82963 521.12 80956.7 OK TCONS_00004264 238.616 3881.51 0 3881.51 OK 540.696 2585.27 0 2585.27 OK 1481.34 112518 0 112518 OK TCONS_00004265 20.1207 4583 2.21551 1364.89 OK 42.8037 3644 6.41198 1839.22 OK 26.8616 418528 5.33545 17264.3 OK TCONS_00004266 4.61433 7289 6.12483 313.014 OK 40.113 1974 77.3318 1723.61 OK 148.362 421908 253.044 95354.1 OK TCONS_00004267 1.63902 15436 2.22861 111.183 OK 232.877 14180.9 442.688 10006.4 OK 597.004 557377 989.844 383702 OK TCONS_00004268 0 0 0 0 OK 66.8244 4975.69 128.14 2871.37 OK 52.132 443062 100.905 33505.9 OK TCONS_00004269 0 0 0 0 OK 483.67 43857.4 887.524 20782.7 OK 0 0 0 0 OK TCONS_00004270 38.5603 4842 51.0804 2615.75 OK 1962.5 134043 2735.12 84326.1 OK 1339.59 1.24242e+06 1853.21 860974 OK TCONS_00004271 6.7 6448 9.23039 454.495 OK 1499 95947.3 2317.83 64410.2 OK 691.965 967722 1167.81 444735 OK TCONS_00004272 4046.88 278853 584.9 274520 OK 12850.8 557979 4314.03 552185 OK 9036.84 6.19015e+06 2968.96 5.8081e+06 OK TCONS_00004273 48.5237 4621 22.869 3291.61 OK 16.9441 2010 16.6999 728.069 OK 14.4389 471244 14.8141 9280.09 OK TCONS_00004274 47.3242 4845 77.7555 3210.24 OK 604.06 28119 922.113 25955.7 OK 434.84 415301 657.371 279477 OK TCONS_00004275 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004276 259.091 33730.2 415.914 17575.4 OK 28.0066 1979 38.7843 1203.41 OK 33.8979 449202 51.1857 21786.6 OK TCONS_00004277 45.5788 1398 38.0356 1197.3 OK 34.9917 483 25.3796 445.453 OK 14.463 163574 13.4044 5513.88 OK TCONS_00004278 429.656 12150 169.996 11286.5 OK 1958.85 25883 938.443 24936.7 OK 7145.22 3.37173e+06 1910.99 2.72406e+06 OK TCONS_00004279 0 0 0 0 OK 118.092 6046.67 218.693 1503.34 OK 200.919 147719 384.478 76598.7 OK TCONS_00004280 69.9383 3375.46 118.272 1837.19 OK 486.461 8242.05 773.646 6192.76 OK 864.324 972511 1522.7 329517 OK TCONS_00004281 19.3685 3196.78 36.2796 508.788 OK 16.7341 396 31.6265 213.029 OK 52.54 155533 100.731 20030.5 OK TCONS_00004282 7.4865 9 0.000545388 8.03299 OK 26.5422 27 0 26.5422 OK 19.2924 75.9899 0 73.4272 OK TCONS_00004283 0.000284146 1 0.000545388 0.000304888 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004284 7.08542 7.95273 0 7.95273 OK 19.4755 19.4755 0 19.4755 OK 13.8725 41.5589 0 41.5589 OK TCONS_00004285 166.677 2290 5.961 2213.4 OK 870.749 5619 2.14692 5612.84 OK 3075.69 684723 311.788 436701 OK TCONS_00004286 0 0 0 0 OK 0 0 0 0 OK 165.711 379190 309.551 23528.3 OK TCONS_00004287 7.74884 195 5.961 102.902 OK 2.07709 79 2.14692 13.3889 OK 2.41262 38757 2.44291 342.554 OK TCONS_00004288 752.195 39791 977.815 37360.6 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004289 33.9246 4178.25 49.2081 1684.99 OK 141.005 4069 203.471 3622.72 OK 115.713 2.57991e+06 172.241 183572 OK TCONS_00004290 1416.11 87859.1 996.706 70336.2 OK 7971.07 205134 223.221 204794 OK 23967 4.0244e+07 355.785 3.80224e+07 OK TCONS_00004291 13.5297 2845 16.2951 672 OK 16.4525 730 20.7183 422.699 OK 138.501 2.56384e+06 185.477 219725 OK TCONS_00004292 29.7061 1476 0 1475.46 OK 32.0017 823 0 822.192 OK 27.3971 43465 0 43464 OK TCONS_00004293 5.26007 100 9.45756 42.5737 OK 0 0 0 0 OK 65.2273 26257.9 121.909 4509.66 OK TCONS_00004294 55.9397 485 21.6649 452.762 OK 168.647 428 20.1406 406.317 OK 1117.17 85822 354.778 77238.7 OK TCONS_00004295 0 0 0 0 OK 3.07268 54 6.01281 7.40294 OK 0 0 0 0 OK TCONS_00004296 2.36709 160 3.53301 19.1586 OK 0 0 0 0 OK 132.704 9761 214.103 9174.81 OK TCONS_00004297 10.2576 145 9.79543 83.0228 OK 15.066 56 14.803 36.2983 OK 42.497 4923 41.104 2938.14 OK TCONS_00004298 2.1686 242 4.00141 17.5521 OK 0 0 0 0 OK 15.4135 5678 24.382 1065.65 OK TCONS_00004299 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TCONS_00004300 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004301 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004302 0 0 0 0 OK 0.000420414 1 0.000812757 0.000420414 OK 0.000336693 1 0.000648192 0.000891246 OK TCONS_00004303 20.0303 170 19.4073 115.074 OK 29.4552 30 0.000812757 29.4552 OK 8.80779 24.4984 0.000648192 23.3147 OK TCONS_00004304 21.0777 167 19.4073 121.091 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004305 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004306 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004307 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004308 0 0 0 0 OK 1.00005 2 0 1.00005 OK 0 0 0 0 OK TCONS_00004309 0 0 0 0 OK 0 0 0 0 OK 5.0064 12 0 11.5431 OK TCONS_00004310 96.1199 2393 95.2454 2091.76 OK 9.88948 57 10.2311 32.8114 OK 3235.79 1.34347e+07 4774.3 3.66488e+06 OK TCONS_00004311 153.58 3741 95.2454 3342.21 OK 287.8 972 10.2311 954.864 OK 14595.1 1.66668e+07 4774.3 1.65305e+07 OK TCONS_00004312 369.343 7702.97 0 7702.97 OK 853.157 5421.54 0 5421.54 OK 2956.3 383602 0 383602 OK TCONS_00004313 3559.76 220318 54.1613 219290 OK 10304.7 307378 67.4736 307110 OK 21243.7 2.8887e+07 38.4886 2.77027e+07 OK TCONS_00004314 4.72795 6842 8.47871 291.253 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004315 4.06116 7378 7.14975 250.177 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004316 23.0767 4273 38.7195 1421.58 OK 37.8616 2429.18 67.4736 1128.38 OK 20.7151 2.006e+06 38.4886 27013.4 OK TCONS_00004317 0 0 0 0 OK 6.20228 360.164 11.1477 33.0368 OK 6.95064 902 12.4706 171.83 OK TCONS_00004318 4.69485 114 7.77231 40.1155 OK 17.9255 318.857 33.2355 95.4813 OK 105.122 3045 73.2759 2598.78 OK TCONS_00004319 0 0 0 0 OK 11.3606 108 19.9478 60.5129 OK 18.1121 696 31.0094 447.756 OK TCONS_00004320 7.6785 241.725 13.8206 65.6095 OK 188.434 1283 255.988 1003.7 OK 0 0 0 0 OK TCONS_00004321 80.0772 732 19.3872 684.226 OK 393.106 2375 273.478 2093.9 OK 92.4814 3762.53 61.5126 2286.27 OK TCONS_00004322 0 0 0 0 OK 62.0102 600 115.981 454.645 OK 271.796 31577.3 364.027 15247.5 OK TCONS_00004323 26.2233 303 31.6345 221.271 OK 505.302 6639.83 478.703 3704.76 OK 272.461 27152.9 357.748 15284.7 OK TCONS_00004324 67.2312 671 31.6345 567.292 OK 494.448 7885.6 468.464 3625.19 OK 329.84 18985 374.517 18503.6 OK TCONS_00004325 53.8813 5626 95.7464 2754.98 OK 177.068 2868 260.565 2400.12 OK 227.367 325004 405.684 128730 OK TCONS_00004326 574.7 31475 602.878 29384.7 OK 526.714 7707 544.622 7139.49 OK 583.66 658783 775.847 330454 OK TCONS_00004327 158.371 10761 253.014 8097.6 OK 811.63 11980 894.357 11001.5 OK 347.652 1.19846e+06 604.549 196833 OK TCONS_00004328 371.41 21286 594.116 18990.4 OK 103.605 2800.73 182.328 1404.34 OK 3292.5 3.84758e+06 4433.31 1.86414e+06 OK TCONS_00004329 589.774 31630 773.038 30155.4 OK 219.767 3460 354.492 2978.9 OK 4443.31 2.56549e+06 4787.61 2.5157e+06 OK TCONS_00004330 332.236 19243.9 446.493 16987.4 OK 883.628 12874 765.838 11977.4 OK 1642.25 963248 2306.75 929801 OK TCONS_00004331 89.4616 5326 105.539 4574.21 OK 31.0813 598 43.8965 421.301 OK 26.0576 366662 49.3519 14753.2 OK TCONS_00004332 65.9842 5443 91.0878 3373.8 OK 48.0513 759 56.9279 651.325 OK 475.629 321162 415.175 269290 OK TCONS_00004333 62.2053 5309 46.6881 3180.59 OK 85.3648 1288 78.9434 1157.1 OK 181.369 324002 206.586 102687 OK TCONS_00004334 33.5527 11521.7 64.705 1613.02 OK 33.8932 1009 65.136 580.529 OK 2095.47 2.37239e+06 3199.15 1.0328e+06 OK TCONS_00004335 9.65493 3163 18.1487 464.153 OK 0 0 0 0 OK 201.061 247097 389.686 99097.8 OK TCONS_00004336 1146.44 57557 894.414 55114 OK 1479.8 27291 1845.3 25346.3 OK 3095.34 4.13764e+06 4186.74 1.52561e+06 OK TCONS_00004337 54.6019 5001 106.004 2624.94 OK 0 0 0 0 OK 1144.18 1.28886e+06 2009.28 563935 OK TCONS_00004338 154.986 9575 282.999 7450.81 OK 1697.13 33041.7 1963.76 29068.8 OK 1797.66 974038 2879.75 886020 OK TCONS_00004339 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004340 391.238 21112 571.1 18808.5 OK 973.909 18332 1426.72 16681.3 OK 1635.53 974403 2585.38 806109 OK TCONS_00004341 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004342 223.19 11715 298.836 10729.7 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004343 78.2751 4778 115.654 3763.01 OK 79.3135 1538 125.083 1358.5 OK 81.5019 251823 128.853 40170.1 OK TCONS_00004344 0 0 0 0 OK 32.3255 638 59.0002 444.452 OK 557.862 3.6046e+06 1015.43 1.05599e+06 OK TCONS_00004345 184.007 6295.73 203.857 4228.61 OK 146.827 2424 271.355 2018.76 OK 4175.3 1.35706e+07 6917.7 7.90349e+06 OK TCONS_00004346 80.0172 3840.66 128.6 1838.85 OK 499.572 34890.1 809.703 6868.75 OK 5917.94 5.43899e+07 9069.44 1.12022e+07 OK TCONS_00004347 0 0 0 0 OK 22.3933 436 42.413 307.892 OK 66.0677 3.79092e+06 127.741 125061 OK TCONS_00004348 139.022 3792 182.287 3194.82 OK 2218.96 59174.8 1058.48 30509 OK 16550.5 5.49355e+07 12746.3 3.13287e+07 OK TCONS_00004349 25.629 1182 38.4015 588.971 OK 30.977 634 52.091 425.911 OK 151.231 3.6661e+06 271.063 286267 OK TCONS_00004350 7.58727 175 0 174.36 OK 1.9899 28 0 27.3597 OK 1.01214 1916 0 1915.9 OK TCONS_00004351 77.9796 588.486 0 588.486 OK 119.499 207.666 0 207.666 OK 848.646 44213.8 0 44213.8 OK TCONS_00004352 4.11591 83 6.78307 29.2564 OK 79.1442 1950.11 128.242 405.529 OK 0 0 0 0 OK TCONS_00004353 35.4863 305 35.1739 252.241 OK 226.332 2076.43 277.154 1159.71 OK 5.71289 10 0.00886678 9.18201 OK TCONS_00004354 19.4145 231 27.673 138.001 OK 215.665 1406 271.627 1105.05 OK 0.0044839 1 0.00886678 0.00720673 OK TCONS_00004355 14.5265 307.731 21.0644 103.256 OK 82.0085 645.704 129.069 420.206 OK 0 0 0 0 OK TCONS_00004356 170.517 8293 139.161 6934.85 OK 183.055 2830 192.902 2596.77 OK 146.024 45703 190.277 31016.6 OK TCONS_00004357 703.559 29616 529.417 28613.4 OK 2342.33 36425.8 933.889 33227.6 OK 3882.98 854520 1182.22 824775 OK TCONS_00004358 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004359 52.3747 3549 93.0669 2130.05 OK 114.213 1935 208.479 1620.19 OK 155.788 45974 290.225 33090.6 OK TCONS_00004360 17.3908 1956 32.2585 707.274 OK 7.4531 1092.47 13.8594 105.727 OK 0 0 0 0 OK TCONS_00004361 32.1819 1646 10.5259 1308.82 OK 9.1006 205 4.16628 129.098 OK 2.52668 64627 1.35831 536.687 OK TCONS_00004362 173.717 8464 253.476 7064.97 OK 364.398 13929.3 526.861 5169.24 OK 325.486 245250 514.342 69135.7 OK TCONS_00004363 305.231 13238 272.111 12413.6 OK 106.293 1878 139.363 1507.85 OK 349.393 274664 390.432 74213.8 OK TCONS_00004364 12.4948 1043 15.8386 374.545 OK 672.68 26311 1003.49 24202.6 OK 767.614 9.82001e+07 1369.32 7.58952e+06 OK TCONS_00004365 592.801 18448 187.407 17769.9 OK 11184.9 406702 3952.4 402425 OK 45345.6 5.4146e+08 16504.9 4.48338e+08 OK TCONS_00004366 92.4774 3784 157.2 2772.12 OK 1875.43 71272 3203.99 67476.9 OK 9394.88 9.77802e+07 15502.2 9.28886e+07 OK TCONS_00004367 9.06478 1174 14.2878 271.727 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004368 24.5676 73 0.000655155 72.1102 OK 293.072 989.27 0 966.596 OK 0.0171637 1 0.0339104 0.0249525 OK TCONS_00004369 0.000340285 1 0.000655155 0.000998795 OK 0 0 0 0 OK 2.48604 4 0.0339104 3.61419 OK TCONS_00004370 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TCONS_00004371 1162.09 78056 1374.34 64855.6 OK 1295.29 22779 1701.09 21044.1 OK 2916.24 897243 3157.85 873218 OK TCONS_00004372 1644.14 93216 1401.58 91758.7 OK 2599.43 44087 1708.24 42231.9 OK 3534.54 1.07584e+06 3157.85 1.05836e+06 OK TCONS_00004373 86.9303 8237.62 155.15 4851.55 OK 13.1371 307 21.1436 213.433 OK 0 0 0 0 OK TCONS_00004374 246.079 4099.51 0 4099.51 OK 392.791 1565.31 0 1565.31 OK 0 0 0 0 OK TCONS_00004375 11.3478 4263 18.6492 657.529 OK 5.07327 1082 9.12638 127.922 OK 0 0 0 0 OK TCONS_00004376 133.313 10440 247.079 7724.59 OK 541.49 15143 995.635 13653.6 OK 744.687 582849 1363.91 400910 OK TCONS_00004377 919.695 57534 1230.06 53290 OK 3201.44 84883 3604.99 80724.2 OK 2962.91 4.34781e+06 4069.2 1.59512e+06 OK TCONS_00004378 1650.37 97228 1490.22 95627.4 OK 3418.42 162552 3685.71 86195.3 OK 5552.67 3.18855e+06 5111.21 2.98934e+06 OK TCONS_00004379 231.484 17232 404.039 13412.9 OK 511.89 61457.3 945.612 12907.3 OK 1276.26 2.28028e+06 2207.98 687089 OK TCONS_00004380 163.525 10325 292.561 9475.18 OK 6.4308 1003 12.5095 162.152 OK 0 0 0 0 OK TCONS_00004381 0.233016 14 0.465302 13.5017 OK 9.61431 860 18.5441 242.425 OK 0 0 0 0 OK TCONS_00004382 42.1031 3580 76.14 2439.58 OK 213.456 5929 373.516 5382.29 OK 181.811 295199 337.913 97879.7 OK TCONS_00004383 54.7521 897 47.9431 730.475 OK 81.3763 123 0 122.182 OK 944.062 70888 566.671 69882.7 OK TCONS_00004384 51.465 912 50.7955 686.62 OK 0 0 0 0 OK 452.786 38683 579.459 33516.8 OK TCONS_00004385 42.1899 475 14.012 388.077 OK 2.04538 3 0.845403 2.04538 OK 648.668 31938 126.421 31239.7 OK TCONS_00004386 0 0 0 0 OK 1.94462 3 0.845403 1.94462 OK 22.1901 2611 37.1586 1068.67 OK TCONS_00004387 14.053 181 14.012 129.265 OK 0 0 0 0 OK 69.0962 4783 85.5715 3327.66 OK TCONS_00004388 0 0 0 0 OK 0 0 0 0 OK 4.8928 3378 5.63193 235.636 OK TCONS_00004389 56.2661 1736 91.0179 1312.63 OK 57.687 1038 111.781 791.561 OK 199.517 25852 349.682 22492.6 OK TCONS_00004390 33.8123 1184 53.4556 788.808 OK 256.544 4351.64 401.926 3520.2 OK 93.9806 13055 161.875 10594.9 OK TCONS_00004391 53.8583 2093.55 88.7185 1256.46 OK 250.317 8627.08 437.353 3434.76 OK 208.887 25827 369.036 23549 OK TCONS_00004392 297.243 7501 175.431 6934.39 OK 2350.93 37045.5 890.249 32258.6 OK 2015.31 247669 754.532 227197 OK TCONS_00004393 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004394 0 0 0 0 OK 40.9593 854 79.1193 562.029 OK 0 0 0 0 OK TCONS_00004395 0 0 0 0 OK 3.23573 394 5.40835 44.3996 OK 0 0 0 0 OK TCONS_00004396 11.0396 258 0 257.543 OK 3.00016 42 0 41.1671 OK 0 0 0 0 OK TCONS_00004397 36.0089 171 0 170.375 OK 511.032 2376.24 0 2372.72 OK 255.821 7221 0 7220.07 OK TCONS_00004398 1022.18 38616 167.319 38389 OK 3571.31 58226.3 189.661 57350.1 OK 1118.32 88834 369.363 83683.8 OK TCONS_00004399 164.097 8622.18 167.319 6162.85 OK 189.698 3377.88 189.661 3046.28 OK 381.827 33729 369.363 28572.3 OK TCONS_00004400 11.0532 1893 8.82559 455.4 OK 73.577 1212 69.0652 962.843 OK 81.7724 51466 95.2926 18334 OK TCONS_00004401 19.8826 568.923 32.2927 266.536 OK 58.2393 1322.59 97.8645 370.386 OK 15.5936 3941 28.306 889.347 OK TCONS_00004402 0 0 0 0 OK 15.759 254.786 29.7838 100.223 OK 159.249 24962.2 245.644 9082.43 OK TCONS_00004403 9.93607 345.764 15.8915 133.198 OK 25.3977 633.393 41.9927 161.522 OK 46.7033 3428 80.0447 2663.63 OK TCONS_00004404 86.3595 1257 79.8302 1157.69 OK 578.276 3992 306.137 3677.67 OK 426.766 26097 427.641 24339.8 OK TCONS_00004405 38.0154 906.009 51.7169 509.614 OK 69.7933 748.396 111.304 443.866 OK 200.587 26948.1 275.144 11440.1 OK TCONS_00004406 23.7278 538.928 29.4163 318.082 OK 90.0242 705 114.331 572.529 OK 91.1876 16629.9 117.638 5200.7 OK TCONS_00004407 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004408 2.88735 229 1.57808 38.7062 OK 11.2106 125 7.82228 71.2965 OK 4.21282 4347 3.14322 240.27 OK TCONS_00004409 1.40441 654 1.7005 18.8268 OK 4.33971 63 7.20042 27.5993 OK 0 0 0 0 OK TCONS_00004410 108.778 1424 16.2714 1283.93 OK 436.126 2230 122.951 2104.81 OK 1955.42 200048 248.476 191697 OK TCONS_00004411 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004412 0 0 0 0 OK 55.3895 380 87.3973 267.319 OK 119.005 19890 216.549 11666.6 OK TCONS_00004413 6.28075 181.523 8.21784 74.1328 OK 26.5895 171 34.669 128.325 OK 0 0 0 0 OK TCONS_00004414 3.58129 166 1.95731 42.2706 OK 12.7962 84 5.47665 61.7566 OK 6.14363 11626 4.17611 602.283 OK TCONS_00004415 13.394 283 6.98116 158.092 OK 14.5462 81 4.93967 70.2026 OK 64.2936 9656 31.2638 6302.94 OK TCONS_00004416 162.703 2007 0 2006.23 OK 247.108 749 8.36998 737.231 OK 229.13 5826 1.61297 5388.04 OK TCONS_00004417 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004418 0 0 0 0 OK 8.02743 47 8.36998 23.9493 OK 1.41359 1810 1.61297 33.2408 OK TCONS_00004419 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004420 741.442 36375 250.174 35591.6 OK 618.748 10865 694.911 9920.69 OK 277.739 77052 392.382 54244.4 OK TCONS_00004421 122.396 7134 205.774 5875.4 OK 942.879 16151 941.222 15117.6 OK 1851.09 380563 880.444 361532 OK TCONS_00004422 1198.5 58762 90.1333 57531.8 OK 2242.79 36845 677.165 35959.8 OK 2388.4 494076 607.218 466472 OK TCONS_00004423 0 0 0 0 OK 3.21741 8 4.12139 3.21741 OK 0 0 0 0 OK TCONS_00004424 0.876918 3 1.33493 1.29662 OK 8.87328 16 6.49258 8.87328 OK 0 0 0 0 OK TCONS_00004425 1.85847 5 2.21318 2.74796 OK 2.18671 6 3.62681 2.18671 OK 0 0 0 0 OK TCONS_00004426 2.33812 8 2.1315 3.45718 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004427 0.70703 2 0.397675 1.04542 OK 3.17762 5 1.342 3.17762 OK 0 0 0 0 OK TCONS_00004428 6.94482 8 0 7.70653 OK 3.92034 10 5.41364 3.92034 OK 0 0 0 0 OK TCONS_00004429 0 0 0 0 OK 15.545 21 5.41364 15.545 OK 0.000618572 1 0.00120265 0.00130652 OK TCONS_00004430 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004431 0 0 0 0 OK 0 0 0 0 OK 7.85707 18.2218 0.00120265 16.5954 OK TCONS_00004432 0 0 0 0 OK 0 0 0 0 OK 0.00258505 1 0.00508834 0.00258505 OK TCONS_00004433 147.542 1922 16.4363 1795.05 OK 205.432 1070 193.813 867.4 OK 0 0 0 0 OK TCONS_00004434 7.13682 299.537 12.6873 86.8293 OK 110.74 641 152.251 467.582 OK 0.281552 1 0.18297 0.281552 OK TCONS_00004435 0 0 0 0 OK 58.7983 372 97.1202 248.266 OK 0.133063 1 0.181144 0.133063 OK TCONS_00004436 2.88485 299 4.14256 35.0983 OK 66.6291 328 38.5506 281.33 OK 0 0 0 0 OK TCONS_00004437 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004438 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TCONS_00004439 11.048 224.22 17.7267 150.495 OK 17.7244 115 31.8512 71.0903 OK 115.577 6035.44 161.771 4966.29 OK TCONS_00004440 3.12933 397 5.19856 42.6275 OK 28.7603 181 47.0892 115.354 OK 29.8119 2004 50.1883 1281 OK TCONS_00004441 146.408 2093 25.3554 1994.36 OK 353.497 1502 75.3482 1417.83 OK 442.99 20081 205.004 19035.1 OK TCONS_00004442 0 0 0 0 OK 0 0 0 0 OK 8.30351 2594 14.7139 356.798 OK TCONS_00004443 5.45122 214 3.70378 74.256 OK 3.66226 30 1.22778 14.6888 OK 19.8535 1872 7.60156 853.097 OK cummeRbund/inst/extdata/isoforms.fpkm_tracking0000644000175200017520000051240114516004263022712 0ustar00biocbuildbiocbuildtracking_id class_code nearest_ref_id gene_id gene_short_name tss_id locus length coverage iPS_FPKM iPS_conf_lo iPS_conf_hi iPS_status hESC_FPKM hESC_conf_lo hESC_conf_hi hESC_status Fibroblasts_FPKM Fibroblasts_conf_lo Fibroblasts_conf_hi Fibroblasts_status TCONS_00000001 = uc001aaa.3 XLOC_000001 - TSS1 chr1:11873-29961 1652 - 6.88821 0 122.95 OK 0 0 0 OK 10.9963 0 118.178 OK TCONS_00000002 = uc010nxq.1 XLOC_000001 - TSS1 chr1:11873-29961 1488 - 13.1105 0 126.372 OK 0.347386 0 3.15457 OK 0 0 0 OK TCONS_00000003 = uc010nxr.1 XLOC_000001 - TSS1 chr1:11873-29961 1595 - 0.218851 0 7.03901 OK 0 0 0 OK 5.15434 0 132.926 OK TCONS_00000004 = uc001aal.1 XLOC_000002 OR4F5 - chr1:69090-70008 918 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000005 = uc001aaq.1 XLOC_000003 - - chr1:321083-321114 31 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000006 = uc001aar.1 XLOC_000004 - - chr1:321145-321223 78 - 0 0 0 OK 697259 112161 1.28236e+06 OK 14237.7 0 78180.9 OK TCONS_00000007 = uc009vjk.2 XLOC_000005 - TSS2 chr1:322036-328580 2750 - 189.247 43.7707 334.723 OK 358.383 249.161 467.605 OK 29.2848 0 64.2647 OK TCONS_00000008 = uc001aau.2 XLOC_000005 - TSS3 chr1:322036-328580 4369 - 76.6833 0 232.97 OK 338.308 260.583 416.033 OK 5.01291 0 19.0115 OK TCONS_00000009 = uc001aav.3 XLOC_000005 - TSS3 chr1:322036-328580 4272 - 89.8931 0 239.956 OK 0.0127652 0 0.470594 OK 13.7589 0 32.6863 OK TCONS_00000010 = uc010nxu.1 XLOC_000006 OR4F16 - chr1:367658-368595 937 - 1.51396 0 5.87661 OK 0 0 0 OK 0 0 0 OK TCONS_00000011 = uc001aax.1 XLOC_000007 - TSS4 chr1:420205-421839 802 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000012 = uc001aaz.2 XLOC_000008 - - chr1:566461-568045 1584 - 41712.9 41177.1 42248.8 OK 91983.2 91487.1 92479.3 OK 69492.5 47017.9 91967.2 OK TCONS_00000013 = uc001aba.1 XLOC_000009 - - chr1:568148-568842 694 - 665.127 286.861 1043.39 OK 6464.44 5613.09 7315.78 OK 26012.6 8889.07 43136.2 OK TCONS_00000014 = uc001abb.2 XLOC_000010 - - chr1:568843-568912 69 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000015 = uc001abc.2 XLOC_000011 - - chr1:569326-570349 1023 - 7343.63 5236.71 9450.56 OK 31401.9 28536.7 34267 OK 37535.9 12446.1 62625.8 OK TCONS_00000016 = uc009vjn.1 XLOC_000012 - TSS5 chr1:763063-789740 510 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000017 = uc001abp.1 XLOC_000012 - TSS5 chr1:763063-789740 854 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000018 = uc001abq.1 XLOC_000012 - TSS5 chr1:763063-789740 701 - 0 0 0 OK 81.4928 38.0915 124.894 OK 60.0796 0 238.455 OK TCONS_00000019 = uc009vjo.1 XLOC_000012 - TSS5 chr1:763063-789740 517 - 40.7706 0 154.398 OK 0 0 0 OK 17.1018 0 265.73 OK TCONS_00000020 = uc001abr.1 XLOC_000012 - TSS5 chr1:763063-789740 1543 - 80.8625 23.5065 138.219 OK 100.78 73.4387 128.122 OK 214.895 73.1158 356.675 OK TCONS_00000021 = uc001abs.2 XLOC_000013 - - chr1:791897-794579 2682 - 8.98318 1.09737 16.869 OK 28.2795 20.9855 35.5735 OK 74.5004 23.5495 125.451 OK TCONS_00000022 = uc001abu.1 XLOC_000014 - TSS6 chr1:846814-850328 3043 - 8.69571 1.30977 16.0817 OK 27.5823 20.5446 34.6199 OK 0.58031 0 1.55109 OK TCONS_00000023 = uc001abv.1 XLOC_000015 SAMD11 TSS7 chr1:860529-894679 490 - 95.4282 0 619.043 OK 0 0 0 OK 0 0 0 OK TCONS_00000024 = uc001abw.1 XLOC_000015 SAMD11 TSS8 chr1:860529-894679 2554 - 52.9724 0 144.687 OK 1.74761 0 20.2147 OK 3.81714 0 290.443 OK TCONS_00000025 = uc001abx.1 XLOC_000015 SAMD11 TSS9 chr1:860529-894679 2121 - 48.0828 0 161.788 OK 4.50533 0 23.9737 OK 34.9169 0 334.708 OK TCONS_00000026 = uc001aca.1 XLOC_000016 KLHL17 TSS10 chr1:895966-901095 2560 - 63.5773 9.94217 117.212 OK 180.736 130.393 231.079 OK 138.131 30.5583 245.704 OK TCONS_00000027 = uc001acb.1 XLOC_000016 KLHL17 TSS11 chr1:895966-901095 955 - 55.6229 0 144.357 OK 151.63 72.2295 231.031 OK 48.7092 0 168.468 OK TCONS_00000028 = uc001acc.1 XLOC_000016 KLHL17 TSS12 chr1:895966-901095 2003 - 29.3795 0 78.4723 OK 229.433 164.679 294.188 OK 99.7819 0 212.064 OK TCONS_00000029 = uc010nyb.1 XLOC_000016 KLHL17 TSS13 chr1:895966-901095 1149 - 34.9548 0 105.595 OK 180.118 104.051 256.186 OK 60.5379 0 193.719 OK TCONS_00000030 = uc001acd.2 XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 2398 - 6.18605 0.40302 11.9691 OK 13.3791 6.94109 19.817 OK 5.90797 0 41.0692 OK TCONS_00000031 = uc001ace.2 XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 2554 - 0.000108087 0 2.04195 OK 9.40489 3.8758 14.934 OK 22.8971 0 52.1497 OK TCONS_00000032 = uc001acf.2 XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 2293 - 0 0 0 OK 0 0 0 OK 30.5047 0 67.0591 OK TCONS_00000033 = uc001acj.3 XLOC_000018 ISG15 TSS15 chr1:948846-949915 662 - 550.84 220.139 881.541 OK 987.18 798.765 1175.6 OK 3379.09 1852.53 4905.64 OK TCONS_00000034 = uc001ack.1 XLOC_000019 AGRN TSS16 chr1:955502-991492 7319 - 162.844 89.8907 235.797 OK 1857.6 1668.93 2046.27 OK 2553.38 1302.85 3803.9 OK TCONS_00000035 = uc009vjs.1 XLOC_000020 - TSS17 chr1:995082-1001833 673 - 2.60573 0 12.5916 OK 3.11297 0 8.45215 OK 5.82921 0 29.297 OK TCONS_00000036 = uc001acl.1 XLOC_000020 - TSS17 chr1:995082-1001833 971 - 19.9887 2.70834 37.269 OK 28.951 17.0526 40.8494 OK 64.5665 1.56366 127.569 OK TCONS_00000037 = uc001acv.2 XLOC_000021 - TSS18 chr1:1072396-1079432 1616 - 0 0 0 OK 1.64828 0 3.73103 OK 0 0 0 OK TCONS_00000038 = uc001acw.2 XLOC_000022 - - chr1:1102483-1102578 95 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000039 = uc010nye.1 XLOC_000023 - - chr1:1103242-1103332 90 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000040 = uc010nyf.1 XLOC_000024 - - chr1:1104384-1104467 83 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000041 = uc001acy.2 XLOC_000025 TTLL10 TSS19 chr1:1108435-1133313 2259 - 0 0 0 OK 9.72146 4.47198 14.9709 OK 0 0 0 OK TCONS_00000042 = uc010nyg.1 XLOC_000025 TTLL10 TSS19 chr1:1108435-1133313 2278 - 0 0 0 OK 0.00267487 0 0.894791 OK 0 0 0 OK TCONS_00000043 = uc001acz.1 XLOC_000025 TTLL10 TSS20 chr1:1108435-1133313 2111 - 0 0 0 OK 6.97279 2.01336 11.9322 OK 0 0 0 OK TCONS_00000044 = uc001adk.2 XLOC_000026 B3GALT6 - chr1:1167628-1170418 2790 - 223.432 108.188 338.676 OK 276.214 227.595 324.832 OK 1068.96 617.478 1520.43 OK TCONS_00000045 = uc001adt.1 XLOC_000027 SCNN1D TSS21 chr1:1215815-1227409 3054 - 0 0 0 OK 2.57257 0 7.31455 OK 9.60499 0 29.932 OK TCONS_00000046 = uc001adu.1 XLOC_000027 SCNN1D TSS21 chr1:1215815-1227409 2960 - 8.76366 2.09562 15.4317 OK 11.929 3.62748 20.2306 OK 19.6908 0 44.4193 OK TCONS_00000047 = uc001adv.2 XLOC_000027 SCNN1D TSS22 chr1:1215815-1227409 2590 - 0.000995546 0 2.00733 OK 25.3683 12.865 37.8716 OK 15.2046 0 38.8838 OK TCONS_00000048 = uc001adw.2 XLOC_000027 SCNN1D TSS22 chr1:1215815-1227409 2684 - 0 0 0 OK 4.36667 0 10.2072 OK 6.75717 0 24.3184 OK TCONS_00000049 = uc001adx.2 XLOC_000027 SCNN1D TSS22 chr1:1215815-1227409 2530 - 0 0 0 OK 30.4263 16.9744 43.8783 OK 12.2197 0 47.6642 OK TCONS_00000050 = uc001aed.2 XLOC_000028 PUSL1 TSS23 chr1:1227763-1260046 1239 - 253.688 0 583.851 OK 666.825 418.631 915.019 OK 694.672 0 2057.39 OK TCONS_00000051 = uc010nyi.1 XLOC_000028 PUSL1 TSS23 chr1:1227763-1260046 1181 - 81.6371 0 261.06 OK 108.47 1.07573 215.865 OK 160.99 0 1191.98 OK TCONS_00000052 = uc009vjx.2 XLOC_000028 PUSL1 TSS24 chr1:1227763-1260046 1932 - 21.1644 0 123.978 OK 14.7123 0 53.2867 OK 15.8664 0 616.273 OK TCONS_00000053 = uc001aeo.2 XLOC_000029 GLTPD1 TSS25 chr1:1260142-1264275 2192 - 140.404 57.7844 223.024 OK 187.156 149.818 224.494 OK 781.158 428.727 1133.59 OK TCONS_00000054 = uc010nyk.1 XLOC_000030 TAS1R3 TSS26 chr1:1266725-1269843 2558 - 6.25639 0.748851 11.7639 OK 2.57898 0.558292 4.59967 OK 4.31837 0 8.68841 OK TCONS_00000055 = uc001afm.2 XLOC_000031 - TSS27 chr1:1334909-1342693 1747 - 53.2662 0 201.851 OK 152.655 72.5948 232.716 OK 319.473 0 868.813 OK TCONS_00000056 = uc001afn.1 XLOC_000031 - TSS27 chr1:1334909-1342693 1594 - 95.5427 0 253.509 OK 92.5876 29.5912 155.584 OK 62.6627 0 418.167 OK TCONS_00000057 = uc009vkc.1 XLOC_000031 - TSS27 chr1:1334909-1342693 1741 - 103.752 0 280.6 OK 308.066 198.426 417.706 OK 185.591 0 637.661 OK TCONS_00000058 = uc010nyp.1 XLOC_000032 - TSS28 chr1:1361507-1363166 491 - 7.20193 0 21.8767 OK 59.0363 32.2743 85.7983 OK 0 0 0 OK TCONS_00000059 = uc001afr.2 XLOC_000033 VWA1 TSS29 chr1:1370908-1376145 2141 - 5.8712 0 55.7043 OK 58.9274 0 140.956 OK 29.8843 0 99.2644 OK TCONS_00000060 = uc001afs.2 XLOC_000033 VWA1 TSS29 chr1:1370908-1376145 2536 - 222.846 102.784 342.907 OK 469.362 387.247 551.477 OK 444.091 214.109 674.073 OK TCONS_00000061 = uc001aft.2 XLOC_000034 ATAD3C TSS30 chr1:1385068-1405538 3859 - 12.4598 2.74524 22.1743 OK 69.2663 54.4066 84.1261 OK 15.5201 2.93467 28.1056 OK TCONS_00000062 = uc001afv.2 XLOC_000035 ATAD3B TSS31 chr1:1407163-1431581 2432 - 117.436 0.943989 233.928 OK 409.377 321.924 496.83 OK 275.225 68.8205 481.63 OK TCONS_00000063 = uc001afw.2 XLOC_000035 ATAD3B TSS32 chr1:1407163-1431581 1939 - 77.2479 0 183.718 OK 111.183 59.9484 162.418 OK 43.4345 0 137.441 OK TCONS_00000064 = uc001afx.2 XLOC_000035 ATAD3B TSS32 chr1:1407163-1431581 2667 - 202.814 67.8347 337.792 OK 138.44 68.5829 208.298 OK 154.302 0 319.41 OK TCONS_00000065 = uc001afy.2 XLOC_000035 ATAD3B TSS33 chr1:1407163-1431581 1170 - 35.8479 0 150.016 OK 321.282 129.76 512.804 OK 321.282 0 654.988 OK TCONS_00000066 = uc001afz.1 XLOC_000036 ATAD3A TSS34 chr1:1447554-1470064 2611 - 31.4583 0 110.344 OK 54.4924 15.3557 93.6291 OK 39.157 0 219.548 OK TCONS_00000067 = uc001aga.1 XLOC_000036 ATAD3A TSS34 chr1:1447554-1470064 2467 - 470.224 218.199 722.248 OK 790.187 647.172 933.203 OK 819.961 254.633 1385.29 OK TCONS_00000068 = uc001agb.1 XLOC_000036 ATAD3A TSS35 chr1:1447554-1470064 2329 - 100.608 0 223.85 OK 542.034 418.405 665.662 OK 1200.71 478.111 1923.3 OK TCONS_00000069 = uc001agc.1 XLOC_000036 - - chr1:1447554-1470064 2616 - 18.499 0 71.5338 OK 25.8427 0.679674 51.0057 OK 15.9237 0 194.569 OK TCONS_00000070 = uc001agf.1 XLOC_000037 - TSS36 chr1:1535818-1543166 1048 - 2.79141 0 8.36422 OK 10.6728 3.90909 17.4365 OK 5.74721 0 13.7722 OK TCONS_00000071 = uc001agg.2 XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 3243 - 13.0332 0 36.1356 OK 0.00352987 0 0.615929 OK 17.092 0 77.2561 OK TCONS_00000072 = uc001agh.2 XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 3201 - 9.17877 0 28.7895 OK 86.1128 46.7493 125.476 OK 316.769 119.635 513.902 OK TCONS_00000073 = uc001agi.2 XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 3231 - 0 0 0 OK 4.48044 0 17.226 OK 0 0 0 OK TCONS_00000074 = uc001agj.2 XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 3026 - 28.9547 0 58.9289 OK 100.346 63.6034 137.089 OK 66.3531 0 172.477 OK TCONS_00000075 = uc001agk.2 XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 3048 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000076 = uc001agl.1 XLOC_000038 MIB2 TSS38 chr1:1550883-1565984 2930 - 4.60985 0 20.8228 OK 37.6352 4.96135 70.309 OK 44.1025 0 134.088 OK TCONS_00000077 = uc001agm.2 XLOC_000038 - TSS38 chr1:1550883-1565984 2890 - 0.0361283 0 1.8205 OK 26.2154 7.05147 45.3793 OK 16.9683 0 82.8635 OK TCONS_00000078 = uc010nyq.1 XLOC_000038 MIB2 TSS39 chr1:1550883-1565984 3311 - 0 0 0 OK 3.88743 0 11.076 OK 56.0751 0 156.18 OK TCONS_00000079 = uc009vkh.2 XLOC_000038 MIB2 TSS40 chr1:1550883-1565984 2590 - 0 0 0 OK 100.348 62.3934 138.302 OK 45.3624 0 272.337 OK TCONS_00000080 = uc001agn.2 XLOC_000038 MIB2 TSS41 chr1:1550883-1565984 2308 - 12.0776 0 40.1051 OK 0 0 0 OK 30.3273 0 284.908 OK TCONS_00000081 = uc001ago.2 XLOC_000038 - TSS42 chr1:1550883-1565984 585 - 20.1981 0 139.654 OK 217.26 11.3877 423.133 OK 0 0 0 OK TCONS_00000082 = uc001agp.2 XLOC_000039 MMP23B TSS43 chr1:1567559-1570029 1239 - 3.14247 0 12.2684 OK 33.88 18.0044 49.7556 OK 6.12558 0 19.2931 OK TCONS_00000083 = uc001agq.2 XLOC_000039 - TSS43 chr1:1567559-1570029 1306 - 9.57879 0 20.9378 OK 23.6518 10.1005 37.203 OK 0 0 0 OK TCONS_00000084 = uc001agr.2 XLOC_000039 - TSS44 chr1:1567559-1570029 905 - 0 0 0 OK 0 0 0 OK 13.8369 0 36.035 OK TCONS_00000085 = uc009vki.2 XLOC_000039 - TSS45 chr1:1567559-1570029 850 - 0.730004 0 7.95551 OK 9.67624 0 26.3795 OK 6.24162 0 31.9677 OK TCONS_00000086 = uc001ahi.1 XLOC_000040 - TSS46 chr1:1571099-1677431 906 - 0 0 0 OK 73.9259 0 204.54 OK 90.7454 0 2295.13 OK TCONS_00000087 = uc009vko.1 XLOC_000040 - TSS47 chr1:1571099-1677431 848 - 19.4885 0 121.567 OK 18.0861 0 106.613 OK 2.78903 0 5238.31 OK TCONS_00000088 = uc001ahx.1 XLOC_000041 - TSS48 chr1:1571099-1677431 1808 - 65.0308 0 219.479 OK 78.5208 2.15522 154.886 OK 84.1606 0 1061.25 OK TCONS_00000089 = uc001aig.1 XLOC_000042 - TSS49 chr1:1822909-1824112 921 - 4.99201 0 13.0756 OK 3.15678 0 7.15379 OK 11.254 0 24.0748 OK TCONS_00000090 = uc001aih.1 XLOC_000043 CALML6 TSS50 chr1:1846265-1848733 1101 - 5.39767 0 12.9423 OK 26.9908 16.4977 37.4839 OK 1.08118 0 3.44841 OK TCONS_00000091 = uc001aip.2 XLOC_000044 GABRD TSS51 chr1:1950767-1962192 1925 - 12.037 2.28368 21.7903 OK 41.7053 30.9987 52.4118 OK 0.393202 0 1.41275 OK TCONS_00000092 = uc001aiq.2 XLOC_000045 PRKCZ TSS52 chr1:1981908-2139172 2324 - 199.815 52.1436 347.487 OK 833.609 681.248 985.97 OK 0 0 0 OK TCONS_00000093 = uc001air.2 XLOC_000045 PRKCZ TSS53 chr1:1981908-2139172 2112 - 0 0 0 OK 0 0 0 OK 45.4119 0 156.55 OK TCONS_00000094 = uc010nyw.1 XLOC_000045 PRKCZ TSS54 chr1:1981908-2139172 2032 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000095 = uc001ais.2 XLOC_000045 PRKCZ TSS55 chr1:1981908-2139172 2009 - 94.566 0 220.657 OK 60.5588 0 129.341 OK 0 0 0 OK TCONS_00000096 = uc009vla.2 XLOC_000045 PRKCZ TSS56 chr1:1981908-2139172 1745 - 0 0 0 OK 0 0 0 OK 34.2875 0 174.055 OK TCONS_00000097 = uc009vlb.2 XLOC_000045 PRKCZ TSS57 chr1:1981908-2139172 1212 - 5.19072 0 140.764 OK 3.07856 0 36.4667 OK 0 0 0 OK TCONS_00000098 = uc010nyx.1 XLOC_000045 PRKCZ TSS57 chr1:1981908-2139172 1849 - 0 0 0 OK 14.6847 0 56.0454 OK 0 0 0 OK TCONS_00000099 = uc001ait.2 XLOC_000045 PRKCZ TSS58 chr1:1981908-2139172 1859 - 7.19324 0 87.0707 OK 17.4198 0 48.8643 OK 0 0 0 OK TCONS_00000100 = uc001aiu.1 XLOC_000045 - - chr1:1981908-2139172 2089 - 16.6051 0 75.873 OK 54.9905 12.3765 97.6045 OK 11.1992 0 125.537 OK TCONS_00000101 = uc001aiz.1 XLOC_000046 - - chr1:1981908-2139172 1943 - 66.2174 0 158.32 OK 109.688 49.1409 170.236 OK 100.493 0 256.343 OK TCONS_00000102 = uc001aja.3 XLOC_000047 SKI TSS59 chr1:2160133-2241651 5706 - 246.057 139.664 352.451 OK 740.008 646.624 833.392 OK 1645.91 940.496 2351.32 OK TCONS_00000103 = uc001aje.1 XLOC_000048 RER1 TSS60 chr1:2323213-2344010 3093 - 800.086 476.256 1123.92 OK 772.363 649.835 894.891 OK 3798.35 1902.54 5694.16 OK TCONS_00000104 = uc001ajf.1 XLOC_000048 RER1 TSS60 chr1:2323213-2344010 3203 - 33.4962 0 122.928 OK 30.1072 4.99162 55.2227 OK 143.247 0 575.754 OK TCONS_00000105 = uc001aji.1 XLOC_000049 PLCH2 TSS61 chr1:2407753-2436969 4834 - 0 0 0 OK 1.11603 0 2.44788 OK 0.769693 0 4.06489 OK TCONS_00000106 = uc010nyz.1 XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 3951 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000107 = uc009vle.1 XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 3939 - 0 0 0 OK 6.36609e-05 0 0.497185 OK 0.593027 0 4.98522 OK TCONS_00000108 = uc001ajj.1 XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 4854 - 2.28814e-05 0 1.03298 OK 0 0 0 OK 0 0 0 OK TCONS_00000109 = uc001ajk.1 XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 5564 - 1.08359 0 2.87839 OK 1.19958 0 2.40297 OK 1.27131 0 4.08712 OK TCONS_00000110 = uc001ajl.1 XLOC_000049 PLCH2 TSS63 chr1:2407753-2436969 2241 - 1.2132 0 5.26466 OK 0 0 0 OK 0 0 0 OK TCONS_00000111 = uc010nzc.1 XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 722 - 21.3399 0 99.2141 OK 0.103287 0 3.40592 OK 118.524 0 409.04 OK TCONS_00000112 = uc009vlf.1 XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 1671 - 4.50144 0 23.5184 OK 1.72115 0 4.50751 OK 42.8167 0 145.188 OK TCONS_00000113 = uc001ajt.1 XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 4460 - 2.02513 0 7.90803 OK 0.4903 0 1.36247 OK 46.0527 0 106.863 OK TCONS_00000114 = uc001ajr.2 XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 1704 - 20.3741 0 52.4313 OK 0 0 0 OK 650.706 280.598 1020.81 OK TCONS_00000115 = uc001ajs.2 XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 1561 - 0 0 0 OK 1.45201 0 4.42749 OK 29.4904 0 143.972 OK TCONS_00000116 = uc001aju.1 XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 2709 - 222.585 36.4149 408.755 OK 431.86 338.283 525.436 OK 616.77 232.585 1000.95 OK TCONS_00000117 = uc001ajv.1 XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 2763 - 0 0 0 OK 36.9813 8.66116 65.3015 OK 5.26014 0 132.95 OK TCONS_00000118 = uc001ajw.1 XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 2677 - 147.391 0 297.517 OK 327.266 246.582 407.95 OK 561.382 197.151 925.612 OK TCONS_00000119 = uc010nzd.1 XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 2697 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000120 = uc010nze.1 XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 2601 - 20.6279 0 70.2256 OK 15.5461 0 34.9892 OK 21.4195 0 144.599 OK TCONS_00000121 = uc010nzf.1 XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 2598 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000122 = uc001ajx.1 XLOC_000051 C1orf93 TSS66 chr1:2518248-2564481 2571 - 48.0815 0 133.857 OK 46.1049 14.1008 78.109 OK 83.8728 0 255.808 OK TCONS_00000123 = uc001ajz.2 XLOC_000052 ACTRT2 - chr1:2938045-2939465 1420 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000124 = uc001akc.2 XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 8659 - 0.586072 0 1.72703 OK 4.52426 2.56981 6.47872 OK 0 0 0 OK TCONS_00000125 = uc001akd.2 XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 8716 - 0.00101879 0 0.567688 OK 0 0 0 OK 7.0186 0.561578 13.4756 OK TCONS_00000126 = uc001ake.2 XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 8662 - 0.419018 0 1.55957 OK 0.770522 0 2.28146 OK 0 0 0 OK TCONS_00000127 = uc001akf.2 XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 8719 - 0.000730027 0 0.567201 OK 0 0 0 OK 1.20838 0 7.4165 OK TCONS_00000128 = uc009vlh.2 XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 8720 - 0.000653284 0 0.567057 OK 0 0 0 OK 0 0 0 OK TCONS_00000129 = uc001akg.3 XLOC_000054 ARHGEF16 TSS68 chr1:3371146-3397675 2902 - 135.254 53.9378 216.57 OK 229.313 180.517 278.109 OK 2.38434 0 7.0422 OK TCONS_00000130 = uc001aki.2 XLOC_000054 ARHGEF16 TSS69 chr1:3371146-3397675 2209 - 0 0 0 OK 60.5958 27.1107 94.0808 OK 2.38281 0 8.41518 OK TCONS_00000131 = uc001akj.2 XLOC_000054 ARHGEF16 TSS70 chr1:3371146-3397675 2217 - 23.0853 0 80.9527 OK 60.018 28.905 91.1311 OK 0.0183886 0 1.15392 OK TCONS_00000132 = uc009vli.1 XLOC_000054 ARHGEF16 TSS71 chr1:3371146-3397675 1403 - 8.08924 0 60.6874 OK 11.6052 0 28.8434 OK 0 0 0 OK TCONS_00000133 = uc010nzh.1 XLOC_000054 ARHGEF16 TSS71 chr1:3371146-3397675 1817 - 0 0 0 OK 5.86138 0 18.5419 OK 0 0 0 OK TCONS_00000134 = uc001akm.2 XLOC_000055 TPRG1L TSS72 chr1:3541555-3546692 2425 - 546.504 302.59 790.417 OK 498.776 417.899 579.653 OK 2676.03 1552.21 3799.85 OK TCONS_00000135 = uc009vlj.2 XLOC_000055 TPRG1L TSS72 chr1:3541555-3546692 2248 - 0 0 0 OK 0 0 0 OK 20.4274 0 287.534 OK TCONS_00000136 = uc001akq.2 XLOC_000056 TP73 TSS73 chr1:3569128-3650467 1904 - 4.13128 0 13.838 OK 0 0 0 OK 0.438492 0 2.75575 OK TCONS_00000137 = uc001akp.2 XLOC_000056 TP73 TSS73 chr1:3569128-3650467 2845 - 5.30242 0 11.8443 OK 63.3435 47.6627 79.0243 OK 3.93866 0 8.99546 OK TCONS_00000138 = uc010nzj.1 XLOC_000056 TP73 TSS74 chr1:3569128-3650467 1585 - 1.53994 0 6.41886 OK 5.31366 0 14.0565 OK 0 0 0 OK TCONS_00000139 = uc001akr.2 XLOC_000056 TP73 TSS74 chr1:3569128-3650467 2822 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000140 = uc001aks.2 XLOC_000056 TP73 TSS74 chr1:3569128-3650467 2728 - 0 0 0 OK 4.94475 0 10.8724 OK 0 0 0 OK TCONS_00000141 = uc009vlk.1 XLOC_000056 TP73 TSS74 chr1:3569128-3650467 2673 - 0 0 0 OK 0.0344885 0 0.785779 OK 0 0 0 OK TCONS_00000142 = uc009vll.2 XLOC_000056 - TSS75 chr1:3569128-3650467 1091 - 3.71815 0 12.9619 OK 0.585598 0 3.51027 OK 0 0 0 OK TCONS_00000143 = uc010nzk.1 XLOC_000056 TP73 TSS75 chr1:3569128-3650467 2655 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000144 = uc010nzl.1 XLOC_000056 - TSS76 chr1:3569128-3650467 1894 - 0 0 0 OK 0.923281 0 12.4564 OK 0.0133356 0 1.36251 OK TCONS_00000145 = uc001akv.2 XLOC_000057 CCDC27 TSS77 chr1:3668964-3688209 2174 - 0.580625 0 2.25377 OK 2.99279 0.634917 5.35067 OK 0.344217 0 1.23675 OK TCONS_00000146 = uc001akw.3 XLOC_000058 - TSS78 chr1:3689351-3692545 545 - 29.1182 1.52983 56.7065 OK 76.8718 48.7695 104.974 OK 58.9016 6.1034 111.7 OK TCONS_00000147 = uc009vln.1 XLOC_000059 DFFB TSS79 chr1:3773844-3801992 760 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000148 = uc001ala.1 XLOC_000059 DFFB TSS79 chr1:3773844-3801992 679 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000149 = uc009vlo.1 XLOC_000059 DFFB TSS79 chr1:3773844-3801992 956 - 0 0 0 OK 4.80895 0 22.2279 OK 0 0 0 OK TCONS_00000150 = uc001alb.2 XLOC_000059 CAD TSS79 chr1:3773844-3801992 3049 - 0 0 0 OK 0 0 0 OK 5.63584 0 63.2635 OK TCONS_00000151 = uc001alc.2 XLOC_000059 DFFB TSS79 chr1:3773844-3801992 3027 - 62.8589 19.4478 106.27 OK 86.6597 64.6641 108.655 OK 101.804 29.8944 173.713 OK TCONS_00000152 = uc001ald.2 XLOC_000059 DFFB TSS79 chr1:3773844-3801992 3077 - 6.55552 0 29.4468 OK 0 0 0 OK 0 0 0 OK TCONS_00000153 = uc001ale.2 XLOC_000059 CAD TSS79 chr1:3773844-3801992 3164 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000154 = uc009vlp.2 XLOC_000059 CAD TSS79 chr1:3773844-3801992 3151 - 3.55215 0 29.5341 OK 5.5449 0 12.7704 OK 0 0 0 OK TCONS_00000155 = uc009vlq.2 XLOC_000059 CAD TSS79 chr1:3773844-3801992 3114 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000156 = uc009vlr.2 XLOC_000059 CAD TSS79 chr1:3773844-3801992 3196 - 0 0 0 OK 14.4431 4.20032 24.6859 OK 4.99183 0 27.9467 OK TCONS_00000157 = uc010nzn.1 XLOC_000059 DFFB TSS79 chr1:3773844-3801992 3099 - 0.00638818 0 1.66332 OK 8.65205 0.595917 16.7082 OK 4.32215 0 28.7398 OK TCONS_00000158 = uc001alg.2 XLOC_000060 - TSS80 chr1:3816967-3833877 1950 - 5.25796 0 11.3543 OK 0.672575 0 3.34763 OK 1.74517 0 5.22828 OK TCONS_00000159 = uc010nzo.1 XLOC_000060 - TSS80 chr1:3816967-3833877 1279 - 0.0100414 0 4.39677 OK 14.4718 6.95284 21.9908 OK 1.74564 0 5.44009 OK TCONS_00000160 = uc001alh.3 XLOC_000060 - TSS80 chr1:3816967-3833877 1055 - 1.6192 0 7.06924 OK 9.81514 2.93372 16.6966 OK 0.782057 0 3.41107 OK TCONS_00000161 = uc001ali.1 XLOC_000061 - TSS81 chr1:4000676-4015322 3242 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000162 = uc001alj.2 XLOC_000062 - TSS82 chr1:4472110-4484744 2074 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000163 = uc001alm.1 XLOC_000063 AJAP1 TSS83 chr1:4715104-4843850 2070 - 25.884 0 77.9417 OK 24.6786 6.2376 43.1195 OK 0.851814 0 2.57808 OK TCONS_00000164 = uc001aln.2 XLOC_000063 AJAP1 TSS83 chr1:4715104-4843850 2922 - 78.56 21.3017 135.818 OK 49.2798 33.2269 65.3327 OK 0.414322 0 1.66352 OK TCONS_00000165 = uc001alo.3 XLOC_000064 - - chr1:4847557-4852182 4625 - 37.4079 11.2885 63.5273 OK 18.1722 13.5426 22.8018 OK 0.154615 0 0.555523 OK TCONS_00000166 = uc009vlv.1 XLOC_000065 KCNAB2 TSS84 chr1:6052765-6160523 3128 - 7.70132 0 29.9418 OK 20.2988 7.89535 32.7022 OK 68.4146 0.707363 136.122 OK TCONS_00000167 = uc001alu.2 XLOC_000065 KCNAB2 TSS85 chr1:6052765-6160523 2388 - 4.70189 0 23.6288 OK 14.9138 3.68932 26.1382 OK 1.91789 0 34.113 OK TCONS_00000168 = uc001alv.1 XLOC_000065 KCNAB2 TSS85 chr1:6052765-6160523 3171 - 4.61083 0 29.9074 OK 0 0 0 OK 0 0 0 OK TCONS_00000169 = uc001alw.1 XLOC_000065 KCNAB2 TSS85 chr1:6052765-6160523 3129 - 48.7059 8.83202 88.5798 OK 95.0662 71.8645 118.268 OK 32.7443 0 84.645 OK TCONS_00000170 = uc001alx.1 XLOC_000065 KCNAB2 TSS86 chr1:6052765-6160523 3557 - 3.9331 0 27.0755 OK 0.784025 0 3.96989 OK 0 0 0 OK TCONS_00000171 = uc001aly.1 XLOC_000065 KCNAB2 TSS87 chr1:6052765-6160523 3426 - 3.90167 0 29.1169 OK 0.706557 0 4.26385 OK 0 0 0 OK TCONS_00000172 = uc009vlw.1 XLOC_000065 KCNAB2 TSS87 chr1:6052765-6160523 3137 - 1.06639 0 6.48726 OK 0 0 0 OK 0 0 0 OK TCONS_00000173 = uc001amf.1 XLOC_000066 RNF207 TSS88 chr1:6266188-6296044 1293 - 11.3399 0 85.8279 OK 12.8983 0 50.6886 OK 4.63395 0 104.992 OK TCONS_00000174 = uc001amg.2 XLOC_000066 RNF207 TSS88 chr1:6266188-6296044 3963 - 37.9114 0 138.554 OK 28.2454 0.993569 55.4972 OK 35.0042 0 351.584 OK TCONS_00000175 = uc001amh.2 XLOC_000066 RNF207 TSS89 chr1:6266188-6296044 1412 - 15.3246 0 237.481 OK 17.0218 0 66.4273 OK 10.1307 0 1022.49 OK TCONS_00000176 = uc010nzp.1 XLOC_000066 RNF207 TSS90 chr1:6266188-6296044 1421 - 13.014 0 241.412 OK 17.9047 0 67.4698 OK 18.1716 0 1034.72 OK TCONS_00000177 = uc001amm.2 XLOC_000067 C1orf211 TSS91 chr1:6297870-6299490 1248 - 56.5093 17.4592 95.5594 OK 132.225 101.278 163.171 OK 4.35392 0 9.9704 OK TCONS_00000178 = uc009vly.1 XLOC_000068 HES3 TSS92 chr1:6304261-6305638 687 - 435.49 167.883 703.097 OK 1431.61 1179.29 1683.94 OK 0 0 0 OK TCONS_00000179 = uc001amy.2 XLOC_000069 ESPN TSS93 chr1:6484847-6521003 3530 - 7.69434 0 16.3569 OK 20.3609 6.88119 33.8405 OK 0.205083 0 0.894501 OK TCONS_00000180 = uc001amz.2 XLOC_000069 ESPN TSS94 chr1:6484847-6521003 1883 - 11.3056 0 27.1057 OK 157.325 115.978 198.673 OK 0 0 0 OK TCONS_00000181 = uc001ant.2 XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 2698 - 1.5274 0 4.85725 OK 0.605201 0 1.88579 OK 0 0 0 OK TCONS_00000182 = uc001anu.2 XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 1936 - 2.01343 0 6.79721 OK 0.10991 0 1.17006 OK 8.05147e-05 0 1.33365 OK TCONS_00000183 = uc001anv.2 XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 1293 - 0 0 0 OK 0.536804 0 2.90782 OK 4.20431 0 11.5663 OK TCONS_00000184 = uc001anw.2 XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 2364 - 0.00440741 0 2.21976 OK 0 0 0 OK 1.29131 0 4.66984 OK TCONS_00000185 = uc009vmc.1 XLOC_000071 ZBTB48 TSS96 chr1:6640055-6649339 2257 - 69.0214 0 139.692 OK 15.0088 0.0602618 29.9573 OK 40.46 0 112.946 OK TCONS_00000186 = uc001anx.2 XLOC_000071 ZBTB48 TSS96 chr1:6640055-6649339 2337 - 60.0558 0 127.884 OK 78.4398 45.0306 111.849 OK 47.2474 0 116.387 OK TCONS_00000187 = uc009vmd.1 XLOC_000071 ZBTB48 TSS96 chr1:6640055-6649339 2265 - 28.5408 0 80.9502 OK 147.658 105.032 190.285 OK 126.765 19.3153 234.215 OK TCONS_00000188 = uc001any.1 XLOC_000071 - TSS97 chr1:6640055-6649339 2483 - 23.546 0 68.0149 OK 85.1502 54.8878 115.413 OK 38.1578 0 102.208 OK TCONS_00000189 = uc001aob.3 XLOC_000072 PHF13 TSS98 chr1:6673755-6684092 3669 - 277.454 147.158 407.75 OK 660.096 566.862 753.331 OK 769.313 441.751 1096.88 OK TCONS_00000190 = uc001aoc.2 XLOC_000073 THAP3 TSS99 chr1:6684924-6761966 1363 - 69.7903 0 270.762 OK 126.801 34.04 219.563 OK 402.426 0 1046.12 OK TCONS_00000191 = uc001aod.2 XLOC_000073 THAP3 TSS100 chr1:6684924-6761966 1270 - 27.7067 0 193.703 OK 87.2395 8.25456 166.224 OK 129.652 0 629.304 OK TCONS_00000192 = uc001aoe.1 XLOC_000073 THAP3 TSS100 chr1:6684924-6761966 2094 - 7.22222 0 113.094 OK 19.5526 0 52.1803 OK 26.3763 0 314.839 OK TCONS_00000193 = uc001aoh.2 XLOC_000074 - TSS101 chr1:6845383-7829763 722 - 1270.29 606.993 1933.59 OK 1433.01 1163.59 1702.43 OK 3192.65 1719.82 4665.47 OK TCONS_00000194 = uc001aoi.2 XLOC_000074 CAMTA1 TSS101 chr1:6845383-7829763 8441 - 4.74737 0 16.3548 OK 8.2803 2.66768 13.8929 OK 3.72176 0 24.6657 OK TCONS_00000195 = uc001aok.3 XLOC_000074 CAMTA1 TSS102 chr1:6845383-7829763 5417 - 8.87986 0 34.9381 OK 26.1246 14.0847 38.1644 OK 0 0 0 OK TCONS_00000196 = uc001aoj.2 XLOC_000074 CAMTA1 TSS103 chr1:6845383-7829763 5158 - 0 0 0 OK 0 0 0 OK 1.97243 0 40.9763 OK TCONS_00000197 = uc009vmf.2 XLOC_000074 - TSS104 chr1:6845383-7829763 3979 - 1.762 0 41.0413 OK 0 0 0 OK 0 0 0 OK TCONS_00000198 = uc001aol.2 XLOC_000075 VAMP3 TSS105 chr1:7831328-7841491 2204 - 1500.64 962.379 2038.91 OK 502.334 419.37 585.299 OK 7098.44 3876.89 10320 OK TCONS_00000199 = uc001aon.2 XLOC_000076 PER3 TSS106 chr1:7844379-7973294 1523 - 54.7294 0 200.706 OK 7.32764 0 20.8878 OK 29.553 0 195.596 OK TCONS_00000200 = uc009vmg.1 XLOC_000076 PER3 TSS106 chr1:7844379-7973294 3524 - 13.107 0 67.7636 OK 0 0 0 OK 17.4103 0 82.8904 OK TCONS_00000201 = uc009vmh.1 XLOC_000076 PER3 TSS107 chr1:7844379-7973294 3414 - 26.7829 0 123.208 OK 47.2457 28.5439 65.9475 OK 0 0 0 OK TCONS_00000202 = uc001aoo.2 XLOC_000076 PER3 TSS107 chr1:7844379-7973294 6251 - 42.7797 0 92.8869 OK 7.06457 1.40267 12.7265 OK 82.6263 4.20638 161.046 OK TCONS_00000203 = uc001aop.2 XLOC_000076 PER3 TSS107 chr1:7844379-7973294 6278 - 139.727 47.5836 231.869 OK 53.7103 39.7842 67.6364 OK 221.632 88.7033 354.56 OK TCONS_00000204 = uc010nzw.1 XLOC_000076 PER3 TSS107 chr1:7844379-7973294 6336 - 14.3316 0 50.4134 OK 2.51904 0 7.05031 OK 7.31695 0 43.1988 OK TCONS_00000205 = uc001aow.3 XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 1476 - 57.799 0 210.952 OK 27.1603 0 73.3072 OK 17.1487 0 1349.12 OK TCONS_00000206 = uc001aou.3 XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 902 - 3958.08 2474.46 5441.7 OK 6020.73 5168.1 6873.37 OK 13290.9 5205.71 21376.1 OK TCONS_00000207 = uc001aov.3 XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 842 - 34.9676 0 365.789 OK 35.935 0 132.768 OK 301.624 0 2879.48 OK TCONS_00000208 = uc001aox.3 XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 960 - 626.306 0 1253.47 OK 2349.66 1809.36 2889.96 OK 8031.84 1923.93 14139.8 OK TCONS_00000209 = uc001aoy.1 XLOC_000077 - - chr1:8021713-8045341 2323 - 26.021 0 117.423 OK 14.3833 0 41.7993 OK 7.3862 0 796.686 OK TCONS_00000210 = uc001apb.2 XLOC_000078 SLC45A1 TSS109 chr1:8384389-8404226 2400 - 1.80448 0 6.154 OK 29.7198 20.3457 39.0939 OK 142.738 43.7625 241.713 OK TCONS_00000211 = uc001apc.2 XLOC_000078 SLC45A1 TSS110 chr1:8384389-8404226 1756 - 9.62868 0 19.3119 OK 9.9298 1.33427 18.5253 OK 69.3396 0 173.193 OK TCONS_00000212 = uc001apm.2 XLOC_000079 CA6 TSS111 chr1:9005921-9035146 1334 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000213 = uc009vmn.2 XLOC_000079 CA6 TSS111 chr1:9005921-9035146 1154 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000214 = uc001apt.2 XLOC_000080 H6PD TSS112 chr1:9294862-9331392 9113 - 137.324 75.6555 198.993 OK 93.0165 77.025 109.008 OK 1112.18 629.474 1594.88 OK TCONS_00000215 = uc010oae.1 XLOC_000081 SPSB1 TSS113 chr1:9352940-9429588 3115 - 70.5381 22.0311 119.045 OK 18.3153 7.78939 28.8412 OK 201.501 11.8174 391.185 OK TCONS_00000216 = uc001apv.2 XLOC_000081 SPSB1 TSS114 chr1:9352940-9429588 2961 - 17.2656 0 47.0766 OK 67.8157 50.0195 85.6119 OK 674.909 329.316 1020.5 OK TCONS_00000217 = uc001apw.2 XLOC_000082 SLC25A33 TSS115 chr1:9599527-9642830 1460 - 216.702 89.7467 343.656 OK 207.722 137.586 277.857 OK 258.098 86.8484 429.348 OK TCONS_00000218 = uc001apx.2 XLOC_000082 SLC25A33 TSS115 chr1:9599527-9642830 1536 - 0 0 0 OK 21.5619 0 87.518 OK 8.24063 0 65.4945 OK TCONS_00000219 = uc001apy.2 XLOC_000083 TMEM201 TSS116 chr1:9648976-9674935 3848 - 68.1769 16.6605 119.693 OK 171.51 130.412 212.609 OK 257.242 112.588 401.896 OK TCONS_00000220 = uc001apz.2 XLOC_000083 TMEM201 TSS116 chr1:9648976-9674935 3735 - 54.5583 7.52987 101.587 OK 230.871 182.65 279.092 OK 73.4533 0 153.58 OK TCONS_00000221 = uc001aqb.3 XLOC_000084 PIK3CD TSS117 chr1:9711789-9884550 5410 - 42.5258 0 112.708 OK 260.118 181.483 338.754 OK 45.2674 0 579.677 OK TCONS_00000222 = uc010oaf.1 XLOC_000084 PIK3CD TSS118 chr1:9711789-9884550 5336 - 132.845 26.5593 239.131 OK 155.927 94.5391 217.315 OK 109.373 0 648.449 OK TCONS_00000223 = uc001aqe.3 XLOC_000084 PIK3CD TSS119 chr1:9711789-9884550 5482 - 17.0706 0 54.8339 OK 25.5368 0 51.0761 OK 21.2442 0 553.241 OK TCONS_00000224 = uc001aqp.2 XLOC_000085 NMNAT1 TSS120 chr1:10003485-10045555 3780 - 61.6068 21.6744 101.539 OK 39.4422 30.2486 48.6358 OK 319.369 166.702 472.035 OK TCONS_00000225 = uc001aqq.2 XLOC_000086 RBP7 TSS121 chr1:10057254-10076077 654 - 115.178 32.484 197.872 OK 229.575 173.78 285.371 OK 19.7819 0 39.7651 OK TCONS_00000226 = uc009vms.2 XLOC_000086 RBP7 TSS121 chr1:10057254-10076077 869 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000227 = uc001aqr.3 XLOC_000087 UBE4B TSS122 chr1:10093015-10241294 5515 - 515.733 327.125 704.341 OK 1102.07 970.856 1233.29 OK 1122.9 618.088 1627.72 OK TCONS_00000228 = uc001aqs.3 XLOC_000087 UBE4B TSS122 chr1:10093015-10241294 5902 - 15.4936 0 48.4491 OK 20.3244 2.17193 38.4768 OK 40.3364 0 143.901 OK TCONS_00000229 = uc010oai.1 XLOC_000087 UBE4B TSS122 chr1:10093015-10241294 5548 - 0 0 0 OK 0 0 0 OK 6.69762 0 122.769 OK TCONS_00000230 = uc010oaj.1 XLOC_000087 - TSS122 chr1:10093015-10241294 5400 - 0 0 0 OK 4.50396 0 16.6407 OK 0 0 0 OK TCONS_00000231 = uc001aqt.1 XLOC_000087 - TSS123 chr1:10093015-10241294 1035 - 171.613 0 479.562 OK 10.087 0 66.4644 OK 70.0715 0 791.741 OK TCONS_00000232 = uc001aqu.2 XLOC_000087 - TSS124 chr1:10093015-10241294 2038 - 7.8499 0 129.227 OK 10.3213 0 42.9367 OK 200.875 0 653.389 OK TCONS_00000233 = uc009vmt.2 XLOC_000088 - TSS125 chr1:10270763-10441659 1574 - 3.41691 0 358.654 OK 2.25564 0 39.7345 OK 3.63439 0 706.749 OK TCONS_00000234 = uc001aqv.3 XLOC_000088 KIF1B TSS125 chr1:10270763-10441659 7662 - 419.379 235.939 602.82 OK 196.401 149.742 243.06 OK 864.235 440.814 1287.66 OK TCONS_00000235 = uc001aqw.3 XLOC_000088 KIF1B TSS125 chr1:10270763-10441659 10579 - 410.895 257.554 564.236 OK 346.933 294.33 399.535 OK 143.712 0 291.544 OK TCONS_00000236 = uc001aqx.3 XLOC_000088 KIF1B TSS126 chr1:10270763-10441659 10667 - 0 0 0 OK 1.09608 0 9.00725 OK 5.57672 0 81.5452 OK TCONS_00000237 = uc001aqy.2 XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 8667 - 0 0 0 OK 3.19143 0 10.4165 OK 0 0 0 OK TCONS_00000238 = uc001aqz.2 XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 8745 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000239 = uc001ara.2 XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 8625 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000240 = uc001arb.2 XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 8703 - 76.9201 0 185.844 OK 87.5644 57.3981 117.731 OK 29.2168 0 142.034 OK TCONS_00000241 = uc001arc.2 XLOC_000089 PGD TSS128 chr1:10459084-10480200 1936 - 1337.23 829.624 1844.83 OK 6778.74 6061.76 7495.72 OK 13482.1 6095.5 20868.7 OK TCONS_00000242 = uc001ard.2 XLOC_000089 PGD TSS128 chr1:10459084-10480200 1940 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000243 = uc010oak.1 XLOC_000089 PGD TSS128 chr1:10459084-10480200 1870 - 74.0847 0 219.053 OK 402.424 216.163 588.686 OK 483.083 0 2470.52 OK TCONS_00000244 = uc010oal.1 XLOC_000089 PGD TSS128 chr1:10459084-10480200 2051 - 5.58516 0 127.824 OK 2.2212 0 50.1987 OK 4.89393 0 2165.66 OK TCONS_00000245 = uc001are.2 XLOC_000090 APITD1 TSS129 chr1:10490158-10512208 1235 - 67.0275 0 156.476 OK 84.7865 49.158 120.415 OK 99.6012 0 278.374 OK TCONS_00000246 = uc001arf.2 XLOC_000090 APITD1 TSS129 chr1:10490158-10512208 1467 - 6.3006 0 63.5049 OK 0 0 0 OK 21.9227 0 108.02 OK TCONS_00000247 = uc001arg.2 XLOC_000090 Cort TSS129 chr1:10490158-10512208 1400 - 5.24611 0 70.1335 OK 9.52176 0 23.3909 OK 3.73278 0 123.626 OK TCONS_00000248 = uc001arh.2 XLOC_000090 APITD1 TSS130 chr1:10490158-10512208 1427 - 172.607 47.2749 297.939 OK 138.152 98.4097 177.895 OK 526.06 218.688 833.433 OK TCONS_00000249 = uc001ari.2 XLOC_000090 CORT TSS131 chr1:10490158-10512208 1184 - 33.6985 0 108.268 OK 27.3151 7.59018 47.0399 OK 12.1268 0 127.453 OK TCONS_00000250 = uc001arl.2 XLOC_000091 Pex14 TSS132 chr1:10535002-10690813 309 - 31.0581 0 203.961 OK 65.6226 0 223.449 OK 523.392 0 2106.62 OK TCONS_00000251 = uc001arm.1 XLOC_000091 Pex14 TSS132 chr1:10535002-10690813 1132 - 30.027 0 89.3967 OK 6.4866 0 20.5436 OK 19.6946 0 220.823 OK TCONS_00000252 = uc009vmu.1 XLOC_000091 Pex14 TSS132 chr1:10535002-10690813 1125 - 18.0364 0 79.5216 OK 7.51008 0 29.0484 OK 3.68586 0 252.272 OK TCONS_00000253 = uc001arn.2 XLOC_000091 PEX14 TSS132 chr1:10535002-10690813 1924 - 173.496 67.1611 279.831 OK 598.647 499.468 697.826 OK 1041.13 555.011 1527.24 OK TCONS_00000254 = uc009vmv.2 XLOC_000091 PEX14 TSS132 chr1:10535002-10690813 1877 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000255 = uc010oam.1 XLOC_000091 PEX14 TSS132 chr1:10535002-10690813 1839 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000256 = uc010oan.1 XLOC_000091 PEX14 TSS132 chr1:10535002-10690813 1795 - 0 0 0 OK 0 0 0 OK 44.4442 0 165.099 OK TCONS_00000257 = uc009vmw.2 XLOC_000091 PEX14 TSS133 chr1:10535002-10690813 1924 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000258 = uc001art.2 XLOC_000092 TARDBP TSS134 chr1:11072678-11085548 4216 - 1888.95 1374.83 2403.07 OK 2365.52 2106.77 2624.28 OK 2744.34 1535.58 3953.11 OK TCONS_00000259 = uc010oap.1 XLOC_000092 TARDBP TSS134 chr1:11072678-11085548 4052 - 30.0352 0 104.936 OK 35.6818 0 72.6789 OK 0 0 0 OK TCONS_00000260 = uc001ase.2 XLOC_000093 ANGPTL7 TSS135 chr1:11166588-11322608 2237 - 25.3243 0 101.602 OK 0.912846 0 7.62052 OK 10.571 0 84.7445 OK TCONS_00000261 = uc001asg.2 XLOC_000094 UBIAD1 TSS136 chr1:11333254-11348490 3653 - 358.008 199.441 516.575 OK 307.383 257.097 357.67 OK 332.294 172.345 492.244 OK TCONS_00000262 = uc009vmz.1 XLOC_000095 - TSS137 chr1:11539294-11597639 759 - 22.631 0 68.7905 OK 12.7281 0 30.2483 OK 0 0 0 OK TCONS_00000263 = uc001ash.3 XLOC_000095 PTCHD2 TSS137 chr1:11539294-11597639 5213 - 14.6751 1.33607 28.0142 OK 61.7115 48.8554 74.5676 OK 0.546235 0 1.46443 OK TCONS_00000264 = uc001asi.1 XLOC_000095 PTCHD2 TSS138 chr1:11539294-11597639 2837 - 12.3118 0 33.4266 OK 0 0 0 OK 7.55415e-05 0 0.868989 OK TCONS_00000265 = uc001ask.2 XLOC_000096 FBXO44 TSS139 chr1:11708449-11723383 2933 - 0 0 0 OK 18.7336 0 40.385 OK 10.2274 0 59.6611 OK TCONS_00000266 = uc010oaq.1 XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 781 - 41.3995 0 208.17 OK 143.48 16.6133 270.346 OK 66.4903 0 290.353 OK TCONS_00000267 = uc001asl.2 XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 3319 - 74.4128 0.102045 148.723 OK 158.642 102.33 214.954 OK 19.1948 0 60.8603 OK TCONS_00000268 = uc001asm.2 XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 2947 - 0 0 0 OK 59.0165 2.84739 115.186 OK 138.586 15.522 261.651 OK TCONS_00000269 = uc001asn.2 XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 2822 - 55.1609 0 128.397 OK 131.185 63.2802 199.09 OK 183.066 40.5899 325.543 OK TCONS_00000270 = uc010oar.1 XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 2918 - 0 0 0 OK 5.92521 0 39.3998 OK 8.07306 0 58.7162 OK TCONS_00000271 = uc010oas.1 XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 2688 - 0.00708472 0 1.93513 OK 42.0022 0 99.8437 OK 0 0 0 OK TCONS_00000272 = uc001aso.2 XLOC_000097 FBXO6 TSS141 chr1:11724149-11734407 1547 - 77.8716 25.4534 130.29 OK 25.5712 17.1689 33.9736 OK 363.317 155.989 570.645 OK TCONS_00000273 = uc001asr.1 XLOC_000098 C1orf187 TSS142 chr1:11751780-11780336 1773 - 200.894 86.0788 315.709 OK 340.257 276.998 403.517 OK 11.5677 0 24.207 OK TCONS_00000274 = uc001ass.1 XLOC_000099 - - chr1:11782186-11785914 3728 - 138.448 63.8267 213.07 OK 209.081 172.44 245.722 OK 6.38178 0 12.9721 OK TCONS_00000275 = uc001ast.2 XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 1279 - 107.513 0 339.089 OK 212.87 121.661 304.079 OK 117.552 0 453.857 OK TCONS_00000276 = uc001asu.2 XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 1258 - 75.7885 0 308.262 OK 48.0216 0 96.4784 OK 31.884 0 211.834 OK TCONS_00000277 = uc001asv.2 XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 1182 - 326.456 0 660.559 OK 1078.57 872.073 1285.07 OK 1331.71 578.575 2084.84 OK TCONS_00000278 = uc001asw.2 XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 1161 - 238.184 6.58558 469.782 OK 261.965 153.63 370.299 OK 389.478 0 812.01 OK TCONS_00000279 = uc001asx.2 XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 1126 - 0 0 0 OK 9.26798 0 42.3294 OK 41.1964 0 245.026 OK TCONS_00000280 = uc001asy.1 XLOC_000101 C1orf167 TSS144 chr1:11824461-11826573 726 - 4.69748 0 13.8934 OK 3.47934 0 8.39975 OK 1.86471 0 5.94749 OK TCONS_00000281 = uc001asz.2 XLOC_000102 C1orf167 TSS145 chr1:11832138-11866115 2663 - 0 0 0 OK 2.18711 0 8.40798 OK 0 0 0 OK TCONS_00000282 = uc001ata.2 XLOC_000102 C1orf167 TSS146 chr1:11832138-11866115 1738 - 1.75837 0 16.9438 OK 2.17987 0 13.4504 OK 8.96806 0 243.105 OK TCONS_00000283 = uc009vne.1 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 1202 - 22.1488 0 102.377 OK 0.995584 0 7.28035 OK 0 0 0 OK TCONS_00000284 = uc009vnf.1 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 1077 - 0 0 0 OK 7.96239 0 32.3271 OK 11.3029 0 347.528 OK TCONS_00000285 = uc009vng.1 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 1041 - 4.86566 0 179.821 OK 4.82023 0 33.0013 OK 2.44992 0 534.304 OK TCONS_00000286 = uc009vnh.1 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 1194 - 14.401 0 109.117 OK 18.414 0 54.7231 OK 40.6369 0 309.835 OK TCONS_00000287 = uc001ate.3 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 5643 - 108.07 50.2145 165.925 OK 325.683 276.873 374.493 OK 514.96 291.011 738.909 OK TCONS_00000288 = uc010oat.1 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 5627 - 0.0423122 0 1.29723 OK 0.0955929 0 0.937899 OK 0 0 0 OK TCONS_00000289 = uc010oau.1 XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 5577 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000290 = uc010oav.1 XLOC_000103 - TSS148 chr1:11866206-11907840 837 - 0 0 0 OK 8.28757 0 31.2298 OK 16.145 0 429.975 OK TCONS_00000291 = uc010oaw.1 XLOC_000103 - TSS148 chr1:11866206-11907840 957 - 3.15242 0 29.2696 OK 0 0 0 OK 0 0 0 OK TCONS_00000292 = uc010oax.1 XLOC_000103 - TSS148 chr1:11866206-11907840 660 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000293 = uc010oay.1 XLOC_000103 - TSS148 chr1:11866206-11907840 467 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000294 = uc010oaz.1 XLOC_000103 - TSS148 chr1:11866206-11907840 374 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000295 = uc010oba.1 XLOC_000103 - TSS148 chr1:11866206-11907840 934 - 3.25401 0 30.2239 OK 0 0 0 OK 0 0 0 OK TCONS_00000296 = uc001atm.2 XLOC_000104 PLOD1 TSS149 chr1:11994745-12035593 3003 - 849.538 480.251 1218.82 OK 954.766 823.617 1085.92 OK 10325.2 4110.35 16540 OK TCONS_00000297 = uc010obb.1 XLOC_000104 PLOD1 TSS149 chr1:11994745-12035593 3144 - 16.0046 0 194.844 OK 1.78544 0 12.461 OK 116.452 0 1835.19 OK TCONS_00000298 = uc001atn.3 XLOC_000105 MFN2 TSS150 chr1:12040237-12073571 4676 - 578.223 324.988 831.459 OK 790.606 679.528 901.684 OK 2718.63 1063.98 4373.28 OK TCONS_00000299 = uc009vni.2 XLOC_000105 MFN2 TSS150 chr1:12040237-12073571 4531 - 68.8548 0 239.775 OK 151.46 100.665 202.254 OK 152.885 0 1500.9 OK TCONS_00000300 = uc001ato.1 XLOC_000106 MIIP TSS151 chr1:12079511-12092106 1588 - 504.143 253.799 754.486 OK 1223.51 1040.45 1406.58 OK 575.01 277.02 872.999 OK TCONS_00000301 = uc001atq.2 XLOC_000107 TNFRSF8 TSS152 chr1:12123433-12204262 3684 - 178.549 80.9938 276.105 OK 413.544 348.077 479.011 OK 4.49588 0 11.7194 OK TCONS_00000302 = uc010obc.1 XLOC_000107 TNFRSF8 TSS152 chr1:12123433-12204262 3593 - 19.3321 0 72.4532 OK 18.4204 2.92604 33.9147 OK 0.000474981 0 0.677462 OK TCONS_00000303 = uc001atr.2 XLOC_000107 TNFRSF8 TSS153 chr1:12123433-12204262 2359 - 0 0 0 OK 9.03791 0 24.7179 OK 0 0 0 OK TCONS_00000304 = uc001ats.2 XLOC_000107 TNFRSF8 TSS153 chr1:12123433-12204262 2151 - 6.44015 0 62.9259 OK 0 0 0 OK 4.00161 0 15.7775 OK TCONS_00000305 = uc001att.2 XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 3674 - 0 0 0 OK 28.1716 20.0823 36.2609 OK 1285.44 700.762 1870.11 OK TCONS_00000306 = uc001atu.2 XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 3574 - 0.000432929 0 1.42456 OK 5.69324 0.759314 10.6272 OK 110.504 0 301.299 OK TCONS_00000307 = uc009vnk.2 XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 3561 - 15.3502 4.57435 26.126 OK 0 0 0 OK 0 0 0 OK TCONS_00000308 = uc001atv.2 XLOC_000109 VPS13D TSS155 chr1:12290112-12572096 16326 - 12.8407 0 38.8899 OK 0 0 0 OK 0 0 0 OK TCONS_00000309 = uc001atw.2 XLOC_000109 VPS13D TSS155 chr1:12290112-12572096 16251 - 315.192 216.361 414.022 OK 71.9285 56.898 86.959 OK 191.792 34.7885 348.795 OK TCONS_00000310 = uc001atx.2 XLOC_000109 VPS13D TSS156 chr1:12290112-12572096 13946 - 19.4784 0 51.136 OK 66.1936 50.8275 81.5597 OK 94.7776 0 253.886 OK TCONS_00000311 = uc001aty.1 XLOC_000109 - TSS157 chr1:12290112-12572096 4062 - 39.9995 0 130.49 OK 0 0 0 OK 0 0 0 OK TCONS_00000312 = uc009vnl.2 XLOC_000109 - TSS158 chr1:12290112-12572096 5671 - 0 0 0 OK 20.135 6.13794 34.1321 OK 65.4483 0 177.134 OK TCONS_00000313 = uc010obd.1 XLOC_000109 - TSS159 chr1:12290112-12572096 4219 - 0 0 0 OK 4.58204 0 13.0797 OK 2.38321 0 131.228 OK TCONS_00000314 = uc001atz.1 XLOC_000110 SNORA59B - chr1:12290112-12572096 152 - 452.443 0 6954.29 OK 234.664 0 1858.36 OK 63.6142 0 2752.67 OK TCONS_00000315 = uc001auf.2 XLOC_000111 AADACL4 TSS160 chr1:12704565-12727096 1574 - 0.911079 0 3.43339 OK 1.34969 0 3.25839 OK 0 0 0 OK TCONS_00000316 = uc001aug.1 XLOC_000112 AADACL3 TSS161 chr1:12776117-12788726 3832 - 8.82724 0 26.7047 OK 1.92876 0 4.16682 OK 0 0 0 OK TCONS_00000317 = uc009vnn.1 XLOC_000112 AADACL3 TSS161 chr1:12776117-12788726 4049 - 47.604 14.4641 80.7439 OK 8.12602 4.87454 11.3775 OK 0 0 0 OK TCONS_00000318 = uc010obe.1 XLOC_000113 C1orf158 TSS162 chr1:12806162-12821101 897 - 1.78172 0 8.60998 OK 0.698209 0 3.4627 OK 0 0 0 OK TCONS_00000319 = uc001auh.2 XLOC_000113 C1orf158 TSS162 chr1:12806162-12821101 1018 - 5.40803e-05 0 5.83215 OK 0.592256 0 2.93724 OK 0 0 0 OK TCONS_00000320 = uc001aui.2 XLOC_000114 PRAMEF12 TSS163 chr1:12834983-12838046 1783 - 3.60576 0 8.25249 OK 0.853096 0 2.25332 OK 0 0 0 OK TCONS_00000321 = uc001auj.1 XLOC_000115 PRAMEF1 TSS164 chr1:12851545-12856223 1606 - 1.07984 0 3.77465 OK 0 0 0 OK 0 0 0 OK TCONS_00000322 = uc001aum.1 XLOC_000116 PRAMEF2 TSS165 chr1:12916940-12921764 1642 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000323 = uc001aup.2 XLOC_000117 PRAMEF8 TSS166 chr1:12976449-12980566 1841 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000324 = uc009vnq.1 XLOC_000118 PRAMEF22 TSS167 chr1:12998301-13117751 1446 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000325 = uc001auu.1 XLOC_000119 PRAMEF6 TSS168 chr1:13359818-13369057 1855 - 0.310672 0 1.64522 OK 0 0 0 OK 0 0 0 OK TCONS_00000326 = uc001auw.1 XLOC_000120 PRAMEF9 TSS169 chr1:13421175-13428191 1863 - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK TCONS_00000327 = uc001aux.2 XLOC_000121 PRAMEF16 TSS170 chr1:13495253-13498257 1584 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000328 = uc009vnv.1 XLOC_000122 PRAMEF20 TSS171 chr1:13516065-13526943 1597 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000329 = uc001auz.3 XLOC_000123 PRAMEF10 TSS172 chr1:13629937-13635298 1511 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000330 = uc001ava.1 XLOC_000124 PRAMEF9 TSS173 chr1:13641972-13648988 1863 - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK TCONS_00000331 = uc009vnz.1 XLOC_000125 PRAMEF17 TSS174 chr1:13716087-13719064 1557 - 0 0 0 OK 0.330232 0 1.26905 OK 0 0 0 OK TCONS_00000332 = uc009voa.1 XLOC_000126 PRAMEF20 TSS175 chr1:13736906-13747803 1597 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000333 = uc001avc.2 XLOC_000127 PDPN TSS176 chr1:13910251-13944450 2804 - 695.717 363.437 1028 OK 816.633 656.551 976.715 OK 40.2891 0 96.477 OK TCONS_00000334 = uc001avd.2 XLOC_000127 PDPN TSS176 chr1:13910251-13944450 2810 - 602.018 287.765 916.272 OK 879.809 709.521 1050.1 OK 70.7232 9.4972 131.949 OK TCONS_00000335 = uc009vob.2 XLOC_000127 PDPN TSS177 chr1:13910251-13944450 2699 - 0 0 0 OK 6.91549 0 28.1518 OK 0 0 0 OK TCONS_00000336 = uc009voc.2 XLOC_000127 PDPN TSS177 chr1:13910251-13944450 2541 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000337 = uc001ave.2 XLOC_000127 PDPN TSS178 chr1:13910251-13944450 2628 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000338 = uc001avf.2 XLOC_000127 PDPN TSS178 chr1:13910251-13944450 2634 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000339 = uc001avg.2 XLOC_000128 PRDM2 TSS179 chr1:14026734-14151572 2700 - 0 0 0 OK 12.8679 0 26.1446 OK 27.8928 0 122.208 OK TCONS_00000340 = uc001avh.2 XLOC_000128 PRDM2 TSS180 chr1:14026734-14151572 7456 - 47.3072 1.25487 93.3594 OK 9.21056 2.5931 15.828 OK 0 0 0 OK TCONS_00000341 = uc001avi.2 XLOC_000128 PRDM2 TSS180 chr1:14026734-14151572 7955 - 14.792 0 39.9282 OK 20.5972 11.244 29.9504 OK 14.8538 0 45.2703 OK TCONS_00000342 = uc001avj.2 XLOC_000128 PRDM2 TSS181 chr1:14026734-14151572 2129 - 0 0 0 OK 1.65694 0 10.3792 OK 0 0 0 OK TCONS_00000343 = uc009vod.1 XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 2020 - 4.006 0 121.226 OK 0 0 0 OK 43.9125 0 174.229 OK TCONS_00000344 = uc001avk.2 XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 6272 - 173.834 83.3001 264.367 OK 111.179 88.5434 133.815 OK 358.942 192.325 525.56 OK TCONS_00000345 = uc009voe.2 XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 2301 - 0 0 0 OK 0.921398 0 11.4766 OK 28.7964 0 141.697 OK TCONS_00000346 = uc009vof.2 XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 2357 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000347 = uc001avl.1 XLOC_000128 - - chr1:14026734-14151572 4052 - 3.13048 0 17.9272 OK 0.709477 0 2.93563 OK 2.32779 0 64.5204 OK TCONS_00000348 = uc009vog.1 XLOC_000129 - TSS183 chr1:14925212-15478960 3905 - 48.9164 11.8928 85.94 OK 45.0754 27.3766 62.7741 OK 3.19938 0 58.3721 OK TCONS_00000349 = uc010obj.1 XLOC_000129 - TSS183 chr1:14925212-15478960 3833 - 2.81237 0 20.9224 OK 0 0 0 OK 0 0 0 OK TCONS_00000350 = uc001avm.3 XLOC_000129 - TSS183 chr1:14925212-15478960 6021 - 0 0 0 OK 9.84787 3.11669 16.579 OK 6.7035 0 37.6764 OK TCONS_00000351 = uc001avo.2 XLOC_000129 - TSS184 chr1:14925212-15478960 3842 - 1.99898 0 21.9495 OK 19.5662 6.88158 32.2509 OK 29.388 0 98.7243 OK TCONS_00000352 = uc001avp.2 XLOC_000129 - TSS185 chr1:14925212-15478960 3643 - 0 0 0 OK 0 0 0 OK 13.2968 0 66.0987 OK TCONS_00000353 = uc001avq.2 XLOC_000129 - TSS186 chr1:14925212-15478960 3653 - 5.70387 0 24.8579 OK 0 0 0 OK 205.94 0 452.786 OK TCONS_00000354 = uc001avr.2 XLOC_000129 - TSS187 chr1:14925212-15478960 3393 - 0 0 0 OK 79.6627 55.0254 104.3 OK 208.608 0 479.942 OK TCONS_00000355 = uc001avs.3 XLOC_000129 - TSS188 chr1:14925212-15478960 4528 - 7.67766 0 24.5275 OK 5.19027 0 11.3244 OK 10.0324 0 51.1545 OK TCONS_00000356 = uc001avw.3 XLOC_000130 TMEM51 TSS189 chr1:15479027-15546973 2015 - 14.7555 0 56.7156 OK 0.0170528 0 1.03992 OK 0 0 0 OK TCONS_00000357 = uc010obk.1 XLOC_000130 TMEM51 TSS189 chr1:15479027-15546973 1942 - 29.1579 0 79.0907 OK 68.8043 40.0636 97.5451 OK 34.1487 0 116.359 OK TCONS_00000358 = uc001avz.2 XLOC_000130 TMEM51 TSS190 chr1:15479027-15546973 1879 - 0 0 0 OK 17.2845 1.57331 32.9958 OK 65.7759 0 185.612 OK TCONS_00000359 = uc001avx.2 XLOC_000130 TMEM51 TSS190 chr1:15479027-15546973 1911 - 67.688 0 135.859 OK 40.9662 17.8305 64.1018 OK 359.502 36.4497 682.554 OK TCONS_00000360 = uc001avy.2 XLOC_000130 TMEM51 TSS190 chr1:15479027-15546973 1984 - 33.4567 0 81.42 OK 105.307 71.1479 139.466 OK 254.61 46.6072 462.614 OK TCONS_00000361 = uc001awb.2 XLOC_000131 FHAD1 TSS191 chr1:15573767-15726776 5090 - 3.59181 0.183939 6.99968 OK 6.18974 3.93462 8.44486 OK 2.29329 0 5.69816 OK TCONS_00000362 = uc001awd.1 XLOC_000131 FHAD1 TSS192 chr1:15573767-15726776 3506 - 2.21856 0 5.46644 OK 1.79489 0.20316 3.38662 OK 0.862567 0 3.90708 OK TCONS_00000363 = uc010obl.1 XLOC_000131 - TSS193 chr1:15573767-15726776 2834 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000364 = uc001awe.1 XLOC_000131 FHAD1 TSS194 chr1:15573767-15726776 2672 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000365 = uc001awf.2 XLOC_000131 FHAD1 TSS195 chr1:15573767-15726776 1378 - 0 0 0 OK 0.429055 0 2.04463 OK 0.572031 0 3.90272 OK TCONS_00000366 = uc001awg.2 XLOC_000131 - TSS196 chr1:15573767-15726776 1239 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000367 = uc001awh.2 XLOC_000132 EFHD2 TSS197 chr1:15736390-15756839 2419 - 330.754 166.776 494.733 OK 468.604 391.665 545.542 OK 2197 1271.73 3122.27 OK TCONS_00000368 = uc001awi.1 XLOC_000133 CTRC TSS198 chr1:15764937-15773153 899 - 3.36755e-05 0 6.80907 OK 0 0 0 OK 0 0 0 OK TCONS_00000369 = uc001awj.1 XLOC_000133 CTRC TSS198 chr1:15764937-15773153 753 - 2.23634 0 10.8068 OK 0 0 0 OK 5.61806 0 14.0003 OK TCONS_00000370 = uc001awk.2 XLOC_000134 CELA2A TSS199 chr1:15783222-15798585 919 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000371 = uc001awl.2 XLOC_000135 CELA2B TSS200 chr1:15802595-15851384 922 - 0 0 0 OK 1.27477 0 8.01985 OK 0 0 0 OK TCONS_00000372 = uc001awr.1 XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 2314 - 108.544 0 248.389 OK 22.5422 3.21503 41.8694 OK 18.3447 0 120.225 OK TCONS_00000373 = uc001aws.2 XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 6023 - 264.402 137.955 390.849 OK 106.224 82.8924 129.555 OK 279.288 135.236 423.34 OK TCONS_00000374 = uc001awt.2 XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 5838 - 92.0125 11.4082 172.617 OK 24.4409 10.7251 38.1567 OK 78.8225 0 161.552 OK TCONS_00000375 = uc001awu.2 XLOC_000136 - TSS202 chr1:15853351-15918872 2927 - 6.69281 0 73.9549 OK 1.81648 0 7.31877 OK 2.11882 0 91.0102 OK TCONS_00000376 = uc001aww.2 XLOC_000137 DDI2 TSS203 chr1:15944069-15988216 1462 - 45.7332 0 156.435 OK 1.92594 0 13.6556 OK 0.922843 0 14.8423 OK TCONS_00000377 = uc001awx.1 XLOC_000137 DDI2 TSS203 chr1:15944069-15988216 1759 - 439.099 149.697 728.502 OK 268.762 203.047 334.476 OK 310.347 73.3654 547.328 OK TCONS_00000378 = uc009voj.1 XLOC_000137 DDI2 TSS204 chr1:15944069-15988216 1349 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000379 = uc010obn.1 XLOC_000137 RSC1A1 - chr1:15944069-15988216 1853 - 534.708 227.419 841.998 OK 259.157 196.292 322.022 OK 376.086 126.216 625.956 OK TCONS_00000380 = uc001awz.2 XLOC_000138 - - chr1:15992765-15995535 2770 - 252.085 124.534 379.636 OK 304.42 251.674 357.166 OK 236.84 106.42 367.26 OK TCONS_00000381 = uc010obo.1 XLOC_000139 PLEKHM2 TSS205 chr1:16010826-16061262 4120 - 363.264 206.673 519.855 OK 779.207 675.262 883.152 OK 2346.33 1341.89 3350.77 OK TCONS_00000382 = uc001axb.1 XLOC_000140 SLC25A34 TSS206 chr1:16062808-16067885 3070 - 6.39779 0.605227 12.1903 OK 8.64356 5.26239 12.0247 OK 9.3373 0 19.2115 OK TCONS_00000383 = uc009vok.1 XLOC_000140 - TSS207 chr1:16062808-16067885 1741 - 2.07297 0 8.32109 OK 0.000570561 0 1.20321 OK 4.66039 0 17.5192 OK TCONS_00000384 = uc001axc.2 XLOC_000141 TMEM82 TSS208 chr1:16068916-16074475 1518 - 11.5611 1.91174 21.2104 OK 31.4534 22.0675 40.8392 OK 0 0 0 OK TCONS_00000385 = uc001axd.1 XLOC_000142 FBLIM1 TSS209 chr1:16083153-16114431 3493 - 17.9129 0 73.0066 OK 28.622 0 60.497 OK 72.561 0 525.317 OK TCONS_00000386 = uc001axe.1 XLOC_000142 FBLIM1 TSS210 chr1:16083153-16114431 3349 - 565.849 311.457 820.241 OK 821.848 703.206 940.49 OK 2026.56 926.491 3126.63 OK TCONS_00000387 = uc001axf.2 XLOC_000142 FBLIM1 TSS210 chr1:16083153-16114431 2046 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000388 = uc001axg.1 XLOC_000142 FBLIM1 TSS211 chr1:16083153-16114431 1524 - 55.3931 0 243.059 OK 23.593 0 59.2406 OK 11.5775 0 662.25 OK TCONS_00000389 = uc001axh.1 XLOC_000142 FBLIM1 TSS211 chr1:16083153-16114431 2792 - 256.047 67.5364 444.557 OK 85.4176 40.8827 129.953 OK 333.297 0 860.312 OK TCONS_00000390 = uc001axk.1 XLOC_000143 SPEN TSS212 chr1:16160709-16266950 12227 - 145.636 81.7357 209.536 OK 241.251 184.702 297.8 OK 293.864 120.858 466.87 OK TCONS_00000391 = uc010obp.1 XLOC_000143 SPEN TSS213 chr1:16160709-16266950 11900 - 40.228 5.06363 75.3923 OK 140.357 82.3092 198.405 OK 168.12 40.5038 295.735 OK TCONS_00000392 = uc001axn.2 XLOC_000144 C1orf64 TSS214 chr1:16330730-16333180 917 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000393 = uc001axt.2 XLOC_000145 CLCNKA TSS215 chr1:16340522-16400127 3059 - 1.3355 0 53.7048 OK 6.02437 0.115613 11.9331 OK 0 0 0 OK TCONS_00000394 = uc001axu.2 XLOC_000145 CLCNKA TSS216 chr1:16340522-16400127 2535 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000395 = uc001axv.2 XLOC_000145 CLCNKA TSS216 chr1:16340522-16400127 2532 - 0 0 0 OK 9.02387 0.970341 17.0774 OK 0 0 0 OK TCONS_00000396 = uc010obw.1 XLOC_000145 CLCNKA TSS216 chr1:16340522-16400127 2406 - 2.87744 0 54.8139 OK 10.1766 1.3032 19.05 OK 0.308418 0 7.49156 OK TCONS_00000397 = uc001axw.3 XLOC_000145 CLCNKB TSS216 chr1:16340522-16400127 2535 - 5.98972 0 51.8621 OK 4.34296 0 10.6439 OK 0 0 0 OK TCONS_00000398 = uc010obx.1 XLOC_000145 CLCNKA TSS217 chr1:16340522-16400127 903 - 1.5524 0 22.3485 OK 5.14419 0 17.7705 OK 0 0 0 OK TCONS_00000399 = uc010oby.1 XLOC_000145 CLCNKA TSS217 chr1:16340522-16400127 1097 - 0 0 0 OK 2.91986 0 14.6624 OK 0 0 0 OK TCONS_00000400 = uc001axx.3 XLOC_000145 CLCNKB TSS218 chr1:16340522-16400127 2591 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000401 = uc001axy.3 XLOC_000145 CLCNKB TSS219 chr1:16340522-16400127 2128 - 12.6409 0 62.956 OK 52.0827 34.1208 70.0445 OK 1.81089 0 20.3662 OK TCONS_00000402 = uc010ocb.1 XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 1498 - 41.0821 0 213.346 OK 0 0 0 OK 133.313 0 1644.95 OK TCONS_00000403 = uc001ayi.3 XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 3583 - 407.437 171.903 642.971 OK 532.647 424.229 641.065 OK 1857.43 112.434 3602.43 OK TCONS_00000404 = uc001ayk.3 XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 3580 - 422.625 127.467 717.784 OK 574.155 433.204 715.106 OK 1815.92 0 3724.92 OK TCONS_00000405 = uc001aym.3 XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 3633 - 351.835 51.5672 652.103 OK 256.538 126.02 387.056 OK 1504.54 115.723 2893.35 OK TCONS_00000406 = uc001ayp.3 XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 1342 - 0 0 0 OK 0 0 0 OK 218.793 0 751.247 OK TCONS_00000407 = uc001ayo.2 XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 2079 - 272.536 78.2692 466.804 OK 519.227 431.761 606.694 OK 3410.49 1902.97 4918.02 OK TCONS_00000408 = uc001ayq.2 XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 2003 - 0 0 0 OK 16.6368 0 36.7289 OK 100.612 0 439.417 OK TCONS_00000409 = uc010ocd.1 XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 2001 - 302.124 100.097 504.151 OK 0 0 0 OK 0 0 0 OK TCONS_00000410 = uc001ayv.1 XLOC_000148 - - chr1:16860385-16864669 2415 - 8.40518 0 22.5657 OK 12.2273 6.65505 17.7995 OK 1.32866 0 3.3985 OK TCONS_00000411 = uc009vow.2 XLOC_000149 MST1 TSS222 chr1:16972068-16976914 1397 - 3.60238 0 11.6082 OK 4.10051 0 13.4892 OK 0 0 0 OK TCONS_00000412 = uc010ocg.1 XLOC_000149 MST1 TSS222 chr1:16972068-16976914 1586 - 0.00122752 0 3.46275 OK 6.52829 0 15.6675 OK 0 0 0 OK TCONS_00000413 = uc010och.1 XLOC_000149 MST1 TSS222 chr1:16972068-16976914 2635 - 0 0 0 OK 1.45662 0 5.63271 OK 6.5283 0 15.3628 OK TCONS_00000414 = uc010oci.1 XLOC_000149 MST1 TSS223 chr1:16972068-16976914 1403 - 0 0 0 OK 6.80472 0 17.3325 OK 3.089 0 10.684 OK TCONS_00000415 = uc001azk.2 XLOC_000149 MST1 TSS223 chr1:16972068-16976914 1748 - 2.50115 0 15.9718 OK 3.75649 0 11.9502 OK 1.53504 0 10.5998 OK TCONS_00000416 = uc001azl.3 XLOC_000149 MST1 TSS223 chr1:16972068-16976914 2736 - 0 0 0 OK 0.00527233 0 0.737459 OK 0 0 0 OK TCONS_00000417 = uc001azm.3 XLOC_000149 MST1 TSS224 chr1:16972068-16976914 2413 - 7.81031 0 17.7496 OK 63.0415 43.5852 82.4979 OK 3.07999 0 10.8015 OK TCONS_00000418 = uc009vox.2 XLOC_000149 MST1 TSS224 chr1:16972068-16976914 2026 - 1.86514 0 7.11126 OK 33.4266 16.5495 50.3037 OK 0.615404 0 3.43592 OK TCONS_00000419 = uc009voy.1 XLOC_000150 - TSS225 chr1:17066767-17299474 1668 - 2.30684 0 127.542 OK 4.93427 0 28.0652 OK 0 0 0 OK TCONS_00000420 = uc001azt.2 XLOC_000150 CROCC TSS226 chr1:17066767-17299474 6656 - 27.4034 0 57.257 OK 428.259 354.129 502.389 OK 98.6818 31.8198 165.544 OK TCONS_00000421 = uc009voz.1 XLOC_000150 CROCC TSS227 chr1:17066767-17299474 2614 - 47.5917 0 116.051 OK 30.5389 0 76.5493 OK 3.8214 0 60.5204 OK TCONS_00000422 = uc001azu.2 XLOC_000150 CROCC TSS228 chr1:17066767-17299474 6137 - 65.6699 18.2084 113.131 OK 100.239 53.167 147.311 OK 17.1632 0 59.7634 OK TCONS_00000423 = uc001azv.2 XLOC_000150 - TSS229 chr1:17066767-17299474 2424 - 15.9225 0 60.3287 OK 62.5679 17.7392 107.397 OK 49.7705 0 124.533 OK TCONS_00000424 = uc001bah.1 XLOC_000151 PADI1 TSS230 chr1:17531620-17572501 3847 - 2.7984 0 10.3872 OK 1.50479 0 3.19272 OK 0 0 0 OK TCONS_00000425 = uc010oco.1 XLOC_000151 PADI1 TSS231 chr1:17531620-17572501 2600 - 5.28057 0 16.6213 OK 0.286309 0 1.61701 OK 0 0 0 OK TCONS_00000426 = uc010ocp.1 XLOC_000151 - TSS231 chr1:17531620-17572501 2474 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000427 = uc010ocq.1 XLOC_000151 - TSS231 chr1:17531620-17572501 2455 - 7.45961 0 20.4336 OK 6.34529e-05 0 0.817224 OK 6.06956e-06 0 1.02954 OK TCONS_00000428 = uc009vpb.1 XLOC_000151 - TSS232 chr1:17531620-17572501 2086 - 0 0 0 OK 2.33196 0 5.25577 OK 0.513935 0 1.74582 OK TCONS_00000429 = uc001bai.2 XLOC_000152 PADI3 TSS233 chr1:17575592-17610725 3186 - 8.59656 1.07534 16.1178 OK 12.671 8.61879 16.7231 OK 0.32407 0 1.03362 OK TCONS_00000430 = uc009vpc.2 XLOC_000153 PADI4 TSS234 chr1:17634689-17690495 1551 - 0 0 0 OK 1.38095 0 4.41678 OK 0 0 0 OK TCONS_00000431 = uc001baj.2 XLOC_000153 PADI4 TSS234 chr1:17634689-17690495 2265 - 4.09774 0 8.73756 OK 3.11869 0.278925 5.95846 OK 0 0 0 OK TCONS_00000432 = uc001bak.1 XLOC_000154 PADI6 TSS235 chr1:17698740-17728195 2347 - 0 0 0 OK 0.21117 0 0.811504 OK 0 0 0 OK TCONS_00000433 = uc009vpe.1 XLOC_000155 ARHGEF10L TSS236 chr1:17866329-18024369 3667 - 57.9053 0 124.56 OK 55.941 25.7273 86.1546 OK 9.97606 0 80.3509 OK TCONS_00000434 = uc001ban.2 XLOC_000155 ARHGEF10L TSS236 chr1:17866329-18024369 4493 - 28.6581 0 76.133 OK 64.0925 34.8693 93.3157 OK 18.9462 0 74.1161 OK TCONS_00000435 = uc001bao.2 XLOC_000155 ARHGEF10L TSS237 chr1:17866329-18024369 4260 - 0 0 0 OK 0 0 0 OK 208.168 46.1213 370.214 OK TCONS_00000436 = uc001bap.2 XLOC_000155 ARHGEF10L TSS237 chr1:17866329-18024369 4245 - 158.893 62.1068 255.68 OK 479.078 400.922 557.233 OK 35.3353 0 117.86 OK TCONS_00000437 = uc010ocr.1 XLOC_000155 ARHGEF10L TSS238 chr1:17866329-18024369 2011 - 0 0 0 OK 2.78634 0 19.6284 OK 5.30615 0 156.718 OK TCONS_00000438 = uc001baq.2 XLOC_000155 ARHGEF10L TSS239 chr1:17866329-18024369 4599 - 24.8197 0 70.9372 OK 25.6249 7.29019 43.9596 OK 0 0 0 OK TCONS_00000439 = uc001bar.2 XLOC_000155 ARHGEF10L TSS240 chr1:17866329-18024369 3481 - 0 0 0 OK 5.26 0 16.963 OK 0 0 0 OK TCONS_00000440 = uc010ocs.1 XLOC_000155 ARHGEF10L TSS240 chr1:17866329-18024369 3691 - 0 0 0 OK 0 0 0 OK 381.592 151.451 611.732 OK TCONS_00000441 = uc009vpf.2 XLOC_000155 - TSS241 chr1:17866329-18024369 3075 - 2.21468 0 63.4655 OK 5.36255 0 18.9326 OK 0 0 0 OK TCONS_00000442 = uc001bas.2 XLOC_000155 - TSS242 chr1:17866329-18024369 2261 - 12.7177 0 69.1669 OK 44.6171 10.5906 78.6436 OK 14.6487 0 130.905 OK TCONS_00000443 = uc001bat.2 XLOC_000156 ACTL8 TSS243 chr1:18081807-18153556 1859 - 9.62232 1.18858 18.0561 OK 17.1125 10.9181 23.3069 OK 6.95204 0.2121 13.692 OK TCONS_00000444 = uc001bau.1 XLOC_000157 IGSF21 TSS244 chr1:18434239-18704976 1943 - 58.273 18.1053 98.4407 OK 398.742 315.075 482.408 OK 0 0 0 OK TCONS_00000445 = uc001bav.1 XLOC_000157 IGSF21 TSS245 chr1:18434239-18704976 1884 - 2.74185 0 26.2821 OK 3.24727 0 61.6295 OK 0 0 0 OK TCONS_00000446 = uc001baw.1 XLOC_000158 - - chr1:18434239-18704976 1111 - 1.3684 0 10.4514 OK 18.0164 0 38.878 OK 0 0 0 OK TCONS_00000447 = uc001bax.2 XLOC_000159 KLHDC7A - chr1:18807423-18812539 5055 - 104.809 46.7452 162.873 OK 209.176 173.777 244.576 OK 0 0 0 OK TCONS_00000448 = uc009vpg.2 XLOC_000159 KLHDC7A TSS246 chr1:18807423-18812539 4093 - 0 0 0 OK 8.37135 0 23.4298 OK 0.745204 0 1.93601 OK TCONS_00000449 = uc001bay.2 XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 2259 - 5.07852e-05 0 2.31276 OK 7.1892e-05 0 0.910255 OK 0 0 0 OK TCONS_00000450 = uc001baz.2 XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 2253 - 6.55753e-05 0 2.31943 OK 0 0 0 OK 0 0 0 OK TCONS_00000451 = uc010oct.1 XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 6052 - 0.593912 0 1.7564 OK 0.969259 0.12168 1.81684 OK 0 0 0 OK TCONS_00000452 = uc001bbs.2 XLOC_000161 MRTO4 TSS248 chr1:19578074-19586621 2272 - 773.162 453.595 1092.73 OK 961.74 822.192 1101.29 OK 1651.61 939.806 2363.42 OK TCONS_00000453 = uc001bby.2 XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 1884 - 70.7134 0 162.667 OK 217.71 165.625 269.795 OK 338.197 114.182 562.213 OK TCONS_00000454 = uc001bbz.2 XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 1642 - 6.84301 0 53.4815 OK 0.0310775 0 1.31621 OK 25.1112 0 111.739 OK TCONS_00000455 = uc001bca.2 XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 2254 - 28.264 0 89.8326 OK 28.45 9.71447 47.1855 OK 68.4588 0 170.549 OK TCONS_00000456 = uc001bcb.2 XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 1611 - 0 0 0 OK 16.3096 0 34.7991 OK 16.9445 0 107.682 OK TCONS_00000457 = uc001bcc.2 XLOC_000162 PQLC2 TSS250 chr1:19638739-19655793 1740 - 80.1847 0 162.335 OK 62.153 30.4872 93.8188 OK 139.07 0 304.602 OK TCONS_00000458 = uc001bch.1 XLOC_000163 C1orf151 TSS251 chr1:19923466-19984945 2298 - 3.27686 0 100.682 OK 17.1755 0 36.81 OK 91.329 0 1752.37 OK TCONS_00000459 = uc001bci.1 XLOC_000163 C1orf151 TSS251 chr1:19923466-19984945 2589 - 246.288 70.507 422.068 OK 618.381 516.011 720.752 OK 1693.34 0 4198.67 OK TCONS_00000460 = uc009vpl.1 XLOC_000163 NBL1 TSS251 chr1:19923466-19984945 2025 - 0 0 0 OK 162.125 101.194 223.057 OK 8926.42 2956.39 14896.5 OK TCONS_00000461 = uc001bcj.1 XLOC_000163 NBL1 TSS252 chr1:19923466-19984945 2054 - 0 0 0 OK 1.64141 0 17.0922 OK 3.52907 0 2423.53 OK TCONS_00000462 = uc009vpm.1 XLOC_000163 NBL1 TSS253 chr1:19923466-19984945 2088 - 0 0 0 OK 0 0 0 OK 30.6081 0 1920.08 OK TCONS_00000463 = uc001bck.1 XLOC_000163 NBL1 TSS254 chr1:19923466-19984945 2021 - 463.905 201.419 726.392 OK 16.9244 0 39.9956 OK 1884.11 0 4561 OK TCONS_00000464 = uc001bcl.2 XLOC_000164 HTR6 TSS255 chr1:19991779-20006054 1983 - 3.39355 0 7.66135 OK 22.3161 15.5051 29.1271 OK 0 0 0 OK TCONS_00000465 = uc001bcs.3 XLOC_000165 OTUD3 TSS256 chr1:20208887-20239429 6506 - 148.118 78.5111 217.725 OK 157.667 131.532 183.802 OK 87.3998 38.6021 136.198 OK TCONS_00000466 = uc001bcw.2 XLOC_000166 PLA2G5 TSS257 chr1:20354671-20418393 2793 - 6.43535e-05 0 1.8424 OK 0 0 0 OK 2.12447 0 31.9517 OK TCONS_00000467 = uc001bcx.2 XLOC_000166 PLA2G5 TSS257 chr1:20354671-20418393 2581 - 0.482643 0 2.4868 OK 0 0 0 OK 0 0 0 OK TCONS_00000468 = uc001bcy.2 XLOC_000166 PLA2G5 TSS258 chr1:20354671-20418393 1893 - 0 0 0 OK 0.847143 0 2.42832 OK 147.21 39.2714 255.148 OK TCONS_00000469 = uc009vpp.1 XLOC_000167 PLA2G2F TSS259 chr1:20465822-20476879 2719 - 0 0 0 OK 0.361045 0 1.08683 OK 0 0 0 OK TCONS_00000470 = uc001bdb.2 XLOC_000168 UBXN10 TSS260 chr1:20512577-20519941 2971 - 12.3177 2.70219 21.9333 OK 17.9074 12.8575 22.9573 OK 0.492177 0 1.39458 OK TCONS_00000471 = uc001bdd.2 XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 3743 - 1.83014 0 4.5453 OK 11.844 7.05424 16.6339 OK 0 0 0 OK TCONS_00000472 = uc009vps.2 XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 4475 - 1.30646 0 3.55729 OK 6.27626 2.78634 9.76618 OK 0.000774709 0 0.542867 OK TCONS_00000473 = uc010odc.1 XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 4419 - 3.74866e-05 0 1.13976 OK 0 0 0 OK 0.572137 0 1.52356 OK TCONS_00000474 = uc001bde.3 XLOC_000169 VWA5B1 TSS262 chr1:20617411-20681387 2908 - 0 0 0 OK 1.08334 0 2.90121 OK 0 0 0 OK TCONS_00000475 = uc009vpt.2 XLOC_000169 VWA5B1 TSS262 chr1:20617411-20681387 2632 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000476 = uc001bdj.2 XLOC_000170 FAM43B - chr1:20878931-20881512 2581 - 1.9757 0 4.79309 OK 40.5541 30.5386 50.5696 OK 1.55058 0 3.52437 OK TCONS_00000477 = uc001bdk.2 XLOC_000171 CDA TSS263 chr1:20915443-20945398 957 - 223.547 76.3485 370.746 OK 133.245 98.9045 167.586 OK 232.113 70.0502 394.177 OK TCONS_00000478 = uc001bdl.2 XLOC_000171 - TSS263 chr1:20915443-20945398 1078 - 0 0 0 OK 1.59843 0 42.5238 OK 0 0 0 OK TCONS_00000479 = uc009vpv.2 XLOC_000171 - TSS263 chr1:20915443-20945398 787 - 17.3734 0 85.2727 OK 6.30992 0 20.6577 OK 0 0 0 OK TCONS_00000480 = uc001bdm.2 XLOC_000172 PINK1 TSS264 chr1:20959947-20978003 2659 - 640.208 365.853 914.562 OK 326.979 265.85 388.108 OK 2213.85 1142.71 3284.98 OK TCONS_00000481 = uc001bdn.2 XLOC_000172 PINK1 TSS265 chr1:20959947-20978003 1658 - 0 0 0 OK 114.96 63.3891 166.53 OK 832.083 0 1760.82 OK TCONS_00000482 = uc001beo.1 XLOC_000173 - TSS266 chr1:21543739-21672034 2437 - 2.1975 0 17.0697 OK 7.51557 0 20.6432 OK 3.33508 0 117.732 OK TCONS_00000483 = uc001beq.1 XLOC_000174 - TSS267 chr1:21761832-21762609 105 - 0 0 0 OK 12075.7 2561.85 21589.6 OK 7652.6 0 16802.3 OK TCONS_00000484 = uc001ber.2 XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 3765 - 11.3784 0 34.7448 OK 3.12392 0 7.65375 OK 50.1038 0 137.972 OK TCONS_00000485 = uc001bes.2 XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 4294 - 68.9507 24.2451 113.656 OK 37.3701 26.4183 48.3219 OK 428.32 197.914 658.727 OK TCONS_00000486 = uc009vqb.2 XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 3729 - 0 0 0 OK 1.81796 0 5.24041 OK 15.9541 0 79.8183 OK TCONS_00000487 = uc010odm.1 XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 3555 - 4.87776 0 24.0476 OK 17.0989 7.89884 26.2989 OK 34.3555 0 128.635 OK TCONS_00000488 = uc001bet.2 XLOC_000176 ALPL TSS269 chr1:21835857-21904904 2595 - 877.819 534.019 1221.62 OK 4753.79 4238.97 5268.62 OK 56.7111 3.24454 110.178 OK TCONS_00000489 = uc010odn.1 XLOC_000176 ALPL TSS269 chr1:21835857-21904904 2554 - 14.1413 0 89.6176 OK 40.1523 0 109.691 OK 0 0 0 OK TCONS_00000490 = uc010odo.1 XLOC_000176 ALPL TSS269 chr1:21835857-21904904 2430 - 46.976 0 190.077 OK 130.881 38.5571 223.204 OK 2.32536 0 35.0427 OK TCONS_00000491 = uc010odp.1 XLOC_000176 ALPL TSS269 chr1:21835857-21904904 2314 - 14.1212 0 99.3224 OK 120.584 28.2118 212.956 OK 0 0 0 OK TCONS_00000492 = uc001beu.3 XLOC_000176 ALPL TSS270 chr1:21835857-21904904 2557 - 0 0 0 OK 0 0 0 OK 7.78492 0 32.0206 OK TCONS_00000493 = uc001bfg.1 XLOC_000177 LDLRAD2 TSS271 chr1:22138757-22263750 4012 - 10.8443 0 49.4651 OK 22.0415 0 52.5544 OK 16.2682 0 6109.78 OK TCONS_00000494 = uc001bfh.1 XLOC_000177 LDLRAD2 TSS272 chr1:22138757-22263750 987 - 11.8862 0 221.676 OK 10.8865 0 99.2934 OK 166.982 0 29549 OK TCONS_00000495 = uc001bfk.2 XLOC_000178 CELA3B TSS273 chr1:22303417-22339033 1001 - 1.39771 0 7.20083 OK 0 0 0 OK 0 0 0 OK TCONS_00000496 = uc009vqf.2 XLOC_000178 - TSS273 chr1:22303417-22339033 1328 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000497 = uc001bfl.2 XLOC_000178 CELA3A TSS274 chr1:22303417-22339033 905 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000498 = uc001bfm.3 XLOC_000179 - TSS275 chr1:22351706-22357713 1100 - 27.4246 0 107.103 OK 4.05105 0 19.7938 OK 6.30679 0 115.17 OK TCONS_00000499 = uc001bfn.3 XLOC_000179 - TSS276 chr1:22351706-22357713 1036 - 470.397 188.643 752.15 OK 427.827 341.371 514.283 OK 527.288 217.338 837.237 OK TCONS_00000500 = uc009vqg.1 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 718 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000501 = uc001bfp.2 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 1512 - 13.0529 0 226.573 OK 9.59677 0 30.7045 OK 70.2619 0 1686.83 OK TCONS_00000502 = uc001bfq.2 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 2293 - 339.897 0 686.419 OK 74.2264 25.7298 122.723 OK 668.209 0 2096.23 OK TCONS_00000503 = uc001bfr.2 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 2167 - 243.283 0 875.586 OK 9.02759 0 30.6924 OK 0 0 0 OK TCONS_00000504 = uc009vqh.2 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 2094 - 2997.59 1849.36 4145.83 OK 1520.88 1310.21 1731.54 OK 9098.98 4509.42 13688.5 OK TCONS_00000505 = uc010odr.1 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 2302 - 11.3168 0 162.163 OK 3.95557 0 18.9503 OK 0 0 0 OK TCONS_00000506 = uc010ods.1 XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 2343 - 39.4183 0 171.3 OK 8.77177 0 28.3414 OK 55.0216 0 1056.12 OK TCONS_00000507 = uc001bft.2 XLOC_000181 ZBTB40 TSS278 chr1:22778343-22857650 8992 - 1.95825 0 15.3019 OK 5.74741 0 11.7517 OK 7.10626 0 28.2795 OK TCONS_00000508 = uc001bfu.2 XLOC_000181 ZBTB40 TSS278 chr1:22778343-22857650 8704 - 81.1618 36.8897 125.434 OK 115.94 91.3394 140.541 OK 203.748 108.907 298.589 OK TCONS_00000509 = uc009vqi.1 XLOC_000181 ZBTB40 TSS278 chr1:22778343-22857650 8368 - 5.796 0 27.5916 OK 76.4937 55.6987 97.2886 OK 7.15473 0 30.0231 OK TCONS_00000510 = uc001bfv.1 XLOC_000181 - TSS279 chr1:22778343-22857650 2160 - 41.9937 0 111.704 OK 23.69 0.441524 46.9385 OK 12.3722 0 108.831 OK TCONS_00000511 = uc001bfw.2 XLOC_000182 EPHA8 TSS280 chr1:22890003-22930087 1844 - 30.6745 6.20652 55.1425 OK 69.3632 47.4182 91.3082 OK 0 0 0 OK TCONS_00000512 = uc001bfx.1 XLOC_000182 EPHA8 TSS280 chr1:22890003-22930087 4996 - 2.71483 0 7.83431 OK 16.9383 10.421 23.4555 OK 0 0 0 OK TCONS_00000513 = uc001bfy.2 XLOC_000183 C1QA TSS281 chr1:22963117-22966174 1097 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000514 = uc001bfz.2 XLOC_000183 C1QA TSS282 chr1:22963117-22966174 1049 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000515 = uc001bga.3 XLOC_000184 C1QC TSS283 chr1:22970117-22974602 1190 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000516 = uc001bgc.3 XLOC_000184 C1QC TSS283 chr1:22970117-22974602 1167 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000517 = uc001bgb.2 XLOC_000184 C1QC TSS283 chr1:22970117-22974602 1311 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000518 = uc001bgd.2 XLOC_000185 C1QB TSS284 chr1:22979681-22988028 1043 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000519 = uc009vqj.1 XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 4032 - 0.0140869 0 1.26936 OK 80.4755 51.7107 109.24 OK 73.628 0 278.361 OK TCONS_00000520 = uc001bge.2 XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 4868 - 0 0 0 OK 37.3058 19.4343 55.1772 OK 79.1362 0 246.869 OK TCONS_00000521 = uc001bgf.2 XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 4865 - 58.1996 24.2193 92.1799 OK 183.879 143.513 224.246 OK 794.32 339.585 1249.05 OK TCONS_00000522 = uc010odu.1 XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 4629 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000523 = uc001bgg.1 XLOC_000187 - - chr1:23243782-23247347 3565 - 1.74546 0 3.9763 OK 8.0467 5.05988 11.0335 OK 18.4428 3.44917 33.4364 OK TCONS_00000524 = uc001bgi.2 XLOC_000188 - TSS286 chr1:23345940-23410184 3035 - 2064.11 1426.3 2701.92 OK 3123.43 2750.05 3496.8 OK 1754.94 897.589 2612.29 OK TCONS_00000525 = uc001bgj.2 XLOC_000188 - TSS286 chr1:23345940-23410184 3107 - 556.677 175.107 938.247 OK 911.067 698.856 1123.28 OK 597.396 99.5527 1095.24 OK TCONS_00000526 = uc001bgv.2 XLOC_000189 C1orf213 TSS287 chr1:23685941-23698278 887 - 6.87752 0 118.747 OK 2.53326 0 7.75234 OK 73.0221 0 322.578 OK TCONS_00000527 = uc001bgw.2 XLOC_000189 C1orf213 - chr1:23685941-23698278 2815 - 8.91818 0 33.4669 OK 4.45377 1.19709 7.71044 OK 27.3759 0 92.7495 OK TCONS_00000528 = uc001bhf.1 XLOC_000190 - - chr1:23832921-23857713 2178 - 7.64299 0 21.0616 OK 0.939918 0 3.91205 OK 0 0 0 OK TCONS_00000529 = uc001bhi.3 XLOC_000191 MDS2 TSS288 chr1:23907984-23967056 1779 - 6.59897e-05 0 3.04152 OK 0 0 0 OK 0 0 0 OK TCONS_00000530 = uc001bhj.3 XLOC_000191 MDS2 TSS289 chr1:23907984-23967056 1625 - 0.878658 0 4.24619 OK 0 0 0 OK 0 0 0 OK TCONS_00000531 = uc001bhk.2 XLOC_000192 RPL11 TSS290 chr1:24018293-24022913 607 - 6878.03 3034.71 10721.3 OK 6624.43 4634.51 8614.36 OK 57034.4 0 120251 OK TCONS_00000532 = uc001bhl.2 XLOC_000192 RPL11 TSS290 chr1:24018293-24022913 604 - 728.583 0 2157.89 OK 1583.34 567.367 2599.31 OK 8804.01 0 36317.8 OK TCONS_00000533 = uc001bhm.2 XLOC_000192 RPL11 TSS291 chr1:24018293-24022913 594 - 37247.7 28518.8 45976.5 OK 66407.9 60090.9 72724.8 OK 56810.6 5947.22 107674 OK TCONS_00000534 = uc001bhn.1 XLOC_000192 RPL11 TSS291 chr1:24018293-24022913 1975 - 227.08 0 558.532 OK 191.396 26.3709 356.421 OK 86.3727 0 5223.64 OK TCONS_00000535 = uc001bho.2 XLOC_000193 TCEB3 TSS292 chr1:24069855-24104777 4942 - 755.461 500.365 1010.56 OK 523.425 449.786 597.064 OK 1232.52 710.214 1754.83 OK TCONS_00000536 = uc001bhq.2 XLOC_000194 C1orf128 TSS293 chr1:24104875-24114720 1620 - 1031.1 585.034 1477.16 OK 1150.34 973.267 1327.41 OK 1578.13 864.273 2291.99 OK TCONS_00000537 = uc010oeb.1 XLOC_000194 - TSS293 chr1:24104875-24114720 1576 - 42.6282 0 144.062 OK 57.722 11.6848 103.759 OK 138.236 0 368.919 OK TCONS_00000538 = uc001bhr.2 XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 1686 - 60.6827 0 192.717 OK 0 0 0 OK 0 0 0 OK TCONS_00000539 = uc001bhs.1 XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 1728 - 107.325 0 260.912 OK 366.517 237.845 495.188 OK 138.908 0 347.561 OK TCONS_00000540 = uc001bht.2 XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 1622 - 728.399 345.869 1110.93 OK 738.535 550.861 926.209 OK 245.964 0 503.753 OK TCONS_00000541 = uc001bhu.2 XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 1590 - 151.125 0 346.217 OK 1591.41 1317.47 1865.36 OK 801.526 326.057 1277 OK TCONS_00000542 = uc001big.2 XLOC_000196 PNRC2 TSS295 chr1:24286300-24289947 2412 - 2032.12 1397.99 2666.24 OK 1015.28 870.304 1160.25 OK 1795.17 1048.34 2541.99 OK TCONS_00000543 = uc010oei.1 XLOC_000197 - TSS296 chr1:24526729-24538180 1846 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00000544 = uc001bix.2 XLOC_000198 GRHL3 TSS297 chr1:24645880-24681807 2799 - 11.6632 0 25.3412 OK 24.5694 18.1154 31.0234 OK 0 0 0 OK TCONS_00000545 = uc001biy.2 XLOC_000198 GRHL3 TSS298 chr1:24645880-24681807 2699 - 9.34923 0 22.3551 OK 0.00104564 0 0.746452 OK 3.65658e-05 0 0.923571 OK TCONS_00000546 = uc001biz.2 XLOC_000198 GRHL3 TSS298 chr1:24645880-24681807 2512 - 0.00176595 0 2.07322 OK 0 0 0 OK 0.713246 0 2.12472 OK TCONS_00000547 = uc010oek.1 XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 1814 - 5.7743 0 133.837 OK 0.568882 0 3.14544 OK 2.27352 0 620.8 OK TCONS_00000548 = uc001bjg.2 XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 1732 - 102.299 0 262.948 OK 55.217 26.4182 84.0158 OK 181.782 0 693.997 OK TCONS_00000549 = uc001bjh.2 XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 5425 - 340.07 186.719 493.422 OK 80.6785 63.1297 98.2273 OK 1388.46 665.41 2111.5 OK TCONS_00000550 = uc009vrc.2 XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 5535 - 0 0 0 OK 4.01002 0 8.91311 OK 60.0129 0 394.357 OK TCONS_00000551 = uc001bji.2 XLOC_000199 - TSS300 chr1:24742244-24799472 2736 - 22.1357 0 89.5964 OK 5.64277 0 12.4566 OK 7.66113 0 322.35 OK TCONS_00000552 = uc001bjj.2 XLOC_000200 RCAN3 TSS301 chr1:24829386-24862425 1697 - 326.184 141.385 510.982 OK 113.081 85.3306 140.832 OK 219.138 56.3326 381.943 OK TCONS_00000553 = uc009vrd.2 XLOC_000200 RCAN3 TSS302 chr1:24829386-24862425 1413 - 20.7252 0 88.5662 OK 0 0 0 OK 77.2898 0 299.924 OK TCONS_00000554 = uc009vre.2 XLOC_000200 - TSS302 chr1:24829386-24862425 1269 - 15.7185 0 96.9772 OK 11.8633 0 25.7417 OK 51.8532 0 317.685 OK TCONS_00000555 = uc009vrf.2 XLOC_000200 - TSS302 chr1:24829386-24862425 1271 - 0 0 0 OK 4.24998 0 15.5901 OK 46.3362 0 225.029 OK TCONS_00000556 = uc009vrg.2 XLOC_000200 - TSS302 chr1:24829386-24862425 1097 - 10.6171 0 119.919 OK 2.64685 0 14.2982 OK 8.94425 0 127.308 OK TCONS_00000557 = uc001bjk.1 XLOC_000201 C1orf130 TSS303 chr1:24882601-24935816 3953 - 1.31366 0 3.14984 OK 2.35713 0.82725 3.88701 OK 0.128844 0 0.527799 OK TCONS_00000558 = uc001bjm.2 XLOC_000202 SRRM1 TSS304 chr1:24969593-24999771 3933 - 816.952 510.008 1123.9 OK 805.739 675.901 935.577 OK 789.315 313.429 1265.2 OK TCONS_00000559 = uc010oel.1 XLOC_000202 SRRM1 TSS304 chr1:24969593-24999771 3969 - 0.0198022 0 1.82379 OK 0 0 0 OK 574.066 181.597 966.535 OK TCONS_00000560 = uc009vrh.1 XLOC_000202 SRRM1 TSS305 chr1:24969593-24999771 2393 - 41.7106 0 140.057 OK 47.1916 0 141.741 OK 28.5028 0 259.28 OK TCONS_00000561 = uc009vri.1 XLOC_000202 SRRM1 TSS306 chr1:24969593-24999771 2510 - 347.64 90.4553 604.825 OK 876.963 688.501 1065.42 OK 164.784 0 656.281 OK TCONS_00000562 = uc010oem.1 XLOC_000202 - TSS306 chr1:24969593-24999771 1489 - 84.2414 0 319.212 OK 66.4895 0.338421 132.641 OK 70.3113 0 457.782 OK TCONS_00003803 = uc009vis.2 XLOC_001217 - TSS1906 chr1:11873-29961 842 - 0.0436773 0 7.35198 OK 347.213 219.116 475.309 OK 560.298 46.1225 1074.47 OK TCONS_00003804 = uc001aae.3 XLOC_001217 - TSS1907 chr1:11873-29961 2411 - 20.2689 0 86.7858 OK 0 0 0 OK 0 0 0 OK TCONS_00003805 = uc009vit.2 XLOC_001217 - TSS1907 chr1:11873-29961 2648 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003806 = uc009viu.2 XLOC_001217 - TSS1907 chr1:11873-29961 2705 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003807 = uc001aab.3 XLOC_001217 - TSS1908 chr1:11873-29961 1745 - 108.765 0 264.527 OK 0 0 0 OK 0 0 0 OK TCONS_00003808 = uc001aac.3 XLOC_001217 - TSS1909 chr1:11873-29961 1745 - 10.3996 0 115.166 OK 1.80263 0 15.1887 OK 7.75088 0 119.067 OK TCONS_00003809 = uc001aah.3 XLOC_001217 - TSS1909 chr1:11873-29961 1768 - 59.4507 0 187.493 OK 102.706 45.2215 160.19 OK 173.783 0 408.132 OK TCONS_00003810 = uc009viq.2 XLOC_001217 - TSS1909 chr1:11873-29961 1636 - 44.5281 0 140.424 OK 14.6077 0 34.6421 OK 21.7772 0 129.471 OK TCONS_00003811 = uc009vir.2 XLOC_001217 - TSS1909 chr1:11873-29961 2005 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003812 = uc009viv.2 XLOC_001217 - TSS1909 chr1:11873-29961 3181 - 38.8286 0 106.91 OK 13.2227 0 26.5816 OK 47.9895 0 119.363 OK TCONS_00003813 = uc009viw.2 XLOC_001217 - TSS1909 chr1:11873-29961 3517 - 74.8157 0 158.151 OK 51.2562 28.6952 73.8172 OK 0 0 0 OK TCONS_00003814 = uc009vix.2 XLOC_001217 - TSS1909 chr1:11873-29961 1189 - 4.01193 0 251.75 OK 2.59699 0 23.927 OK 0 0 0 OK TCONS_00003815 = uc009vjd.2 XLOC_001217 - TSS1910 chr1:11873-29961 1101 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003816 = uc009viy.2 XLOC_001217 - TSS1909 chr1:11873-29961 1134 - 12.1835 0 194.495 OK 5.35614 0 23.6491 OK 0 0 0 OK TCONS_00003817 = uc009viz.2 XLOC_001217 - TSS1909 chr1:11873-29961 1097 - 0 0 0 OK 36.3642 0 77.7982 OK 0.0461934 0 4.44066 OK TCONS_00003818 = uc009vjc.1 XLOC_001217 - TSS1911 chr1:11873-29961 717 - 166.699 0 541.09 OK 224.306 102.258 346.353 OK 240.082 0 645.46 OK TCONS_00003819 = uc001aai.1 XLOC_001217 - TSS1907 chr1:11873-29961 1577 - 479.443 153.944 804.942 OK 95.223 47.2016 143.244 OK 76.652 0 231.392 OK TCONS_00003820 = uc010nxs.1 XLOC_001217 - TSS1909 chr1:11873-29961 1148 - 16.824 0 189.83 OK 38.5776 0 87.5407 OK 16.2553 0 192.669 OK TCONS_00003821 = uc009vjb.1 XLOC_001217 - TSS1912 chr1:11873-29961 1022 - 42.2462 0 222.067 OK 122.62 49.9311 195.309 OK 228.081 0 542.697 OK TCONS_00003822 = uc009vje.2 XLOC_001217 - TSS1909 chr1:11873-29961 806 - 0 0 0 OK 27.8905 0 69.0519 OK 46.2659 0 298.955 OK TCONS_00003823 = uc009vjf.2 XLOC_001217 - TSS1909 chr1:11873-29961 868 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003824 = uc001aak.2 XLOC_001218 - TSS1913 chr1:34611-36081 1129 - 13.7184 1.56112 25.8757 OK 16.5503 8.50309 24.5975 OK 4.32826 0 10.5235 OK TCONS_00003825 = uc010nxt.1 XLOC_001219 - TSS1914 chr1:89294-237877 2373 - 12.8434 0 40.4901 OK 2.45836 0 7.59087 OK 13.5604 0 28.5077 OK TCONS_00003826 = uc001aam.3 XLOC_001220 - - chr1:89294-237877 1390 - 342.399 150.861 533.938 OK 634.855 524.149 745.561 OK 19.9712 0 44.4515 OK TCONS_00003827 = uc010nxv.1 XLOC_001221 OR4F16 - chr1:621097-622034 937 - 1.51396 0 5.87661 OK 0 0 0 OK 0 0 0 OK TCONS_00003828 = uc001abe.3 XLOC_001222 - TSS1915 chr1:661139-679736 4272 - 15.7705 0 91.3192 OK 18.7126 2.74613 34.6791 OK 1.6027 0 20.2923 OK TCONS_00003829 = uc009vjm.2 XLOC_001222 - TSS1916 chr1:661139-679736 4295 - 161.143 20.1116 302.174 OK 297.645 236.943 358.346 OK 39.9694 4.47313 75.4657 OK TCONS_00003830 = uc002khh.2 XLOC_001222 - TSS1917 chr1:661139-679736 4812 - 96.6862 10.2203 183.152 OK 191.32 144.848 237.792 OK 22.9579 0 54.5472 OK TCONS_00003831 = uc001abi.1 XLOC_001223 - - chr1:661139-679736 78 - 0 0 0 OK 697259 0 2.79472e+06 OK 14237.7 0 365954 OK TCONS_00003832 = uc001abj.2 XLOC_001224 - - chr1:661139-679736 31 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003833 = uc010nxw.1 XLOC_001225 - - chr1:661139-679736 78 - 0 0 0 OK 697259 0 2.79472e+06 OK 14237.7 0 365954 OK TCONS_00003834 = uc001abl.2 XLOC_001226 - - chr1:661139-679736 31 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003835 = uc001abm.2 XLOC_001222 - TSS1917 chr1:661139-679736 683 - 169.764 0 507.516 OK 520.885 292.794 748.976 OK 45.3238 0 168.405 OK TCONS_00003836 = uc001abo.2 XLOC_001227 - TSS1918 chr1:700236-714006 1317 - 247.682 103.907 391.458 OK 235.71 185.668 285.751 OK 50.5377 9.42215 91.6533 OK TCONS_00003837 = uc010nxx.1 XLOC_001228 - - chr1:761586-762902 1316 - 29.1742 7.70701 50.6415 OK 19.6665 11.5626 27.7703 OK 39.9678 6.81386 73.1216 OK TCONS_00003838 = uc001abt.3 XLOC_001229 FAM41C TSS1919 chr1:803452-812182 1704 - 17.3524 4.7668 29.9381 OK 2.1691 0 4.48622 OK 7.41126 0 14.9157 OK TCONS_00003839 = uc010nxy.1 XLOC_001230 - TSS1920 chr1:852952-854817 496 - 0 0 0 OK 0 0 0 OK 7.62477 0 20.6728 OK TCONS_00003840 = uc010nxz.1 XLOC_001230 - TSS1920 chr1:852952-854817 436 - 0 0 0 OK 4.38548 0 16.6636 OK 0 0 0 OK TCONS_00003841 = uc001aby.3 XLOC_001231 NOC2L TSS1921 chr1:860529-894679 4282 - 36.029 0 101.075 OK 100.448 56.5333 144.362 OK 55.7714 0 492.764 OK TCONS_00003842 = uc001abz.3 XLOC_001231 NOC2L TSS1922 chr1:860529-894679 2799 - 328.516 127.865 529.168 OK 547.174 419.441 674.908 OK 646.349 106.239 1186.46 OK TCONS_00003843 = uc009vjq.2 XLOC_001231 NOC2L TSS1922 chr1:860529-894679 2814 - 256.209 73.1015 439.318 OK 1090.31 914.057 1266.57 OK 1445.11 454.626 2435.59 OK TCONS_00003844 = uc009vjr.1 XLOC_001231 NOC2L TSS1922 chr1:860529-894679 896 - 43.7364 0 260.927 OK 97.2158 0 208.789 OK 72.8474 0 900.598 OK TCONS_00003845 = uc001acg.2 XLOC_001232 C1orf170 TSS1923 chr1:910578-917473 1214 - 9.49353 0 19.9648 OK 14.7182 7.08177 22.3546 OK 36.2061 3.03557 69.3766 OK TCONS_00003846 = uc001ach.2 XLOC_001232 C1orf170 TSS1924 chr1:910578-917473 3040 - 0 0 0 OK 0.517867 0 2.40899 OK 2.14049 0 8.01859 OK TCONS_00003847 = uc001aci.2 XLOC_001233 HES4 TSS1925 chr1:934341-935552 962 - 54.1565 11.0853 97.2278 OK 25.1834 11.4684 38.8983 OK 29.4876 0 65.9328 OK TCONS_00003848 = uc010nyc.1 XLOC_001233 HES4 TSS1925 chr1:934341-935552 1040 - 0 0 0 OK 12.2395 1.62527 22.8538 OK 4.13955 0 25.7443 OK TCONS_00003849 = uc010nyd.1 XLOC_001234 - TSS1926 chr1:1017197-1051736 1870 - 0 0 0 OK 0 0 0 OK 6.02886 0 56.515 OK TCONS_00003850 = uc001acm.2 XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 1750 - 9.95714 0 47.2577 OK 21.5806 4.15913 39.0021 OK 22.7448 0 122.396 OK TCONS_00003851 = uc009vju.1 XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 1741 - 0.00198038 0 3.09528 OK 11.9017 0 26.3618 OK 53.0677 0 181.473 OK TCONS_00003852 = uc001acn.2 XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 2741 - 16.1923 0 44.6862 OK 14.7307 3.76971 25.6916 OK 0 0 0 OK TCONS_00003853 = uc001acp.2 XLOC_001234 C1orf159 TSS1928 chr1:1017197-1051736 1979 - 50.4508 0.525248 100.376 OK 91.6026 61.4046 121.8 OK 59.219 0 171.725 OK TCONS_00003854 = uc001acr.2 XLOC_001234 - TSS1929 chr1:1017197-1051736 2373 - 0 0 0 OK 3.76844 0 11.2482 OK 4.24905 0 43.3182 OK TCONS_00003855 = uc001acs.2 XLOC_001234 - TSS1929 chr1:1017197-1051736 2276 - 0 0 0 OK 29.6027 12.5359 46.6696 OK 39.2481 0 100.448 OK TCONS_00003856 = uc001act.2 XLOC_001234 C1orf159 TSS1929 chr1:1017197-1051736 2704 - 18.8091 0 45.1259 OK 6.807 0 14.8624 OK 19.7743 0 61.3035 OK TCONS_00003857 = uc001acu.2 XLOC_001234 C1orf159 TSS1929 chr1:1017197-1051736 2104 - 0 0 0 OK 0 0 0 OK 21.0061 0 77.1739 OK TCONS_00003858 = uc001acx.1 XLOC_001235 - TSS1930 chr1:1108435-1133313 3532 - 0.346272 0 1.78395 OK 5.99833 3.26167 8.73498 OK 0 0 0 OK TCONS_00003859 = uc001ada.2 XLOC_001236 TNFRSF18 TSS1931 chr1:1138888-1142089 1062 - 2.09869 0 9.84106 OK 10.3558 0.808242 19.9033 OK 0 0 0 OK TCONS_00003860 = uc001adb.2 XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 1178 - 1.73622 0 6.57555 OK 0 0 0 OK 14.2685 0 28.6165 OK TCONS_00003861 = uc001adc.2 XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 1199 - 0.00252879 0 4.74227 OK 24.8393 13.5618 36.1167 OK 0.00130815 0 2.28068 OK TCONS_00003862 = uc001add.2 XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 988 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003863 = uc001ade.2 XLOC_001237 TNFRSF4 TSS1933 chr1:1146706-1149512 1067 - 1.29516 0 6.6725 OK 0 0 0 OK 5.89401 0 12.8778 OK TCONS_00003864 = uc001adf.2 XLOC_001237 TNFRSF4 TSS1933 chr1:1146706-1149512 1700 - 0 0 0 OK 1.21775 0 2.94864 OK 0 0 0 OK TCONS_00003865 = uc001adg.2 XLOC_001238 SDF4 TSS1934 chr1:1152288-1167447 3539 - 60.6719 0 136.285 OK 105.623 62.8327 148.414 OK 71.6823 0 617.962 OK TCONS_00003866 = uc001adh.3 XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 2021 - 829.134 458.508 1199.76 OK 1473.6 1260.01 1687.18 OK 8370.57 4261.26 12479.9 OK TCONS_00003867 = uc001adi.3 XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 2137 - 39.6628 0 152.233 OK 17.9039 0 44.1172 OK 539.303 0 1868.4 OK TCONS_00003868 = uc009vjv.2 XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 1542 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003869 = uc009vjw.2 XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 2153 - 0 0 0 OK 5.79383 0 21.4619 OK 49.0895 0 999.561 OK TCONS_00003870 = uc001adj.1 XLOC_001238 SDF4 TSS1936 chr1:1152288-1167447 771 - 32.4396 0 287.775 OK 210.708 62.714 358.702 OK 114.07 0 3312.32 OK TCONS_00003871 = uc001adl.1 XLOC_001239 FAM132A TSS1937 chr1:1177832-1182102 1036 - 17.131 3.00892 31.2531 OK 41.9198 28.3894 55.4503 OK 75.8216 10.8039 140.839 OK TCONS_00003872 = uc001adm.2 XLOC_001240 UBE2J2 TSS1938 chr1:1189293-1209234 2262 - 16.9893 0 75.1996 OK 15.5986 0 34.1698 OK 27.9153 0 219.894 OK TCONS_00003873 = uc001adn.2 XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 2379 - 22.0748 0 76.4892 OK 27.7097 2.78921 52.6301 OK 45.6069 0 225.093 OK TCONS_00003874 = uc001ado.2 XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 2306 - 5.41455 0 73.5691 OK 0 0 0 OK 2.68872 0 247.792 OK TCONS_00003875 = uc001adp.2 XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 2258 - 417.932 188.426 647.439 OK 594.103 477.434 710.772 OK 1659.15 867.65 2450.64 OK TCONS_00003876 = uc001adq.2 XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 2387 - 25.4338 0 112.869 OK 37.5213 0 99.205 OK 75.7217 0 279.293 OK TCONS_00003877 = uc001adr.2 XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 2127 - 0 0 0 OK 18.384 0 49.2599 OK 85.2438 0 286.606 OK TCONS_00003878 = uc001ads.2 XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 2380 - 10.1146 0 68.193 OK 21.3064 0 42.9115 OK 95.4488 0 347.781 OK TCONS_00003879 = uc010nyh.1 XLOC_001241 - - chr1:1189293-1209234 3517 - 17.2606 0 51.4891 OK 37.017 16.7475 57.2865 OK 20.3727 0 89.1972 OK TCONS_00003880 = uc001ady.2 XLOC_001242 ACAP3 TSS1940 chr1:1227763-1260046 3211 - 9.37264 0 74.2674 OK 139.601 71.7322 207.47 OK 101.369 0 437.866 OK TCONS_00003881 = uc001aea.2 XLOC_001242 ACAP3 TSS1941 chr1:1227763-1260046 5325 - 25.8307 0 74.8109 OK 113.499 67.0995 159.898 OK 86.9123 0 284.304 OK TCONS_00003882 = uc001aeb.2 XLOC_001242 ACAP3 TSS1942 chr1:1227763-1260046 3759 - 93.257 0 191.075 OK 181.357 110.619 252.095 OK 810.457 116.624 1504.29 OK TCONS_00003883 = uc001aec.1 XLOC_001242 - TSS1943 chr1:1227763-1260046 1946 - 26.1554 0 127.888 OK 117.46 33.8827 201.038 OK 131.616 0 709.538 OK TCONS_00003884 = uc009vjy.1 XLOC_001243 CPSF3L TSS1944 chr1:1227763-1260046 2880 - 79.6054 0 192.563 OK 94.0403 33.8728 154.208 OK 120.03 0 496.806 OK TCONS_00003885 = uc001aee.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 2135 - 590.361 257.107 923.615 OK 1597.84 1318.11 1877.56 OK 2355.04 711.934 3998.15 OK TCONS_00003886 = uc001aef.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 2608 - 15.5849 0 93.1917 OK 41.6009 0 85.6853 OK 16.3417 0 452.747 OK TCONS_00003887 = uc001aeg.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 2510 - 11.6979 0 95.8203 OK 37.6829 0 78.8786 OK 23.1589 0 473.017 OK TCONS_00003888 = uc001aeh.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 1832 - 0 0 0 OK 21.2906 0 64.1614 OK 3.63351 0 815.064 OK TCONS_00003889 = uc001aei.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 1841 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003890 = uc001aej.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 1698 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003891 = uc001aek.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 1918 - 22.9173 0 129.569 OK 99.7638 22.3861 177.141 OK 74.3645 0 666.501 OK TCONS_00003892 = uc009vjz.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 2069 - 28.1613 0 127.161 OK 4.26182 0 33.6676 OK 3.66246 0 701.004 OK TCONS_00003893 = uc010nyj.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 2242 - 0 0 0 OK 45.4548 0 97.9165 OK 82.7322 0 580.841 OK TCONS_00003894 = uc001ael.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 1570 - 4.09686 0 206.988 OK 41.7594 0 101.862 OK 7.63052 0 864.996 OK TCONS_00003895 = uc001aem.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 1104 - 109.796 0 386.237 OK 428.913 212.206 645.62 OK 407.64 0 1518.33 OK TCONS_00003896 = uc001aen.1 XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 2483 - 74.8279 0 206.509 OK 131.639 55.9243 207.355 OK 14.441 0 468.955 OK TCONS_00003897 = uc002quu.2 XLOC_001244 DVL1 TSS1946 chr1:1270658-1284492 2182 - 63.7322 0 172.039 OK 263.001 102.409 423.593 OK 252.541 0 788.766 OK TCONS_00003898 = uc009vka.2 XLOC_001244 DVL1L1 TSS1946 chr1:1270658-1284492 2193 - 8.10625 0 61.6261 OK 31.5522 0 186.876 OK 49.6575 0 524.94 OK TCONS_00003899 = uc001aer.3 XLOC_001244 DVL1 TSS1947 chr1:1270658-1284492 2923 - 173.57 60.0717 287.069 OK 674.206 553.931 794.481 OK 1267.03 652.486 1881.58 OK TCONS_00003900 = uc001aeu.1 XLOC_001244 DVL1 TSS1948 chr1:1270658-1284492 4402 - 30.2667 0 67.9866 OK 193.963 141.571 246.356 OK 23.7193 0 116.238 OK TCONS_00003901 = uc001aex.3 XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 2005 - 6.14109 0 154.008 OK 11.8645 0 24.3286 OK 95.5511 0 2206.12 OK TCONS_00003902 = uc001aey.3 XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 1987 - 101.118 0 261.934 OK 0.00314546 0 1.04164 OK 2934.02 0 6584.05 OK TCONS_00003903 = uc001aez.2 XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 1996 - 248.639 0 768.622 OK 55.4345 31.8089 79.0601 OK 2864.03 0 6496.11 OK TCONS_00003904 = uc001aew.2 XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 2299 - 721.263 162.336 1280.19 OK 67.479 43.9127 91.0453 OK 8407.76 2732.83 14082.7 OK TCONS_00003905 = uc001afa.2 XLOC_001245 MXRA8 TSS1950 chr1:1288071-1297157 2728 - 2.23252 0 130.782 OK 18.5375 6.65185 30.4231 OK 18.6477 0 1565.25 OK TCONS_00003906 = uc001afb.1 XLOC_001246 AURKAIP1 TSS1951 chr1:1309109-1310818 781 - 1486.29 429.321 2543.26 OK 1941.94 1531.12 2352.75 OK 3221.31 986.215 5456.4 OK TCONS_00003907 = uc009vkb.1 XLOC_001246 AURKAIP1 TSS1952 chr1:1309109-1310818 813 - 37.1577 0 298.816 OK 185.125 54.3988 315.85 OK 358.847 0 1369.49 OK TCONS_00003908 = uc001afd.2 XLOC_001246 AURKAIP1 TSS1952 chr1:1309109-1310818 909 - 323.055 0 1095.53 OK 651.469 432.547 870.392 OK 1592.97 90.3237 3095.62 OK TCONS_00003909 = uc001afc.2 XLOC_001246 AURKAIP1 TSS1953 chr1:1309109-1310818 990 - 711.073 137.94 1284.21 OK 881.639 641.734 1121.54 OK 1861.17 403.947 3318.4 OK TCONS_00003910 = uc010nym.1 XLOC_001247 - TSS1954 chr1:1321090-1334718 2914 - 5.40934 0 86.6842 OK 15.222 0 38.1295 OK 6.77005 0 201.908 OK TCONS_00003911 = uc001aff.1 XLOC_001247 CCNL2 TSS1955 chr1:1321090-1334718 4362 - 114.444 3.14115 225.747 OK 110.19 65.2334 155.146 OK 134.515 0 345.352 OK TCONS_00003912 = uc001afg.1 XLOC_001247 CCNL2 TSS1956 chr1:1321090-1334718 2868 - 6.6959 0 89.1507 OK 107.558 0 261.608 OK 19.8352 0 209.547 OK TCONS_00003913 = uc001afh.2 XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 5269 - 348.681 184.379 512.982 OK 352.289 280.826 423.752 OK 674.159 301.412 1046.91 OK TCONS_00003914 = uc001afi.2 XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 3115 - 172.404 14.834 329.974 OK 443.979 283.846 604.112 OK 322.484 0 808.388 OK TCONS_00003915 = uc001afj.2 XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 3129 - 17.0885 0 84.7288 OK 96.9882 45.5948 148.382 OK 18.1877 0 191.06 OK TCONS_00003916 = uc001afk.2 XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 3839 - 84.4595 0 188.854 OK 112.752 64.1239 161.381 OK 97.6848 0 339.464 OK TCONS_00003917 = uc001afo.3 XLOC_001248 MRPL20 TSS1958 chr1:1334909-1342693 732 - 3025.74 1703.21 4348.28 OK 4267.92 3599.47 4936.36 OK 8706.81 4659.66 12754 OK TCONS_00003918 = uc010nyn.1 XLOC_001248 MRPL20 TSS1958 chr1:1334909-1342693 1148 - 108.19 0 340.038 OK 88.7189 11.8203 165.617 OK 37.8673 0 558.576 OK TCONS_00003919 = uc001afp.2 XLOC_001249 - TSS1959 chr1:1353801-1356650 1456 - 48.4609 10.5983 86.3236 OK 17.1724 4.28041 30.0644 OK 85.2846 8.08158 162.488 OK TCONS_00003920 = uc001afq.2 XLOC_001249 - TSS1959 chr1:1353801-1356650 1475 - 0.00430007 0 3.73508 OK 49.1286 31.229 67.0282 OK 0.00204697 0 1.792 OK TCONS_00003921 = uc010nyo.1 XLOC_001249 - TSS1959 chr1:1353801-1356650 2016 - 6.61991 0 24.912 OK 6.86284 0.223504 13.5022 OK 15.6317 0 48.2588 OK TCONS_00003922 = uc009vkf.2 XLOC_001250 C1orf70 TSS1960 chr1:1470158-1475740 1116 - 31.9981 5.39734 58.5989 OK 83.1162 61.5122 104.72 OK 233.834 79.2517 388.416 OK TCONS_00003923 = uc001agd.2 XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 1302 - 1955.08 1125.52 2784.63 OK 3166.29 2731.74 3600.84 OK 6236.3 3304.63 9167.98 OK TCONS_00003924 = uc009vkg.1 XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 1497 - 17.0327 0 174.592 OK 11.4081 0 37.1104 OK 4.14556 0 649.699 OK TCONS_00003925 = uc001age.1 XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 2970 - 407.325 161.607 653.043 OK 235.83 159.844 311.816 OK 430.732 0 954.81 OK TCONS_00003926 = uc009vkj.2 XLOC_001252 CDC2L1 TSS1962 chr1:1571099-1677431 1629 - 33.8277 0 160.618 OK 205.562 59.0219 352.102 OK 286.25 0 1373.22 OK TCONS_00003927 = uc001ags.1 XLOC_001252 CDC2L1 TSS1963 chr1:1571099-1677431 2053 - 0 0 0 OK 123.643 33.6056 213.68 OK 186.844 0 1029.17 OK TCONS_00003928 = uc001agt.1 XLOC_001252 CDC2L1 TSS1963 chr1:1571099-1677431 1877 - 9.33823 0 135.943 OK 168.137 58.4402 277.834 OK 179.943 0 1110.15 OK TCONS_00003929 = uc001agv.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 2452 - 10.4083 0 99.9748 OK 0 0 0 OK 0 0 0 OK TCONS_00003930 = uc001agw.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 2451 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003931 = uc001agx.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 2404 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003932 = uc001agy.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 2431 - 0 0 0 OK 22.1371 0 58.1262 OK 6.57877 0 802.824 OK TCONS_00003933 = uc001agz.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 2192 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003934 = uc001aha.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 2499 - 23.7584 0 102.845 OK 109.837 33.2422 186.432 OK 182.067 0 861.513 OK TCONS_00003935 = uc010nyr.1 XLOC_001252 CDC2L1 TSS1965 chr1:1571099-1677431 262 - 76.2007 0 634.572 OK 816.237 0 2093.74 OK 795.035 0 20768.2 OK TCONS_00003936 = uc001ahc.1 XLOC_001253 CDC2L1 TSS1969 chr1:1571099-1677431 335 - 81.9647 0 509.713 OK 251.238 0 684.019 OK 440.918 0 3485.7 OK TCONS_00003937 = uc009vkl.1 XLOC_001254 SLC35E2 TSS1970 chr1:1571099-1677431 2236 - 19.9963 0 109.14 OK 15.2497 0 54.2933 OK 8.02851 0 815.143 OK TCONS_00003938 = uc001ahe.3 XLOC_001254 - TSS1971 chr1:1571099-1677431 5141 - 57.9127 0 130.206 OK 222.366 149.606 295.126 OK 276.724 0 723.736 OK TCONS_00003939 = uc001ahf.3 XLOC_001254 - TSS1970 chr1:1571099-1677431 6420 - 39.3012 0 89.1672 OK 80.1962 41.0331 119.359 OK 47.7522 0 300.301 OK TCONS_00003940 = uc001ahg.3 XLOC_001254 - TSS1970 chr1:1571099-1677431 6002 - 42.2344 0 95.6911 OK 45.5718 14.9635 76.1801 OK 234.425 0 615.316 OK TCONS_00003941 = uc001ahh.3 XLOC_001254 - TSS1972 chr1:1571099-1677431 5915 - 21.1415 0 66.3653 OK 231.222 162.672 299.772 OK 216.993 0 603.789 OK TCONS_00003942 = uc009vkm.1 XLOC_001254 SLC35E2 TSS1973 chr1:1571099-1677431 1231 - 48.2599 0 223.438 OK 122.207 2.4671 241.946 OK 362.567 0 1875.37 OK TCONS_00003943 = uc009vkn.1 XLOC_001254 SLC35E2 TSS1970 chr1:1571099-1677431 2279 - 21.1432 0 106.909 OK 37.3588 0 83.0054 OK 25.3689 0 783.128 OK TCONS_00003944 = uc001ahj.3 XLOC_001252 CDC2L2 TSS1966 chr1:1571099-1677431 1777 - 4.69427 0 168.13 OK 110.433 17.4495 203.416 OK 19.8478 0 1069.73 OK TCONS_00003945 = uc009vkp.2 XLOC_001252 CDC2L2 TSS1967 chr1:1571099-1677431 1557 - 22.682 0 164.01 OK 146.455 30.1265 262.784 OK 84.2667 0 1251.48 OK TCONS_00003946 = uc009vkq.2 XLOC_001252 CDC2L2 TSS1967 chr1:1571099-1677431 1504 - 21.915 0 166.364 OK 98.0216 2.56271 193.481 OK 85.2622 0 1298.75 OK TCONS_00003947 = uc009vkr.2 XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 2595 - 10.007 0 94.4969 OK 204.998 103.477 306.519 OK 293.354 0 945.749 OK TCONS_00003948 = uc009vks.2 XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 2625 - 44.5894 0 149.251 OK 618 446.673 789.327 OK 1043.7 0 2330.01 OK TCONS_00003949 = uc010nys.1 XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 1966 - 10.5985 0 122.548 OK 162.241 57.9622 266.52 OK 113.359 0 1003.47 OK TCONS_00003950 = uc010nyt.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 1920 - 0 0 0 OK 0 0 0 OK 84.1064 0 1001.03 OK TCONS_00003951 = uc010nyu.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 1277 - 10.2217 0 207.634 OK 38.1573 0 111.936 OK 87.1897 0 1557.16 OK TCONS_00003952 = uc009vkt.1 XLOC_001252 CDC2L1 TSS1964 chr1:1571099-1677431 1108 - 0 0 0 OK 21.7767 0 84.7472 OK 7.69268 0 2131.71 OK TCONS_00003953 = uc009vku.1 XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 1120 - 0.128652 0 7.38609 OK 1.12006 0 587.32 OK 3.69003 0 2773.47 OK TCONS_00003954 = uc009vkv.1 XLOC_001252 CDC2L2 TSS1964 chr1:1571099-1677431 1150 - 8.10282 0 269.633 OK 24.8037 0 84.2873 OK 114.365 0 1772.1 OK TCONS_00003955 = uc001aht.1 XLOC_001252 CDC2L2 TSS1968 chr1:1571099-1677431 887 - 2.85432 0 40.805 OK 17.5163 0 104.005 OK 91.7595 0 2408.44 OK TCONS_00003956 = uc001ahu.1 XLOC_001252 CDC2L1 TSS1968 chr1:1571099-1677431 704 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003957 = uc001ahv.1 XLOC_001252 CDC2L1 TSS1968 chr1:1571099-1677431 734 - 23.5881 0 407.115 OK 12.0452 0 124.703 OK 20.3251 0 3272.99 OK TCONS_00003958 = uc001ahw.1 XLOC_001252 CDC2L1 TSS1968 chr1:1571099-1677431 657 - 8.90936 0 770.484 OK 0 0 0 OK 0 0 0 OK TCONS_00003959 = uc001ahy.2 XLOC_001254 SLC35E2 TSS1972 chr1:1571099-1677431 2149 - 93.1692 0 248.949 OK 127.494 38.4432 216.546 OK 113.042 0 917.138 OK TCONS_00003960 = uc001ahz.2 XLOC_001254 SLC35E2 TSS1972 chr1:1571099-1677431 1731 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003961 = uc001aia.1 XLOC_001255 - - chr1:1571099-1677431 3841 - 251.624 92.9647 410.284 OK 341.44 239.089 443.79 OK 1014.62 54.4883 1974.75 OK TCONS_00003962 = uc001aib.1 XLOC_001254 SLC35E2 TSS1972 chr1:1571099-1677431 1430 - 96.0585 0 298.365 OK 274.135 113.969 434.301 OK 431.974 0 1699.8 OK TCONS_00003963 = uc010nyv.1 XLOC_001256 NADK TSS1974 chr1:1682677-1711508 3021 - 10.1742 0 60.2712 OK 13.2843 0 31.0456 OK 1.85523 0 157.807 OK TCONS_00003964 = uc009vkw.2 XLOC_001256 NADK TSS1975 chr1:1682677-1711508 3127 - 0 0 0 OK 0 0 0 OK 215.942 0 748.229 OK TCONS_00003965 = uc001aic.2 XLOC_001256 NADK TSS1975 chr1:1682677-1711508 3228 - 331.317 158.238 504.397 OK 510.173 410.355 609.992 OK 988.439 356.907 1619.97 OK TCONS_00003966 = uc001aid.3 XLOC_001256 NADK TSS1976 chr1:1682677-1711508 3152 - 38.1873 0 144.248 OK 332.932 224.374 441.49 OK 0 0 0 OK TCONS_00003967 = uc001aie.2 XLOC_001256 NADK TSS1977 chr1:1682677-1711508 3646 - 46.8111 0 112.04 OK 91.3616 30.1322 152.591 OK 2.79122 0 112.776 OK TCONS_00003968 = uc009vkx.1 XLOC_001256 NADK TSS1978 chr1:1682677-1711508 1431 - 57.4086 0 205.703 OK 210.14 107.373 312.907 OK 43.7417 0 310.979 OK TCONS_00003969 = uc001aif.2 XLOC_001257 GNB1 TSS1979 chr1:1716729-1822495 3127 - 4274.57 3258.02 5291.12 OK 4816.83 4329.66 5303.99 OK 16698 6417.07 26978.8 OK TCONS_00003970 = uc009vky.2 XLOC_001257 GNB1 TSS1979 chr1:1716729-1822495 2981 - 13.2928 0 153.823 OK 4.54411 0 32.9057 OK 10.8403 0 3346.07 OK TCONS_00003971 = uc001aii.2 XLOC_001258 TMEM52 TSS1980 chr1:1849028-1850740 1118 - 78.6765 14.1773 143.176 OK 212.131 156.646 267.616 OK 0 0 0 OK TCONS_00003972 = uc001aij.2 XLOC_001258 TMEM52 TSS1981 chr1:1849028-1850740 958 - 23.4913 0 76.1659 OK 79.5862 37.1237 122.049 OK 23.4115 2.02793 44.795 OK TCONS_00003973 = uc001aik.2 XLOC_001259 C1orf222 TSS1982 chr1:1853396-1859368 2097 - 0 0 0 OK 2.02001 0 4.61222 OK 0 0 0 OK TCONS_00003974 = uc001ail.2 XLOC_001259 C1orf222 TSS1983 chr1:1853396-1859368 2755 - 0 0 0 OK 1.04698 0 2.82985 OK 0 0 0 OK TCONS_00003975 = uc001aim.1 XLOC_001260 KIAA1751 TSS1984 chr1:1884751-1935276 4710 - 0.583424 0 2.09416 OK 0.932315 0.00687002 1.85776 OK 0 0 0 OK TCONS_00003976 = uc009vkz.1 XLOC_001260 KIAA1751 TSS1985 chr1:1884751-1935276 2572 - 0.437707 0 2.45861 OK 0 0 0 OK 0 0 0 OK TCONS_00003977 = uc001ain.1 XLOC_001260 KIAA1751 TSS1984 chr1:1884751-1935276 2145 - 0.645169 0 3.11763 OK 0 0 0 OK 0 0 0 OK TCONS_00003978 = uc001aio.1 XLOC_001261 - TSS1986 chr1:1944651-1946969 1954 - 4.28982 0 9.13831 OK 8.18597 4.02555 12.3464 OK 0 0 0 OK TCONS_00003979 = uc009vlc.1 XLOC_001262 - TSS1987 chr1:1981908-2139172 1253 - 13.1667 0 127.959 OK 33.574 0 81.1922 OK 27.1259 0 228.561 OK TCONS_00003980 = uc001aiv.1 XLOC_001263 - TSS1988 chr1:1981908-2139172 2347 - 41.939 0 115.752 OK 73.6555 26.7743 120.537 OK 137.693 0 307.885 OK TCONS_00003981 = uc001aiw.1 XLOC_001263 C1orf86 TSS1988 chr1:1981908-2139172 2216 - 0 0 0 OK 0 0 0 OK 40.4901 0 164.222 OK TCONS_00003982 = uc001aix.1 XLOC_001263 - TSS1989 chr1:1981908-2139172 2266 - 6.98486 0 67.3153 OK 25.7926 0 54.4134 OK 78.7015 0 223.633 OK TCONS_00003983 = uc001aiy.2 XLOC_001263 C1orf86 TSS1988 chr1:1981908-2139172 728 - 377.586 0 784.063 OK 1775.08 1335.8 2214.35 OK 2591.54 1130.08 4052.99 OK TCONS_00003984 = uc001ajb.1 XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 1641 - 5.67183 0 35.428 OK 66.6827 21.3525 112.013 OK 19.3469 0 78.0679 OK TCONS_00003985 = uc009vld.2 XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 1826 - 1.30462 0 9.07071 OK 2.05545 0 18.9633 OK 0 0 0 OK TCONS_00003986 = uc001ajc.3 XLOC_001265 - - chr1:2252695-2322993 2248 - 54.2991 11.6048 96.9934 OK 912.804 775.369 1050.24 OK 177.628 58.4676 296.788 OK TCONS_00003987 = uc001ajd.1 XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 1345 - 40.4484 0 97.4314 OK 34.0396 0 76.4195 OK 64.133 0 164.932 OK TCONS_00003988 = uc010nyy.1 XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 1530 - 7.56119 0 32.8798 OK 6.7722 0 22.8762 OK 19.0177 0 81.0934 OK TCONS_00003989 = uc001ajg.2 XLOC_001266 PEX10 TSS1991 chr1:2323213-2344010 2072 - 0 0 0 OK 9.44927 0 32.19 OK 23.7899 0 743.415 OK TCONS_00003990 = uc001ajh.2 XLOC_001266 PEX10 TSS1991 chr1:2323213-2344010 2012 - 290.341 47.1703 533.511 OK 452.417 333.158 571.676 OK 893.546 0 2126.46 OK TCONS_00003991 = uc001ajm.1 XLOC_001267 PANK4 TSS1992 chr1:2439974-2458035 2642 - 174.785 79.7438 269.827 OK 361.252 300.101 422.403 OK 500.991 263.612 738.37 OK TCONS_00003992 = uc010nza.1 XLOC_001267 PANK4 TSS1992 chr1:2439974-2458035 2525 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003993 = uc001ajn.2 XLOC_001268 HES5 TSS1993 chr1:2460184-2461684 1305 - 6.35744 0 13.7346 OK 2.94754 0 6.09621 OK 0 0 0 OK TCONS_00003994 = uc001ajo.2 XLOC_001269 - TSS1994 chr1:2481358-2495265 2368 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003995 = uc001ajp.2 XLOC_001269 - TSS1994 chr1:2481358-2495265 2209 - 0.907232 0 5.69552 OK 0.47493 0 1.80482 OK 6.38716 0 37.2825 OK TCONS_00003996 = uc001ajq.2 XLOC_001269 - TSS1994 chr1:2481358-2495265 2303 - 0 0 0 OK 7.33509e-05 0 0.897997 OK 0 0 0 OK TCONS_00003997 = uc010nzb.1 XLOC_001269 - TSS1995 chr1:2481358-2495265 3322 - 1.10294 0 5.46926 OK 0.649192 0 1.67207 OK 9.83614 0 57.7644 OK TCONS_00003998 = uc009vlg.1 XLOC_001270 MMEL1 TSS1996 chr1:2518248-2564481 2754 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00003999 = uc001ajy.2 XLOC_001270 MMEL1 TSS1997 chr1:2518248-2564481 2902 - 0.931281 0 9.82019 OK 12.7571 0 28.6315 OK 3.38316 0 110.889 OK TCONS_00004000 = uc001aka.2 XLOC_001271 - TSS1998 chr1:2976182-2980350 2222 - 0.620738 0 2.33924 OK 0 0 0 OK 0.336145 0 1.20775 OK TCONS_00004001 = uc010nzg.1 XLOC_001272 - TSS1999 chr1:2980635-2984289 620 - 0 0 0 OK 0 0 0 OK 9.74659 0 22.4902 OK TCONS_00004002 = uc001akk.2 XLOC_001273 MEGF6 TSS2000 chr1:3404512-3528059 6472 - 69.8392 15.621 124.058 OK 41.8309 24.9788 58.6829 OK 92.849 29.832 155.866 OK TCONS_00004003 = uc001akl.2 XLOC_001273 MEGF6 TSS2001 chr1:3404512-3528059 7432 - 43.7292 5.09832 82.36 OK 177.762 147.458 208.065 OK 64.5702 7.50835 121.632 OK TCONS_00004004 = uc001ako.2 XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 1698 - 179.578 39.4838 319.673 OK 319.493 233.421 405.566 OK 402.167 153.034 651.301 OK TCONS_00004005 = uc001akn.3 XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 2041 - 62.1764 0 146.868 OK 203.665 141.08 266.249 OK 99.5061 0 260.449 OK TCONS_00004006 = uc010nzi.1 XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 5724 - 23.0108 0 48.264 OK 74.6828 53.6938 95.6717 OK 18.6731 0 47.6274 OK TCONS_00004007 = uc001akt.3 XLOC_001275 - TSS2003 chr1:3652549-3663886 3322 - 0 0 0 OK 11.3698 0 27.9975 OK 30.0855 0 101.367 OK TCONS_00004008 = uc009vlm.2 XLOC_001275 KIAA0495 TSS2004 chr1:3652549-3663886 6356 - 201.581 112.658 290.504 OK 422.204 363.725 480.683 OK 227.555 119.154 335.957 OK TCONS_00004009 = uc001akx.1 XLOC_001276 LRRC47 TSS2005 chr1:3696783-3713068 2648 - 867.894 535.552 1200.24 OK 1345.43 1168.58 1522.28 OK 1410.28 820.996 1999.56 OK TCONS_00004010 = uc001aky.2 XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 6458 - 15.12 0 42.1754 OK 29.6392 17.6112 41.6673 OK 85.1871 0.535191 169.839 OK TCONS_00004011 = uc010nzm.1 XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 5892 - 139.485 61.8467 217.123 OK 100.25 78.128 122.371 OK 305.484 145.292 465.676 OK TCONS_00004012 = uc001akz.2 XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 2208 - 111.609 0 240.837 OK 52.3176 19.7224 84.9128 OK 177.709 0 448.472 OK TCONS_00004013 = uc001alf.2 XLOC_001278 C1orf174 TSS2007 chr1:3805702-3816857 1660 - 473.292 230.075 716.51 OK 538.523 444.087 632.959 OK 1178.32 645.634 1711.01 OK TCONS_00004014 = uc009vls.2 XLOC_001278 C1orf174 TSS2007 chr1:3805702-3816857 2505 - 15.8862 0 55.9773 OK 12.5397 0 25.4565 OK 4.40735 0 87.0398 OK TCONS_00004015 = uc001alp.1 XLOC_001279 - TSS2008 chr1:5621768-5728315 847 - 0 0 0 OK 0.669469 0 2.5727 OK 0 0 0 OK TCONS_00004016 = uc001alq.1 XLOC_001280 NPHP4 TSS2009 chr1:5922869-6052531 5002 - 38.0315 9.02157 67.0413 OK 140.655 113.269 168.041 OK 98.804 39.2818 158.326 OK TCONS_00004017 = uc001alr.1 XLOC_001280 NPHP4 TSS2010 chr1:5922869-6052531 4370 - 12.3891 0 31.8145 OK 32.7056 18.2592 47.1519 OK 8.76607 0 28.8702 OK TCONS_00004018 = uc001als.1 XLOC_001280 - TSS2009 chr1:5922869-6052531 3630 - 9.73733 0 31.9579 OK 9.30267 0 19.2262 OK 3.94762 0 30.575 OK TCONS_00004019 = uc001alt.1 XLOC_001280 - TSS2009 chr1:5922869-6052531 2596 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004020 = uc009vlt.1 XLOC_001280 - TSS2009 chr1:5922869-6052531 2773 - 0 0 0 OK 3.48039 0 11.1437 OK 0 0 0 OK TCONS_00004021 = uc009vlu.1 XLOC_001280 - TSS2011 chr1:5922869-6052531 1349 - 1.34942 0 12.2253 OK 5.2451 0 20.9799 OK 3.61882 0 90.8012 OK TCONS_00004022 = uc001alz.1 XLOC_001281 CHD5 TSS2012 chr1:6161852-6240183 6343 - 0 0 0 OK 3.24653 0.180409 6.31265 OK 2.58654 0 6.09219 OK TCONS_00004023 = uc001ama.1 XLOC_001281 - TSS2013 chr1:6161852-6240183 7735 - 3.69165 0 10.4053 OK 0.766551 0 2.46407 OK 0.873718 0 3.28683 OK TCONS_00004024 = uc001amb.1 XLOC_001281 CHD5 TSS2014 chr1:6161852-6240183 9646 - 6.8891 0.168879 13.6093 OK 13.8631 9.7945 17.9318 OK 0.611774 0 2.53731 OK TCONS_00004025 = uc001amc.1 XLOC_001281 - TSS2015 chr1:6161852-6240183 3491 - 3.73417 0 15.8629 OK 4.78329 0 9.93525 OK 0 0 0 OK TCONS_00004026 = uc009vlx.1 XLOC_001281 - TSS2016 chr1:6161852-6240183 2198 - 0.120394 0 2.51404 OK 5.03226 0 12.1064 OK 0 0 0 OK TCONS_00004027 = uc001amd.2 XLOC_001282 RPL22 TSS2017 chr1:6245080-6259679 2084 - 2222.07 1497.94 2946.2 OK 4302.07 3804.75 4799.39 OK 7509.61 3373.53 11645.7 OK TCONS_00004028 = uc001ame.2 XLOC_001282 RPL22 TSS2017 chr1:6245080-6259679 2067 - 209.378 0 498.139 OK 72.9481 0 206.297 OK 2365.52 0 4861.9 OK TCONS_00004029 = uc001amk.2 XLOC_001283 ICMT TSS2018 chr1:6266188-6296044 4813 - 1235.93 850.233 1621.63 OK 1196.78 1047.41 1346.14 OK 2319.74 1196.78 3442.71 OK TCONS_00004030 = uc001aml.2 XLOC_001283 - TSS2018 chr1:6266188-6296044 4920 - 243.59 70.8457 416.335 OK 137.374 85.5473 189.202 OK 288.283 0 725.553 OK TCONS_00004031 = uc001amo.1 XLOC_001284 GPR153 - chr1:6307413-6321035 2710 - 79.9572 20.6655 139.249 OK 174.868 135.877 213.86 OK 498.6 208.29 788.911 OK TCONS_00004032 = uc001amp.1 XLOC_001284 GPR153 TSS2019 chr1:6307413-6321035 2632 - 37.8293 0 81.4618 OK 97.14 67.2326 127.047 OK 268.364 48.4351 488.292 OK TCONS_00004033 = uc001amq.2 XLOC_001285 ACOT7 TSS2020 chr1:6324332-6453826 1413 - 239.832 0 481.175 OK 1356.8 1067.01 1646.59 FAIL 2679.84 926.627 4433.06 FAIL TCONS_00004034 = uc001amr.2 XLOC_001285 ACOT7 TSS2021 chr1:6324332-6453826 1429 - 0 0 0 OK 0 0 0 FAIL 39.0287 0 609.432 FAIL TCONS_00004035 = uc001ams.2 XLOC_001285 ACOT7 TSS2022 chr1:6324332-6453826 1624 - 126.845 0 296.16 OK 93.6803 17.9687 169.392 FAIL 110.585 0 588.532 FAIL TCONS_00004036 = uc010nzq.1 XLOC_001285 ACOT7 TSS2023 chr1:6324332-6453826 1294 - 462.887 122.773 803 OK 1047.97 778.058 1317.89 FAIL 732.481 0 2348.44 FAIL TCONS_00004037 = uc001amt.2 XLOC_001285 ACOT7 TSS2024 chr1:6324332-6453826 1804 - 134.974 0 285.391 OK 731.817 545.98 917.654 FAIL 70.6091 0 498.697 FAIL TCONS_00004038 = uc001amu.2 XLOC_001285 - TSS2024 chr1:6324332-6453826 1877 - 0 0 0 OK 4.72572 0 28.9878 FAIL 0 0 0 FAIL TCONS_00004039 = uc001amv.2 XLOC_001285 - TSS2024 chr1:6324332-6453826 1802 - 0 0 0 OK 324.209 197.978 450.441 FAIL 963.208 0 2275.18 FAIL TCONS_00004040 = uc001amw.2 XLOC_001286 HES2 TSS2025 chr1:6472499-6484730 1200 - 0 0 0 OK 2.2157 0 5.31734 OK 0.48661 0 2.81936 OK TCONS_00004041 = uc001amx.2 XLOC_001286 HES2 TSS2026 chr1:6472499-6484730 4259 - 5.92301 1.46722 10.3788 OK 6.44393 3.96808 8.91978 OK 1.41752 0 3.11887 OK TCONS_00004042 = uc001ana.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1066 - 0 0 0 OK 0.707673 0 6.70518 OK 6.84793 0 89.8072 OK TCONS_00004043 = uc001anb.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1559 - 4.86935 0 76.5539 OK 0 0 0 OK 0 0 0 OK TCONS_00004044 = uc001anc.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1448 - 0 0 0 OK 42.3646 0 85.7074 OK 0.414166 0 7.0012 OK TCONS_00004045 = uc001and.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1313 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004046 = uc001ane.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1615 - 23.1541 0 91.8581 OK 166.161 94.6025 237.719 OK 5.81123 0 55.208 OK TCONS_00004047 = uc001anf.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1504 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004048 = uc001ang.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1480 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004049 = uc001anh.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1642 - 0 0 0 OK 10.7434 0 35.0063 OK 0 0 0 OK TCONS_00004050 = uc009vlz.2 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 1199 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004051 = uc001ani.1 XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 894 - 22.6201 0 122.87 OK 112.149 25.1693 199.13 OK 11.3936 0 104.399 OK TCONS_00004052 = uc001anj.1 XLOC_001287 PLEKHG5 TSS2028 chr1:6521220-6580069 3694 - 12.7468 0 49.9051 OK 35.8901 13.1062 58.674 OK 1.74109 0 24.1775 OK TCONS_00004053 = uc009vma.1 XLOC_001287 PLEKHG5 TSS2029 chr1:6521220-6580069 5038 - 2.06233 0 21.2378 OK 38.9511 19.3035 58.5986 OK 2.5797 0 17.2003 OK TCONS_00004054 = uc010nzr.1 XLOC_001287 PLEKHG5 TSS2030 chr1:6521220-6580069 4725 - 14.2602 0 44.3271 OK 62.1096 36.3441 87.8751 OK 0 0 0 OK TCONS_00004055 = uc001ank.1 XLOC_001287 PLEKHG5 TSS2031 chr1:6521220-6580069 4698 - 0 0 0 OK 73.921 39.464 108.378 OK 0 0 0 OK TCONS_00004056 = uc001anl.1 XLOC_001287 PLEKHG5 TSS2032 chr1:6521220-6580069 4715 - 17.5992 0 45.307 OK 43.3127 11.3454 75.2799 OK 34.905 0.568263 69.2418 OK TCONS_00004057 = uc009vmb.1 XLOC_001287 PLEKHG5 TSS2032 chr1:6521220-6580069 4515 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004058 = uc001anm.1 XLOC_001287 PLEKHG5 TSS2033 chr1:6521220-6580069 4643 - 25.7562 0 57.6831 OK 4.59064 0 18.3624 OK 0.024414 0 0.923507 OK TCONS_00004059 = uc001ann.1 XLOC_001287 PLEKHG5 TSS2034 chr1:6521220-6580069 4783 - 0 0 0 OK 9.71361 0 28.5646 OK 0 0 0 OK TCONS_00004060 = uc001ano.1 XLOC_001287 PLEKHG5 TSS2035 chr1:6521220-6580069 4761 - 0.00544137 0 1.06121 OK 51.9914 27.3208 76.662 OK 18.3016 0 42.6962 OK TCONS_00004061 = uc001anp.1 XLOC_001287 PLEKHG5 TSS2036 chr1:6521220-6580069 5221 - 14.4826 0 39.4641 OK 0 0 0 OK 0 0 0 OK TCONS_00004062 = uc001anq.1 XLOC_001287 PLEKHG5 TSS2036 chr1:6521220-6580069 4528 - 0 0 0 OK 6.79791 0 17.0916 OK 3.95345 0 19.7523 OK TCONS_00004063 = uc001anr.1 XLOC_001287 - TSS2037 chr1:6521220-6580069 1548 - 30.5163 0 105.072 OK 77.8501 24.5101 131.19 OK 12.5671 0 61.8728 OK TCONS_00004064 = uc001ans.2 XLOC_001288 NOL9 TSS2038 chr1:6585209-6614581 2832 - 503.823 285.234 722.412 OK 189.708 153.676 225.74 OK 361.435 179.702 543.168 OK TCONS_00004065 = uc010nzs.1 XLOC_001288 NOL9 TSS2038 chr1:6585209-6614581 2864 - 0 0 0 OK 0 0 0 OK 2.40754 0 59.3603 OK TCONS_00004066 = uc001anz.1 XLOC_001289 KLHL21 TSS2039 chr1:6650778-6662929 6318 - 109.476 28.7693 190.182 OK 62.094 41.7541 82.4338 OK 77.2985 0 177.029 OK TCONS_00004067 = uc009vme.2 XLOC_001289 KLHL21 TSS2040 chr1:6650778-6662929 3475 - 134.239 0 277.918 OK 151.442 108.192 194.693 OK 601.611 0 1210.3 OK TCONS_00004068 = uc001aoa.2 XLOC_001289 KLHL21 TSS2039 chr1:6650778-6662929 4486 - 0 0 0 OK 154.599 116.614 192.584 OK 378.033 0 871.522 OK TCONS_00004069 = uc010nzt.1 XLOC_001290 DNAJC11 TSS2041 chr1:6684924-6761966 1357 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004070 = uc001aof.2 XLOC_001290 DNAJC11 TSS2042 chr1:6684924-6761966 3293 - 727.027 447.816 1006.24 OK 1331.6 1158.6 1504.6 OK 1673.01 906.2 2439.82 OK TCONS_00004071 = uc001aog.2 XLOC_001290 DNAJC11 TSS2042 chr1:6684924-6761966 3137 - 11.865 0 73.97 OK 28.6342 0 58.4629 OK 29.7673 0 214.653 OK TCONS_00004072 = uc010nzu.1 XLOC_001290 - TSS2042 chr1:6684924-6761966 3219 - 4.91606 0 73.8295 OK 12.0359 0 32.9772 OK 28.6155 0 208.592 OK TCONS_00004073 = uc001aoq.2 XLOC_001291 UTS2 TSS2043 chr1:7844379-7973294 1647 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004074 = uc001aor.2 XLOC_001291 UTS2 TSS2044 chr1:7844379-7973294 643 - 2.40953 0 40.4693 OK 0.950535 0 7.59851 OK 0 0 0 OK TCONS_00004075 = uc001aos.2 XLOC_001291 UTS2 TSS2045 chr1:7844379-7973294 647 - 0.0400905 0 10.1271 OK 0 0 0 OK 0 0 0 OK TCONS_00004076 = uc001aot.2 XLOC_001292 TNFRSF9 TSS2046 chr1:7979907-8000887 1883 - 0 0 0 OK 0.267901 0 1.02951 OK 1.38187 0 3.32436 OK TCONS_00004077 = uc001aoz.2 XLOC_001293 ERRFI1 TSS2047 chr1:8071779-8086393 3128 - 641.313 371.667 910.958 OK 442.172 371.365 512.98 OK 2240.53 1261.49 3219.56 OK TCONS_00004078 = uc001apa.1 XLOC_001293 ERRFI1 TSS2048 chr1:8071779-8086393 2156 - 137.346 0 301.849 OK 21.342 0.261651 42.4224 OK 71.1003 0 385.659 OK TCONS_00004079 = uc001apd.2 XLOC_001294 RERE TSS2049 chr1:8412465-8877699 6306 - 1.40725 0 34.3439 OK 320.719 249.022 392.416 OK 1692.19 822.22 2562.16 OK TCONS_00004080 = uc001ape.2 XLOC_001294 RERE TSS2050 chr1:8412465-8877699 8192 - 16.3557 0 42.0768 OK 23.9344 6.23339 41.6355 OK 9.81398 0 180.606 OK TCONS_00004081 = uc001apf.2 XLOC_001294 RERE TSS2050 chr1:8412465-8877699 8007 - 170.627 90.6356 250.618 OK 638.676 550.668 726.684 OK 268.727 0 939.015 OK TCONS_00004082 = uc010nzx.1 XLOC_001294 RERE TSS2051 chr1:8412465-8877699 2592 - 0 0 0 OK 0 0 0 OK 47.6257 0 611.766 OK TCONS_00004083 = uc001apg.1 XLOC_001295 - - chr1:8412465-8877699 584 - 20.7508 0 141.351 OK 0 0 0 OK 0 0 0 OK TCONS_00004084 = uc001aph.1 XLOC_001294 - TSS2052 chr1:8412465-8877699 2710 - 85.8783 0 199.024 OK 3.82252 0 23.5895 OK 6.13498 0 577.522 OK TCONS_00004085 = uc001api.1 XLOC_001296 ENO1 TSS2053 chr1:8921062-8938780 2267 - 444.441 0 984.339 OK 211.161 0 439.419 OK 181.074 0 4449.48 OK TCONS_00004086 = uc001apj.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1812 - 19439.6 15768 23111.2 OK 29778.1 26125.7 33430.4 OK 33570.6 13951.6 53189.6 OK TCONS_00004087 = uc001apk.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1801 - 0 0 0 OK 8898.81 6208.05 11589.6 OK 12912.6 660.911 25164.3 OK TCONS_00004088 = uc001apl.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1753 - 0 0 0 OK 54.1427 0 372.14 OK 0 0 0 OK TCONS_00004089 = uc009vmi.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1683 - 0 0 0 OK 914.141 0 2799.55 OK 679.817 0 6603.85 OK TCONS_00004090 = uc009vmj.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1644 - 9.70153 0 500.863 OK 3.84797 0 211.467 OK 0 0 0 OK TCONS_00004091 = uc009vmk.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1453 - 2186.7 687.794 3685.61 OK 12561.6 9264.55 15858.7 OK 24138 5648 42628 OK TCONS_00004092 = uc009vml.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1448 - 10.0879 0 576.533 OK 8.52523 0 222.073 OK 0 0 0 OK TCONS_00004093 = uc009vmm.1 XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 1276 - 351.21 0 1073.3 OK 210.717 0 518.12 OK 150.373 0 8312.1 OK TCONS_00004094 = uc009vmo.1 XLOC_001297 SLC2A7 TSS2055 chr1:9063358-9086404 1539 - 0 0 0 OK 0.358204 0 1.3662 OK 0.725244 0 2.31316 OK TCONS_00004095 = uc010nzy.1 XLOC_001298 SLC2A5 TSS2056 chr1:9097006-9148510 2012 - 0 0 0 OK 0.000167835 0 1.02064 OK 7.16648 0 55.0592 OK TCONS_00004096 = uc010nzz.1 XLOC_001298 SLC2A5 TSS2057 chr1:9097006-9148510 1942 - 0 0 0 OK 2.90964 0.310704 5.50857 OK 0 0 0 OK TCONS_00004097 = uc001apo.2 XLOC_001298 SLC2A5 TSS2058 chr1:9097006-9148510 2436 - 0.00429204 0 2.1455 OK 0 0 0 OK 51.3731 0 120.886 OK TCONS_00004098 = uc010oaa.1 XLOC_001298 SLC2A5 TSS2058 chr1:9097006-9148510 2398 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004099 = uc010oab.1 XLOC_001298 SLC2A5 TSS2059 chr1:9097006-9148510 2411 - 3.56432 0 7.89466 OK 0 0 0 OK 61.3688 0 152.307 OK TCONS_00004100 = uc010oac.1 XLOC_001298 SLC2A5 TSS2057 chr1:9097006-9148510 920 - 2.34161 0 8.86464 OK 0 0 0 OK 4.17775 0 161.314 OK TCONS_00004101 = uc001app.3 XLOC_001298 SLC2A5 TSS2058 chr1:9097006-9148510 1279 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004102 = uc001apq.1 XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 1153 - 9.05298 0 29.6271 OK 5.68802 0 12.0645 OK 24.4065 0 70.7223 OK TCONS_00004103 = uc010oad.1 XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 958 - 16.7212 0 44.5371 OK 50.5863 32.7116 68.4611 OK 72.7269 1.65727 143.797 OK TCONS_00004104 = uc001apr.2 XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 2913 - 1.60049 0 5.56287 OK 1.55989 0 3.23101 OK 1.42116 0 6.58612 OK TCONS_00004105 = uc001aps.2 XLOC_001299 - - chr1:9164475-9189356 2396 - 9.67107 0 21.2243 OK 5.09214 1.70063 8.48366 OK 1.26783 0 6.71727 OK TCONS_00004106 = uc009vmq.2 XLOC_001300 - TSS2061 chr1:9208346-9242451 3934 - 95.9263 41.8317 150.021 OK 212.722 175.801 249.643 OK 69.3907 24.6136 114.168 OK TCONS_00004107 = uc001aqc.3 XLOC_001301 C1orf200 TSS2062 chr1:9711789-9884550 1822 - 0 0 0 OK 0.589835 0 7.29737 OK 0 0 0 OK TCONS_00004108 = uc001aqd.2 XLOC_001302 - TSS2063 chr1:9711789-9884550 951 - 86.8241 0 296.064 OK 230.865 41.3861 420.343 OK 61.7832 0 735.129 OK TCONS_00004109 = uc001aqf.2 XLOC_001303 - TSS2064 chr1:9711789-9884550 2235 - 3.82816 0 142.417 OK 145.676 47.7779 243.573 OK 695.497 0 3185.75 OK TCONS_00004110 = uc001aqh.2 XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 5191 - 0 0 0 OK 0 0 0 OK 2515.79 763.811 4267.77 OK TCONS_00004111 = uc001aqi.2 XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 5161 - 340.016 175.427 504.606 OK 1063.01 901.716 1224.3 OK 1606.44 240.881 2972 OK TCONS_00004112 = uc010oag.1 XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 5134 - 134.509 22.6305 246.388 OK 521.539 407.002 636.076 OK 26.3156 0 596.151 OK TCONS_00004113 = uc001aqk.1 XLOC_001304 CTNNBIP1 TSS2066 chr1:9908333-9970316 2995 - 72.4794 0 164.318 OK 124.662 79.4162 169.909 OK 95.0697 0 201.771 OK TCONS_00004114 = uc001aql.1 XLOC_001304 CTNNBIP1 TSS2066 chr1:9908333-9970316 2961 - 406.916 212.057 601.776 OK 531.034 441.986 620.082 OK 414.727 201.61 627.843 OK TCONS_00004115 = uc001aqn.2 XLOC_001305 LZIC TSS2067 chr1:9989777-10003427 1345 - 14.1134 0 70.9786 OK 3.50582 0 12.2378 OK 7.08002 0 145.74 OK TCONS_00004116 = uc001aqo.2 XLOC_001305 LZIC TSS2068 chr1:9989777-10003427 1500 - 217.917 63.8961 371.937 OK 164.494 124.398 204.589 OK 674.732 273.861 1075.6 OK TCONS_00004117 = uc009vmr.2 XLOC_001305 LZIC TSS2068 chr1:9989777-10003427 1440 - 89.4602 0 190.602 OK 29.7283 9.01355 50.4431 OK 335.17 54.8654 615.474 OK TCONS_00004118 = uc010oah.1 XLOC_001305 LZIC TSS2068 chr1:9989777-10003427 1383 - 0 0 0 OK 0 0 0 OK 5.13452 0 158.728 OK TCONS_00004119 = uc001arj.2 XLOC_001306 DFFA TSS2069 chr1:10520604-10532613 2036 - 485.4 200.041 770.758 OK 857.687 677.009 1038.36 OK 848.024 176.304 1519.74 OK TCONS_00004120 = uc001ark.2 XLOC_001306 DFFA TSS2069 chr1:10520604-10532613 3391 - 298.378 127.281 469.476 OK 268.726 178.795 358.656 OK 316.625 0 676.964 OK TCONS_00004121 = uc001aro.2 XLOC_001307 CASZ1 TSS2070 chr1:10696667-10856707 7931 - 8.71581 0.771074 16.6605 OK 21.1364 13.6543 28.6185 OK 0.352429 0 1.98924 OK TCONS_00004122 = uc001arp.1 XLOC_001307 CASZ1 TSS2070 chr1:10696667-10856707 4405 - 1.21532 0 13.0076 OK 37.729 23.9568 51.5012 OK 1.6466 0 5.85861 OK TCONS_00004123 = uc009vmx.2 XLOC_001307 CASZ1 TSS2071 chr1:10696667-10856707 3250 - 8.95125 0 23.0557 OK 49.2697 30.8745 67.6649 OK 6.07219 0 13.3662 OK TCONS_00004124 = uc001arq.1 XLOC_001307 - TSS2072 chr1:10696667-10856707 2267 - 2.07597 0 17.4301 OK 1.40186 0 5.909 OK 0 0 0 OK TCONS_00004125 = uc001arr.1 XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 2262 - 1.66784 0 4.93382 OK 0 0 0 OK 0.00205508 0 1.1104 OK TCONS_00004126 = uc001ars.1 XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 2238 - 0 0 0 OK 0.000964262 0 0.903489 OK 0.331458 0 1.4527 OK TCONS_00004127 = uc010oao.1 XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 2316 - 0.000832712 0 2.25219 OK 4.32713 1.54357 7.11069 OK 0 0 0 OK TCONS_00004128 = uc001aru.2 XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 2443 - 68.298 23.2927 113.303 OK 45.371 33.3684 57.3736 OK 15.0124 2.22666 27.7982 OK TCONS_00004129 = uc001arv.2 XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 720 - 0 0 0 OK 1.00455 0 5.94688 OK 0 0 0 OK TCONS_00004130 = uc001arw.2 XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 2190 - 6.76699 0 21.9887 OK 11.1666 4.74257 17.5906 OK 0 0 0 OK TCONS_00004131 = uc001arx.1 XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 874 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004132 = uc001ary.1 XLOC_001310 SRM TSS2075 chr1:11114648-11120091 828 - 1171.02 417.682 1924.36 OK 432.981 192.938 673.023 OK 3003.63 0 6336.11 OK TCONS_00004133 = uc001arz.1 XLOC_001310 SRM TSS2076 chr1:11114648-11120091 1273 - 1002.98 383.446 1622.51 OK 4481.12 3922.01 5040.24 OK 7820.85 3902.21 11739.5 OK TCONS_00004134 = uc001asa.2 XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 2805 - 1339.2 881.232 1797.18 OK 1276.69 1105.87 1447.51 OK 1601.03 919.091 2282.96 OK TCONS_00004135 = uc001asb.2 XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 2730 - 0 0 0 OK 4.49163 0 17.4542 OK 7.79258 0 169.887 OK TCONS_00004136 = uc009vmy.1 XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 2689 - 90.8453 0 232.261 OK 67.2406 24.0681 110.413 OK 33.2215 0 184.285 OK TCONS_00004137 = uc001asc.2 XLOC_001312 - TSS2078 chr1:11166588-11322608 4020 - 59.0429 0 147.043 OK 135.175 73.202 197.149 OK 170.948 0 412.495 OK TCONS_00004138 = uc001asd.2 XLOC_001312 MTOR TSS2079 chr1:11166588-11322608 8724 - 578.796 399.141 758.451 OK 892.477 790.031 994.924 OK 636.873 351.515 922.231 OK TCONS_00004139 = uc001asj.2 XLOC_001313 FBXO2 TSS2080 chr1:11708449-11723383 1534 - 302.813 84.8574 520.768 OK 1488.36 1236.56 1740.16 OK 72.9584 0 190.995 OK TCONS_00004140 = uc009vna.2 XLOC_001313 FBXO2 TSS2080 chr1:11708449-11723383 1543 - 0 0 0 OK 7.02688 0 45.4745 OK 0 0 0 OK TCONS_00004141 = uc009vnb.1 XLOC_001313 FBXO2 TSS2081 chr1:11708449-11723383 1183 - 5.94962 0 126.235 OK 4.06337 0 38.0406 OK 0 0 0 OK TCONS_00004142 = uc001asq.3 XLOC_001314 MAD2L2 TSS2082 chr1:11734537-11751678 1830 - 107.944 0 589.2 OK 309.163 176.719 441.607 OK 303.3 0 956.301 OK TCONS_00004143 = uc009vnc.2 XLOC_001314 MAD2L2 TSS2082 chr1:11734537-11751678 1151 - 4377.8 2967.48 5788.12 OK 6448.41 5676.23 7220.59 OK 2064.91 868.695 3261.13 OK TCONS_00004144 = uc001atb.1 XLOC_001315 MTHFR TSS2083 chr1:11832138-11866115 7188 - 12.2816 0 32.9022 OK 64.418 46.6473 82.1887 OK 263.856 79.0046 448.707 OK TCONS_00004145 = uc001atc.1 XLOC_001315 MTHFR TSS2084 chr1:11832138-11866115 7105 - 98.8766 45.0748 152.678 OK 93.2442 71.8689 114.62 OK 277.975 102.778 453.172 OK TCONS_00004146 = uc001atd.1 XLOC_001315 MTHFR TSS2085 chr1:11832138-11866115 1411 - 66.9034 0 176.825 OK 27.4533 0 55.8914 OK 108.763 0 395.992 OK TCONS_00004147 = uc009vnd.1 XLOC_001315 MTHFR TSS2085 chr1:11832138-11866115 1017 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004148 = uc001ati.2 XLOC_001316 NPPA TSS2086 chr1:11866206-11907840 852 - 3.4039 0 32.5388 OK 10.2838 0 34.928 OK 18.088 0 138.237 OK TCONS_00004149 = uc001atj.2 XLOC_001317 NPPB TSS2087 chr1:11917521-11918992 697 - 770.486 289.163 1251.81 OK 7.22153 0 14.4521 OK 0 0 0 OK TCONS_00004150 = uc001atk.2 XLOC_001318 KIAA2013 TSS2088 chr1:11980123-11986480 2339 - 537.636 271.843 803.428 OK 657.437 549.153 765.722 OK 1330.79 700.142 1961.44 OK TCONS_00004151 = uc001atl.1 XLOC_001318 KIAA2013 TSS2088 chr1:11980123-11986480 2534 - 136.358 0 281.585 OK 97.0102 54.1044 139.916 OK 113.009 0 465.303 OK TCONS_00004152 = uc001aub.2 XLOC_001319 DHRS3 TSS2089 chr1:12627939-12677820 1368 - 664.349 249.834 1078.86 OK 334.324 242.248 426.4 OK 292.677 22.1621 563.193 OK TCONS_00004153 = uc001auc.2 XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 1805 - 631.203 278.074 984.333 OK 302.602 228.431 376.772 OK 457.869 181.031 734.707 OK TCONS_00004154 = uc009vnm.2 XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 1262 - 34.783 0 178.53 OK 10.8508 0 33.1405 OK 0 0 0 OK TCONS_00004155 = uc001aud.3 XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 1222 - 29.3372 0 178.583 OK 28.066 0 58.84 OK 1.34044 0 232.556 OK TCONS_00004156 = uc001aue.1 XLOC_001319 DHRS3 TSS2091 chr1:12627939-12677820 252 - 17.2087 0 278.548 OK 0 0 0 OK 67.1677 0 2691.35 OK TCONS_00004157 = uc001auk.2 XLOC_001320 PRAMEF11 TSS2092 chr1:12884467-12891264 1839 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004158 = uc009vno.2 XLOC_001321 - - chr1:12907235-12908578 1002 - 162.796 57.3101 268.281 OK 2184.6 1858.47 2510.73 OK 1951.16 1042.71 2859.6 OK TCONS_00004159 = uc010obf.1 XLOC_001321 HNRNPCL1 TSS2093 chr1:12907235-12908578 1106 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004160 = uc001aun.2 XLOC_001322 PRAMEF4 TSS2094 chr1:12939032-12946025 1840 - 0.174144 0 1.17777 OK 0 0 0 OK 0 0 0 OK TCONS_00004161 = uc001auo.2 XLOC_001323 PRAMEF10 TSS2095 chr1:12952727-12958094 1517 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004162 = uc001auq.2 XLOC_001324 PRAMEF6 TSS2096 chr1:12998301-13117751 1720 - 0.337687 0 3.45331 OK 0 0 0 OK 0 0 0 OK TCONS_00004163 = uc001aur.2 XLOC_001324 PRAMEF5 TSS2097 chr1:12998301-13117751 1734 - 0.334536 0 3.42231 OK 0 0 0 OK 0 0 0 OK TCONS_00004164 = uc001aus.1 XLOC_001324 PRAMEF5 TSS2097 chr1:12998301-13117751 1855 - 0.000123029 0 2.8665 OK 0 0 0 OK 0 0 0 OK TCONS_00004165 = uc010obg.1 XLOC_001325 - - chr1:13182960-13183967 1007 - 22.2793 4.558 40.0006 OK 275.825 215.388 336.261 OK 207.399 65.638 349.159 OK TCONS_00004166 = uc001aut.1 XLOC_001326 PRAMEF22 TSS2098 chr1:13328195-13331692 2104 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004167 = uc010obh.1 XLOC_001327 PRAMEF8 TSS2099 chr1:13386648-13390765 1826 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004168 = uc001auv.2 XLOC_001327 PRAMEF8 TSS2100 chr1:13386648-13390765 1841 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004169 = uc009vnt.1 XLOC_001328 PRAMEF14 TSS2101 chr1:13447413-13452656 2100 - 0.200361 0 2.70335 OK 0 0 0 OK 0 0 0 OK TCONS_00004170 = uc010obi.1 XLOC_001328 PRAMEF13 TSS2101 chr1:13447413-13452656 2164 - 0.000572928 0 2.42333 OK 0 0 0 OK 0 0 0 OK TCONS_00004171 = uc009vnu.1 XLOC_001329 PRAMEF18 TSS2102 chr1:13474052-13477569 2123 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004172 = uc001auy.2 XLOC_001330 PRAMEF8 TSS2103 chr1:13607430-13611550 1844 - 0.694912 0 2.69739 OK 0 0 0 OK 0 0 0 OK TCONS_00004173 = uc009vnw.1 XLOC_001331 PRAMEF14 TSS2104 chr1:13668268-13673511 2100 - 0.803811 0 2.80977 OK 0 0 0 OK 0 0 0 OK TCONS_00004174 = uc009vny.1 XLOC_001332 PRAMEF18 TSS2105 chr1:13694888-13698405 2123 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004175 = uc001avb.2 XLOC_001333 LRRC38 TSS2106 chr1:13801446-13840242 1906 - 6.96034 0.720957 13.1997 OK 8.16584 3.94913 12.3826 OK 0 0 0 OK TCONS_00004176 = uc001avv.3 XLOC_001334 C1orf126 TSS2107 chr1:14925212-15478960 6978 - 8.04256 0 20.7586 OK 9.25388 3.6012 14.9066 OK 0.859289 0 31.1292 OK TCONS_00004177 = uc009voh.2 XLOC_001334 C1orf126 TSS2107 chr1:14925212-15478960 7099 - 0.000490761 0 0.698922 OK 0 0 0 OK 0 0 0 OK TCONS_00004178 = uc001awc.1 XLOC_001335 - TSS2108 chr1:15573767-15726776 3105 - 0.432797 0 2.09139 OK 3.71564 1.40094 6.03034 OK 2.62025 0 6.72752 OK TCONS_00004179 = uc001awm.1 XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 4316 - 75.4615 15.7292 135.194 OK 32.8483 18.1651 47.5315 OK 25.7553 0 61.4369 OK TCONS_00004180 = uc001awn.2 XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 1987 - 0 0 0 OK 197.024 142.349 251.7 OK 118.428 2.10389 234.752 OK TCONS_00004181 = uc001awo.2 XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 1537 - 145.227 0 301.698 OK 132.595 79.0999 186.09 OK 55.404 0 146.221 OK TCONS_00004182 = uc001awp.2 XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 2045 - 0 0 0 OK 17.767 0 41.731 OK 8.22122 0 58.9074 OK TCONS_00004183 = uc009voi.2 XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 1847 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004184 = uc010obm.1 XLOC_001336 CASP9 TSS2110 chr1:15802595-15851384 1904 - 0 0 0 OK 0 0 0 OK 29.4638 0 102.482 OK TCONS_00004185 = uc001awq.2 XLOC_001336 CASP9 TSS2111 chr1:15802595-15851384 1798 - 173.37 18.8501 327.89 OK 51.7979 20.3228 83.2729 OK 51.1746 0 127.107 OK TCONS_00004186 = uc001awv.1 XLOC_001337 AGMAT TSS2112 chr1:15853351-15918872 2196 - 122.09 0 265.635 OK 115.866 75.573 156.159 OK 43.2083 0 137.727 OK TCONS_00004187 = uc009vol.1 XLOC_001338 - - chr1:16133656-16134194 538 - 7916.63 5112.58 10720.7 OK 16097 14174.7 18019.4 OK 21049.2 11785.6 30312.9 OK TCONS_00004188 = uc001axj.2 XLOC_001339 - TSS2113 chr1:16160709-16266950 2732 - 68.8094 0 163.282 OK 58.2932 18.0093 98.5771 OK 39.9858 0 168.854 OK TCONS_00004189 = uc001axl.3 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 2749 - 106.181 28.2893 184.072 OK 259.204 208.882 309.525 OK 560.414 289.763 831.066 OK TCONS_00004190 = uc010obq.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 2564 - 0 0 0 OK 6.42816 0 17.7481 OK 5.22855 0 85.1743 OK TCONS_00004191 = uc010obr.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 2770 - 35.4246 0 87.25 OK 24.9031 7.46596 42.3402 OK 48.555 0 140.045 OK TCONS_00004192 = uc010obs.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 2745 - 0 0 0 OK 6.98597 0 17.2731 OK 0 0 0 OK TCONS_00004193 = uc010obt.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 1894 - 0.0412124 0 2.86572 OK 2.7664 0 11.5206 OK 13.5911 0 115.327 OK TCONS_00004194 = uc010obu.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 1928 - 10.1074 0 49.866 OK 7.07875 0 19.4034 OK 9.63291 0 111.703 OK TCONS_00004195 = uc009vom.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 995 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004196 = uc010obv.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 1166 - 11.9384 0 87.5108 OK 8.33768 0 26.3456 OK 26.7081 0 202.167 OK TCONS_00004197 = uc009von.1 XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 905 - 15.5862 0 68.4302 OK 20.1751 0 46.6597 OK 2.23494 0 34.7412 OK TCONS_00004198 = uc001axm.1 XLOC_001341 - - chr1:16317618-16317647 29 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004199 = uc001axo.2 XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 2892 - 100.427 13.9433 186.91 OK 3.62862 0 8.34379 OK 235.204 42.3394 428.068 OK TCONS_00004200 = uc001axp.2 XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 2877 - 12.5495 0 51.3328 OK 0 0 0 OK 16.7923 0 87.8912 OK TCONS_00004201 = uc001axq.2 XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 2904 - 8.04701 0 48.3381 OK 0 0 0 OK 26.6845 0 117.226 OK TCONS_00004202 = uc001axr.2 XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 2907 - 0 0 0 OK 0 0 0 OK 60.3352 0 240.983 OK TCONS_00004203 = uc001axs.2 XLOC_001342 HSPB7 TSS2116 chr1:16340522-16400127 2415 - 71.8733 0 160.429 OK 3.46957 0 8.17261 OK 397.66 55.8486 739.472 OK TCONS_00004204 = uc010obz.1 XLOC_001343 FAM131C TSS2117 chr1:16340522-16400127 892 - 7.54529 0 177.61 OK 4.46492 0 16.9523 OK 7.5659 0 322.48 OK TCONS_00004205 = uc001axz.3 XLOC_001343 FAM131C TSS2117 chr1:16340522-16400127 1700 - 6.09452 0 73.3079 OK 21.4939 8.36523 34.6225 OK 38.8477 0 159.849 OK TCONS_00004206 = uc001aya.1 XLOC_001344 EPHA2 TSS2118 chr1:16450831-16482564 3946 - 234.901 119.065 350.737 OK 573.472 491.06 655.885 OK 923.073 511.47 1334.68 OK TCONS_00004207 = uc010oca.1 XLOC_001344 EPHA2 TSS2118 chr1:16450831-16482564 1631 - 22.2582 0 172.971 OK 2.16378 0 24.2617 OK 0 0 0 OK TCONS_00004208 = uc001ayb.1 XLOC_001345 ARHGEF19 TSS2119 chr1:16524598-16539104 2008 - 17.0126 0 57.3312 OK 324.019 226.134 421.903 OK 132.515 30.4787 234.551 OK TCONS_00004209 = uc009voo.1 XLOC_001345 ARHGEF19 TSS2119 chr1:16524598-16539104 1984 - 0 0 0 OK 0 0 0 OK 38.3291 0 133.324 OK TCONS_00004210 = uc001ayc.1 XLOC_001345 ARHGEF19 TSS2120 chr1:16524598-16539104 3029 - 156.261 66.9287 245.594 OK 678.385 568.95 787.821 OK 8.10745 0 31.0825 OK TCONS_00004211 = uc001ayd.2 XLOC_001346 C1orf89 TSS2121 chr1:16558182-16563659 1559 - 28.2148 8.31912 48.1105 OK 53.4824 39.5802 67.3846 OK 182.341 64.6878 299.993 OK TCONS_00004212 = uc001aye.3 XLOC_001347 FBXO42 TSS2122 chr1:16576559-16678948 2474 - 22.2988 0 92.2622 OK 2.24339 0 10.5925 OK 15.5838 0 89.1198 OK TCONS_00004213 = uc001ayf.2 XLOC_001347 FBXO42 TSS2123 chr1:16576559-16678948 3055 - 11.178 0 57.7157 OK 8.45144 0 18.9118 OK 30.8971 0 157.892 OK TCONS_00004214 = uc001ayg.2 XLOC_001347 FBXO42 TSS2124 chr1:16576559-16678948 2975 - 292.804 138.52 447.089 OK 256.568 210.379 302.757 OK 533.075 280.508 785.642 OK TCONS_00004215 = uc001ayh.2 XLOC_001347 - TSS2125 chr1:16576559-16678948 2963 - 27.075 0 81.0616 OK 0.999115 0 3.93364 OK 0 0 0 OK TCONS_00004216 = uc001ayl.1 XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 3650 - 0 0 0 OK 0 0 0 OK 0.168084 0 13.948 OK TCONS_00004217 = uc001ayn.2 XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 2014 - 1.25463 0 18.4322 OK 0 0 0 OK 0 0 0 OK TCONS_00004218 = uc010occ.1 XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 2030 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004219 = uc001ayt.2 XLOC_001349 - TSS2127 chr1:16793930-16819196 5368 - 39.2853 14.5125 64.058 OK 48.5164 36.7903 60.2425 OK 16.8693 2.15158 31.587 OK TCONS_00004220 = uc001ayr.3 XLOC_001349 - TSS2128 chr1:16793930-16819196 574 - 0 0 0 OK 76.9358 17.4498 136.422 OK 33.8911 0 119.733 OK TCONS_00004221 = uc001ays.2 XLOC_001349 - TSS2129 chr1:16793930-16819196 1122 - 7.75221 0 53.3814 OK 47.6242 17.1968 78.0516 OK 17.5001 0 67.9667 OK TCONS_00004222 = uc009voq.1 XLOC_001350 - TSS2130 chr1:16860385-16864669 2482 - 23.1603 3.70763 42.613 OK 11.9908 6.58234 17.3992 OK 0.8365 0 2.58351 OK TCONS_00004223 = uc001ayw.2 XLOC_001351 - - chr1:16888922-16890082 1160 - 223.564 85.5058 361.622 OK 175.981 136.018 215.945 OK 1764.52 961.378 2567.66 OK TCONS_00004224 = uc009vos.1 XLOC_001352 NBPF1 TSS2131 chr1:16890411-16939982 4268 - 153.181 51.7958 254.565 OK 109.231 81.5872 136.875 OK 592.825 260.015 925.635 OK TCONS_00004225 = uc001ayz.1 XLOC_001352 NBPF1 TSS2132 chr1:16890411-16939982 1512 - 0 0 0 OK 120.904 47.2642 194.544 OK 551.679 0 1124.28 OK TCONS_00004226 = uc009vot.1 XLOC_001352 NBPF1 TSS2132 chr1:16890411-16939982 1512 - 65.4571 0 212.032 OK 27.9922 0.105468 55.8789 OK 232.03 0 638.644 OK TCONS_00004227 = uc010oce.1 XLOC_001352 NBPF1 TSS2133 chr1:16890411-16939982 2216 - 2.67381 0 115.26 OK 2.13127 0 10.4539 OK 2.38008 0 261.588 OK TCONS_00004228 = uc001aza.3 XLOC_001352 NBPF1 TSS2131 chr1:16890411-16939982 2663 - 100.986 0 213.349 OK 59.3019 33.3114 85.2923 OK 99.1905 0 314.465 OK TCONS_00004229 = uc001azb.1 XLOC_001352 NBPF1 TSS2134 chr1:16890411-16939982 3026 - 8.12905 0 58.4269 OK 1.71985 0 7.19816 OK 41.2295 0 175.391 OK TCONS_00004230 = uc001azc.1 XLOC_001352 NBPF1 TSS2131 chr1:16890411-16939982 2696 - 119.817 8.82267 230.81 OK 53.7943 29.4989 78.0898 OK 198.126 0 458.17 OK TCONS_00004231 = uc010ocf.1 XLOC_001353 - TSS2135 chr1:16944752-16971178 1404 - 146.83 0 298.651 OK 39.2466 3.04286 75.4504 OK 151.051 0 313.083 OK TCONS_00004232 = uc001aze.2 XLOC_001353 - TSS2136 chr1:16944752-16971178 2173 - 24.9871 0 82.2865 OK 109.535 66.0943 152.976 OK 60.3527 0 147.065 OK TCONS_00004233 = uc009vov.1 XLOC_001353 - TSS2136 chr1:16944752-16971178 1966 - 0 0 0 OK 40.9893 11.0741 70.9045 OK 22.2743 0 79.5207 OK TCONS_00004234 = uc001azf.2 XLOC_001353 - TSS2137 chr1:16944752-16971178 2746 - 62.8563 0 129.209 OK 148.568 105.21 191.927 OK 44.2115 0 111.293 OK TCONS_00004235 = uc001azg.1 XLOC_001353 - TSS2138 chr1:16944752-16971178 1912 - 59.3619 0 134.904 OK 154.311 100.132 208.489 OK 73.4927 0 172.311 OK TCONS_00004236 = uc001azi.1 XLOC_001353 - TSS2138 chr1:16944752-16971178 2029 - 16.2307 0 57.5677 OK 32.3396 7.38314 57.2961 OK 16.1259 0 70.5133 OK TCONS_00004237 = uc001azj.1 XLOC_001353 - TSS2139 chr1:16944752-16971178 596 - 93.9509 0 347.663 OK 210.996 83.331 338.661 OK 217.203 0 557.922 OK TCONS_00004238 = uc001azn.1 XLOC_001354 ESPN TSS2140 chr1:17017712-17046652 2015 - 2.07327 0 5.81874 OK 11.1097 6.20784 16.0115 OK 0 0 0 OK TCONS_00004239 = uc010ocj.1 XLOC_001354 ESPNP TSS2141 chr1:17017712-17046652 1171 - 0 0 0 OK 3.47275 0 7.65156 OK 0 0 0 OK TCONS_00004240 = uc001azp.3 XLOC_001355 MSTP9 TSS2142 chr1:17066767-17299474 4170 - 14.2231 0 47.6041 OK 38.162 12.8322 63.4919 OK 1.55467 0 34.5536 OK TCONS_00004241 = uc010ock.1 XLOC_001355 MSTP9 TSS2143 chr1:17066767-17299474 4395 - 1.90183 0 33.477 OK 3.25841 0 11.095 OK 1.59851 0 32.2719 OK TCONS_00004242 = uc001azs.1 XLOC_001356 - TSS2144 chr1:17066767-17299474 359 - 133.893 0 504.624 OK 415.352 32.9291 797.775 OK 408.247 0 1179.03 OK TCONS_00004243 = uc001azw.2 XLOC_001357 MFAP2 TSS2145 chr1:17300999-17308081 1100 - 1631.49 897.928 2365.06 OK 4040.61 3336.12 4745.1 OK 1960.36 874.211 3046.5 OK TCONS_00004244 = uc001azx.2 XLOC_001357 MFAP2 TSS2145 chr1:17300999-17308081 1097 - 316.038 0 677.029 OK 825.956 324.309 1327.6 OK 401.58 0 892.772 OK TCONS_00004245 = uc001azy.2 XLOC_001357 MFAP2 TSS2146 chr1:17300999-17308081 1081 - 0 0 0 OK 0 0 0 OK 31.938 0 335.945 OK TCONS_00004246 = uc010ocl.1 XLOC_001357 MFAP2 TSS2146 chr1:17300999-17308081 1078 - 0 0 0 OK 0 0 0 OK 11.7873 0 350.997 OK TCONS_00004247 = uc001azz.1 XLOC_001358 ATP13A2 TSS2147 chr1:17312452-17338423 1224 - 66.6283 0 273.207 OK 366.46 205.875 527.046 OK 231.387 0 528.322 OK TCONS_00004248 = uc001baa.2 XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 3996 - 124.905 20.1141 229.695 OK 537.876 416.048 659.704 OK 177.11 45.9366 308.283 OK TCONS_00004249 = uc001bab.2 XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 3981 - 125.906 36.644 215.167 OK 472.669 378.005 567.334 OK 205.856 50.6022 361.11 OK TCONS_00004250 = uc001bac.2 XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 3694 - 4.40168 0 44.0657 OK 12.3556 0 89.4394 OK 24.341 0 75.4891 OK TCONS_00004251 = uc009vpa.1 XLOC_001358 ATP13A2 TSS2149 chr1:17312452-17338423 1080 - 0 0 0 OK 22.7704 0 78.4159 OK 46.6117 0 247.147 OK TCONS_00004252 = uc001bad.1 XLOC_001358 ATP13A2 TSS2150 chr1:17312452-17338423 1639 - 26.0242 0 105.824 OK 18.4495 0 52.2647 OK 0 0 0 OK TCONS_00004253 = uc001bae.2 XLOC_001359 SDHB TSS2151 chr1:17345226-17380665 1143 - 1562.94 903.16 2222.73 OK 1548.47 1310.11 1786.83 OK 5372.43 3139.35 7605.51 OK TCONS_00004254 = uc001baf.2 XLOC_001360 PADI2 TSS2152 chr1:17393256-17445948 4362 - 25.3396 7.16262 43.5166 OK 62.6093 49.0897 76.1288 OK 1.76593e-05 0 0.556858 OK TCONS_00004255 = uc010ocm.1 XLOC_001360 - TSS2152 chr1:17393256-17445948 4014 - 0 0 0 OK 0 0 0 OK 0.887434 0 2.24643 OK TCONS_00004256 = uc001bag.1 XLOC_001360 PADI2 TSS2152 chr1:17393256-17445948 1625 - 6.09039 0 25.3573 OK 3.49549 0 12.5172 OK 0 0 0 OK TCONS_00004257 = uc010ocn.1 XLOC_001361 - - chr1:17393256-17445948 22 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004258 = uc001bal.2 XLOC_001362 RCC2 TSS2153 chr1:17733251-17766220 3950 - 2447.51 1730.57 3164.45 OK 4130.7 3664.34 4597.05 OK 869.89 449.813 1289.97 OK TCONS_00004259 = uc001bam.2 XLOC_001362 RCC2 TSS2154 chr1:17733251-17766220 4091 - 895.394 476.348 1314.44 OK 1326.29 1070.74 1581.85 OK 178.175 0 363.289 OK TCONS_00004260 = uc001bba.1 XLOC_001363 TAS1R2 TSS2155 chr1:19166092-19186155 2521 - 0.541163 0 2.03937 OK 0 0 0 OK 0 0 0 OK TCONS_00004261 = uc010ocu.1 XLOC_001364 ALDH4A1 TSS2156 chr1:19197925-19229293 3241 - 85.8408 8.14943 163.532 OK 218.303 159.662 276.944 OK 130.588 7.30382 253.872 OK TCONS_00004262 = uc001bbb.2 XLOC_001364 ALDH4A1 TSS2157 chr1:19197925-19229293 2368 - 14.7849 0 62.4313 OK 13.708 0 99.2557 OK 0 0 0 OK TCONS_00004263 = uc001bbc.2 XLOC_001364 ALDH4A1 TSS2157 chr1:19197925-19229293 3381 - 163.444 60.3852 266.502 OK 420.478 326.5 514.456 OK 406.234 197.354 615.114 OK TCONS_00004264 = uc001bbd.2 XLOC_001365 IFFO2 TSS2158 chr1:19230773-19282826 5835 - 102.06 48.7649 155.355 OK 89.541 72.7006 106.381 OK 303.773 166.199 441.347 OK TCONS_00004265 = uc001bbe.1 XLOC_001366 - - chr1:19398603-19536746 3402 - 15.0916 0 116.645 OK 12.454 0 47.5815 OK 9.6791 0 475.904 OK TCONS_00004266 = uc001bbf.2 XLOC_001366 - TSS2159 chr1:19398603-19536746 941 - 14.6135 0 555.378 OK 50.0495 0 160.92 OK 229.039 0 2234.55 OK TCONS_00004267 = uc010ocv.1 XLOC_001366 - TSS2160 chr1:19398603-19536746 2535 - 1.68163 0 256.626 OK 92.8871 0 187.884 OK 294.701 0 1031.77 OK TCONS_00004268 = uc009vph.2 XLOC_001366 UBR4 TSS2161 chr1:19398603-19536746 2916 - 0 0 0 OK 22.9292 0 71.3365 OK 22.1323 0 587.311 OK TCONS_00004269 = uc010ocw.1 XLOC_001366 - TSS2162 chr1:19398603-19536746 2888 - 0 0 0 OK 167.676 22.4737 312.879 OK 0 0 0 OK TCONS_00004270 = uc001bbg.2 XLOC_001366 - TSS2163 chr1:19398603-19536746 3481 - 28.2328 0 130.129 OK 557.747 349.643 765.85 OK 470.997 0 1254.8 OK TCONS_00004271 = uc001bbh.2 XLOC_001366 - TSS2164 chr1:19398603-19536746 3477 - 4.91166 0 122.644 OK 426.519 250.247 602.791 OK 243.59 0 936.189 OK TCONS_00004272 = uc001bbi.2 XLOC_001366 UBR4 TSS2165 chr1:19398603-19536746 15880 - 623.312 460.643 785.98 OK 765.815 676.786 854.844 OK 666.218 299.375 1033.06 OK TCONS_00004273 = uc001bbj.1 XLOC_001366 UBR4 TSS2166 chr1:19398603-19536746 3162 - 39.3315 0 149.532 OK 5.33048 0 33.5387 OK 5.62521 0 540.505 OK TCONS_00004274 = uc001bbk.1 XLOC_001366 UBR4 TSS2167 chr1:19398603-19536746 3124 - 38.8471 0 153.122 OK 192.593 85.6652 299.52 OK 171.68 0 680.545 OK TCONS_00004275 = uc001bbl.1 XLOC_001366 - TSS2168 chr1:19398603-19536746 2172 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004276 = uc001bbm.1 XLOC_001366 UBR4 TSS2169 chr1:19398603-19536746 5751 - 112.418 0 271.794 OK 4.71016 0 19.6735 OK 7.05837 0 286.173 OK TCONS_00004277 = uc001bbn.2 XLOC_001367 KIAA0090 TSS2170 chr1:19544584-19578046 2675 - 44.1215 0 116.51 OK 13.1602 0 29.6914 OK 6.73706 0 383.528 OK TCONS_00004278 = uc001bbo.2 XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 4237 - 256.033 124.664 387.402 OK 452.421 378.106 526.736 OK 2042.6 992.755 3092.44 OK TCONS_00004279 = uc001bbp.2 XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 4234 - 0 0 0 OK 27.296 0 63.2434 OK 57.4804 0 277.391 OK TCONS_00004280 = uc001bbq.2 XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 4234 - 41.707 0 111 OK 112.439 70.4712 154.407 OK 247.27 0 811.52 OK TCONS_00004281 = uc001bbr.2 XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 4171 - 11.7322 0 80.2288 OK 3.92853 0 13.272 OK 15.2695 0 244.502 OK TCONS_00004282 = uc010ocx.1 XLOC_001368 AKR7L TSS2172 chr1:19592475-19600568 2314 - 8.47305 1.68239 15.2637 OK 11.7019 7.12012 16.2836 OK 10.5092 1.01211 20.0062 OK TCONS_00004283 = uc010ocy.1 XLOC_001368 AKR7L TSS2172 chr1:19592475-19600568 2117 - 0.000354505 0 2.49559 OK 0 0 0 OK 0 0 0 OK TCONS_00004284 = uc001bbv.1 XLOC_001369 AKR7A3 TSS2173 chr1:19609056-19615280 1241 - 16.1619 3.29675 29.0271 OK 17.2325 9.42284 25.0423 OK 15.2534 1.07679 29.43 OK TCONS_00004285 = uc001bbw.2 XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 1362 - 341.159 145.262 537.057 OK 693.277 573.913 812.641 OK 3035.54 1402.19 4668.9 OK TCONS_00004286 = uc001bbx.2 XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 1257 - 0 0 0 OK 0 0 0 OK 179.738 0 1515.56 OK TCONS_00004287 = uc009vpi.1 XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 1032 - 22.0575 0 101.557 OK 2.29939 0 21.9783 OK 3.31248 0 543.905 OK TCONS_00004288 = uc001bcd.2 XLOC_001371 CAPZB TSS2175 chr1:19665273-19811992 1575 - 1302.83 611.827 1993.83 OK 0 0 0 OK 0 0 0 OK TCONS_00004289 = uc010ocz.1 XLOC_001371 CAPZB TSS2176 chr1:19665273-19811992 2084 - 43.0618 0 207.16 OK 69.4828 6.61671 132.349 OK 70.755 0 2035.05 OK TCONS_00004290 = uc001bce.2 XLOC_001371 CAPZB TSS2177 chr1:19665273-19811992 1629 - 2361.48 1372.9 3350.07 OK 5169.04 4581.63 5756.45 OK 19294.6 9080.47 29508.8 OK TCONS_00004291 = uc009vpk.2 XLOC_001371 CAPZB TSS2177 chr1:19665273-19811992 2049 - 17.4929 0 155.419 OK 8.25067 0 35.3494 OK 86.3183 0 2082.15 OK TCONS_00004292 = uc001bcf.1 XLOC_001372 - - chr1:19665273-19811992 2093 - 37.4567 0 134.342 OK 15.7099 0 43.8763 OK 16.6971 0 270.816 OK TCONS_00004293 = uc001bcm.2 XLOC_001373 TMCO4 TSS2178 chr1:20008706-20126758 2232 - 6.20966 0 29.8202 OK 0 0 0 OK 36.9795 0 220.714 OK TCONS_00004294 = uc001bcn.2 XLOC_001373 TMCO4 TSS2179 chr1:20008706-20126758 2973 - 48.488 10.3098 86.6662 OK 56.5465 42.6732 70.4197 OK 464.48 220.881 708.08 OK TCONS_00004295 = uc001bco.1 XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 2401 - 0 0 0 OK 1.29633 0 7.49683 OK 0 0 0 OK TCONS_00004296 = uc001bcp.1 XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 2281 - 2.72756 0 31.8784 OK 0 0 0 OK 73.4655 0 182.856 OK TCONS_00004297 = uc009vpn.1 XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 1715 - 16.1889 0 54.1977 OK 9.20491 0.0607255 18.3491 OK 32.2829 0 138.884 OK TCONS_00004298 = uc001bcq.1 XLOC_001373 TMCO4 TSS2181 chr1:20008706-20126758 1045 - 6.08129 0 93.3291 OK 0 0 0 OK 20.9118 0 225.377 OK TCONS_00004299 = uc001bcr.2 XLOC_001374 RNF186 - chr1:20140522-20141771 1249 - 1.07721 0 4.18133 OK 0.423276 0 1.6266 OK 0 0 0 OK TCONS_00004300 = uc001bct.1 XLOC_001375 PLA2G2E TSS2182 chr1:20246799-20250110 487 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004301 = uc001bcu.2 XLOC_001376 PLA2G2A TSS2183 chr1:20301924-20306932 922 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004302 = uc001bcv.2 XLOC_001376 PLA2G2A TSS2184 chr1:20301924-20306932 999 - 0 0 0 OK 0.000482041 0 2.29366 OK 0.000476318 0 2.82987 OK TCONS_00004303 = uc010oda.1 XLOC_001376 PLA2G2A TSS2184 chr1:20301924-20306932 968 - 61.8417 0 142.352 OK 35.1077 22.0511 48.1644 OK 12.9515 0 27.5079 OK TCONS_00004304 = uc010odb.1 XLOC_001376 PLA2G2A TSS2184 chr1:20301924-20306932 888 - 72.4826 0 161.362 OK 0 0 0 OK 0 0 0 OK TCONS_00004305 = uc001bcz.2 XLOC_001377 PLA2G2D TSS2185 chr1:20438440-20446008 2621 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004306 = uc009vpo.2 XLOC_001377 - TSS2185 chr1:20438440-20446008 2514 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004307 = uc009vpq.1 XLOC_001378 PLA2G2C TSS2186 chr1:20490483-20501687 453 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004308 = uc009vpu.1 XLOC_001379 - TSS2187 chr1:20687597-20755275 1452 - 0 0 0 OK 0.74001 0 2.83297 OK 0 0 0 OK TCONS_00004309 = uc001bdf.1 XLOC_001379 - TSS2188 chr1:20687597-20755275 2467 - 0 0 0 OK 0 0 0 OK 2.56345 0 6.11092 OK TCONS_00004310 = uc001bdg.2 XLOC_001380 CAMK2N1 TSS2189 chr1:20808884-20812728 1607 - 163.673 0 330.269 OK 6.4946 0 16.4108 OK 2654.04 0 8666.76 OK TCONS_00004311 = uc001bdh.2 XLOC_001380 CAMK2N1 TSS2190 chr1:20808884-20812728 2350 - 171.705 34.941 308.47 OK 124.278 97.3523 151.204 OK 7835.73 3452.15 12219.3 OK TCONS_00004312 = uc001bdi.3 XLOC_001381 MUL1 TSS2191 chr1:20825942-20834674 2456 - 392.307 205.86 578.753 OK 351.837 291.107 412.567 OK 1509.04 876.74 2141.34 OK TCONS_00004313 = uc001bdo.1 XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 2126 - 4421.99 3255.85 5588.14 OK 4971.96 4436.95 5506.96 OK 12703.4 6275.46 19131.3 OK TCONS_00004314 = uc009vpw.1 XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 2135 - 5.84642 0 210.415 OK 0 0 0 OK 0 0 0 OK TCONS_00004315 = uc010odd.1 XLOC_001382 - TSS2192 chr1:20978259-20988037 2073 - 5.18588 0 224.553 OK 0 0 0 OK 0 0 0 OK TCONS_00004316 = uc010ode.1 XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 2015 - 30.3966 0 202.602 OK 19.3729 0 69.8108 OK 13.1454 0 1810.7 OK TCONS_00004317 = uc001bdp.3 XLOC_001383 KIF17 TSS2193 chr1:20990508-21044317 1812 - 0 0 0 OK 3.5495 0 25.2713 OK 4.98873 0 48.1008 OK TCONS_00004318 = uc001bdq.3 XLOC_001383 KIF17 TSS2193 chr1:20990508-21044317 1671 - 7.59828 0 42.1585 OK 11.229 0 33.6005 OK 82.6962 0 169.515 OK TCONS_00004319 = uc009vpx.2 XLOC_001383 KIF17 TSS2194 chr1:20990508-21044317 1978 - 0 0 0 OK 5.90044 0 16.6955 OK 11.7825 0 46.107 OK TCONS_00004320 = uc001bdr.3 XLOC_001383 KIF17 TSS2195 chr1:20990508-21044317 3776 - 5.15833 0 26.0476 OK 48.9997 30.3712 67.6282 OK 0 0 0 OK TCONS_00004321 = uc001bds.3 XLOC_001383 KIF17 TSS2195 chr1:20990508-21044317 3773 - 53.8428 17.4593 90.2263 OK 102.304 76.9382 127.669 OK 29.9178 0 69.6045 OK TCONS_00004322 = uc001bdt.1 XLOC_001384 SH2D5 TSS2196 chr1:21046224-21059330 3705 - 0 0 0 OK 16.4694 3.45812 29.4807 OK 89.3077 0 206.086 OK TCONS_00004323 = uc009vpy.1 XLOC_001384 SH2D5 TSS2196 chr1:21046224-21059330 3834 - 17.3446 0 40.3711 OK 129.453 87.7018 171.205 OK 86.3601 0 190.82 OK TCONS_00004324 = uc001bdu.1 XLOC_001384 SH2D5 TSS2197 chr1:21046224-21059330 3063 - 56.3467 12.9268 99.7667 OK 160.628 102.931 218.324 OK 132.567 21.811 243.324 OK TCONS_00004325 = uc010odf.1 XLOC_001385 HP1BP3 TSS2198 chr1:21069170-21113799 3139 - 44.0552 0 166.711 OK 56.1343 22.179 90.0896 OK 89.2902 0 537.056 OK TCONS_00004326 = uc010odg.1 XLOC_001385 HP1BP3 TSS2199 chr1:21069170-21113799 4775 - 302.536 115.748 489.323 OK 107.411 71.6054 143.216 OK 147.345 0 557.151 OK TCONS_00004327 = uc001bdv.1 XLOC_001385 HP1BP3 TSS2200 chr1:21069170-21113799 4317 - 92.6039 0 213.917 OK 183.91 134.307 233.513 OK 97.5133 0 711.643 OK TCONS_00004328 = uc001bdw.1 XLOC_001385 HP1BP3 TSS2200 chr1:21069170-21113799 3921 - 240.174 51.4836 428.863 OK 25.9672 0 52.4954 OK 1021.61 0 2238.88 OK TCONS_00004329 = uc010odh.1 XLOC_001385 HP1BP3 TSS2201 chr1:21069170-21113799 3797 - 394.454 156.556 632.353 OK 56.9742 26.4754 87.4731 OK 1426.22 397.978 2454.46 OK TCONS_00004330 = uc001bdy.1 XLOC_001385 HP1BP3 TSS2202 chr1:21069170-21113799 1860 - 478.545 78.9201 878.17 OK 494.915 367.814 622.015 OK 1140.1 0 2502.82 OK TCONS_00004331 = uc001bdz.2 XLOC_001385 - TSS2201 chr1:21069170-21113799 2544 - 91.5259 0 240.853 OK 12.355 0 31.7963 OK 12.8279 0 609.017 OK TCONS_00004332 = uc001bea.2 XLOC_001385 HP1BP3 TSS2201 chr1:21069170-21113799 2537 - 67.7047 0 219.105 OK 19.1563 0 41.1226 OK 234.83 0 794.429 OK TCONS_00004333 = uc001beb.2 XLOC_001385 HP1BP3 TSS2200 chr1:21069170-21113799 927 - 201.731 0 674.317 OK 108.229 17.2266 199.231 OK 286.111 0 2081.98 OK TCONS_00004334 = uc010odi.1 XLOC_001386 EIF4G3 TSS2203 chr1:21132975-21503340 5160 - 16.2897 0 120.515 OK 6.37526 0 18.3251 OK 487.969 0 1205.32 OK TCONS_00004335 = uc009vpz.2 XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 4949 - 4.89492 0 61.9213 OK 0 0 0 OK 48.898 0 290.681 OK TCONS_00004336 = uc010odj.1 XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 5786 - 494.463 287.514 701.412 OK 247.208 192.013 302.403 OK 640.112 0 1481.42 OK TCONS_00004337 = uc001bec.2 XLOC_001386 EIF4G3 TSS2205 chr1:21132975-21503340 5850 - 23.2845 0 83.5985 OK 0 0 0 OK 233.937 0 698.17 OK TCONS_00004338 = uc001bed.2 XLOC_001386 EIF4G3 TSS2206 chr1:21132975-21503340 6175 - 62.5109 0 141.445 OK 265.087 208.302 321.872 OK 347.572 0 729.213 OK TCONS_00004339 = uc001bee.2 XLOC_001386 EIF4G3 TSS2206 chr1:21132975-21503340 6193 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004340 = uc001bef.2 XLOC_001386 EIF4G3 TSS2206 chr1:21132975-21503340 6283 - 155.005 39.872 270.137 OK 149.423 107.877 190.97 OK 310.62 0 685.567 OK TCONS_00004341 = uc001beg.2 XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 1836 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004342 = uc010odk.1 XLOC_001386 EIF4G3 TSS2207 chr1:21132975-21503340 1915 - 310.854 9.35684 612.35 OK 0 0 0 OK 0 0 0 OK TCONS_00004343 = uc001beh.2 XLOC_001386 EIF4G3 TSS2208 chr1:21132975-21503340 2088 - 99.134 0 274.22 OK 39.0388 0.43254 77.6451 OK 49.7966 0 663.007 OK TCONS_00004344 = uc001bej.2 XLOC_001387 ECE1 TSS2209 chr1:21543739-21672034 5241 - 0 0 0 OK 5.98009 0 15.3256 OK 127.783 0 997.551 OK TCONS_00004345 = uc001bei.2 XLOC_001387 ECE1 TSS2210 chr1:21543739-21672034 5087 - 90.6691 12.4744 168.864 OK 28.0163 9.22743 46.8052 OK 986.479 0 2727.2 OK TCONS_00004346 = uc001bek.2 XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 5096 - 39.3564 0 100.319 OK 95.1492 23.9971 166.301 OK 1395.64 0 4874.16 OK TCONS_00004347 = uc010odl.1 XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 5000 - 0 0 0 OK 4.34987 0 12.4619 OK 15.8926 0 952.608 OK TCONS_00004348 = uc001bem.2 XLOC_001387 ECE1 TSS2212 chr1:21543739-21672034 5136 - 67.8265 7.73965 127.913 OK 419.192 327.282 511.102 OK 3871.51 403.938 7339.09 OK TCONS_00004349 = uc009vqa.1 XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 2198 - 30.7121 0 113.11 OK 14.4148 0 37.8486 OK 87.2531 0 2296.65 OK TCONS_00004350 = uc001ben.1 XLOC_001388 - - chr1:21543739-21672034 2326 - 8.5531 0 38.3786 OK 0.863796 0 5.45777 OK 0.547703 0 47.9207 OK TCONS_00004351 = uc001bep.1 XLOC_001389 - TSS2213 chr1:21749600-21754300 2057 - 100.478 37.9623 162.993 OK 59.716 45.3134 74.1186 OK 526.991 265.844 788.138 OK TCONS_00004352 = uc001bev.2 XLOC_001390 RAP1GAP TSS2214 chr1:21922708-21995856 3348 - 3.1394 0 17.0373 OK 23.4017 0 49.5166 OK 0 0 0 OK TCONS_00004353 = uc001bew.2 XLOC_001390 RAP1GAP TSS2215 chr1:21922708-21995856 3300 - 27.4868 0.432069 54.5415 OK 67.9603 40.5951 95.3256 OK 2.12746 0 4.48271 OK TCONS_00004354 = uc001bex.2 XLOC_001390 RAP1GAP TSS2216 chr1:21922708-21995856 3333 - 14.88 0 38.1777 OK 64.0794 41.797 86.3618 OK 0.00165223 0 0.738614 OK TCONS_00004355 = uc001bey.2 XLOC_001390 RAP1GAP TSS2216 chr1:21922708-21995856 3494 - 10.5936 0 36.1794 OK 23.1783 8.81449 37.5421 OK 0 0 0 OK TCONS_00004356 = uc001bfa.2 XLOC_001391 USP48 TSS2217 chr1:22004793-22109688 3639 - 119.181 0 246.481 OK 49.6025 20.7725 78.4325 OK 49.025 0 192.573 OK TCONS_00004357 = uc001bfb.2 XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 4462 - 397.254 202.914 591.593 OK 512.56 429.032 596.088 OK 1051.93 551.074 1552.78 OK TCONS_00004358 = uc001bfc.2 XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 4306 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004359 = uc009vqc.2 XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 4264 - 31.0054 0 101.54 OK 26.2055 6.01966 46.3914 OK 44.2579 0 166.085 OK TCONS_00004360 = uc010odq.1 XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 4498 - 9.73763 0 59.2654 OK 1.61711 0 15.96 OK 0 0 0 OK TCONS_00004361 = uc001bfd.1 XLOC_001391 USP48 TSS2219 chr1:22004793-22109688 2089 - 40.7577 0 143.522 OK 4.47726 0 18.5653 OK 1.54293 0 312.022 OK TCONS_00004362 = uc001bfe.1 XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 2126 - 215.746 0 444.263 OK 175.948 61.9746 289.922 OK 194.761 0 787.418 OK TCONS_00004363 = uc001bff.2 XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 2411 - 330.639 81.3712 579.906 OK 44.7452 8.25987 81.2305 OK 182.168 0 728.664 OK TCONS_00004364 = uc001bfi.2 XLOC_001392 HSPG2 TSS2220 chr1:22138757-22263750 3586 - 8.87162 0 54.733 OK 185.017 95.7889 274.245 OK 262.104 0 7029.42 OK TCONS_00004365 = uc001bfj.2 XLOC_001392 HSPG2 TSS2221 chr1:22138757-22263750 14287 - 101.632 55.0597 148.203 OK 741.639 657.067 826.212 OK 3722.7 0 7543.35 OK TCONS_00004366 = uc009vqd.2 XLOC_001392 HSPG2 TSS2221 chr1:22138757-22263750 14290 - 15.8513 0 36.9392 OK 124.328 88.932 159.724 OK 771.12 0 2394.37 OK TCONS_00004367 = uc009vqe.1 XLOC_001392 HSPG2 TSS2222 chr1:22138757-22263750 846 - 32.9146 0 281.74 OK 0 0 0 OK 0 0 0 OK TCONS_00004368 = uc001bfs.3 XLOC_001393 WNT4 TSS2223 chr1:22443799-22470385 3903 - 15.9522 4.85667 27.0478 OK 73.6692 57.8567 89.4816 OK 0.00537242 0 0.631395 OK TCONS_00004369 = uc010odt.1 XLOC_001393 WNT4 TSS2224 chr1:22443799-22470385 3883 - 0.000222119 0 1.30571 OK 0 0 0 OK 0.782392 0 2.04125 OK TCONS_00004370 = uc001bgh.1 XLOC_001394 - TSS2225 chr1:23337326-23342343 510 - 3.40123 0 13.2023 OK 1.30651 0 5.02077 OK 0 0 0 OK TCONS_00004371 = uc001bgk.2 XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 8653 - 331.605 172.158 491.052 OK 143.088 109.743 176.433 OK 398.717 139.701 657.733 OK TCONS_00004372 = uc010odv.1 XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 8587 - 472.843 297.231 648.455 OK 289.415 242.66 336.17 OK 487.054 201.198 772.91 OK TCONS_00004373 = uc001bgl.2 XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 3921 - 56.1574 0 173.422 OK 3.29156 0 12.0717 OK 0 0 0 OK TCONS_00004374 = uc001bgn.2 XLOC_001396 HTR1D - chr1:23518388-23521222 2834 - 223.865 107.37 340.36 OK 138.505 110.603 166.407 OK 0 0 0 OK TCONS_00004375 = uc001bgo.2 XLOC_001397 HNRNPR TSS2227 chr1:23636276-23670853 1637 - 18.8159 0 235.337 OK 3.27082 0 45.6852 OK 0 0 0 OK TCONS_00004376 = uc001bgp.3 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2740 - 125.856 0 318.777 OK 198.346 108.195 288.497 OK 337.66 0 1029.99 OK TCONS_00004377 = uc001bgr.3 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2731 - 871.304 416.82 1325.79 OK 1176.83 962.635 1391.02 OK 1348.2 0 3245.79 OK TCONS_00004378 = uc001bgs.3 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2565 - 1672.29 1040.38 2304.2 OK 1344.32 1027.22 1661.43 OK 2703.15 964.57 4441.73 OK TCONS_00004379 = uc009vqk.2 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2574 - 233.679 0 498.711 OK 200.546 6.29924 394.793 OK 618.972 0 2083.69 OK TCONS_00004380 = uc009vql.2 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2451 - 174.016 0 390.278 OK 2.65635 0 28.8201 OK 0 0 0 OK TCONS_00004381 = uc010odw.1 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2617 - 0.231084 0 7.65235 OK 3.70001 0 26.2717 OK 0 0 0 OK TCONS_00004382 = uc010odx.1 XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 2388 - 46.0789 0 177.045 OK 90.6925 25.2616 156.123 OK 95.6502 0 667.332 OK TCONS_00004383 = uc001bgt.2 XLOC_001398 ZNF436 TSS2229 chr1:23685941-23698278 4314 - 32.0809 0 67.178 OK 18.4192 13.3986 23.4398 OK 264.956 115.508 414.403 OK TCONS_00004384 = uc001bgu.2 XLOC_001398 ZNF436 TSS2230 chr1:23685941-23698278 4492 - 28.9081 0 62.8343 OK 0 0 0 OK 121.81 15.9871 227.633 OK TCONS_00004385 = uc001bgx.1 XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 1586 - 72.9916 0 148.404 OK 1.36049 0 3.66464 OK 539.056 242.03 836.083 OK TCONS_00004386 = uc009vqm.1 XLOC_001399 TCEA3 TSS2232 chr1:23707554-23751261 540 - 0 0 0 OK 4.90057 0 13.6303 OK 75.1132 0 421.044 OK TCONS_00004387 = uc009vqn.1 XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 738 - 61.7872 0 180.091 OK 0 0 0 OK 147.495 0 442.753 OK TCONS_00004388 = uc010ody.1 XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 646 - 0 0 0 OK 0 0 0 OK 12.5792 0 311.431 OK TCONS_00004389 = uc001bgy.1 XLOC_001400 ASAP3 TSS2233 chr1:23755055-23811057 2552 - 57.325 0 142.224 OK 22.8075 0 48.2833 OK 97.6727 0 255.097 OK TCONS_00004390 = uc001bgz.1 XLOC_001400 - TSS2234 chr1:23755055-23811057 2791 - 31.2959 0 94.9927 OK 92.1289 44.7493 139.508 OK 41.7841 0 143.383 OK TCONS_00004391 = uc010odz.1 XLOC_001400 - TSS2235 chr1:23755055-23811057 4088 - 33.3151 0 89.9209 OK 59.9998 15.4729 104.527 OK 61.9722 0 157.329 OK TCONS_00004392 = uc001bha.2 XLOC_001400 ASAP3 TSS2235 chr1:23755055-23811057 4129 - 181.965 75.926 288.004 OK 557.63 466.323 648.937 OK 591.657 299.448 883.866 OK TCONS_00004393 = uc010oea.1 XLOC_001400 ASAP3 TSS2235 chr1:23755055-23811057 4102 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004394 = uc001bhb.2 XLOC_001400 ASAP3 TSS2236 chr1:23755055-23811057 1768 - 0 0 0 OK 24.2074 0 58.75 OK 0 0 0 OK TCONS_00004395 = uc001bhc.1 XLOC_001400 ASAP3 TSS2237 chr1:23755055-23811057 697 - 0 0 0 OK 5.93528 0 78.7546 OK 0 0 0 OK TCONS_00004396 = uc001bhd.2 XLOC_001401 - - chr1:23755055-23811057 2041 - 14.3352 0 56.05 OK 1.51415 0 8.05567 OK 0 0 0 OK TCONS_00004397 = uc001bhe.1 XLOC_001402 E2F2 TSS2238 chr1:23832921-23857713 5192 - 17.3678 4.7535 29.9821 OK 95.4288 77.2231 113.634 OK 59.0676 19.8264 98.3088 OK TCONS_00004398 = uc001bhh.3 XLOC_001403 ID3 TSS2239 chr1:23884409-23886322 1287 - 2233.71 1374.86 3092.55 OK 3052.85 2640.31 3465.39 OK 1179.44 550.757 1808.12 OK TCONS_00004399 = uc001bhg.1 XLOC_001403 ID3 - chr1:23884409-23886322 1547 - 290.313 0 618.864 OK 130.941 50.7059 211.176 OK 325.332 12.3701 638.294 OK TCONS_00004400 = uc001bhp.1 XLOC_001404 - TSS2240 chr1:24069855-24104777 1074 - 29.788 0 264.297 OK 77.4967 4.15983 150.834 OK 107.333 0 702.882 OK TCONS_00004401 = uc009vqo.1 XLOC_001405 GALE TSS2241 chr1:24122088-24127294 1607 - 33.6768 0 114.477 OK 38.3217 0 86.1816 OK 12.7034 0 114.987 OK TCONS_00004402 = uc001bhv.1 XLOC_001405 GALE TSS2242 chr1:24122088-24127294 1631 - 0 0 0 OK 10.1974 0 30.8549 OK 127.586 0 380.75 OK TCONS_00004403 = uc001bhw.1 XLOC_001405 GALE TSS2242 chr1:24122088-24127294 1553 - 17.4871 0 82.9391 OK 17.3703 0 51.7957 OK 39.5664 0 138.771 OK TCONS_00004404 = uc001bhx.1 XLOC_001405 GALE TSS2243 chr1:24122088-24127294 1566 - 150.589 26.9428 274.235 OK 392.012 306.35 477.675 OK 357.933 86.953 628.912 OK TCONS_00004405 = uc001bhy.1 XLOC_001405 GALE TSS2243 chr1:24122088-24127294 1676 - 61.4119 0 158.662 OK 43.8262 9.46915 78.1832 OK 155.802 0 410.815 OK TCONS_00004406 = uc001bhz.1 XLOC_001405 GALE TSS2243 chr1:24122088-24127294 1824 - 34.8907 0 103.164 OK 51.369 21.0673 81.6707 OK 64.4525 0 246.749 OK TCONS_00004407 = uc009vqp.1 XLOC_001405 GALE TSS2243 chr1:24122088-24127294 1570 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004408 = uc001bia.2 XLOC_001405 GALE TSS2244 chr1:24122088-24127294 1244 - 6.56657 0 75.3981 OK 9.86629 0 29.5456 OK 4.63048 0 149.567 OK TCONS_00004409 = uc009vqq.1 XLOC_001405 GALE TSS2243 chr1:24122088-24127294 934 - 4.49564 0 168.221 OK 5.43458 0 25.3141 OK 0 0 0 OK TCONS_00004410 = uc001bib.2 XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 1607 - 184.728 56.5612 312.894 OK 286.755 224.657 348.854 OK 1600.17 868.148 2332.19 OK TCONS_00004411 = uc009vqr.2 XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 1190 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004412 = uc010oec.1 XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 1394 - 0 0 0 OK 42.7613 12.6627 72.8598 OK 114.728 0 386.652 OK TCONS_00004413 = uc001bic.2 XLOC_001406 HMGCL TSS2246 chr1:24128367-24165110 2160 - 7.68224 0 40.6411 OK 12.5886 0.206477 24.9707 OK 0 0 0 OK TCONS_00004414 = uc009vqs.1 XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 1411 - 7.05744 0 57.8374 OK 9.6936 0 23.5795 OK 5.84858 0 211.14 OK TCONS_00004415 = uc001bid.1 XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 2054 - 17.3205 0 60.829 OK 7.27536 0 16.2781 OK 39.9903 0 162.231 OK TCONS_00004416 = uc001bie.2 XLOC_001407 FUCA1 TSS2247 chr1:24171573-24194821 2077 - 207.2 93.0962 321.303 OK 122.432 95.3123 149.551 OK 140.427 46.8684 233.985 OK TCONS_00004417 = uc009vqt.1 XLOC_001407 - TSS2247 chr1:24171573-24194821 1076 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004418 = uc010oed.1 XLOC_001407 - TSS2247 chr1:24171573-24194821 953 - 0 0 0 OK 9.88427 0 26.7672 OK 2.14565 0 131.299 OK TCONS_00004419 = uc001bif.2 XLOC_001408 CNR2 TSS2248 chr1:24200460-24239817 1774 - 0.725191 0 2.81492 OK 0 0 0 OK 0 0 0 OK TCONS_00004420 = uc001bij.1 XLOC_001409 - TSS2249 chr1:24292938-24306821 2239 - 869.644 422.244 1317.04 OK 282.334 187.209 377.458 OK 156.955 0 470.687 OK TCONS_00004421 = uc010oee.1 XLOC_001409 SFRS13A TSS2249 chr1:24292938-24306821 1842 - 177.784 0 423.155 OK 533.444 389.643 677.245 OK 1297.57 432.71 2162.43 OK TCONS_00004422 = uc010oef.1 XLOC_001409 SFRS13A TSS2249 chr1:24292938-24306821 2924 - 1054.92 628.182 1481.65 OK 767.195 635.873 898.516 OK 1010.81 415.849 1605.77 OK TCONS_00004423 = uc001bil.3 XLOC_001410 MYOM3 TSS2250 chr1:24382531-24438665 2686 - 0 0 0 OK 1.19576 0 3.29814 OK 0 0 0 OK TCONS_00004424 = uc001bim.3 XLOC_001410 MYOM3 TSS2251 chr1:24382531-24438665 4859 - 0.452065 0 2.23786 OK 1.77127 0.174322 3.36822 OK 0 0 0 OK TCONS_00004425 = uc001bin.3 XLOC_001410 MYOM3 TSS2252 chr1:24382531-24438665 5799 - 0.798149 0 2.71878 OK 0.363637 0 1.17831 OK 0 0 0 OK TCONS_00004426 = uc001bio.2 XLOC_001410 MYOM3 TSS2252 chr1:24382531-24438665 3940 - 1.49896 0 5.12555 OK 0 0 0 OK 0 0 0 OK TCONS_00004427 = uc001bip.1 XLOC_001410 MYOM3 TSS2253 chr1:24382531-24438665 5094 - 0.347098 0 1.73564 OK 0.607421 0 1.4623 OK 0 0 0 OK TCONS_00004428 = uc010oeg.1 XLOC_001411 IL22RA1 TSS2254 chr1:24446260-24469611 2703 - 6.64523 1.2324 12.0581 OK 1.45433 0 3.80055 OK 0 0 0 OK TCONS_00004429 = uc001biq.1 XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 2798 - 0 0 0 OK 5.55488 2.27978 8.82997 OK 0.000273846 0 0.885686 OK TCONS_00004430 = uc009vrb.1 XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 2853 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004431 = uc010oeh.1 XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 2725 - 0 0 0 OK 0 0 0 OK 3.57838 0 7.4666 OK TCONS_00004432 = uc001bir.2 XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 4461 - 0 0 0 OK 0 0 0 OK 0.000702974 0 0.54458 OK TCONS_00004433 = uc001bis.2 XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 4548 - 81.6347 33.1208 130.149 OK 44.0625 30.0304 58.0946 OK 0 0 0 OK TCONS_00004434 = uc001bit.2 XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 4417 - 4.07053 0 23.813 OK 24.4887 13.2913 35.6862 OK 0.0773653 0 0.626928 OK TCONS_00004435 = uc001biu.2 XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 4424 - 0 0 0 OK 12.9816 4.46503 21.4982 OK 0.0365025 0 0.585153 OK TCONS_00004436 = uc001biv.2 XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 686 - 13.7311 0 178.337 OK 125.353 57.2073 193.498 OK 0 0 0 OK TCONS_00004437 = uc001biw.2 XLOC_001413 - - chr1:24580829-24580859 30 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004438 = uc010oej.1 XLOC_001414 C1orf201 TSS2257 chr1:24683489-24741587 1961 - 0 0 0 OK 0 0 0 OK 0 0 0 OK TCONS_00004439 = uc001bja.2 XLOC_001414 C1orf201 TSS2258 chr1:24683489-24741587 2497 - 11.5429 0 42.8324 OK 7.16763 0 15.8409 OK 57.9985 0 135.969 OK TCONS_00004440 = uc001bjb.2 XLOC_001414 C1orf201 TSS2259 chr1:24683489-24741587 2827 - 2.86176 0 39.3042 OK 10.1778 0.655751 19.6998 OK 13.0899 0 52.4017 OK TCONS_00004441 = uc001bjc.2 XLOC_001414 C1orf201 TSS2259 chr1:24683489-24741587 2683 - 141.615 53.1116 230.118 OK 132.318 103.304 161.331 OK 205.765 74.1213 337.409 OK TCONS_00004442 = uc001bjd.2 XLOC_001414 C1orf201 TSS2260 chr1:24683489-24741587 2803 - 0 0 0 OK 0 0 0 OK 3.67923 0 48.8139 OK TCONS_00004443 = uc001bjf.2 XLOC_001414 C1orf201 TSS2261 chr1:24683489-24741587 1653 - 8.9548 0 57.0165 OK 2.3477 0 9.37006 OK 15.7206 0 84.2402 OK cummeRbund/inst/extdata/isoforms.read_group_tracking0000644000175200017520000135560714516004263024122 0ustar00biocbuildbiocbuildtracking_id condition replicate raw_frags internal_scaled_frags external_scaled_frags FPKM effective_length status TCONS_00000001 iPS 0 0 0 0 0 - OK TCONS_00000001 iPS 1 9.10202 8.76909 14.9931 14.2863 - OK TCONS_00000001 hESC 1 0 0 0 0 - OK TCONS_00000001 hESC 0 0 0 0 0 - OK TCONS_00000001 Fibroblasts 1 17.8383 14.8843 12.1679 11.6557 - OK TCONS_00000001 Fibroblasts 0 12.0001 14.2788 11.6729 11.1815 - OK TCONS_00000002 iPS 0 9 9.3939 16.0613 17.2049 - OK TCONS_00000002 iPS 1 4.89798 4.71882 8.06806 8.6425 - OK TCONS_00000002 hESC 1 1 0.989851 0.654207 0.621918 - OK TCONS_00000002 hESC 0 0 0 0 0 - OK TCONS_00000002 Fibroblasts 1 0 0 0 0 - OK TCONS_00000002 Fibroblasts 0 0 0 0 0 - OK TCONS_00000003 iPS 0 0 0 0 0 - OK TCONS_00000003 iPS 1 0 0 0 0 - OK TCONS_00000003 hESC 1 0 0 0 0 - OK TCONS_00000003 hESC 0 0 0 0 0 - OK TCONS_00000003 Fibroblasts 1 13.1617 10.9821 8.9779 8.94522 - OK TCONS_00000003 Fibroblasts 0 0 0 0 0 - OK TCONS_00000004 iPS 0 0 0 0 0 - OK TCONS_00000004 iPS 1 0 0 0 0 - OK TCONS_00000004 hESC 1 0 0 0 0 - OK TCONS_00000004 hESC 0 0 0 0 0 - OK TCONS_00000004 Fibroblasts 1 0 0 0 0 - OK TCONS_00000004 Fibroblasts 0 0 0 0 0 - OK TCONS_00000005 iPS 0 0 0 0 0 - OK TCONS_00000005 iPS 1 0 0 0 0 - OK TCONS_00000005 hESC 1 0 0 0 0 - OK TCONS_00000005 hESC 0 0 0 0 0 - OK TCONS_00000005 Fibroblasts 1 0 0 0 0 - OK TCONS_00000005 Fibroblasts 0 0 0 0 0 - OK TCONS_00000006 iPS 0 0 0 0 0 - OK TCONS_00000006 iPS 1 0 0 0 0 - OK TCONS_00000006 hESC 1 4.33333 4.28935 2.8349 835811 - OK TCONS_00000006 hESC 0 7 7.07177 4.67384 1.37799e+06 - OK TCONS_00000006 Fibroblasts 1 0 0 0 0 - OK TCONS_00000006 Fibroblasts 0 0.333333 0.396629 0.324245 28475.5 - OK TCONS_00000007 iPS 0 178.505 186.317 318.558 174.487 - OK TCONS_00000007 iPS 1 224.46 216.249 369.735 202.519 - OK TCONS_00000007 hESC 1 1093.38 1082.28 715.295 400.032 - OK TCONS_00000007 hESC 0 882.376 891.423 589.154 329.487 - OK TCONS_00000007 Fibroblasts 1 70.2161 58.5883 47.8961 26.3142 - OK TCONS_00000007 Fibroblasts 0 60.8503 72.4051 59.1913 32.5198 - OK TCONS_00000008 iPS 0 172.297 179.838 307.481 103.522 - OK TCONS_00000008 iPS 1 87.4097 84.2124 143.983 48.4758 - OK TCONS_00000008 hESC 1 1442.31 1427.67 943.567 321.749 - OK TCONS_00000008 hESC 0 1572.69 1588.82 1050.07 358.067 - OK TCONS_00000008 Fibroblasts 1 0.00215915 0.00180159 0.00147281 0.000496783 - OK TCONS_00000008 Fibroblasts 0 30.5502 36.3513 29.7173 10.0237 - OK TCONS_00000009 iPS 0 66.698 69.6172 119.029 41.0212 - OK TCONS_00000009 iPS 1 245.664 236.678 404.664 139.46 - OK TCONS_00000009 hESC 1 0.886556 0.877559 0.579991 0.202507 - OK TCONS_00000009 hESC 0 0.0416799 0.0421073 0.0278293 0.00971677 - OK TCONS_00000009 Fibroblasts 1 49.6484 41.4266 33.8664 11.6937 - OK TCONS_00000009 Fibroblasts 0 45.6995 54.3772 44.4535 15.3493 - OK TCONS_00000010 iPS 0 0 0 0 0 - OK TCONS_00000010 iPS 1 1 0.963422 1.64722 3.02791 - OK TCONS_00000010 hESC 1 0 0 0 0 - OK TCONS_00000010 hESC 0 0 0 0 0 - OK TCONS_00000010 Fibroblasts 1 0 0 0 0 - OK TCONS_00000010 Fibroblasts 0 0 0 0 0 - OK TCONS_00000011 iPS 0 0 0 0 0 - OK TCONS_00000011 iPS 1 0 0 0 0 - OK TCONS_00000011 hESC 1 0 0 0 0 - OK TCONS_00000011 hESC 0 0 0 0 0 - OK TCONS_00000011 Fibroblasts 1 0 0 0 0 - OK TCONS_00000011 Fibroblasts 0 0 0 0 0 - OK TCONS_00000012 iPS 0 24157 25214.3 43110.4 43050.2 - OK TCONS_00000012 iPS 1 24152 23268.6 39783.7 39728.2 - OK TCONS_00000012 hESC 1 147707 146208 96630.9 100259 - OK TCONS_00000012 hESC 0 127539 128847 85156.6 88354.2 - OK TCONS_00000012 Fibroblasts 1 130138 108587 88770.3 89137.8 - OK TCONS_00000012 Fibroblasts 0 48844 58118.9 47512.3 47709 - OK TCONS_00000013 iPS 0 161 168.046 287.32 771.893 - OK TCONS_00000013 iPS 1 119 114.647 196.02 526.613 - OK TCONS_00000013 hESC 1 3594 3557.52 2351.22 7026.17 - OK TCONS_00000013 hESC 0 3409 3443.95 2276.16 6801.86 - OK TCONS_00000013 Fibroblasts 1 24798 20691.4 16915.3 46127.7 - OK TCONS_00000013 Fibroblasts 0 1036 1232.72 1007.75 2748.13 - OK TCONS_00000014 iPS 0 0 0 0 0 - OK TCONS_00000014 iPS 1 0 0 0 0 - OK TCONS_00000014 hESC 1 0 0 0 0 - OK TCONS_00000014 hESC 0 0 0 0 0 - OK TCONS_00000014 Fibroblasts 1 0 0 0 0 - OK TCONS_00000014 Fibroblasts 0 0 0 0 0 - OK TCONS_00000015 iPS 0 2531 2641.77 4516.81 7468.16 - OK TCONS_00000015 iPS 1 2582 2487.56 4253.13 7032.19 - OK TCONS_00000015 hESC 1 29211 28914.5 19110 33690.7 - OK TCONS_00000015 hESC 0 26951 27227.3 17994.9 31724.9 - OK TCONS_00000015 Fibroblasts 1 49557.5 41350.8 33804.4 56407.6 - OK TCONS_00000015 Fibroblasts 0 10092 12008.3 9816.85 16380.9 - OK TCONS_00000016 iPS 0 0.426463 0.445128 0.761063 3.14292 - OK TCONS_00000016 iPS 1 0 0 0 0 - OK TCONS_00000016 hESC 1 0 0 0 0 - OK TCONS_00000016 hESC 0 0 0 0 0 - OK TCONS_00000016 Fibroblasts 1 0 0 0 0 - OK TCONS_00000016 Fibroblasts 0 0 0 0 0 - OK TCONS_00000017 iPS 0 0 0 0 0 - OK TCONS_00000017 iPS 1 4.44036 4.27795 7.31427 15.0705 - OK TCONS_00000017 hESC 1 0 0 0 0 - OK TCONS_00000017 hESC 0 0 0 0 0 - OK TCONS_00000017 Fibroblasts 1 0 0 0 0 - OK TCONS_00000017 Fibroblasts 0 0 0 0 0 - OK TCONS_00000018 iPS 0 0 0 0 0 - OK TCONS_00000018 iPS 1 0 0 0 0 - OK TCONS_00000018 hESC 1 48.0431 47.5555 31.4301 92.5542 - OK TCONS_00000018 hESC 0 44.0379 44.4894 29.4037 86.5869 - OK TCONS_00000018 Fibroblasts 1 23.1011 19.2756 15.7578 42.3991 - OK TCONS_00000018 Fibroblasts 0 22.0343 26.2183 21.4335 57.6706 - OK TCONS_00000019 iPS 0 7.03515 7.34305 12.5549 50.8089 - OK TCONS_00000019 iPS 1 1.84559 1.77808 3.0401 12.3031 - OK TCONS_00000019 hESC 1 0 0 0 0 - OK TCONS_00000019 hESC 0 0 0 0 0 - OK TCONS_00000019 Fibroblasts 1 0 0 0 0 - OK TCONS_00000019 Fibroblasts 0 12.0613 14.3516 11.7325 48.5659 - OK TCONS_00000020 iPS 0 53.0384 55.3597 94.652 97.337 - OK TCONS_00000020 iPS 1 34.464 33.2034 56.77 58.3804 - OK TCONS_00000020 hESC 1 118.374 117.172 77.4408 82.8399 - OK TCONS_00000020 hESC 0 169.712 171.452 113.315 121.215 - OK TCONS_00000020 Fibroblasts 1 325.649 271.721 222.133 229.739 - OK TCONS_00000020 Fibroblasts 0 195.654 232.807 190.32 196.837 - OK TCONS_00000021 iPS 0 15 15.6565 26.7689 15.0589 - OK TCONS_00000021 iPS 1 3 2.89027 4.94167 2.77995 - OK TCONS_00000021 hESC 1 79 78.1982 51.6823 29.7021 - OK TCONS_00000021 hESC 0 72 72.7382 48.0737 27.6282 - OK TCONS_00000021 Fibroblasts 1 230 191.912 156.888 88.533 - OK TCONS_00000021 Fibroblasts 0 108 128.508 105.056 59.2833 - OK TCONS_00000022 iPS 0 16 16.7003 28.5535 14.0463 - OK TCONS_00000022 iPS 1 4 3.85369 6.58889 3.24126 - OK TCONS_00000022 hESC 1 98 97.0054 64.1123 32.1328 - OK TCONS_00000022 hESC 0 71 71.728 47.4061 23.7597 - OK TCONS_00000022 Fibroblasts 1 2 1.6688 1.36425 0.67294 - OK TCONS_00000022 Fibroblasts 0 1 1.18989 0.972736 0.47982 - OK TCONS_00000023 iPS 0 22.095 23.062 39.4305 172.931 - OK TCONS_00000023 iPS 1 1.00001 0.963435 1.64724 7.22435 - OK TCONS_00000023 hESC 1 0 0 0 0 - OK TCONS_00000023 hESC 0 0 0 0 0 - OK TCONS_00000023 Fibroblasts 1 0 0 0 0 - OK TCONS_00000023 Fibroblasts 0 1 1.18989 0.972736 4.37202 - OK TCONS_00000024 iPS 0 98.2263 102.525 175.294 103.901 - OK TCONS_00000024 iPS 1 0 0 0 0 - OK TCONS_00000024 hESC 1 10.6666 10.5583 6.97813 4.23036 - OK TCONS_00000024 hESC 0 0 0 0 0 - OK TCONS_00000024 Fibroblasts 1 10.883 9.08075 7.42354 4.41456 - OK TCONS_00000024 Fibroblasts 0 0 0 0 0 - OK TCONS_00000025 iPS 0 72.0849 75.2399 128.642 93.15 - OK TCONS_00000025 iPS 1 5.84031 5.62669 9.6203 6.96607 - OK TCONS_00000025 hESC 1 0 0 0 0 - OK TCONS_00000025 hESC 0 16.5335 16.703 11.0393 8.21721 - OK TCONS_00000025 Fibroblasts 1 73.2685 61.1352 49.9782 36.3346 - OK TCONS_00000025 Fibroblasts 0 51.6691 61.4804 50.2604 36.5397 - OK TCONS_00000026 iPS 0 75.4676 78.7706 134.679 79.6273 - OK TCONS_00000026 iPS 1 47.8616 46.1109 78.8387 46.6124 - OK TCONS_00000026 hESC 1 507.821 502.667 332.22 200.885 - OK TCONS_00000026 hESC 0 413.996 418.241 276.421 167.146 - OK TCONS_00000026 Fibroblasts 1 324.047 270.385 221.04 131.115 - OK TCONS_00000026 Fibroblasts 0 250.618 298.207 243.785 144.607 - OK TCONS_00000027 iPS 0 21.2489 22.1789 37.9206 68.1122 - OK TCONS_00000027 iPS 1 14.0147 13.5021 23.0854 41.4654 - OK TCONS_00000027 hESC 1 124.639 123.374 81.5396 157.065 - OK TCONS_00000027 hESC 0 123.429 124.695 82.4125 158.746 - OK TCONS_00000027 Fibroblasts 1 34.9914 29.1968 23.8685 43.3015 - OK TCONS_00000027 Fibroblasts 0 29.2978 34.8611 28.4991 51.7022 - OK TCONS_00000028 iPS 0 26.3266 27.4788 46.9823 36.2069 - OK TCONS_00000028 iPS 1 17.3938 16.7576 28.6515 22.0803 - OK TCONS_00000028 hESC 1 447.755 443.211 292.924 232.477 - OK TCONS_00000028 hESC 0 441.772 446.302 294.967 234.098 - OK TCONS_00000028 Fibroblasts 1 157.415 131.347 107.376 83.1034 - OK TCONS_00000028 Fibroblasts 0 150.063 178.559 145.972 112.974 - OK TCONS_00000029 iPS 0 17.9569 18.7428 32.0458 46.1833 - OK TCONS_00000029 iPS 1 9.72988 9.37399 16.0273 23.098 - OK TCONS_00000029 hESC 1 188.786 186.87 123.505 188.186 - OK TCONS_00000029 hESC 0 181.802 183.666 121.388 184.96 - OK TCONS_00000029 Fibroblasts 1 63.5465 53.0231 43.3466 62.9707 - OK TCONS_00000029 Fibroblasts 0 40.0211 47.6206 38.9299 56.5546 - OK TCONS_00000030 iPS 0 8.9998 9.39369 16.061 10.1855 - OK TCONS_00000030 iPS 1 0.000453221 0.000436643 0.000746556 0.00047345 - OK TCONS_00000030 hESC 1 40.9388 40.5233 26.7824 17.3996 - OK TCONS_00000030 hESC 0 21.9497 22.1748 14.6556 9.52126 - OK TCONS_00000030 Fibroblasts 1 0.00254343 0.00212224 0.00173493 0.00110412 - OK TCONS_00000030 Fibroblasts 0 17.8089 21.1906 17.3234 11.0247 - OK TCONS_00000031 iPS 0 0.000203865 0.000212788 0.000363817 0.000215643 - OK TCONS_00000031 iPS 1 0 0 0 0 - OK TCONS_00000031 hESC 1 18.0612 17.8779 11.8158 7.16309 - OK TCONS_00000031 hESC 0 30.0493 30.3574 20.0637 12.1632 - OK TCONS_00000031 Fibroblasts 1 82.025 68.4416 55.9512 33.2725 - OK TCONS_00000031 Fibroblasts 0 28.5292 33.9465 27.7514 16.5029 - OK TCONS_00000032 iPS 0 0 0 0 0 - OK TCONS_00000032 iPS 1 1.99955 1.92641 3.2937 2.19198 - OK TCONS_00000032 hESC 1 0 0 0 0 - OK TCONS_00000032 hESC 0 0.000932932 0.000942497 0.00062291 0.000425187 - OK TCONS_00000032 Fibroblasts 1 24.9724 20.837 17.0343 11.3782 - OK TCONS_00000032 Fibroblasts 0 69.6619 82.8898 67.7627 45.2628 - OK TCONS_00000033 iPS 0 136 141.952 242.705 694.225 - OK TCONS_00000033 iPS 1 80 77.0738 131.778 376.933 - OK TCONS_00000033 hESC 1 536 530.56 350.655 1123.84 - OK TCONS_00000033 hESC 0 469 473.809 313.147 1003.63 - OK TCONS_00000033 Fibroblasts 1 1854 1546.98 1264.66 3675.44 - OK TCONS_00000033 Fibroblasts 0 998 1187.51 970.791 2821.38 - OK TCONS_00000034 iPS 0 465 485.352 829.836 164.14 - OK TCONS_00000034 iPS 1 494.333 476.252 814.277 161.062 - OK TCONS_00000034 hESC 1 14186.7 14042.7 9281.01 1849.52 - OK TCONS_00000034 hESC 0 14148 14293.1 9446.49 1882.49 - OK TCONS_00000034 Fibroblasts 1 23277.1 19422.4 15877.9 3144.04 - OK TCONS_00000034 Fibroblasts 0 10113.6 12034 9837.85 1948.03 - OK TCONS_00000035 iPS 0 1 1.04377 1.78459 3.75098 - OK TCONS_00000035 iPS 1 0 0 0 0 - OK TCONS_00000035 hESC 1 1.19849 1.18632 0.784059 2.45178 - OK TCONS_00000035 hESC 0 2 2.02051 1.33538 4.17578 - OK TCONS_00000035 Fibroblasts 1 1.09022 0.909679 0.743665 2.11352 - OK TCONS_00000035 Fibroblasts 0 3.40836 4.05557 3.31544 9.4226 - OK TCONS_00000036 iPS 0 7 7.30637 12.4922 21.9914 - OK TCONS_00000036 iPS 1 6 5.78053 9.88334 17.3988 - OK TCONS_00000036 hESC 1 26.8015 26.5295 17.5337 33.0539 - OK TCONS_00000036 hESC 0 22 22.2256 14.6892 27.6915 - OK TCONS_00000036 Fibroblasts 1 17.9098 14.9439 12.2167 21.7175 - OK TCONS_00000036 Fibroblasts 0 61.5916 73.2871 59.9124 106.506 - OK TCONS_00000037 iPS 0 0 0 0 0 - OK TCONS_00000037 iPS 1 0 0 0 0 - OK TCONS_00000037 hESC 1 2 1.9797 1.30841 1.32641 - OK TCONS_00000037 hESC 0 3 3.03076 2.00307 2.03063 - OK TCONS_00000037 Fibroblasts 1 0 0 0 0 - OK TCONS_00000037 Fibroblasts 0 0 0 0 0 - OK TCONS_00000038 iPS 0 0 0 0 0 - OK TCONS_00000038 iPS 1 0 0 0 0 - OK TCONS_00000038 hESC 1 0 0 0 0 - OK TCONS_00000038 hESC 0 0 0 0 0 - OK TCONS_00000038 Fibroblasts 1 0 0 0 0 - OK TCONS_00000038 Fibroblasts 0 0 0 0 0 - OK TCONS_00000039 iPS 0 0 0 0 0 - OK TCONS_00000039 iPS 1 0 0 0 0 - OK TCONS_00000039 hESC 1 0 0 0 0 - OK TCONS_00000039 hESC 0 0 0 0 0 - OK TCONS_00000039 Fibroblasts 1 0 0 0 0 - OK TCONS_00000039 Fibroblasts 0 0 0 0 0 - OK TCONS_00000040 iPS 0 0 0 0 0 - OK TCONS_00000040 iPS 1 0 0 0 0 - OK TCONS_00000040 hESC 1 0 0 0 0 - OK TCONS_00000040 hESC 0 0 0 0 0 - OK TCONS_00000040 Fibroblasts 1 0 0 0 0 - OK TCONS_00000040 Fibroblasts 0 0 0 0 0 - OK TCONS_00000041 iPS 0 0 0 0 0 - OK TCONS_00000041 iPS 1 0 0 0 0 - OK TCONS_00000041 hESC 1 29.9539 29.6499 19.596 13.599 - OK TCONS_00000041 hESC 0 10.9505 11.0628 7.31156 5.07399 - OK TCONS_00000041 Fibroblasts 1 0 0 0 0 - OK TCONS_00000041 Fibroblasts 0 0 0 0 0 - OK TCONS_00000042 iPS 0 0 0 0 0 - OK TCONS_00000042 iPS 1 0 0 0 0 - OK TCONS_00000042 hESC 1 0.0124439 0.0123176 0.00814088 0.00559733 - OK TCONS_00000042 hESC 0 0.01142 0.0115371 0.00762502 0.00524265 - OK TCONS_00000042 Fibroblasts 1 0 0 0 0 - OK TCONS_00000042 Fibroblasts 0 0 0 0 0 - OK TCONS_00000043 iPS 0 0 0 0 0 - OK TCONS_00000043 iPS 1 0 0 0 0 - OK TCONS_00000043 hESC 1 12.0337 11.9115 7.8725 5.89099 - OK TCONS_00000043 hESC 0 19.0381 19.2333 12.7115 9.51204 - OK TCONS_00000043 Fibroblasts 1 0 0 0 0 - OK TCONS_00000043 Fibroblasts 0 0 0 0 0 - OK TCONS_00000044 iPS 0 249 259.898 444.364 239.683 - OK TCONS_00000044 iPS 1 231 222.551 380.509 205.241 - OK TCONS_00000044 hESC 1 744 736.449 486.73 267.968 - OK TCONS_00000044 hESC 0 792 800.121 528.811 291.136 - OK TCONS_00000044 Fibroblasts 1 3028 2526.56 2065.47 1117.41 - OK TCONS_00000044 Fibroblasts 0 1912 2275.07 1859.87 1006.18 - OK TCONS_00000045 iPS 0 0 0 0 0 - OK TCONS_00000045 iPS 1 0.000904374 0.000871294 0.00148971 0.000730036 - OK TCONS_00000045 hESC 1 8.10201 8.01978 5.30039 2.64622 - OK TCONS_00000045 hESC 0 6.15981 6.22297 4.11285 2.05334 - OK TCONS_00000045 Fibroblasts 1 29.8138 24.8766 20.3367 9.99311 - OK TCONS_00000045 Fibroblasts 0 17.6955 21.0557 17.2131 8.45822 - OK TCONS_00000046 iPS 0 10.9992 11.4806 19.629 9.94308 - OK TCONS_00000046 iPS 1 7.57825 7.30105 12.4831 6.32329 - OK TCONS_00000046 hESC 1 54.7866 54.2305 35.8418 18.508 - OK TCONS_00000046 hESC 0 16.2769 16.4438 10.8679 5.612 - OK TCONS_00000046 Fibroblasts 1 53.3888 44.5476 36.4178 18.4992 - OK TCONS_00000046 Fibroblasts 0 42.9606 51.1182 41.7893 21.2277 - OK TCONS_00000047 iPS 0 0 0 0 0 - OK TCONS_00000047 iPS 1 1.42085 1.36888 2.34045 1.36663 - OK TCONS_00000047 hESC 1 84.8944 84.0328 55.5385 33.1576 - OK TCONS_00000047 hESC 0 52.7332 53.2739 35.2095 21.0208 - OK TCONS_00000047 Fibroblasts 1 56.931 47.5032 38.834 22.7491 - OK TCONS_00000047 Fibroblasts 0 21.0611 25.0604 20.4869 12.0013 - OK TCONS_00000048 iPS 0 0 0 0 0 - OK TCONS_00000048 iPS 1 0 0 0 0 - OK TCONS_00000048 hESC 1 9.49328 9.39693 6.21057 3.56635 - OK TCONS_00000048 hESC 0 17.022 17.1965 11.3654 6.52646 - OK TCONS_00000048 Fibroblasts 1 29.5407 24.6488 20.1504 11.3619 - OK TCONS_00000048 Fibroblasts 0 7.69176 9.15233 7.48206 4.21879 - OK TCONS_00000049 iPS 0 0.000838242 0.000874929 0.00149592 0.000895675 - OK TCONS_00000049 iPS 1 0 0 0 0 - OK TCONS_00000049 hESC 1 71.7237 70.9957 46.9221 28.7413 - OK TCONS_00000049 hESC 0 72.8081 73.5547 48.6133 29.7772 - OK TCONS_00000049 Fibroblasts 1 14.3257 11.9534 9.77191 5.87029 - OK TCONS_00000049 Fibroblasts 0 19.591 23.3111 19.0569 11.4481 - OK TCONS_00000050 iPS 0 116.855 121.969 208.538 275.295 - OK TCONS_00000050 iPS 1 106.379 102.488 175.23 231.325 - OK TCONS_00000050 hESC 1 803.465 795.311 525.632 730.129 - OK TCONS_00000050 hESC 0 695.059 702.186 464.085 644.637 - OK TCONS_00000050 Fibroblasts 1 520.85 434.597 355.284 472.462 - OK TCONS_00000050 Fibroblasts 0 655.176 779.585 637.313 847.508 - OK TCONS_00000051 iPS 0 37.4756 39.1158 66.8788 93.3404 - OK TCONS_00000051 iPS 1 27.5307 26.5237 45.3493 63.2924 - OK TCONS_00000051 hESC 1 93.428 92.4798 61.1212 90.0279 - OK TCONS_00000051 hESC 0 139.313 140.742 93.0183 137.01 - OK TCONS_00000051 Fibroblasts 1 240.747 200.879 164.219 230.975 - OK TCONS_00000051 Fibroblasts 0 101.825 121.16 99.0486 139.312 - OK TCONS_00000052 iPS 0 17.9684 18.7549 32.0663 25.7063 - OK TCONS_00000052 iPS 1 12.3329 11.8818 20.3151 16.2858 - OK TCONS_00000052 hESC 1 26.8896 26.6167 17.5913 14.5404 - OK TCONS_00000052 hESC 0 27.9675 28.2543 18.6737 15.435 - OK TCONS_00000052 Fibroblasts 1 31.5573 26.3314 21.526 17.3332 - OK TCONS_00000052 Fibroblasts 0 18.485 21.9951 17.981 14.4788 - OK TCONS_00000053 iPS 0 137 142.996 244.489 170.826 - OK TCONS_00000053 iPS 1 94 90.5617 154.839 108.187 - OK TCONS_00000053 hESC 1 380 376.143 248.599 178.383 - OK TCONS_00000053 hESC 0 421 425.317 281.098 201.703 - OK TCONS_00000053 Fibroblasts 1 1474 1229.91 1005.45 705.236 - OK TCONS_00000053 Fibroblasts 0 1239 1474.27 1205.22 845.357 - OK TCONS_00000054 iPS 0 9 9.3939 16.0613 9.50402 - OK TCONS_00000054 iPS 1 3 2.89027 4.94167 2.92415 - OK TCONS_00000054 hESC 1 5 4.94925 3.27103 1.97961 - OK TCONS_00000054 hESC 0 8 8.08203 5.34153 3.23266 - OK TCONS_00000054 Fibroblasts 1 14 11.6816 9.54973 5.66941 - OK TCONS_00000054 Fibroblasts 0 5 5.94944 4.86368 2.88743 - OK TCONS_00000055 iPS 0 28.3019 29.5405 50.5073 45.2319 - OK TCONS_00000055 iPS 1 56.9198 54.8378 93.7596 83.9666 - OK TCONS_00000055 hESC 1 352.096 348.523 230.344 213.471 - OK TCONS_00000055 hESC 0 0 0 0 0 - OK TCONS_00000055 Fibroblasts 1 617.066 514.879 420.915 378.825 - OK TCONS_00000055 Fibroblasts 0 311.451 370.592 302.96 272.665 - OK TCONS_00000056 iPS 0 43.6831 45.595 77.9566 77.302 - OK TCONS_00000056 iPS 1 66.5829 64.1475 109.677 108.756 - OK TCONS_00000056 hESC 1 155.353 153.777 101.633 104.682 - OK TCONS_00000056 hESC 0 121.434 122.679 81.0804 83.5124 - OK TCONS_00000056 Fibroblasts 1 101.996 85.1054 69.5739 69.3695 - OK TCONS_00000056 Fibroblasts 0 57.1945 68.055 55.6352 55.4717 - OK TCONS_00000057 iPS 0 74.9964 78.2788 133.838 120.316 - OK TCONS_00000057 iPS 1 44.0372 42.4264 72.539 65.2102 - OK TCONS_00000057 hESC 1 418.288 414.043 273.647 254.603 - OK TCONS_00000057 hESC 0 765.318 773.165 510.996 475.434 - OK TCONS_00000057 Fibroblasts 1 277.299 231.379 189.153 170.89 - OK TCONS_00000057 Fibroblasts 0 199.71 237.633 194.266 175.51 - OK TCONS_00000058 iPS 0 0 0 0 0 - OK TCONS_00000058 iPS 1 2 1.92684 3.29445 14.4039 - OK TCONS_00000058 hESC 1 23 22.7666 15.0468 78.7253 - OK TCONS_00000058 hESC 0 16 16.1641 10.6831 55.8942 - OK TCONS_00000058 Fibroblasts 1 0 0 0 0 - OK TCONS_00000058 Fibroblasts 0 0 0 0 0 - OK TCONS_00000059 iPS 0 9.228 9.63189 16.4682 11.8038 - OK TCONS_00000059 iPS 1 0 0 0 0 - OK TCONS_00000059 hESC 1 190.04 188.111 124.325 91.5793 - OK TCONS_00000059 hESC 0 83.4042 84.2593 55.6882 41.0204 - OK TCONS_00000059 Fibroblasts 1 0 0 0 0 - OK TCONS_00000059 Fibroblasts 0 55.362 65.8746 53.8526 38.7529 - OK TCONS_00000060 iPS 0 151.772 158.415 270.851 161.76 - OK TCONS_00000060 iPS 1 287 276.502 472.753 282.342 - OK TCONS_00000060 hESC 1 1118.96 1107.6 732.031 447.23 - OK TCONS_00000060 hESC 0 1211.1 1223.51 808.638 494.032 - OK TCONS_00000060 Fibroblasts 1 1437 1199.03 980.212 587.348 - OK TCONS_00000060 Fibroblasts 0 531.638 632.589 517.144 309.875 - OK TCONS_00000061 iPS 0 27.6667 28.8776 49.3738 18.9195 - OK TCONS_00000061 iPS 1 9.33333 8.99194 15.3741 5.89119 - OK TCONS_00000061 hESC 1 244.667 242.183 160.063 62.2307 - OK TCONS_00000061 hESC 0 298.167 301.224 199.083 77.4015 - OK TCONS_00000061 Fibroblasts 1 47.4833 39.6201 32.3895 12.4376 - OK TCONS_00000061 Fibroblasts 0 49.5 58.8994 48.1504 18.4899 - OK TCONS_00000062 iPS 0 110.185 115.008 196.636 122.83 - OK TCONS_00000062 iPS 1 112.049 107.95 184.57 115.293 - OK TCONS_00000062 hESC 1 824.577 816.209 539.444 345.07 - OK TCONS_00000062 hESC 0 1120.97 1132.47 748.464 478.775 - OK TCONS_00000062 Fibroblasts 1 228.261 190.461 155.702 97.5972 - OK TCONS_00000062 Fibroblasts 0 758.56 902.601 737.879 462.516 - OK TCONS_00000063 iPS 0 77.8533 81.2607 138.936 110.94 - OK TCONS_00000063 iPS 1 32.647 31.4529 53.777 42.9405 - OK TCONS_00000063 hESC 1 199.888 197.859 130.768 107.648 - OK TCONS_00000063 hESC 0 216.78 219.003 144.742 119.152 - OK TCONS_00000063 Fibroblasts 1 106.285 88.6838 72.4992 58.1464 - OK TCONS_00000063 Fibroblasts 0 41.4399 49.3088 40.3101 32.3298 - OK TCONS_00000064 iPS 0 273.313 285.275 487.752 276.033 - OK TCONS_00000064 iPS 1 131.087 126.292 215.929 122.2 - OK TCONS_00000064 hESC 1 462.904 458.205 302.835 175.108 - OK TCONS_00000064 hESC 0 276.558 279.394 184.656 106.773 - OK TCONS_00000064 Fibroblasts 1 267.691 223.361 182.599 103.662 - OK TCONS_00000064 Fibroblasts 0 349.02 415.294 339.504 192.737 - OK TCONS_00000065 iPS 0 14.8152 15.4637 26.4392 37.3051 - OK TCONS_00000065 iPS 1 15.0505 14.5 24.7916 34.9804 - OK TCONS_00000065 hESC 1 424.364 420.057 277.622 413.658 - OK TCONS_00000065 hESC 0 265.688 268.412 177.397 264.323 - OK TCONS_00000065 Fibroblasts 1 230.096 191.992 156.954 223.198 - OK TCONS_00000065 Fibroblasts 0 294.047 349.883 286.03 406.751 - OK TCONS_00000066 iPS 0 38.947 40.6516 69.5045 40.236 - OK TCONS_00000066 iPS 1 23.9342 23.0588 39.425 22.8231 - OK TCONS_00000066 hESC 1 144.347 142.882 94.4326 55.8828 - OK TCONS_00000066 hESC 0 141.377 142.827 94.3965 55.8615 - OK TCONS_00000066 Fibroblasts 1 104.342 87.0626 71.1739 41.3345 - OK TCONS_00000066 Fibroblasts 0 72.7876 86.609 70.8031 41.1192 - OK TCONS_00000067 iPS 0 513.179 535.639 915.815 563.363 - OK TCONS_00000067 iPS 1 382.081 368.106 629.373 387.158 - OK TCONS_00000067 hESC 1 1373.94 1360 898.843 566.011 - OK TCONS_00000067 hESC 0 2456.57 2481.76 1640.23 1032.87 - OK TCONS_00000067 Fibroblasts 1 1248.45 1041.7 851.595 525.643 - OK TCONS_00000067 Fibroblasts 0 1819.87 2165.44 1770.26 1092.68 - OK TCONS_00000068 iPS 0 38.3303 40.0079 68.4041 44.7651 - OK TCONS_00000068 iPS 1 129.518 124.78 213.345 139.617 - OK TCONS_00000068 hESC 1 1791.79 1773.6 1172.2 786.459 - OK TCONS_00000068 hESC 0 707.886 715.144 472.649 317.113 - OK TCONS_00000068 Fibroblasts 1 2008.65 1676.01 1370.15 899.906 - OK TCONS_00000068 Fibroblasts 0 2343.04 2787.95 2279.16 1496.94 - OK TCONS_00000069 iPS 0 9.21084 9.61397 16.4376 9.49626 - OK TCONS_00000069 iPS 1 28.3001 27.265 46.6166 26.9312 - OK TCONS_00000069 hESC 1 59.7406 59.1342 39.0827 23.0799 - OK TCONS_00000069 hESC 0 74.3294 75.0915 49.6291 29.3079 - OK TCONS_00000069 Fibroblasts 1 47.9496 40.0092 32.7076 18.9562 - OK TCONS_00000069 Fibroblasts 0 22.6179 26.9127 22.0012 12.7511 - OK TCONS_00000070 iPS 0 1 1.04377 1.78459 2.8669 - OK TCONS_00000070 iPS 1 1 0.963422 1.64722 2.64622 - OK TCONS_00000070 hESC 1 14 13.8579 9.15889 15.6591 - OK TCONS_00000070 hESC 0 6 6.06152 4.00615 6.84937 - OK TCONS_00000070 Fibroblasts 1 10 8.344 6.82124 9.2071 - OK TCONS_00000070 Fibroblasts 0 0 0 0 0 - OK TCONS_00000071 iPS 0 19.8662 20.7357 35.4532 16.3063 - OK TCONS_00000071 iPS 1 20.0934 19.3584 33.0983 15.2232 - OK TCONS_00000071 hESC 1 0.0583406 0.0577485 0.0381668 0.0178632 - OK TCONS_00000071 hESC 0 0.019189 0.0193858 0.0128123 0.00599657 - OK TCONS_00000071 Fibroblasts 1 66.2317 55.2637 45.1782 20.8321 - OK TCONS_00000071 Fibroblasts 0 51.7906 61.625 50.3786 23.23 - OK TCONS_00000072 iPS 0 14.1683 14.7884 25.2847 11.7904 - OK TCONS_00000072 iPS 1 0.141314 0.136145 0.232776 0.108545 - OK TCONS_00000072 hESC 1 235.126 232.74 153.821 73.0075 - OK TCONS_00000072 hESC 0 315.525 318.76 210.673 99.9908 - OK TCONS_00000072 Fibroblasts 1 1287.14 1073.99 877.992 410.47 - OK TCONS_00000072 Fibroblasts 0 506.797 603.032 492.98 230.473 - OK TCONS_00000073 iPS 0 0 0 0 0 - OK TCONS_00000073 iPS 1 0 0 0 0 - OK TCONS_00000073 hESC 1 31.2831 30.9656 20.4656 9.6167 - OK TCONS_00000073 hESC 0 0 0 0 0 - OK TCONS_00000073 Fibroblasts 1 0 0 0 0 - OK TCONS_00000073 Fibroblasts 0 0 0 0 0 - OK TCONS_00000074 iPS 0 38.2071 39.8793 68.1841 33.7411 - OK TCONS_00000074 iPS 1 35.1007 33.8168 57.8187 28.6118 - OK TCONS_00000074 hESC 1 309.827 306.683 202.691 102.204 - OK TCONS_00000074 hESC 0 303.014 306.121 202.32 102.016 - OK TCONS_00000074 Fibroblasts 1 108.038 90.147 73.6954 36.5684 - OK TCONS_00000074 Fibroblasts 0 149.142 177.462 145.076 71.9881 - OK TCONS_00000075 iPS 0 0 0 0 0 - OK TCONS_00000075 iPS 1 0 0 0 0 - OK TCONS_00000075 hESC 1 0 0 0 0 - OK TCONS_00000075 hESC 0 0 0 0 0 - OK TCONS_00000075 Fibroblasts 1 0 0 0 0 - OK TCONS_00000075 Fibroblasts 0 0 0 0 0 - OK TCONS_00000076 iPS 0 4.20046 4.3843 7.49611 3.83838 - OK TCONS_00000076 iPS 1 3.50387 3.3757 5.77165 2.95538 - OK TCONS_00000076 hESC 1 72.3284 71.5944 47.3178 24.7046 - OK TCONS_00000076 hESC 0 135.731 137.122 90.6262 47.3159 - OK TCONS_00000076 Fibroblasts 1 180.253 150.403 122.955 63.1376 - OK TCONS_00000076 Fibroblasts 0 78.9124 93.8969 76.761 39.4169 - OK TCONS_00000077 iPS 0 0.0239349 0.0249824 0.042714 0.0221931 - OK TCONS_00000077 iPS 1 3.87807 3.73622 6.38805 3.31906 - OK TCONS_00000077 hESC 1 87.0375 86.1542 56.9405 30.1741 - OK TCONS_00000077 hESC 0 71.3715 72.1033 47.6541 25.253 - OK TCONS_00000077 Fibroblasts 1 10.1406 8.46129 6.91713 3.6043 - OK TCONS_00000077 Fibroblasts 0 29.2237 34.7729 28.427 14.8124 - OK TCONS_00000078 iPS 0 0 0 0 0 - OK TCONS_00000078 iPS 1 0 0 0 0 - OK TCONS_00000078 hESC 1 28.7306 28.439 18.7958 8.60342 - OK TCONS_00000078 hESC 0 0 0 0 0 - OK TCONS_00000078 Fibroblasts 1 200.771 167.523 136.951 61.7799 - OK TCONS_00000078 Fibroblasts 0 115.331 137.231 112.187 50.6086 - OK TCONS_00000079 iPS 0 0 0 0 0 - OK TCONS_00000079 iPS 1 0.197963 0.190722 0.326089 0.190408 - OK TCONS_00000079 hESC 1 242.387 239.927 158.571 94.6701 - OK TCONS_00000079 hESC 0 273.703 276.509 182.749 109.105 - OK TCONS_00000079 Fibroblasts 1 183.559 153.162 125.21 73.3486 - OK TCONS_00000079 Fibroblasts 0 62.1814 73.9889 60.4861 35.4331 - OK TCONS_00000080 iPS 0 16.4096 17.1278 29.2844 19.3524 - OK TCONS_00000080 iPS 1 0.247454 0.238403 0.407612 0.269367 - OK TCONS_00000080 hESC 1 0 0 0 0 - OK TCONS_00000080 hESC 0 0 0 0 0 - OK TCONS_00000080 Fibroblasts 1 0 0 0 0 - OK TCONS_00000080 Fibroblasts 0 49.6212 59.0437 48.2684 32.0146 - OK TCONS_00000081 iPS 0 1.12442 1.17363 2.00664 6.7982 - OK TCONS_00000081 iPS 1 3.8372 3.69684 6.32072 21.4137 - OK TCONS_00000081 hESC 1 97.2222 96.2355 63.6034 246.925 - OK TCONS_00000081 hESC 0 86.6367 87.525 57.8466 224.576 - OK TCONS_00000081 Fibroblasts 1 12.8616 10.7317 8.77319 30.2889 - OK TCONS_00000081 Fibroblasts 0 0 0 0 0 - OK TCONS_00000082 iPS 0 0.00046687 0.000487304 0.000833174 0.00109989 - OK TCONS_00000082 iPS 1 5.49971 5.29854 9.05925 11.9593 - OK TCONS_00000082 hESC 1 37.8574 37.4732 24.7666 34.402 - OK TCONS_00000082 hESC 0 39.3254 39.7286 26.2572 36.4726 - OK TCONS_00000082 Fibroblasts 1 9.69795 8.09197 6.6152 8.79699 - OK TCONS_00000082 Fibroblasts 0 1.59183 1.8941 1.54843 2.05912 - OK TCONS_00000083 iPS 0 5.06101 5.28251 9.03184 11.2215 - OK TCONS_00000083 iPS 1 0.000290174 0.000279561 0.000477982 0.000593862 - OK TCONS_00000083 hESC 1 35.2744 34.9164 23.0767 30.076 - OK TCONS_00000083 hESC 0 20.6708 20.8827 13.8017 17.9878 - OK TCONS_00000083 Fibroblasts 1 0 0 0 0 - OK TCONS_00000083 Fibroblasts 0 0 0 0 0 - OK TCONS_00000084 iPS 0 0 0 0 0 - OK TCONS_00000084 iPS 1 0 0 0 0 - OK TCONS_00000084 hESC 1 0 0 0 0 - OK TCONS_00000084 hESC 0 0 0 0 0 - OK TCONS_00000084 Fibroblasts 1 0.000266517 0.000222382 0.000181798 0.000352411 - OK TCONS_00000084 Fibroblasts 0 19.2402 22.8937 18.7156 36.2798 - OK TCONS_00000085 iPS 0 1.43853 1.50149 2.56719 5.32049 - OK TCONS_00000085 iPS 1 0 0 0 0 - OK TCONS_00000085 hESC 1 8.36824 8.28331 5.47456 12.3046 - OK TCONS_00000085 hESC 0 5.50384 5.56027 3.67487 8.25962 - OK TCONS_00000085 Fibroblasts 1 3.30178 2.755 2.25222 4.72177 - OK TCONS_00000085 Fibroblasts 0 0.0013166 0.0015666 0.0012807 0.00268498 - OK TCONS_00000086 iPS 0 0 0 0 0 - OK TCONS_00000086 iPS 1 0 0 0 0 - OK TCONS_00000086 hESC 1 79.2032 78.3994 51.8153 106.944 - OK TCONS_00000086 hESC 0 37.3306 37.7134 24.9253 51.4446 - OK TCONS_00000086 Fibroblasts 1 76.242 63.6163 52.0065 100.675 - OK TCONS_00000086 Fibroblasts 0 36.3335 43.2328 35.3429 68.4177 - OK TCONS_00000087 iPS 0 7.50053 7.8288 13.3854 27.8227 - OK TCONS_00000087 iPS 1 3.00001 2.89027 4.94168 10.2717 - OK TCONS_00000087 hESC 1 13.7969 13.6569 9.02603 20.3516 - OK TCONS_00000087 hESC 0 11.1694 11.2839 7.4577 16.8154 - OK TCONS_00000087 Fibroblasts 1 9.25985 7.72641 6.31636 13.2816 - OK TCONS_00000087 Fibroblasts 0 0 0 0 0 - OK TCONS_00000088 iPS 0 51.9318 54.2047 92.6772 79.9112 - OK TCONS_00000088 iPS 1 34.5665 33.3022 56.9388 49.0957 - OK TCONS_00000088 hESC 1 119.863 118.646 78.4149 69.8784 - OK TCONS_00000088 hESC 0 151.117 152.667 100.9 89.9153 - OK TCONS_00000088 Fibroblasts 1 203.297 169.631 138.673 120.144 - OK TCONS_00000088 Fibroblasts 0 54.3773 64.7029 52.8948 45.8269 - OK TCONS_00000089 iPS 0 2 2.08753 3.56919 6.70016 - OK TCONS_00000089 iPS 1 1 0.963422 1.64722 3.09221 - OK TCONS_00000089 hESC 1 3 2.96955 1.96262 3.96399 - OK TCONS_00000089 hESC 0 2 2.02051 1.33538 2.69713 - OK TCONS_00000089 Fibroblasts 1 3 2.5032 2.04637 3.88173 - OK TCONS_00000089 Fibroblasts 0 10 11.8989 9.72736 18.4517 - OK TCONS_00000090 iPS 0 3 3.1313 5.35378 8.11241 - OK TCONS_00000090 iPS 1 1 0.963422 1.64722 2.49598 - OK TCONS_00000090 hESC 1 30 29.6955 19.6262 31.5351 - OK TCONS_00000090 hESC 0 23 23.2358 15.3569 24.6753 - OK TCONS_00000090 Fibroblasts 1 2 1.6688 1.36425 1.75278 - OK TCONS_00000090 Fibroblasts 0 0 0 0 0 - OK TCONS_00000091 iPS 0 12 12.5252 21.4151 17.236 - OK TCONS_00000091 iPS 1 5 4.81711 8.23612 6.62886 - OK TCONS_00000091 hESC 1 79 78.1982 51.6823 42.8944 - OK TCONS_00000091 hESC 0 76 76.7792 50.7445 42.116 - OK TCONS_00000091 Fibroblasts 1 0 0 0 0 - OK TCONS_00000091 Fibroblasts 0 1 1.18989 0.972736 0.786404 - OK TCONS_00000092 iPS 0 170.001 177.441 303.382 199 - OK TCONS_00000092 iPS 1 186.632 179.806 307.425 201.652 - OK TCONS_00000092 hESC 1 1884.02 1864.9 1232.54 828.909 - OK TCONS_00000092 hESC 0 1923.55 1943.28 1284.34 863.746 - OK TCONS_00000092 Fibroblasts 1 0 0 0 0 - OK TCONS_00000092 Fibroblasts 0 0 0 0 0 - OK TCONS_00000093 iPS 0 0 0 0 0 - OK TCONS_00000093 iPS 1 0 0 0 0 - OK TCONS_00000093 hESC 1 0 0 0 0 - OK TCONS_00000093 hESC 0 0 0 0 0 - OK TCONS_00000093 Fibroblasts 1 120.037 100.159 81.8803 59.8043 - OK TCONS_00000093 Fibroblasts 0 37.6607 44.812 36.634 26.7569 - OK TCONS_00000094 iPS 0 0.00607722 0.0063432 0.0108454 0.008228 - OK TCONS_00000094 iPS 1 0 0 0 0 - OK TCONS_00000094 hESC 1 0 0 0 0 - OK TCONS_00000094 hESC 0 0 0 0 0 - OK TCONS_00000094 Fibroblasts 1 0 0 0 0 - OK TCONS_00000094 Fibroblasts 0 0 0 0 0 - OK TCONS_00000095 iPS 0 44.3701 46.312 79.1826 60.8233 - OK TCONS_00000095 iPS 1 92.7775 89.3839 152.825 117.391 - OK TCONS_00000095 hESC 1 132.518 131.173 86.694 68.5732 - OK TCONS_00000095 hESC 0 74.5923 75.3571 49.8046 39.3944 - OK TCONS_00000095 Fibroblasts 1 0 0 0 0 - OK TCONS_00000095 Fibroblasts 0 6.05089 7.19988 5.88592 4.54047 - OK TCONS_00000096 iPS 0 0 0 0 0 - OK TCONS_00000096 iPS 1 0 0 0 0 - OK TCONS_00000096 hESC 1 30.6889 30.3774 20.0769 18.6306 - OK TCONS_00000096 hESC 0 0 0 0 0 - OK TCONS_00000096 Fibroblasts 1 96.0027 80.1046 65.4857 59.0124 - OK TCONS_00000096 Fibroblasts 0 12.4633 14.8299 12.1235 10.9251 - OK TCONS_00000097 iPS 0 0 0 0 0 - OK TCONS_00000097 iPS 1 3.41092 3.28615 5.61854 7.60888 - OK TCONS_00000097 hESC 1 1.87587 1.85683 1.22721 1.75108 - OK TCONS_00000097 hESC 0 4.49609 4.54219 3.002 4.2835 - OK TCONS_00000097 Fibroblasts 1 0 0 0 0 - OK TCONS_00000097 Fibroblasts 0 0 0 0 0 - OK TCONS_00000098 iPS 0 4.61364 4.81556 8.23347 6.92623 - OK TCONS_00000098 iPS 1 0 0 0 0 - OK TCONS_00000098 hESC 1 38.9788 38.5832 25.5002 22.152 - OK TCONS_00000098 hESC 0 13.9065 14.049 9.28521 8.06605 - OK TCONS_00000098 Fibroblasts 1 0 0 0 0 - OK TCONS_00000098 Fibroblasts 0 0 0 0 0 - OK TCONS_00000099 iPS 0 8.92532 9.31595 15.9281 13.3199 - OK TCONS_00000099 iPS 1 2.10726 2.03018 3.47113 2.90276 - OK TCONS_00000099 hESC 1 29.8919 29.5885 19.5555 16.8841 - OK TCONS_00000099 hESC 0 32.2258 32.5563 21.5169 18.5776 - OK TCONS_00000099 Fibroblasts 1 0 0 0 0 - OK TCONS_00000099 Fibroblasts 0 0 0 0 0 - OK TCONS_00000100 iPS 0 17 17.744 30.3381 22.3337 - OK TCONS_00000100 iPS 1 9.54363 9.19455 15.7205 11.5728 - OK TCONS_00000100 hESC 1 109.687 108.573 71.7578 54.3286 - OK TCONS_00000100 hESC 0 114.196 115.367 76.2475 57.7278 - OK TCONS_00000100 Fibroblasts 1 31.2786 26.0989 21.3359 15.7707 - OK TCONS_00000100 Fibroblasts 0 8.60391 10.2377 8.36934 6.18632 - OK TCONS_00000101 iPS 0 51 53.2321 91.0143 72.5104 - OK TCONS_00000101 iPS 1 45.0002 43.3542 74.1254 59.0552 - OK TCONS_00000101 hESC 1 212 209.848 138.692 113.906 - OK TCONS_00000101 hESC 0 200.001 202.051 133.539 109.674 - OK TCONS_00000101 Fibroblasts 1 206 171.886 140.518 112.444 - OK TCONS_00000101 Fibroblasts 0 111.001 132.078 107.974 86.4024 - OK TCONS_00000102 iPS 0 591 616.866 1054.69 269.372 - OK TCONS_00000102 iPS 1 527 507.724 868.087 221.712 - OK TCONS_00000102 hESC 1 4208 4165.29 2752.9 709.915 - OK TCONS_00000102 hESC 0 4521 4567.35 3018.63 778.44 - OK TCONS_00000102 Fibroblasts 1 8777.5 7323.94 5987.34 1531.34 - OK TCONS_00000102 Fibroblasts 0 7039 8375.62 6847.09 1751.24 - OK TCONS_00000103 iPS 0 1118.63 1167.59 1996.3 965.254 - OK TCONS_00000103 iPS 1 786.095 757.342 1294.87 626.099 - OK TCONS_00000103 hESC 1 2413.66 2389.16 1579.03 777.628 - OK TCONS_00000103 hESC 0 2373.03 2397.36 1584.45 780.296 - OK TCONS_00000103 Fibroblasts 1 12154.1 10141.4 8290.58 4019.4 - OK TCONS_00000103 Fibroblasts 0 7543.28 8975.65 7337.62 3557.39 - OK TCONS_00000104 iPS 0 23.4201 24.4451 41.7953 19.4766 - OK TCONS_00000104 iPS 1 63.9939 61.6532 105.412 49.122 - OK TCONS_00000104 hESC 1 139.556 138.14 91.2986 43.3036 - OK TCONS_00000104 hESC 0 71.3699 72.1017 47.653 22.6022 - OK TCONS_00000104 Fibroblasts 1 282.071 235.36 192.407 89.8929 - OK TCONS_00000104 Fibroblasts 0 375.443 446.735 365.207 170.625 - OK TCONS_00000105 iPS 0 0 0 0 0 - OK TCONS_00000105 iPS 1 0 0 0 0 - OK TCONS_00000105 hESC 1 9.64033 9.54249 6.30677 1.93379 - OK TCONS_00000105 hESC 0 0 0 0 0 - OK TCONS_00000105 Fibroblasts 1 0 0 0 0 - OK TCONS_00000105 Fibroblasts 0 5.21414 6.20424 5.07199 1.54004 - OK TCONS_00000106 iPS 0 0 0 0 0 - OK TCONS_00000106 iPS 1 0 0 0 0 - OK TCONS_00000106 hESC 1 0.000662248 0.000655527 0.000433247 0.000164288 - OK TCONS_00000106 hESC 0 0 0 0 0 - OK TCONS_00000106 Fibroblasts 1 0.124387 0.103788 0.0848471 0.0317876 - OK TCONS_00000106 Fibroblasts 0 0 0 0 0 - OK TCONS_00000107 iPS 0 0 0 0 0 - OK TCONS_00000107 iPS 1 0 0 0 0 - OK TCONS_00000107 hESC 1 0.00165185 0.00163508 0.00108065 0.000411107 - OK TCONS_00000107 hESC 0 0.000123352 0.000124616 8.23607e-05 3.13321e-05 - OK TCONS_00000107 Fibroblasts 1 1.87561 1.56501 1.2794 0.48085 - OK TCONS_00000107 Fibroblasts 0 1.82573 2.17241 1.77595 0.667472 - OK TCONS_00000108 iPS 0 0 0 0 0 - OK TCONS_00000108 iPS 1 3.58948 3.45819 5.91268 1.78465 - OK TCONS_00000108 hESC 1 0 0 0 0 - OK TCONS_00000108 hESC 0 1.47133 1.48641 0.982391 0.299922 - OK TCONS_00000108 Fibroblasts 1 0 0 0 0 - OK TCONS_00000108 Fibroblasts 0 0 0 0 0 - OK TCONS_00000109 iPS 0 1.62965 1.70097 2.90826 0.762323 - OK TCONS_00000109 iPS 1 0 0 0 0 - OK TCONS_00000109 hESC 1 6.35735 6.29283 4.15902 1.10103 - OK TCONS_00000109 hESC 0 7.52855 7.60574 5.02675 1.33074 - OK TCONS_00000109 Fibroblasts 1 0 0 0 0 - OK TCONS_00000109 Fibroblasts 0 9.96013 11.8514 9.68858 2.54328 - OK TCONS_00000110 iPS 0 0.370352 0.386561 0.660928 0.450882 - OK TCONS_00000110 iPS 1 1.41052 1.35892 2.32344 1.58504 - OK TCONS_00000110 hESC 1 0 0 0 0 - OK TCONS_00000110 hESC 0 0 0 0 0 - OK TCONS_00000110 Fibroblasts 1 0 0 0 0 - OK TCONS_00000110 Fibroblasts 0 0 0 0 0 - OK TCONS_00000111 iPS 0 8.62689 9.00446 15.3955 39.2721 - OK TCONS_00000111 iPS 1 0.309906 0.29857 0.510484 1.30218 - OK TCONS_00000111 hESC 1 1.30487 1.29162 0.853653 1.6725 - OK TCONS_00000111 hESC 0 0 0 0 0 - OK TCONS_00000111 Fibroblasts 1 89.9667 75.0682 61.3684 158.78 - OK TCONS_00000111 Fibroblasts 0 30.6693 36.493 29.8331 77.1879 - OK TCONS_00000112 iPS 0 5.31247 5.54498 9.4806 8.91954 - OK TCONS_00000112 iPS 1 0 0 0 0 - OK TCONS_00000112 hESC 1 1.94602 1.92627 1.2731 1.24167 - OK TCONS_00000112 hESC 0 2 2.02051 1.33538 1.30241 - OK TCONS_00000112 Fibroblasts 1 68.6532 57.2842 46.83 44.2887 - OK TCONS_00000112 Fibroblasts 0 43.3554 51.5881 42.1734 39.8848 - OK TCONS_00000113 iPS 0 6.80441 7.10222 12.1431 4.00163 - OK TCONS_00000113 iPS 1 0 0 0 0 - OK TCONS_00000113 hESC 1 0 0 0 0 - OK TCONS_00000113 hESC 0 3 3.03076 2.00307 0.66837 - OK TCONS_00000113 Fibroblasts 1 220.838 184.267 150.639 49.7318 - OK TCONS_00000113 Fibroblasts 0 129.004 153.5 125.487 41.4281 - OK TCONS_00000114 iPS 0 23.0566 24.0658 41.1467 37.8803 - OK TCONS_00000114 iPS 1 0.000100082 9.64213e-05 0.000164857 0.00015177 - OK TCONS_00000114 hESC 1 0 0 0 0 - OK TCONS_00000114 hESC 0 0 0 0 0 - OK TCONS_00000114 Fibroblasts 1 1210.55 1010.09 825.748 764.08 - OK TCONS_00000114 Fibroblasts 0 568.698 676.687 553.193 511.88 - OK TCONS_00000115 iPS 0 0 0 0 0 - OK TCONS_00000115 iPS 1 1.68999 1.62818 2.7838 2.82579 - OK TCONS_00000115 hESC 1 6.30646 6.24245 4.12573 3.73868 - OK TCONS_00000115 hESC 0 0 0 0 0 - OK TCONS_00000115 Fibroblasts 1 69.127 57.6795 47.1532 48.1342 - OK TCONS_00000115 Fibroblasts 0 17.6669 21.0216 17.1852 17.5428 - OK TCONS_00000116 iPS 0 224.73 234.566 401.052 223.216 - OK TCONS_00000116 iPS 1 244.288 235.352 402.397 223.964 - OK TCONS_00000116 hESC 1 1145.15 1133.52 749.163 425.876 - OK TCONS_00000116 hESC 0 1159.4 1171.29 774.122 440.065 - OK TCONS_00000116 Fibroblasts 1 1426.6 1190.35 973.115 543.282 - OK TCONS_00000116 Fibroblasts 0 1254.14 1492.28 1219.95 681.085 - OK TCONS_00000117 iPS 0 0 0 0 0 - OK TCONS_00000117 iPS 1 0 0 0 0 - OK TCONS_00000117 hESC 1 178.114 176.306 116.523 64.833 - OK TCONS_00000117 hESC 0 39.9088 40.318 26.6468 14.8261 - OK TCONS_00000117 Fibroblasts 1 0 0 0 0 - OK TCONS_00000117 Fibroblasts 0 17.1553 20.4128 16.6875 9.1221 - OK TCONS_00000118 iPS 0 185.788 193.919 331.555 186.889 - OK TCONS_00000118 iPS 1 105.654 101.79 174.036 98.0993 - OK TCONS_00000118 hESC 1 942.829 933.26 616.805 355.202 - OK TCONS_00000118 hESC 0 757.696 765.465 505.907 291.339 - OK TCONS_00000118 Fibroblasts 1 1369.29 1142.54 934.028 528.13 - OK TCONS_00000118 Fibroblasts 0 1108.06 1318.47 1077.85 609.452 - OK TCONS_00000119 iPS 0 0 0 0 0 - OK TCONS_00000119 iPS 1 0 0 0 0 - OK TCONS_00000119 hESC 1 29.9138 29.6102 19.5698 11.1787 - OK TCONS_00000119 hESC 0 0 0 0 0 - OK TCONS_00000119 Fibroblasts 1 0 0 0 0 - OK TCONS_00000119 Fibroblasts 0 0 0 0 0 - OK TCONS_00000120 iPS 0 38.8454 40.5456 69.3233 40.296 - OK TCONS_00000120 iPS 1 0 0 0 0 - OK TCONS_00000120 hESC 1 65.2863 64.6237 42.7108 25.3814 - OK TCONS_00000120 hESC 0 17.1286 17.3042 11.4366 6.79634 - OK TCONS_00000120 Fibroblasts 1 0 0 0 0 - OK TCONS_00000120 Fibroblasts 0 60.296 71.7455 58.6521 34.2029 - OK TCONS_00000121 iPS 0 0 0 0 0 - OK TCONS_00000121 iPS 1 0 0 0 0 - OK TCONS_00000121 hESC 1 0 0 0 0 - OK TCONS_00000121 hESC 0 0.114773 0.11595 0.0766329 0.0455975 - OK TCONS_00000121 Fibroblasts 1 0 0 0 0 - OK TCONS_00000121 Fibroblasts 0 0 0 0 0 - OK TCONS_00000122 iPS 0 3.57802 3.73462 6.38531 3.75796 - OK TCONS_00000122 iPS 1 100.526 96.8493 165.589 97.4546 - OK TCONS_00000122 hESC 1 23.9319 23.689 15.6564 9.42276 - OK TCONS_00000122 hESC 0 233.905 236.304 156.177 93.9943 - OK TCONS_00000122 Fibroblasts 1 142.766 119.124 97.3844 57.5007 - OK TCONS_00000122 Fibroblasts 0 172.037 204.704 167.346 98.8097 - OK TCONS_00000123 iPS 0 0 0 0 0 - OK TCONS_00000123 iPS 1 0 0 0 0 - OK TCONS_00000123 hESC 1 0 0 0 0 - OK TCONS_00000123 hESC 0 0 0 0 0 - OK TCONS_00000123 Fibroblasts 1 0 0 0 0 - OK TCONS_00000123 Fibroblasts 0 0 0 0 0 - OK TCONS_00000124 iPS 0 2.28903 2.38922 4.085 0.680497 - OK TCONS_00000124 iPS 1 1.69702 1.63494 2.79537 0.465665 - OK TCONS_00000124 hESC 1 39.8014 39.3974 26.0383 4.36491 - OK TCONS_00000124 hESC 0 35.9697 36.3385 24.0167 4.02601 - OK TCONS_00000124 Fibroblasts 1 71.8021 59.9116 48.9779 8.16647 - OK TCONS_00000124 Fibroblasts 0 0 0 0 0 - OK TCONS_00000125 iPS 0 0.00754287 0.007873 0.013461 0.00222743 - OK TCONS_00000125 iPS 1 0.00841976 0.00811178 0.0138692 0.00229499 - OK TCONS_00000125 hESC 1 0 0 0 0 - OK TCONS_00000125 hESC 0 0 0 0 0 - OK TCONS_00000125 Fibroblasts 1 0 0 0 0 - OK TCONS_00000125 Fibroblasts 0 34.5169 41.0712 33.5758 5.56099 - OK TCONS_00000126 iPS 0 1.69278 1.76686 3.02092 0.50306 - OK TCONS_00000126 iPS 1 1.28238 1.23547 2.11236 0.351763 - OK TCONS_00000126 hESC 1 10.1986 10.0951 6.67201 1.11806 - OK TCONS_00000126 hESC 0 10.0303 10.1331 6.69713 1.12227 - OK TCONS_00000126 Fibroblasts 1 12.1979 10.178 8.32051 1.38685 - OK TCONS_00000126 Fibroblasts 0 0 0 0 0 - OK TCONS_00000127 iPS 0 0.00558931 0.00583394 0.00997465 0.00164996 - OK TCONS_00000127 iPS 1 0.00637446 0.00614129 0.0105002 0.00173689 - OK TCONS_00000127 hESC 1 0 0 0 0 - OK TCONS_00000127 hESC 0 0 0 0 0 - OK TCONS_00000127 Fibroblasts 1 0 0 0 0 - OK TCONS_00000127 Fibroblasts 0 8.48314 10.094 8.25186 1.36623 - OK TCONS_00000128 iPS 0 0.00505797 0.00527934 0.00902641 0.00149294 - OK TCONS_00000128 iPS 1 0.00580988 0.00559737 0.00957017 0.00158287 - OK TCONS_00000128 hESC 1 0 0 0 0 - OK TCONS_00000128 hESC 0 0 0 0 0 - OK TCONS_00000128 Fibroblasts 1 0 0 0 0 - OK TCONS_00000128 Fibroblasts 0 0 0 0 0 - OK TCONS_00000129 iPS 0 132.195 137.98 235.914 122.037 - OK TCONS_00000129 iPS 1 172.188 165.89 283.632 146.721 - OK TCONS_00000129 hESC 1 644.582 638.04 421.69 222.463 - OK TCONS_00000129 hESC 0 685.785 692.816 457.892 241.562 - OK TCONS_00000129 Fibroblasts 1 4.94735 4.12806 3.3747 1.75071 - OK TCONS_00000129 Fibroblasts 0 3.92704 4.67274 3.81998 1.98171 - OK TCONS_00000130 iPS 0 0 0 0 0 - OK TCONS_00000130 iPS 1 0 0 0 0 - OK TCONS_00000130 hESC 1 115.911 114.734 75.8295 53.9465 - OK TCONS_00000130 hESC 0 143.532 145.004 95.8353 68.179 - OK TCONS_00000130 Fibroblasts 1 0 0 0 0 - OK TCONS_00000130 Fibroblasts 0 9.01851 10.731 8.77263 6.1018 - OK TCONS_00000131 iPS 0 11.3013 11.7959 20.1682 13.9198 - OK TCONS_00000131 iPS 1 29.2397 28.1702 48.1643 33.2422 - OK TCONS_00000131 hESC 1 175.107 173.329 114.556 81.1706 - OK TCONS_00000131 hESC 0 86.6778 87.5665 57.874 41.0076 - OK TCONS_00000131 Fibroblasts 1 0 0 0 0 - OK TCONS_00000131 Fibroblasts 0 0.0544537 0.0647937 0.052969 0.0366983 - OK TCONS_00000132 iPS 0 4.50409 4.70122 8.03797 9.20262 - OK TCONS_00000132 iPS 1 3.57218 3.44152 5.88417 6.73675 - OK TCONS_00000132 hESC 1 12.2336 12.1094 8.00328 9.57497 - OK TCONS_00000132 hESC 0 17.6599 17.841 11.7914 14.107 - OK TCONS_00000132 Fibroblasts 1 0 0 0 0 - OK TCONS_00000132 Fibroblasts 0 0 0 0 0 - OK TCONS_00000133 iPS 0 0 0 0 0 - OK TCONS_00000133 iPS 1 0 0 0 0 - OK TCONS_00000133 hESC 1 9.16699 9.07395 5.99711 5.31411 - OK TCONS_00000133 hESC 0 13.8453 13.9873 9.24441 8.19158 - OK TCONS_00000133 Fibroblasts 1 0.0526524 0.0439331 0.0359154 0.0309458 - OK TCONS_00000133 Fibroblasts 0 0 0 0 0 - OK TCONS_00000134 iPS 0 598 624.173 1067.19 668.692 - OK TCONS_00000134 iPS 1 405 390.186 667.125 418.016 - OK TCONS_00000134 hESC 1 1231 1218.51 805.328 516.786 - OK TCONS_00000134 hESC 0 1157 1168.86 772.518 495.731 - OK TCONS_00000134 Fibroblasts 1 5969.52 4980.96 4071.95 2560.32 - OK TCONS_00000134 Fibroblasts 0 4509.59 5365.9 4386.64 2758.18 - OK TCONS_00000135 iPS 0 0 0 0 0 - OK TCONS_00000135 iPS 1 0 0 0 0 - OK TCONS_00000135 hESC 1 0 0 0 0 - OK TCONS_00000135 hESC 0 0 0 0 0 - OK TCONS_00000135 Fibroblasts 1 20.4822 17.0903 13.9714 9.53494 - OK TCONS_00000135 Fibroblasts 0 39.4147 46.899 38.3401 26.1657 - OK TCONS_00000136 iPS 0 0.00100719 0.00105127 0.00179742 0.00146415 - OK TCONS_00000136 iPS 1 6.8286 6.57882 11.2482 9.16264 - OK TCONS_00000136 hESC 1 0 0 0 0 - OK TCONS_00000136 hESC 0 0.453447 0.458096 0.302762 0.254416 - OK TCONS_00000136 Fibroblasts 1 0 0 0 0 - OK TCONS_00000136 Fibroblasts 0 3.66354 4.35921 3.56366 2.91602 - OK TCONS_00000137 iPS 0 8.08197 8.43569 14.423 7.61977 - OK TCONS_00000137 iPS 1 0.88761 0.855143 1.46209 0.772431 - OK TCONS_00000137 hESC 1 174.428 172.657 114.112 61.5073 - OK TCONS_00000137 hESC 0 177.891 179.715 118.776 64.0217 - OK TCONS_00000137 Fibroblasts 1 0 0 0 0 - OK TCONS_00000137 Fibroblasts 0 11.3361 13.4887 11.0271 5.84271 - OK TCONS_00000138 iPS 0 1.93893 2.0238 3.46021 3.45294 - OK TCONS_00000138 iPS 1 0 0 0 0 - OK TCONS_00000138 hESC 1 8.38117 8.29611 5.48302 5.68473 - OK TCONS_00000138 hESC 0 7.33782 7.41306 4.8994 5.07964 - OK TCONS_00000138 Fibroblasts 1 0 0 0 0 - OK TCONS_00000138 Fibroblasts 0 0 0 0 0 - OK TCONS_00000139 iPS 0 0 0 0 0 - OK TCONS_00000139 iPS 1 0 0 0 0 - OK TCONS_00000139 hESC 1 0 0 0 0 - OK TCONS_00000139 hESC 0 0 0 0 0 - OK TCONS_00000139 Fibroblasts 1 0 0 0 0 - OK TCONS_00000139 Fibroblasts 0 0 0 0 0 - OK TCONS_00000140 iPS 0 0 0 0 0 - OK TCONS_00000140 iPS 1 0 0 0 0 - OK TCONS_00000140 hESC 1 26.2886 26.0218 17.1982 9.70256 - OK TCONS_00000140 hESC 0 5.31735 5.37187 3.55035 2.00297 - OK TCONS_00000140 Fibroblasts 1 0 0 0 0 - OK TCONS_00000140 Fibroblasts 0 0 0 0 0 - OK TCONS_00000141 iPS 0 0 0 0 0 - OK TCONS_00000141 iPS 1 0 0 0 0 - OK TCONS_00000141 hESC 1 6.77388 6.70513 4.43152 2.55616 - OK TCONS_00000141 hESC 0 0 0 0 0 - OK TCONS_00000141 Fibroblasts 1 0 0 0 0 - OK TCONS_00000141 Fibroblasts 0 0 0 0 0 - OK TCONS_00000142 iPS 0 1.97809 2.06467 3.53009 5.40695 - OK TCONS_00000142 iPS 1 1 0.963422 1.64722 2.52301 - OK TCONS_00000142 hESC 1 1.12877 1.11731 0.738447 1.20016 - OK TCONS_00000142 hESC 0 0 0 0 0 - OK TCONS_00000142 Fibroblasts 1 0 0 0 0 - OK TCONS_00000142 Fibroblasts 0 0 0 0 0 - OK TCONS_00000143 iPS 0 0 0 0 0 - OK TCONS_00000143 iPS 1 0 0 0 0 - OK TCONS_00000143 hESC 1 0 0 0 0 - OK TCONS_00000143 hESC 0 0 0 0 0 - OK TCONS_00000143 Fibroblasts 1 0 0 0 0 - OK TCONS_00000143 Fibroblasts 0 0 0 0 0 - OK TCONS_00000144 iPS 0 0 0 0 0 - OK TCONS_00000144 iPS 1 1.28379 1.23683 2.11469 1.73257 - OK TCONS_00000144 hESC 1 0 0 0 0 - OK TCONS_00000144 hESC 0 0 0 0 0 - OK TCONS_00000144 Fibroblasts 1 2 1.6688 1.36425 1.12281 - OK TCONS_00000144 Fibroblasts 0 0.000312782 0.000372175 0.000304254 0.000250409 - OK TCONS_00000145 iPS 0 0 0 0 0 - OK TCONS_00000145 iPS 1 1 0.963422 1.64722 1.16125 - OK TCONS_00000145 hESC 1 12 11.8782 7.85048 5.68504 - OK TCONS_00000145 hESC 0 1 1.01025 0.667691 0.483518 - OK TCONS_00000145 Fibroblasts 1 0 0 0 0 - OK TCONS_00000145 Fibroblasts 0 1 1.18989 0.972736 0.688434 - OK TCONS_00000146 iPS 0 3 3.1313 5.35378 20.0596 - OK TCONS_00000146 iPS 1 6 5.78053 9.88334 37.0309 - OK TCONS_00000146 hESC 1 37 36.6245 24.2056 105.561 - OK TCONS_00000146 hESC 0 23 23.2358 15.3569 66.9717 - OK TCONS_00000146 Fibroblasts 1 23 19.1912 15.6888 60.0249 - OK TCONS_00000146 Fibroblasts 0 14 16.6584 13.6183 52.1031 - OK TCONS_00000147 iPS 0 0 0 0 0 - OK TCONS_00000147 iPS 1 0 0 0 0 - OK TCONS_00000147 hESC 1 0 0 0 0 - OK TCONS_00000147 hESC 0 0 0 0 0 - OK TCONS_00000147 Fibroblasts 1 15.6777 13.0815 10.6941 25.871 - OK TCONS_00000147 Fibroblasts 0 0 0 0 0 - OK TCONS_00000148 iPS 0 0 0 0 0 - OK TCONS_00000148 iPS 1 0 0 0 0 - OK TCONS_00000148 hESC 1 0 0 0 0 - OK TCONS_00000148 hESC 0 0 0 0 0 - OK TCONS_00000148 Fibroblasts 1 0 0 0 0 - OK TCONS_00000148 Fibroblasts 0 0 0 0 0 - OK TCONS_00000149 iPS 0 0 0 0 0 - OK TCONS_00000149 iPS 1 0 0 0 0 - OK TCONS_00000149 hESC 1 10.0708 9.96863 6.58841 12.6736 - OK TCONS_00000149 hESC 0 0 0 0 0 - OK TCONS_00000149 Fibroblasts 1 0 0 0 0 - OK TCONS_00000149 Fibroblasts 0 0 0 0 0 - OK TCONS_00000150 iPS 0 0 0 0 0 - OK TCONS_00000150 iPS 1 0 0 0 0 - OK TCONS_00000150 hESC 1 0 0 0 0 - OK TCONS_00000150 hESC 0 0 0 0 0 - OK TCONS_00000150 Fibroblasts 1 0 0 0 0 - OK TCONS_00000150 Fibroblasts 0 0 0 0 0 - OK TCONS_00000151 iPS 0 74.1905 77.4376 132.4 65.4957 - OK TCONS_00000151 iPS 1 75 72.2567 123.542 61.1137 - OK TCONS_00000151 hESC 1 192.269 190.317 125.783 63.4016 - OK TCONS_00000151 hESC 0 331.316 334.713 221.217 111.505 - OK TCONS_00000151 Fibroblasts 1 295.071 246.207 201.275 99.8396 - OK TCONS_00000151 Fibroblasts 0 240 285.573 233.457 115.803 - OK TCONS_00000152 iPS 0 15.1065 15.7677 26.959 13.1069 - OK TCONS_00000152 iPS 1 0 0 0 0 - OK TCONS_00000152 hESC 1 0 0 0 0 - OK TCONS_00000152 hESC 0 0.00468633 0.00473438 0.00312902 0.00154959 - OK TCONS_00000152 Fibroblasts 1 0 0 0 0 - OK TCONS_00000152 Fibroblasts 0 0 0 0 0 - OK TCONS_00000153 iPS 0 0 0 0 0 - OK TCONS_00000153 iPS 1 0 0 0 0 - OK TCONS_00000153 hESC 1 0 0 0 0 - OK TCONS_00000153 hESC 0 0 0 0 0 - OK TCONS_00000153 Fibroblasts 1 0 0 0 0 - OK TCONS_00000153 Fibroblasts 0 0 0 0 0 - OK TCONS_00000154 iPS 0 6.68637 6.97902 11.9325 5.65743 - OK TCONS_00000154 iPS 1 0 0 0 0 - OK TCONS_00000154 hESC 1 27.0454 26.7709 17.6933 8.54099 - OK TCONS_00000154 hESC 0 10.5775 10.686 7.06252 3.40925 - OK TCONS_00000154 Fibroblasts 1 0 0 0 0 - OK TCONS_00000154 Fibroblasts 0 0 0 0 0 - OK TCONS_00000155 iPS 0 0 0 0 0 - OK TCONS_00000155 iPS 1 0 0 0 0 - OK TCONS_00000155 hESC 1 0 0 0 0 - OK TCONS_00000155 hESC 0 0 0 0 0 - OK TCONS_00000155 Fibroblasts 1 0 0 0 0 - OK TCONS_00000155 Fibroblasts 0 0 0 0 0 - OK TCONS_00000156 iPS 0 0 0 0 0 - OK TCONS_00000156 iPS 1 0 0 0 0 - OK TCONS_00000156 hESC 1 62.1245 61.4939 40.6422 19.3223 - OK TCONS_00000156 hESC 0 36.6015 36.9768 24.4385 11.6186 - OK TCONS_00000156 Fibroblasts 1 34.9658 29.1754 23.851 11.169 - OK TCONS_00000156 Fibroblasts 0 0 0 0 0 - OK TCONS_00000157 iPS 0 0.0166083 0.0173352 0.029639 0.0143017 - OK TCONS_00000157 iPS 1 0 0 0 0 - OK TCONS_00000157 hESC 1 44.9906 44.534 29.4331 14.4648 - OK TCONS_00000157 hESC 0 0 0 0 0 - OK TCONS_00000157 Fibroblasts 1 0.785353 0.655298 0.535708 0.259186 - OK TCONS_00000157 Fibroblasts 0 0 0 0 0 - OK TCONS_00000158 iPS 0 2.64271 2.75838 4.71617 3.74258 - OK TCONS_00000158 iPS 1 4.6304 4.46103 7.6273 6.05276 - OK TCONS_00000158 hESC 1 0 0 0 0 - OK TCONS_00000158 hESC 0 2.3904 2.41491 1.59605 1.30551 - OK TCONS_00000158 Fibroblasts 1 3.27826 2.73538 2.23618 1.78236 - OK TCONS_00000158 Fibroblasts 0 2.63347 3.13353 2.56167 2.0418 - OK TCONS_00000159 iPS 0 0.357288 0.372925 0.637613 0.811436 - OK TCONS_00000159 iPS 1 0.000127313 0.000122656 0.000209712 0.000266883 - OK TCONS_00000159 hESC 1 14 13.8579 9.15889 12.2413 - OK TCONS_00000159 hESC 0 19.6096 19.8107 13.0931 17.4997 - OK TCONS_00000159 Fibroblasts 1 2.72174 2.27102 1.85656 2.37941 - OK TCONS_00000159 Fibroblasts 0 0.366531 0.436131 0.356538 0.456947 - OK TCONS_00000160 iPS 0 0 0 0 0 - OK TCONS_00000160 iPS 1 1.36947 1.31938 2.25583 3.59534 - OK TCONS_00000160 hESC 1 7 6.92896 4.57945 7.76387 - OK TCONS_00000160 hESC 0 11 11.1128 7.3446 12.4518 - OK TCONS_00000160 Fibroblasts 1 0 0 0 0 - OK TCONS_00000160 Fibroblasts 0 1 1.18989 0.972736 1.56411 - OK TCONS_00000161 iPS 0 0 0 0 0 - OK TCONS_00000161 iPS 1 0 0 0 0 - OK TCONS_00000161 hESC 1 0 0 0 0 - OK TCONS_00000161 hESC 0 0 0 0 0 - OK TCONS_00000161 Fibroblasts 1 0 0 0 0 - OK TCONS_00000161 Fibroblasts 0 0 0 0 0 - OK TCONS_00000162 iPS 0 0 0 0 0 - OK TCONS_00000162 iPS 1 0 0 0 0 - OK TCONS_00000162 hESC 1 0 0 0 0 - OK TCONS_00000162 hESC 0 0 0 0 0 - OK TCONS_00000162 Fibroblasts 1 0 0 0 0 - OK TCONS_00000162 Fibroblasts 0 0 0 0 0 - OK TCONS_00000163 iPS 0 16.9125 17.6527 30.182 22.4406 - OK TCONS_00000163 iPS 1 26.2649 25.3042 43.2642 32.1674 - OK TCONS_00000163 hESC 1 46.0251 45.558 30.1099 23.0308 - OK TCONS_00000163 hESC 0 52.0523 52.586 34.7548 26.5836 - OK TCONS_00000163 Fibroblasts 1 0 0 0 0 - OK TCONS_00000163 Fibroblasts 0 2.34588 2.79133 2.28192 1.70363 - OK TCONS_00000164 iPS 0 37.0875 38.7107 66.1861 33.989 - OK TCONS_00000164 iPS 1 142.735 137.514 235.117 120.741 - OK TCONS_00000164 hESC 1 157.975 156.372 103.348 54.1179 - OK TCONS_00000164 hESC 0 131.948 133.301 88.1003 46.1334 - OK TCONS_00000164 Fibroblasts 1 0 0 0 0 - OK TCONS_00000164 Fibroblasts 0 1.65412 1.96822 1.60902 0.828644 - OK TCONS_00000165 iPS 0 24 25.0504 42.8302 13.5918 - OK TCONS_00000165 iPS 1 117 112.72 192.725 61.1595 - OK TCONS_00000165 hESC 1 102 100.965 66.7291 21.4315 - OK TCONS_00000165 hESC 0 71 71.728 47.4061 15.2255 - OK TCONS_00000165 Fibroblasts 1 0 0 0 0 - OK TCONS_00000165 Fibroblasts 0 1 1.18989 0.972736 0.309231 - OK TCONS_00000166 iPS 0 29.9069 31.2159 53.3717 25.5013 - OK TCONS_00000166 iPS 1 0 0 0 0 - OK TCONS_00000166 hESC 1 82.7346 81.8949 54.1255 26.3344 - OK TCONS_00000166 hESC 0 46.4222 46.8981 30.9957 15.0807 - OK TCONS_00000166 Fibroblasts 1 273.466 228.18 186.538 89.3643 - OK TCONS_00000166 Fibroblasts 0 109.37 130.138 106.388 50.967 - OK TCONS_00000167 iPS 0 1.2931 1.3497 2.30766 1.47006 - OK TCONS_00000167 iPS 1 7.98862 7.69642 13.159 8.38276 - OK TCONS_00000167 hESC 1 39.7217 39.3186 25.9862 16.9602 - OK TCONS_00000167 hESC 0 30.661 30.9754 20.4721 13.3614 - OK TCONS_00000167 Fibroblasts 1 3.6038 3.00701 2.45824 1.57151 - OK TCONS_00000167 Fibroblasts 0 3.59164 4.27364 3.49371 2.23347 - OK TCONS_00000168 iPS 0 0.00149658 0.00156208 0.00267079 0.00125785 - OK TCONS_00000168 iPS 1 3.52124 3.39244 5.80027 2.73172 - OK TCONS_00000168 hESC 1 0 0 0 0 - OK TCONS_00000168 hESC 0 0 0 0 0 - OK TCONS_00000168 Fibroblasts 1 0 0 0 0 - OK TCONS_00000168 Fibroblasts 0 0 0 0 0 - OK TCONS_00000169 iPS 0 42.2764 44.1268 75.4463 36.0364 - OK TCONS_00000169 iPS 1 70.2913 67.7202 115.786 55.3042 - OK TCONS_00000169 hESC 1 309.815 306.67 202.683 98.5801 - OK TCONS_00000169 hESC 0 287.917 290.869 192.239 93.5006 - OK TCONS_00000169 Fibroblasts 1 75.9302 63.3561 51.7938 24.8044 - OK TCONS_00000169 Fibroblasts 0 77.0387 91.6674 74.9384 35.8884 - OK TCONS_00000170 iPS 0 0 0 0 0 - OK TCONS_00000170 iPS 1 9.6599 9.30656 15.912 6.64057 - OK TCONS_00000170 hESC 1 5.93459 5.87436 3.88245 1.64609 - OK TCONS_00000170 hESC 0 0 0 0 0 - OK TCONS_00000170 Fibroblasts 1 0 0 0 0 - OK TCONS_00000170 Fibroblasts 0 0 0 0 0 - OK TCONS_00000171 iPS 0 6.522 6.80745 11.6391 5.05264 - OK TCONS_00000171 iPS 1 0 0 0 0 - OK TCONS_00000171 hESC 1 4.79429 4.74563 3.13645 1.38415 - OK TCONS_00000171 hESC 0 0 0 0 0 - OK TCONS_00000171 Fibroblasts 1 0 0 0 0 - OK TCONS_00000171 Fibroblasts 0 0 0 0 0 - OK TCONS_00000172 iPS 0 0 0 0 0 - OK TCONS_00000172 iPS 1 10.5389 10.1534 17.3599 8.26952 - OK TCONS_00000172 hESC 1 0 0 0 0 - OK TCONS_00000172 hESC 0 0 0 0 0 - OK TCONS_00000172 Fibroblasts 1 0 0 0 0 - OK TCONS_00000172 Fibroblasts 0 0 0 0 0 - OK TCONS_00000173 iPS 0 8.28891 8.6517 14.7923 18.5908 - OK TCONS_00000173 iPS 1 1.33297 1.28422 2.19571 2.75953 - OK TCONS_00000173 hESC 1 20.9199 20.7075 13.6859 18.0531 - OK TCONS_00000173 hESC 0 9.93398 10.0358 6.63283 8.74938 - OK TCONS_00000173 Fibroblasts 1 7.41658 6.18839 5.05903 6.40254 - OK TCONS_00000173 Fibroblasts 0 2.16735 2.5789 2.10826 2.66814 - OK TCONS_00000174 iPS 0 68.1401 71.1224 121.602 45.32 - OK TCONS_00000174 iPS 1 48.9215 47.132 80.5846 30.0331 - OK TCONS_00000174 hESC 1 112.866 111.72 73.8376 27.9095 - OK TCONS_00000174 hESC 0 114.484 115.657 76.4397 28.8931 - OK TCONS_00000174 Fibroblasts 1 158.245 132.04 107.943 40.3122 - OK TCONS_00000174 Fibroblasts 0 80.2224 95.4556 78.0352 29.1429 - OK TCONS_00000175 iPS 0 6.89352 7.19523 12.3021 13.9828 - OK TCONS_00000175 iPS 1 8.66915 8.35206 14.28 16.2309 - OK TCONS_00000175 hESC 1 23.6167 23.377 15.4502 18.3447 - OK TCONS_00000175 hESC 0 20.842 21.0557 13.916 16.5231 - OK TCONS_00000175 Fibroblasts 1 13.6065 11.3532 9.28128 10.6159 - OK TCONS_00000175 Fibroblasts 0 8.05482 9.58433 7.83521 8.96186 - OK TCONS_00000176 iPS 0 11.6774 12.1885 20.8395 23.5164 - OK TCONS_00000176 iPS 1 2.07641 2.00046 3.42031 3.85966 - OK TCONS_00000176 hESC 1 29.5975 29.2971 19.3629 22.818 - OK TCONS_00000176 hESC 0 18.7417 18.9339 12.5137 14.7466 - OK TCONS_00000176 Fibroblasts 1 36.2967 30.286 24.7589 28.1144 - OK TCONS_00000176 Fibroblasts 0 7.56047 8.99611 7.35434 8.35107 - OK TCONS_00000177 iPS 0 23 24.0066 41.0457 53.7339 - OK TCONS_00000177 iPS 1 27 26.0124 44.475 58.2234 - OK TCONS_00000177 hESC 1 167 165.305 109.253 150.428 - OK TCONS_00000177 hESC 0 134 135.374 89.4706 123.19 - OK TCONS_00000177 Fibroblasts 1 8 6.6752 5.45699 7.1959 - OK TCONS_00000177 Fibroblasts 0 1 1.18989 0.972736 1.28271 - OK TCONS_00000178 iPS 0 64 66.8011 114.214 310.974 - OK TCONS_00000178 iPS 1 122 117.538 200.961 547.163 - OK TCONS_00000178 hESC 1 746 738.429 488.038 1480.3 - OK TCONS_00000178 hESC 0 778 785.977 519.464 1575.62 - OK TCONS_00000178 Fibroblasts 1 0 0 0 0 - OK TCONS_00000178 Fibroblasts 0 0 0 0 0 - OK TCONS_00000179 iPS 0 14.1697 14.7899 25.2872 10.6379 - OK TCONS_00000179 iPS 1 7.35392 7.08493 12.1135 5.09595 - OK TCONS_00000179 hESC 1 84.2866 83.4311 55.1408 23.5695 - OK TCONS_00000179 hESC 0 61.7049 62.3376 41.1998 17.6105 - OK TCONS_00000179 Fibroblasts 1 0 0 0 0 - OK TCONS_00000179 Fibroblasts 0 1 1.18989 0.972736 0.410165 - OK TCONS_00000180 iPS 0 5.83028 6.08546 10.4047 8.57926 - OK TCONS_00000180 iPS 1 9.64608 9.29325 15.8893 13.1016 - OK TCONS_00000180 hESC 1 330.713 327.357 216.355 184.103 - OK TCONS_00000180 hESC 0 242.128 244.611 161.667 137.568 - OK TCONS_00000180 Fibroblasts 1 0 0 0 0 - OK TCONS_00000180 Fibroblasts 0 0 0 0 0 - OK TCONS_00000181 iPS 0 0 0 0 0 - OK TCONS_00000181 iPS 1 4.74283e-05 4.56935e-05 7.8125e-05 4.36715e-05 - OK TCONS_00000181 hESC 1 3.32956 3.29577 2.17822 1.24375 - OK TCONS_00000181 hESC 0 0 0 0 0 - OK TCONS_00000181 Fibroblasts 1 0 0 0 0 - OK TCONS_00000181 Fibroblasts 0 3.64792e-05 4.34062e-05 3.54847e-05 1.98972e-05 - OK TCONS_00000182 iPS 0 4 4.17507 7.13837 5.7096 - OK TCONS_00000182 iPS 1 0 0 0 0 - OK TCONS_00000182 hESC 1 0.443143 0.438645 0.289907 0.239069 - OK TCONS_00000182 hESC 0 0 0 0 0 - OK TCONS_00000182 Fibroblasts 1 0 0 0 0 - OK TCONS_00000182 Fibroblasts 0 0 0 0 0 - OK TCONS_00000183 iPS 0 0 0 0 0 - OK TCONS_00000183 iPS 1 0 0 0 0 - OK TCONS_00000183 hESC 1 0.227296 0.22499 0.148699 0.196149 - OK TCONS_00000183 hESC 0 1 1.01025 0.667691 0.880753 - OK TCONS_00000183 Fibroblasts 1 11 9.1784 7.50336 9.49601 - OK TCONS_00000183 Fibroblasts 0 0 0 0 0 - OK TCONS_00000184 iPS 0 0 0 0 0 - OK TCONS_00000184 iPS 1 1.99995 1.9268 3.29437 2.12156 - OK TCONS_00000184 hESC 1 0 0 0 0 - OK TCONS_00000184 hESC 0 0 0 0 0 - OK TCONS_00000184 Fibroblasts 1 0 0 0 0 - OK TCONS_00000184 Fibroblasts 0 2.99996 3.56962 2.91817 1.88599 - OK TCONS_00000185 iPS 0 97.5007 101.768 173.999 117.793 - OK TCONS_00000185 iPS 1 0.015459 0.0148935 0.0254644 0.0172387 - OK TCONS_00000185 hESC 1 57.6191 57.0343 37.6948 26.1846 - OK TCONS_00000185 hESC 0 17.3435 17.5213 11.5801 8.04411 - OK TCONS_00000185 Fibroblasts 1 96.1395 80.2188 65.5791 44.5618 - OK TCONS_00000185 Fibroblasts 0 59.3841 70.6604 57.765 39.252 - OK TCONS_00000186 iPS 0 0 0 0 0 - OK TCONS_00000186 iPS 1 134.989 130.051 222.356 144.978 - OK TCONS_00000186 hESC 1 142.278 140.834 93.0795 62.2135 - OK TCONS_00000186 hESC 0 203.28 205.364 135.728 90.7195 - OK TCONS_00000186 Fibroblasts 1 118.743 99.079 80.9973 53.0018 - OK TCONS_00000186 Fibroblasts 0 68.6325 81.665 66.7613 43.6863 - OK TCONS_00000187 iPS 0 41.3908 43.2024 73.8658 49.8144 - OK TCONS_00000187 iPS 1 0 0 0 0 - OK TCONS_00000187 hESC 1 389.484 385.532 254.803 176.306 - OK TCONS_00000187 hESC 0 276.078 278.909 184.335 127.547 - OK TCONS_00000187 Fibroblasts 1 228.77 190.886 156.049 105.632 - OK TCONS_00000187 Fibroblasts 0 211.104 251.19 205.349 139.003 - OK TCONS_00000188 iPS 0 18.1085 18.901 32.3163 19.7419 - OK TCONS_00000188 iPS 1 26.9959 26.0085 44.4683 27.1656 - OK TCONS_00000188 hESC 1 177.618 175.815 116.199 72.6541 - OK TCONS_00000188 hESC 0 238.299 240.742 159.11 99.4845 - OK TCONS_00000188 Fibroblasts 1 92.3477 77.0549 62.9926 38.6123 - OK TCONS_00000188 Fibroblasts 0 62.8794 74.8194 61.165 37.4921 - OK TCONS_00000189 iPS 0 310 323.568 553.224 223.493 - OK TCONS_00000189 iPS 1 496 477.858 817.023 330.063 - OK TCONS_00000189 hESC 1 2522 2496.4 1649.91 676.812 - OK TCONS_00000189 hESC 0 2395 2419.56 1599.12 655.977 - OK TCONS_00000189 Fibroblasts 1 3100 2586.64 2114.58 856.164 - OK TCONS_00000189 Fibroblasts 0 1712 2037.09 1665.32 674.265 - OK TCONS_00000190 iPS 0 47.0458 49.1048 83.9576 99.3385 - OK TCONS_00000190 iPS 1 18.0188 17.3597 29.6809 35.1184 - OK TCONS_00000190 hESC 1 184.711 182.836 120.839 149.632 - OK TCONS_00000190 hESC 0 136.245 137.642 90.9698 112.645 - OK TCONS_00000190 Fibroblasts 1 503.068 419.759 343.154 408.69 - OK TCONS_00000190 Fibroblasts 0 334.39 397.886 325.273 387.393 - OK TCONS_00000191 iPS 0 10.9542 11.4336 19.5487 25.0811 - OK TCONS_00000191 iPS 1 15.8344 15.2552 26.0828 33.4643 - OK TCONS_00000191 hESC 1 97.4272 96.4384 63.7375 85.9191 - OK TCONS_00000191 hESC 0 103.552 104.614 69.1411 93.2031 - OK TCONS_00000191 Fibroblasts 1 147.202 122.825 100.41 129.745 - OK TCONS_00000191 Fibroblasts 0 98.3015 116.968 95.6214 123.558 - OK TCONS_00000192 iPS 0 5.1296 5.35411 9.15425 6.7215 - OK TCONS_00000192 iPS 1 6.34676 6.11461 10.4545 7.67623 - OK TCONS_00000192 hESC 1 46.9191 46.4429 30.6948 23.1773 - OK TCONS_00000192 hESC 0 33.7029 34.0485 22.5031 16.9919 - OK TCONS_00000192 Fibroblasts 1 18.5677 15.4929 12.6655 9.33748 - OK TCONS_00000192 Fibroblasts 0 60.8505 72.4053 59.1915 43.6382 - OK TCONS_00000193 iPS 0 317.111 330.99 565.914 1443.58 - OK TCONS_00000193 iPS 1 247.677 238.618 407.98 1040.71 - OK TCONS_00000193 hESC 1 744.557 737.001 487.094 1374.3 - OK TCONS_00000193 hESC 0 880.754 889.784 588.071 1659.2 - OK TCONS_00000193 Fibroblasts 1 1926.03 1607.08 1313.79 3399.2 - OK TCONS_00000193 Fibroblasts 0 1101.45 1310.6 1071.42 2772.12 - OK TCONS_00000194 iPS 0 17.7728 18.5506 31.7172 5.42281 - OK TCONS_00000194 iPS 1 14.5446 14.0126 23.9582 4.09623 - OK TCONS_00000194 hESC 1 86.8626 85.981 56.8261 9.77862 - OK TCONS_00000194 hESC 0 60.2778 60.8959 40.247 6.92569 - OK TCONS_00000194 Fibroblasts 1 44.6273 37.237 30.4413 5.20959 - OK TCONS_00000194 Fibroblasts 0 11.8059 14.0477 11.484 1.96532 - OK TCONS_00000195 iPS 0 25.043 26.1391 44.6916 12.0427 - OK TCONS_00000195 iPS 1 12.6184 12.1568 20.7853 5.60088 - OK TCONS_00000195 hESC 1 160.58 158.95 105.053 28.5975 - OK TCONS_00000195 hESC 0 131.802 133.153 88.0028 23.9562 - OK TCONS_00000195 Fibroblasts 1 0 0 0 0 - OK TCONS_00000195 Fibroblasts 0 0.0113055 0.0134523 0.0109973 0.00296778 - OK TCONS_00000196 iPS 0 0 0 0 0 - OK TCONS_00000196 iPS 1 0 0 0 0 - OK TCONS_00000196 hESC 1 0 0 0 0 - OK TCONS_00000196 hESC 0 0 0 0 0 - OK TCONS_00000196 Fibroblasts 1 15.8422 13.2187 10.8063 3.06783 - OK TCONS_00000196 Fibroblasts 0 0 0 0 0 - OK TCONS_00000197 iPS 0 0.573278 0.598369 1.02307 0.379687 - OK TCONS_00000197 iPS 1 5.15981 4.97108 8.49937 3.15433 - OK TCONS_00000197 hESC 1 0 0 0 0 - OK TCONS_00000197 hESC 0 0 0 0 0 - OK TCONS_00000197 Fibroblasts 1 0 0 0 0 - OK TCONS_00000197 Fibroblasts 0 4.56349 5.43004 4.43907 1.65084 - OK TCONS_00000198 iPS 0 1712 1786.93 3055.22 2122.13 - OK TCONS_00000198 iPS 1 749 721.603 1233.77 856.964 - OK TCONS_00000198 hESC 1 1147 1135.36 750.375 535.176 - OK TCONS_00000198 hESC 0 1022 1032.48 682.38 486.681 - OK TCONS_00000198 Fibroblasts 1 16345 13638.3 11149.3 7774.02 - OK TCONS_00000198 Fibroblasts 0 9280 11042.2 9026.99 6294.2 - OK TCONS_00000199 iPS 0 39.339 41.0608 70.2042 73.2609 - OK TCONS_00000199 iPS 1 21.5691 20.7802 35.5292 37.0761 - OK TCONS_00000199 hESC 1 14.2138 14.0696 9.29878 10.0998 - OK TCONS_00000199 hESC 0 6.65221 6.72042 4.44162 4.82425 - OK TCONS_00000199 Fibroblasts 1 83.9141 70.0179 57.2398 60.0782 - OK TCONS_00000199 Fibroblasts 0 5.79849 6.89955 5.6404 5.9201 - OK TCONS_00000200 iPS 0 0 0 0 0 - OK TCONS_00000200 iPS 1 24.7916 23.8848 40.8374 17.2102 - OK TCONS_00000200 hESC 1 0 0 0 0 - OK TCONS_00000200 hESC 0 24.1556 24.4033 16.1285 6.9065 - OK TCONS_00000200 Fibroblasts 1 52.5226 43.8248 35.8269 15.1339 - OK TCONS_00000200 Fibroblasts 0 48.0223 57.1412 46.713 19.7324 - OK TCONS_00000201 iPS 0 81.7948 85.3747 145.97 63.6012 - OK TCONS_00000201 iPS 1 0.00711202 0.00685188 0.0117151 0.00510442 - OK TCONS_00000201 hESC 1 221.771 219.52 145.084 64.2675 - OK TCONS_00000201 hESC 0 84.8218 85.6915 56.6347 25.0874 - OK TCONS_00000201 Fibroblasts 1 0 0 0 0 - OK TCONS_00000201 Fibroblasts 0 0 0 0 0 - OK TCONS_00000202 iPS 0 84.865 88.5793 151.449 35.2154 - OK TCONS_00000202 iPS 1 129.434 124.699 213.206 49.5752 - OK TCONS_00000202 hESC 1 51.4181 50.8962 33.6381 7.89057 - OK TCONS_00000202 hESC 0 53.5377 54.0866 35.7466 8.38518 - OK TCONS_00000202 Fibroblasts 1 625.794 522.162 426.869 99.3841 - OK TCONS_00000202 Fibroblasts 0 253.404 301.523 246.495 57.3894 - OK TCONS_00000203 iPS 0 468.555 489.062 836.18 193.571 - OK TCONS_00000203 iPS 1 228.198 219.852 375.894 87.0175 - OK TCONS_00000203 hESC 1 437.861 433.417 286.451 66.8942 - OK TCONS_00000203 hESC 0 253.833 256.435 169.482 39.5786 - OK TCONS_00000203 Fibroblasts 1 1989.1 1659.71 1356.81 314.497 - OK TCONS_00000203 Fibroblasts 0 583.775 694.627 567.859 131.625 - OK TCONS_00000204 iPS 0 64.4462 67.2668 115.01 26.374 - OK TCONS_00000204 iPS 1 0 0 0 0 - OK TCONS_00000204 hESC 1 28.7365 28.4448 18.7996 4.34858 - OK TCONS_00000204 hESC 0 0 0 0 0 - OK TCONS_00000204 Fibroblasts 1 101.668 84.832 69.3504 15.9235 - OK TCONS_00000204 Fibroblasts 0 0 0 0 0 - OK TCONS_00000205 iPS 0 24.3374 25.4026 43.4324 46.9514 - OK TCONS_00000205 iPS 1 38.2763 36.8762 63.0495 68.158 - OK TCONS_00000205 hESC 1 33.678 33.3362 22.0324 24.8263 - OK TCONS_00000205 hESC 0 41.0261 41.4467 27.3927 30.8664 - OK TCONS_00000205 Fibroblasts 1 17.3557 14.4816 11.8388 12.8748 - OK TCONS_00000205 Fibroblasts 0 19.7284 23.4746 19.1906 20.87 - OK TCONS_00000206 iPS 0 1351.27 1410.41 2411.46 4643.95 - OK TCONS_00000206 iPS 1 981.077 945.192 1616.05 3112.17 - OK TCONS_00000206 hESC 1 4437.26 4392.22 2902.88 6026.58 - OK TCONS_00000206 hESC 0 4728.36 4776.84 3157.08 6554.32 - OK TCONS_00000206 Fibroblasts 1 8401.78 7010.44 5731.05 11155.4 - OK TCONS_00000206 Fibroblasts 0 7624.42 9072.2 7416.55 14436.2 - OK TCONS_00000207 iPS 0 8.43351 8.80262 15.0504 31.5618 - OK TCONS_00000207 iPS 1 10.6454 10.256 17.5353 36.7729 - OK TCONS_00000207 hESC 1 33.7845 33.4416 22.102 50.3161 - OK TCONS_00000207 hESC 0 19.2458 19.4431 12.8502 29.254 - OK TCONS_00000207 Fibroblasts 1 204.562 170.686 139.536 296.047 - OK TCONS_00000207 Fibroblasts 0 146.177 173.935 142.192 301.681 - OK TCONS_00000208 iPS 0 181.156 189.085 323.29 577.024 - OK TCONS_00000208 iPS 1 232.077 223.588 382.283 682.317 - OK TCONS_00000208 hESC 1 1971.79 1951.77 1289.96 2467.95 - OK TCONS_00000208 hESC 0 1917.37 1937.03 1280.21 2449.31 - OK TCONS_00000208 Fibroblasts 1 7098.2 5922.74 4841.85 8727.99 - OK TCONS_00000208 Fibroblasts 0 4203.19 5001.33 4088.6 7370.16 - OK TCONS_00000209 iPS 0 13.8069 14.4112 24.6397 16.1697 - OK TCONS_00000209 iPS 1 32.924 31.7197 54.2332 35.5902 - OK TCONS_00000209 hESC 1 26.4933 26.2244 17.3321 11.6617 - OK TCONS_00000209 hESC 0 38.9966 39.3964 26.0377 17.5192 - OK TCONS_00000209 Fibroblasts 1 20.1052 16.7758 13.7143 9.03264 - OK TCONS_00000209 Fibroblasts 0 8.81925 10.4939 8.57881 5.65026 - OK TCONS_00000210 iPS 0 0 0 0 0 - OK TCONS_00000210 iPS 1 3.43456 3.30893 5.65749 3.58464 - OK TCONS_00000210 hESC 1 69.4714 68.7663 45.4486 29.4993 - OK TCONS_00000210 hESC 0 71.0395 71.7679 47.4324 30.7869 - OK TCONS_00000210 Fibroblasts 1 386.773 322.723 263.827 167.75 - OK TCONS_00000210 Fibroblasts 0 186.297 221.672 181.218 115.224 - OK TCONS_00000211 iPS 0 6 6.2626 10.7076 9.53485 - OK TCONS_00000211 iPS 1 6.56544 6.32529 10.8147 9.6303 - OK TCONS_00000211 hESC 1 19.5286 19.3304 12.7757 11.7705 - OK TCONS_00000211 hESC 0 13.9605 14.1036 9.3213 8.58788 - OK TCONS_00000211 Fibroblasts 1 101.227 84.4641 69.0496 61.791 - OK TCONS_00000211 Fibroblasts 0 86.7033 103.167 84.3394 75.4735 - OK TCONS_00000212 iPS 0 0 0 0 0 - OK TCONS_00000212 iPS 1 0 0 0 0 - OK TCONS_00000212 hESC 1 0 0 0 0 - OK TCONS_00000212 hESC 0 0 0 0 0 - OK TCONS_00000212 Fibroblasts 1 0 0 0 0 - OK TCONS_00000212 Fibroblasts 0 0 0 0 0 - OK TCONS_00000213 iPS 0 0 0 0 0 - OK TCONS_00000213 iPS 1 0 0 0 0 - OK TCONS_00000213 hESC 1 0 0 0 0 - OK TCONS_00000213 hESC 0 0 0 0 0 - OK TCONS_00000213 Fibroblasts 1 0 0 0 0 - OK TCONS_00000213 Fibroblasts 0 0 0 0 0 - OK TCONS_00000214 iPS 0 633 660.705 1129.65 178.631 - OK TCONS_00000214 iPS 1 367 353.576 604.531 95.5945 - OK TCONS_00000214 hESC 1 1007 996.78 658.786 104.797 - OK TCONS_00000214 hESC 0 772 779.916 515.457 81.9967 - OK TCONS_00000214 Fibroblasts 1 11318 9443.73 7720.28 1221.87 - OK TCONS_00000214 Fibroblasts 0 6482 7712.85 6305.28 997.925 - OK TCONS_00000215 iPS 0 76.0205 79.3477 135.666 65.1076 - OK TCONS_00000215 iPS 1 95.0359 91.5597 156.545 75.128 - OK TCONS_00000215 hESC 1 38.5535 38.1622 25.222 12.3267 - OK TCONS_00000215 hESC 0 75.4218 76.1951 50.3584 24.6116 - OK TCONS_00000215 Fibroblasts 1 326.723 272.617 222.865 107.24 - OK TCONS_00000215 Fibroblasts 0 631.052 750.881 613.847 295.375 - OK TCONS_00000216 iPS 0 31.9795 33.3791 57.0704 28.8986 - OK TCONS_00000216 iPS 1 6.96411 6.70938 11.4715 5.80878 - OK TCONS_00000216 hESC 1 246.447 243.945 161.227 83.2243 - OK TCONS_00000216 hESC 0 157.578 159.194 105.214 54.3105 - OK TCONS_00000216 Fibroblasts 1 1919.28 1601.44 1309.18 664.788 - OK TCONS_00000216 Fibroblasts 0 1368.95 1628.89 1331.63 676.183 - OK TCONS_00000217 iPS 0 93 97.0703 165.967 181.635 - OK TCONS_00000217 iPS 1 138 132.952 227.317 248.776 - OK TCONS_00000217 hESC 1 337.665 334.238 220.902 252.129 - OK TCONS_00000217 hESC 0 234.255 236.657 156.41 178.52 - OK TCONS_00000217 Fibroblasts 1 238 198.587 162.345 178.752 - OK TCONS_00000217 Fibroblasts 0 311.564 370.726 303.07 333.697 - OK TCONS_00000218 iPS 0 0 0 0 0 - OK TCONS_00000218 iPS 1 0 0 0 0 - OK TCONS_00000218 hESC 1 17.3354 17.1595 11.3409 12.1962 - OK TCONS_00000218 hESC 0 40.7448 41.1626 27.205 29.2565 - OK TCONS_00000218 Fibroblasts 1 0 0 0 0 - OK TCONS_00000218 Fibroblasts 0 15.436 18.3671 15.0152 15.6092 - OK TCONS_00000219 iPS 0 81.4277 84.9915 145.315 55.8497 - OK TCONS_00000219 iPS 1 126.579 121.949 208.503 80.1351 - OK TCONS_00000219 hESC 1 678.345 671.46 443.778 173.059 - OK TCONS_00000219 hESC 0 665.819 672.645 444.561 173.365 - OK TCONS_00000219 Fibroblasts 1 595.304 496.721 406.071 156.399 - OK TCONS_00000219 Fibroblasts 0 951.131 1131.74 925.199 356.342 - OK TCONS_00000220 iPS 0 79.5723 83.055 142.004 56.3059 - OK TCONS_00000220 iPS 1 80.4214 77.4797 132.472 52.5262 - OK TCONS_00000220 hESC 1 932.155 922.695 609.822 245.458 - OK TCONS_00000220 hESC 0 819.681 828.086 547.294 220.29 - OK TCONS_00000220 Fibroblasts 1 234.696 195.83 160.092 63.6171 - OK TCONS_00000220 Fibroblasts 0 214.869 255.671 209.011 83.0566 - OK TCONS_00000221 iPS 0 110.753 115.6 197.648 53.3301 - OK TCONS_00000221 iPS 1 65.2254 62.8396 107.441 28.99 - OK TCONS_00000221 hESC 1 1396.37 1382.2 913.514 249.013 - OK TCONS_00000221 hESC 0 1468.64 1483.7 980.599 267.299 - OK TCONS_00000221 Fibroblasts 1 258.98 216.093 176.657 47.7372 - OK TCONS_00000221 Fibroblasts 0 150.739 179.363 146.63 39.6231 - OK TCONS_00000222 iPS 0 252.41 263.457 450.449 123.282 - OK TCONS_00000222 iPS 1 316.532 304.954 521.399 142.7 - OK TCONS_00000222 hESC 1 1004.86 994.664 657.388 181.788 - OK TCONS_00000222 hESC 0 753.209 760.931 502.911 139.07 - OK TCONS_00000222 Fibroblasts 1 580.628 484.476 396.06 108.56 - OK TCONS_00000222 Fibroblasts 0 416.003 494.997 404.661 110.918 - OK TCONS_00000223 iPS 0 64.8376 67.6753 115.709 30.7979 - OK TCONS_00000223 iPS 1 11.2425 10.8313 18.519 4.92915 - OK TCONS_00000223 hESC 1 163.794 162.131 107.155 28.8094 - OK TCONS_00000223 hESC 0 128.16 129.474 85.5712 23.0065 - OK TCONS_00000223 Fibroblasts 1 151.504 126.415 103.344 27.5474 - OK TCONS_00000223 Fibroblasts 0 62.3362 74.1731 60.6367 16.1633 - OK TCONS_00000224 iPS 0 134 139.865 239.136 93.6381 - OK TCONS_00000224 iPS 1 45 43.354 74.1251 29.0251 - OK TCONS_00000224 hESC 1 151 149.467 98.7852 39.2591 - OK TCONS_00000224 hESC 0 152 153.558 101.489 40.3336 - OK TCONS_00000224 Fibroblasts 1 1306 1089.73 890.854 349.587 - OK TCONS_00000224 Fibroblasts 0 749 891.226 728.579 285.907 - OK TCONS_00000225 iPS 0 16 16.7003 28.5535 83.0164 - OK TCONS_00000225 iPS 1 30 28.9027 49.4167 143.674 - OK TCONS_00000225 hESC 1 124 122.742 81.1216 264.792 - OK TCONS_00000225 hESC 0 106 107.087 70.7752 231.02 - OK TCONS_00000225 Fibroblasts 1 9 7.5096 6.13911 18.1401 - OK TCONS_00000225 Fibroblasts 0 7 8.32921 6.80915 20.1199 - OK TCONS_00000226 iPS 0 0 0 0 0 - OK TCONS_00000226 iPS 1 0 0 0 0 - OK TCONS_00000226 hESC 1 0 0 0 0 - OK TCONS_00000226 hESC 0 0 0 0 0 - OK TCONS_00000226 Fibroblasts 1 0 0 0 0 - OK TCONS_00000226 Fibroblasts 0 0 0 0 0 - OK TCONS_00000227 iPS 0 1072.8 1119.75 1914.5 506.435 - OK TCONS_00000227 iPS 1 1202.55 1158.56 1980.87 523.989 - OK TCONS_00000227 hESC 1 6175.62 6112.94 4040.13 1079.45 - OK TCONS_00000227 hESC 0 6379.14 6444.54 4259.29 1138.01 - OK TCONS_00000227 Fibroblasts 1 6573.81 5485.19 4484.15 1187.91 - OK TCONS_00000227 Fibroblasts 0 4024.6 4788.82 3914.87 1037.1 - OK TCONS_00000228 iPS 0 36.2656 37.8529 64.7194 15.9646 - OK TCONS_00000228 iPS 1 36.8323 35.4851 60.671 14.9659 - OK TCONS_00000228 hESC 1 103.016 101.97 67.3935 16.7798 - OK TCONS_00000228 hESC 0 142.917 144.382 95.4244 23.759 - OK TCONS_00000228 Fibroblasts 1 231.563 193.216 157.954 39.0163 - OK TCONS_00000228 Fibroblasts 0 170.352 202.699 165.707 40.9313 - OK TCONS_00000229 iPS 0 0 0 0 0 - OK TCONS_00000229 iPS 1 0 0 0 0 - OK TCONS_00000229 hESC 1 0 0 0 0 - OK TCONS_00000229 hESC 0 0 0 0 0 - OK TCONS_00000229 Fibroblasts 1 129.468 108.028 88.3131 23.2515 - OK TCONS_00000229 Fibroblasts 0 0 0 0 0 - OK TCONS_00000230 iPS 0 0 0 0 0 - OK TCONS_00000230 iPS 1 0 0 0 0 - OK TCONS_00000230 hESC 1 27.3659 27.0882 17.903 4.88956 - OK TCONS_00000230 hESC 0 23.2912 23.53 15.5513 4.24728 - OK TCONS_00000230 Fibroblasts 1 0 0 0 0 - OK TCONS_00000230 Fibroblasts 0 0 0 0 0 - OK TCONS_00000231 iPS 0 34.6885 36.2067 61.9049 100.939 - OK TCONS_00000231 iPS 1 88.119 84.8958 145.152 236.676 - OK TCONS_00000231 hESC 1 0 0 0 0 - OK TCONS_00000231 hESC 0 18.7304 18.9224 12.5061 21.7232 - OK TCONS_00000231 Fibroblasts 1 78.0099 65.0914 53.2124 87.5535 - OK TCONS_00000231 Fibroblasts 0 33.5142 39.8782 32.6005 53.6395 - OK TCONS_00000232 iPS 0 10.2501 10.6987 18.2922 13.8332 - OK TCONS_00000232 iPS 1 0 0 0 0 - OK TCONS_00000232 hESC 1 0 0 0 0 - OK TCONS_00000232 hESC 0 39.9233 40.3326 26.6564 20.7482 - OK TCONS_00000232 Fibroblasts 1 277.148 231.252 189.049 143.564 - OK TCONS_00000232 Fibroblasts 0 357.534 425.425 347.786 264.109 - OK TCONS_00000233 iPS 0 3.69071 3.85224 6.58641 6.62397 - OK TCONS_00000233 iPS 1 0 0 0 0 - OK TCONS_00000233 hESC 1 6.96381 6.89313 4.55577 4.76177 - OK TCONS_00000233 hESC 0 0 0 0 0 - OK TCONS_00000233 Fibroblasts 1 11.5985 9.67774 7.91158 8.00113 - OK TCONS_00000233 Fibroblasts 0 0 0 0 0 - OK TCONS_00000234 iPS 0 1325.16 1383.16 2364.87 446.358 - OK TCONS_00000234 iPS 1 1256.83 1210.86 2070.28 390.755 - OK TCONS_00000234 hESC 1 1629.49 1612.95 1066.02 202.645 - OK TCONS_00000234 hESC 0 1514.91 1530.45 1011.49 192.279 - OK TCONS_00000234 Fibroblasts 1 7863.85 6561.59 5364.12 1013.51 - OK TCONS_00000234 Fibroblasts 0 3869.42 4604.18 3763.93 711.164 - OK TCONS_00000235 iPS 0 1439.78 1502.79 2569.42 349.093 - OK TCONS_00000235 iPS 1 2114.79 2037.44 3483.54 473.289 - OK TCONS_00000235 hESC 1 3648.9 3611.86 2387.13 325.991 - OK TCONS_00000235 hESC 0 4056.62 4098.21 2708.57 369.887 - OK TCONS_00000235 Fibroblasts 1 1434.41 1196.87 978.442 133.035 - OK TCONS_00000235 Fibroblasts 0 1026.71 1221.67 998.718 135.792 - OK TCONS_00000236 iPS 0 0 0 0 0 - OK TCONS_00000236 iPS 1 0 0 0 0 - OK TCONS_00000236 hESC 1 0 0 0 0 - OK TCONS_00000236 hESC 0 23.6385 23.8809 15.7832 2.13723 - OK TCONS_00000236 Fibroblasts 1 373.562 311.7 254.816 34.3558 - OK TCONS_00000236 Fibroblasts 0 0 0 0 0 - OK TCONS_00000237 iPS 0 0 0 0 0 - OK TCONS_00000237 iPS 1 0 0 0 0 - OK TCONS_00000237 hESC 1 0 0 0 0 - OK TCONS_00000237 hESC 0 52.3787 52.9157 34.9728 5.85708 - OK TCONS_00000237 Fibroblasts 1 0 0 0 0 - OK TCONS_00000237 Fibroblasts 0 0 0 0 0 - OK TCONS_00000238 iPS 0 0 0 0 0 - OK TCONS_00000238 iPS 1 0 0 0 0 - OK TCONS_00000238 hESC 1 0 0 0 0 - OK TCONS_00000238 hESC 0 0 0 0 0 - OK TCONS_00000238 Fibroblasts 1 0 0 0 0 - OK TCONS_00000238 Fibroblasts 0 0 0 0 0 - OK TCONS_00000239 iPS 0 0 0 0 0 - OK TCONS_00000239 iPS 1 0 0 0 0 - OK TCONS_00000239 hESC 1 0 0 0 0 - OK TCONS_00000239 hESC 0 0 0 0 0 - OK TCONS_00000239 Fibroblasts 1 0 0 0 0 - OK TCONS_00000239 Fibroblasts 0 0 0 0 0 - OK TCONS_00000240 iPS 0 260.373 271.768 464.659 77.006 - OK TCONS_00000240 iPS 1 276.377 266.268 455.255 75.4475 - OK TCONS_00000240 hESC 1 781.646 773.713 511.358 85.2765 - OK TCONS_00000240 hESC 0 815.45 823.811 544.469 90.7981 - OK TCONS_00000240 Fibroblasts 1 237.084 197.823 161.721 26.8258 - OK TCONS_00000240 Fibroblasts 0 149.868 178.327 145.782 24.182 - OK TCONS_00000241 iPS 0 925.941 966.467 1652.43 1321.69 - OK TCONS_00000241 iPS 1 1012.76 975.713 1668.24 1334.33 - OK TCONS_00000241 hESC 1 12578.2 12450.5 8228.74 6785.75 - OK TCONS_00000241 hESC 0 12746.9 12877.6 8511 7018.51 - OK TCONS_00000241 Fibroblasts 1 18343 15305.4 12512.2 10052.2 - OK TCONS_00000241 Fibroblasts 0 21425.6 25494.1 20841.5 16743.9 - OK TCONS_00000242 iPS 0 0 0 0 0 - OK TCONS_00000242 iPS 1 0 0 0 0 - OK TCONS_00000242 hESC 1 0 0 0 0 - OK TCONS_00000242 hESC 0 0 0 0 0 - OK TCONS_00000242 Fibroblasts 1 0 0 0 0 - OK TCONS_00000242 Fibroblasts 0 0 0 0 0 - OK TCONS_00000243 iPS 0 61.0587 63.731 108.965 90.5338 - OK TCONS_00000243 iPS 1 43.8953 42.2897 72.3054 60.0752 - OK TCONS_00000243 hESC 1 608.448 602.273 398.051 341.384 - OK TCONS_00000243 hESC 0 841.091 849.715 561.589 481.64 - OK TCONS_00000243 Fibroblasts 1 548.124 457.355 373.889 312.078 - OK TCONS_00000243 Fibroblasts 0 767.903 913.718 746.967 623.48 - OK TCONS_00000244 iPS 0 0 0 0 0 - OK TCONS_00000244 iPS 1 8.34728 8.04195 13.7498 10.3263 - OK TCONS_00000244 hESC 1 9.36061 9.26561 6.12377 4.73263 - OK TCONS_00000244 hESC 0 0 0 0 0 - OK TCONS_00000244 Fibroblasts 1 8.39479 7.00461 5.72629 4.31842 - OK TCONS_00000244 Fibroblasts 0 7.46912 8.88741 7.26548 5.47918 - OK TCONS_00000245 iPS 0 16.7858 17.5205 29.9559 39.6935 - OK TCONS_00000245 iPS 1 42.3081 40.7606 69.6909 92.3451 - OK TCONS_00000245 hESC 1 82.0165 81.1841 53.6558 74.8244 - OK TCONS_00000245 hESC 0 106.801 107.896 71.3098 99.4435 - OK TCONS_00000245 Fibroblasts 1 45.7886 38.206 31.2335 41.6915 - OK TCONS_00000245 Fibroblasts 0 120.873 143.825 117.578 156.946 - OK TCONS_00000246 iPS 0 0 0 0 0 - OK TCONS_00000246 iPS 1 4.0777 3.92855 6.71688 7.31138 - OK TCONS_00000246 hESC 1 0 0 0 0 - OK TCONS_00000246 hESC 0 0 0 0 0 - OK TCONS_00000246 Fibroblasts 1 25.0387 20.8923 17.0795 18.7036 - OK TCONS_00000246 Fibroblasts 0 22.7135 27.0265 22.0942 24.1952 - OK TCONS_00000247 iPS 0 10.291 10.7415 18.3653 21.0775 - OK TCONS_00000247 iPS 1 0 0 0 0 - OK TCONS_00000247 hESC 1 9.26177 9.16777 6.05911 7.26745 - OK TCONS_00000247 hESC 0 14.6806 14.8311 9.80209 11.7569 - OK TCONS_00000247 Fibroblasts 1 0.0159719 0.0133269 0.0108948 0.0125835 - OK TCONS_00000247 Fibroblasts 0 4.2711 5.08212 4.15465 4.79862 - OK TCONS_00000248 iPS 0 106.64 111.308 190.31 213.733 - OK TCONS_00000248 iPS 1 68.4561 65.9521 112.762 126.641 - OK TCONS_00000248 hESC 1 193.766 191.799 126.763 148.64 - OK TCONS_00000248 hESC 0 173.706 175.487 115.982 135.998 - OK TCONS_00000248 Fibroblasts 1 636.642 531.214 434.269 490.761 - OK TCONS_00000248 Fibroblasts 0 498.66 593.35 485.065 548.165 - OK TCONS_00000249 iPS 0 12.2827 12.8203 21.9197 30.5023 - OK TCONS_00000249 iPS 1 14.1581 13.6403 23.3216 32.4531 - OK TCONS_00000249 hESC 1 33.9557 33.6111 22.214 32.618 - OK TCONS_00000249 hESC 0 24.8128 25.0672 16.5673 24.3266 - OK TCONS_00000249 Fibroblasts 1 19.5146 16.283 13.3114 18.6668 - OK TCONS_00000249 Fibroblasts 0 5.48206 6.52303 5.3326 7.47801 - OK TCONS_00000250 iPS 0 3 3.1313 5.35378 24.5088 - OK TCONS_00000250 iPS 1 0 0 0 0 - OK TCONS_00000250 hESC 1 7.98908 7.908 5.22651 83.5415 - OK TCONS_00000250 hESC 0 9.28327 9.37845 6.19835 99.0756 - OK TCONS_00000250 Fibroblasts 1 60.6084 50.5716 41.3424 437.229 - OK TCONS_00000250 Fibroblasts 0 48.9657 58.2637 47.6307 503.733 - OK TCONS_00000251 iPS 0 8 8.35014 14.2767 20.9378 - OK TCONS_00000251 iPS 1 16.0001 15.4148 26.3557 38.6523 - OK TCONS_00000251 hESC 1 8.15694 8.07416 5.33633 8.28269 - OK TCONS_00000251 hESC 0 5.06414 5.11606 3.38128 5.2482 - OK TCONS_00000251 Fibroblasts 1 14.6492 12.2233 9.99258 14.7744 - OK TCONS_00000251 Fibroblasts 0 16.6816 19.8493 16.2268 23.992 - OK TCONS_00000252 iPS 0 4.97308 5.19074 8.87493 13.1108 - OK TCONS_00000252 iPS 1 7.01916 6.76242 11.5621 17.0806 - OK TCONS_00000252 hESC 1 5.95597 5.89552 3.89644 6.0946 - OK TCONS_00000252 hESC 0 8.34769 8.43328 5.57368 8.71805 - OK TCONS_00000252 Fibroblasts 1 4.7624 3.97375 3.24855 4.83851 - OK TCONS_00000252 Fibroblasts 0 1.62697 1.93591 1.58261 2.3572 - OK TCONS_00000253 iPS 0 132.784 138.596 236.966 190.831 - OK TCONS_00000253 iPS 1 106.981 103.068 176.221 141.913 - OK TCONS_00000253 hESC 1 1106.4 1095.17 723.813 601.09 - OK TCONS_00000253 hESC 0 1110.51 1121.9 741.48 615.762 - OK TCONS_00000253 Fibroblasts 1 1501.33 1252.71 1024.09 828.397 - OK TCONS_00000253 Fibroblasts 0 1545.05 1838.43 1502.92 1215.73 - OK TCONS_00000254 iPS 0 0 0 0 0 - OK TCONS_00000254 iPS 1 0 0 0 0 - OK TCONS_00000254 hESC 1 0 0 0 0 - OK TCONS_00000254 hESC 0 0 0 0 0 - OK TCONS_00000254 Fibroblasts 1 0 0 0 0 - OK TCONS_00000254 Fibroblasts 0 0 0 0 0 - OK TCONS_00000255 iPS 0 0 0 0 0 - OK TCONS_00000255 iPS 1 0 0 0 0 - OK TCONS_00000255 hESC 1 0 0 0 0 - OK TCONS_00000255 hESC 0 0 0 0 0 - OK TCONS_00000255 Fibroblasts 1 0 0 0 0 - OK TCONS_00000255 Fibroblasts 0 0 0 0 0 - OK TCONS_00000256 iPS 0 10.2425 10.6908 18.2787 15.8867 - OK TCONS_00000256 iPS 1 0 0 0 0 - OK TCONS_00000256 hESC 1 0 0 0 0 - OK TCONS_00000256 hESC 0 5.79057 5.84994 3.86631 3.47386 - OK TCONS_00000256 Fibroblasts 1 135.65 113.186 92.5298 80.8092 - OK TCONS_00000256 Fibroblasts 0 35.6783 42.4532 34.7056 30.3095 - OK TCONS_00000257 iPS 0 0 0 0 0 - OK TCONS_00000257 iPS 1 0 0 0 0 - OK TCONS_00000257 hESC 1 0 0 0 0 - OK TCONS_00000257 hESC 0 0 0 0 0 - OK TCONS_00000257 Fibroblasts 1 0 0 0 0 - OK TCONS_00000257 Fibroblasts 0 0 0 0 0 - OK TCONS_00000258 iPS 0 3071.26 3205.68 5480.96 1915.05 - OK TCONS_00000258 iPS 1 3219.39 3101.63 5303.05 1852.88 - OK TCONS_00000258 hESC 1 8537 8450.36 5584.96 1977.36 - OK TCONS_00000258 hESC 0 11870.5 11992.2 7925.84 2806.14 - OK TCONS_00000258 Fibroblasts 1 10008 8350.67 6826.7 2389.86 - OK TCONS_00000258 Fibroblasts 0 9042 10759 8795.48 3079.08 - OK TCONS_00000259 iPS 0 52.7366 55.0447 94.1134 34.2715 - OK TCONS_00000259 iPS 1 42.6127 41.054 70.1927 25.5607 - OK TCONS_00000259 hESC 1 0 0 0 0 - OK TCONS_00000259 hESC 0 202.484 204.56 135.197 49.9152 - OK TCONS_00000259 Fibroblasts 1 0 0 0 0 - OK TCONS_00000259 Fibroblasts 0 0 0 0 0 - OK TCONS_00000260 iPS 0 21 21.9191 37.4765 25.6157 - OK TCONS_00000260 iPS 1 22 21.1953 36.2389 24.7698 - OK TCONS_00000260 hESC 1 2 1.9797 1.30841 0.917903 - OK TCONS_00000260 hESC 0 2 2.02051 1.33538 0.936822 - OK TCONS_00000260 Fibroblasts 1 22 18.3568 15.0067 10.2962 - OK TCONS_00000260 Fibroblasts 0 16 19.0382 15.5638 10.6784 - OK TCONS_00000261 iPS 0 412 430.032 735.253 298.392 - OK TCONS_00000261 iPS 1 622 599.249 1024.57 415.809 - OK TCONS_00000261 hESC 1 1113 1101.7 728.132 300.08 - OK TCONS_00000261 hESC 0 1164 1175.93 777.192 320.299 - OK TCONS_00000261 Fibroblasts 1 953 795.183 650.064 264.412 - OK TCONS_00000261 Fibroblasts 0 1005 1195.84 977.6 397.637 - OK TCONS_00000262 iPS 0 4 4.17507 7.13837 17.0702 - OK TCONS_00000262 iPS 1 7 6.74396 11.5306 27.5733 - OK TCONS_00000262 hESC 1 5.22822 5.17516 3.42034 8.98698 - OK TCONS_00000262 hESC 0 10.0007 10.1032 6.67737 17.5449 - OK TCONS_00000262 Fibroblasts 1 0 0 0 0 - OK TCONS_00000262 Fibroblasts 0 0 0 0 0 - OK TCONS_00000263 iPS 0 21.2549 22.1852 37.9314 10.6344 - OK TCONS_00000263 iPS 1 40.4264 38.9477 66.5913 18.6694 - OK TCONS_00000263 hESC 1 343.772 340.283 224.898 63.7235 - OK TCONS_00000263 hESC 0 319.999 323.28 213.661 60.5395 - OK TCONS_00000263 Fibroblasts 1 0 0 0 0 - OK TCONS_00000263 Fibroblasts 0 3.99971 4.7592 3.89066 1.09247 - OK TCONS_00000264 iPS 0 9.7451 10.1716 17.391 9.21532 - OK TCONS_00000264 iPS 1 17.5736 16.9308 28.9476 15.339 - OK TCONS_00000264 hESC 1 0 0 0 0 - OK TCONS_00000264 hESC 0 0 0 0 0 - OK TCONS_00000264 Fibroblasts 1 0 0 0 0 - OK TCONS_00000264 Fibroblasts 0 0.000292256 0.000347751 0.000284288 0.000151083 - OK TCONS_00000265 iPS 0 0 0 0 0 - OK TCONS_00000265 iPS 1 0 0 0 0 - OK TCONS_00000265 hESC 1 53.6808 53.136 35.1183 18.315 - OK TCONS_00000265 hESC 0 56.7225 57.3041 37.8731 19.7517 - OK TCONS_00000265 Fibroblasts 1 17.4744 14.5807 11.9197 6.11415 - OK TCONS_00000265 Fibroblasts 0 25.6658 30.5395 24.9661 12.8062 - OK TCONS_00000266 iPS 0 12.1317 12.6627 21.6501 49.9161 - OK TCONS_00000266 iPS 1 8.21239 7.912 13.5276 31.189 - OK TCONS_00000266 hESC 1 90.6671 89.7469 59.315 149.732 - OK TCONS_00000266 hESC 0 92.9951 93.9486 62.092 156.742 - OK TCONS_00000266 Fibroblasts 1 62.0331 51.7604 42.3142 98.8168 - OK TCONS_00000266 Fibroblasts 0 14.3489 17.0736 13.9577 32.5956 - OK TCONS_00000267 iPS 0 95.9167 100.115 171.172 76.8302 - OK TCONS_00000267 iPS 1 96.0114 92.4996 158.152 70.9862 - OK TCONS_00000267 hESC 1 541.387 535.892 354.179 161.7 - OK TCONS_00000267 hESC 0 518.522 523.839 346.213 158.063 - OK TCONS_00000267 Fibroblasts 1 67.7124 56.4992 46.1882 20.783 - OK TCONS_00000267 Fibroblasts 0 39.9383 47.522 38.8494 17.4808 - OK TCONS_00000268 iPS 0 0 0 0 0 - OK TCONS_00000268 iPS 1 0 0 0 0 - OK TCONS_00000268 hESC 1 200.943 198.904 131.458 68.2064 - OK TCONS_00000268 hESC 0 151.395 152.948 101.085 52.4475 - OK TCONS_00000268 Fibroblasts 1 505.182 421.524 344.597 175.866 - OK TCONS_00000268 Fibroblasts 0 221.2 263.203 215.169 109.812 - OK TCONS_00000269 iPS 0 66.9503 69.8805 119.479 63.6684 - OK TCONS_00000269 iPS 1 42.096 40.5563 69.3416 36.951 - OK TCONS_00000269 hESC 1 489.963 484.99 320.537 174.3 - OK TCONS_00000269 hESC 0 224.107 226.405 149.634 81.3674 - OK TCONS_00000269 Fibroblasts 1 390.722 326.018 266.521 142.443 - OK TCONS_00000269 Fibroblasts 0 414.339 493.016 403.042 215.408 - OK TCONS_00000270 iPS 0 0 0 0 0 - OK TCONS_00000270 iPS 1 0 0 0 0 - OK TCONS_00000270 hESC 1 34.9398 34.5852 22.8579 11.9872 - OK TCONS_00000270 hESC 0 0 0 0 0 - OK TCONS_00000270 Fibroblasts 1 0 0 0 0 - OK TCONS_00000270 Fibroblasts 0 24.5084 29.1623 23.8402 12.2956 - OK TCONS_00000271 iPS 0 0 0 0 0 - OK TCONS_00000271 iPS 1 11.1802 10.7712 18.4162 10.3354 - OK TCONS_00000271 hESC 1 0 0 0 0 - OK TCONS_00000271 hESC 0 248.368 250.915 165.833 95.0734 - OK TCONS_00000271 Fibroblasts 1 0.0251549 0.0209892 0.0171587 0.00965964 - OK TCONS_00000271 Fibroblasts 0 0 0 0 0 - OK TCONS_00000272 iPS 0 52 54.2759 92.7989 95.1547 - OK TCONS_00000272 iPS 1 35 33.7198 57.6528 59.1164 - OK TCONS_00000272 hESC 1 32.5 32.1702 21.2617 22.6755 - OK TCONS_00000272 hESC 0 41.5 41.9255 27.7092 29.5516 - OK TCONS_00000272 Fibroblasts 1 535 446.404 364.936 376.331 - OK TCONS_00000272 Fibroblasts 0 340 404.562 330.73 341.057 - OK TCONS_00000273 iPS 0 111 115.858 198.09 174.527 - OK TCONS_00000273 iPS 1 155 149.33 255.32 224.949 - OK TCONS_00000273 hESC 1 623 616.677 407.571 371.39 - OK TCONS_00000273 hESC 0 533 538.465 355.879 324.287 - OK TCONS_00000273 Fibroblasts 1 4 3.3376 2.7285 2.41569 - OK TCONS_00000273 Fibroblasts 0 24 28.5573 23.3457 20.6692 - OK TCONS_00000274 iPS 0 146 152.39 260.551 103.514 - OK TCONS_00000274 iPS 1 264 254.344 434.867 172.767 - OK TCONS_00000274 hESC 1 738 730.51 482.805 194.72 - OK TCONS_00000274 hESC 0 843 851.643 562.863 227.009 - OK TCONS_00000274 Fibroblasts 1 7 5.8408 4.77487 1.90117 - OK TCONS_00000274 Fibroblasts 0 28 33.3169 27.2366 10.8446 - OK TCONS_00000275 iPS 0 34.8659 36.3919 62.2215 79.184 - OK TCONS_00000275 iPS 1 67.539 65.0686 111.252 141.581 - OK TCONS_00000275 hESC 1 281.025 278.173 183.848 245.723 - OK TCONS_00000275 hESC 0 217.096 219.322 144.953 193.737 - OK TCONS_00000275 Fibroblasts 1 204.96 171.019 139.808 179.181 - OK TCONS_00000275 Fibroblasts 0 61.4772 73.1509 59.8011 76.6423 - OK TCONS_00000276 iPS 0 32.6455 34.0743 58.259 75.5689 - OK TCONS_00000276 iPS 1 33.4383 32.2152 55.0803 71.4458 - OK TCONS_00000276 hESC 1 79.874 79.0633 52.2541 71.2541 - OK TCONS_00000276 hESC 0 35.2399 35.6012 23.5294 32.0848 - OK TCONS_00000276 Fibroblasts 1 55.6713 46.4521 37.9747 49.6131 - OK TCONS_00000276 Fibroblasts 0 14.5562 17.3202 14.1593 18.4988 - OK TCONS_00000277 iPS 0 123.707 129.121 220.766 307.812 - OK TCONS_00000277 iPS 1 143.188 137.951 235.863 328.861 - OK TCONS_00000277 hESC 1 1139.5 1127.93 745.466 1096.88 - OK TCONS_00000277 hESC 0 1149.65 1161.43 767.608 1129.46 - OK TCONS_00000277 Fibroblasts 1 1435.63 1197.89 979.275 1375.99 - OK TCONS_00000277 Fibroblasts 0 907.801 1080.18 883.051 1240.78 - OK TCONS_00000278 iPS 0 124.282 129.721 221.793 315.78 - OK TCONS_00000278 iPS 1 67.8345 65.3533 111.739 159.089 - OK TCONS_00000278 hESC 1 346.604 343.087 226.751 341.094 - OK TCONS_00000278 hESC 0 204.258 206.353 136.381 205.154 - OK TCONS_00000278 Fibroblasts 1 389.742 325.2 265.852 381.509 - OK TCONS_00000278 Fibroblasts 0 253.427 301.549 246.517 353.763 - OK TCONS_00000279 iPS 0 0 0 0 0 - OK TCONS_00000279 iPS 1 0 0 0 0 - OK TCONS_00000279 hESC 1 0 0 0 0 - OK TCONS_00000279 hESC 0 17.7601 17.9422 11.8583 18.5276 - OK TCONS_00000279 Fibroblasts 1 0 0 0 0 - OK TCONS_00000279 Fibroblasts 0 52.7386 62.753 51.3007 76.3288 - OK TCONS_00000280 iPS 0 2 2.08753 3.56919 6.9543 - OK TCONS_00000280 iPS 1 0 0 0 0 - OK TCONS_00000280 hESC 1 2 1.9797 1.30841 3.66236 - OK TCONS_00000280 hESC 0 2 2.02051 1.33538 3.73785 - OK TCONS_00000280 Fibroblasts 1 2 1.6688 1.36425 2.65814 - OK TCONS_00000280 Fibroblasts 0 0 0 0 0 - OK TCONS_00000281 iPS 0 0 0 0 0 - OK TCONS_00000281 iPS 1 0 0 0 0 - OK TCONS_00000281 hESC 1 6.73468 6.66633 4.40587 2.55177 - OK TCONS_00000281 hESC 0 5.35203 5.40691 3.5735 2.06969 - OK TCONS_00000281 Fibroblasts 1 0 0 0 0 - OK TCONS_00000281 Fibroblasts 0 0 0 0 0 - OK TCONS_00000282 iPS 0 1.1068 1.15524 1.97519 1.77902 - OK TCONS_00000282 iPS 1 1.1557 1.11343 1.9037 1.71463 - OK TCONS_00000282 hESC 1 4.67799 4.63051 3.06037 2.85302 - OK TCONS_00000282 hESC 0 2.20873 2.23138 1.47475 1.37483 - OK TCONS_00000282 Fibroblasts 1 23.6964 19.7722 16.1639 14.6313 - OK TCONS_00000282 Fibroblasts 0 4.41645 5.25508 4.29604 3.88872 - OK TCONS_00000283 iPS 0 4.30271 4.49103 7.6786 10.4992 - OK TCONS_00000283 iPS 1 14.8622 14.3186 24.4814 33.4742 - OK TCONS_00000283 hESC 1 1.17223 1.16034 0.766884 1.1054 - OK TCONS_00000283 hESC 0 1.04099 1.05167 0.695061 1.00187 - OK TCONS_00000283 Fibroblasts 1 0 0 0 0 - OK TCONS_00000283 Fibroblasts 0 0 0 0 0 - OK TCONS_00000284 iPS 0 0 0 0 0 - OK TCONS_00000284 iPS 1 0 0 0 0 - OK TCONS_00000284 hESC 1 8.40962 8.32427 5.50163 9.0877 - OK TCONS_00000284 hESC 0 5.80372 5.86323 3.87509 6.40095 - OK TCONS_00000284 Fibroblasts 1 0 0 0 0 - OK TCONS_00000284 Fibroblasts 0 12.8787 15.3242 12.5276 19.6523 - OK TCONS_00000285 iPS 0 0 0 0 0 - OK TCONS_00000285 iPS 1 3.6994 3.56409 6.09374 9.86787 - OK TCONS_00000285 hESC 1 0 0 0 0 - OK TCONS_00000285 hESC 0 8.18594 8.26987 5.46568 9.42449 - OK TCONS_00000285 Fibroblasts 1 0 0 0 0 - OK TCONS_00000285 Fibroblasts 0 2.56951 3.05743 2.49946 4.084 - OK TCONS_00000286 iPS 0 3.11034 3.24647 5.55068 7.64879 - OK TCONS_00000286 iPS 1 9.18104 8.84522 15.1232 20.8396 - OK TCONS_00000286 hESC 1 8.65289 8.56507 5.66078 8.22662 - OK TCONS_00000286 hESC 0 30.6779 30.9924 20.4833 29.7678 - OK TCONS_00000286 Fibroblasts 1 27.3825 22.848 18.6783 25.9358 - OK TCONS_00000286 Fibroblasts 0 37.4459 44.5564 36.425 50.5781 - OK TCONS_00000287 iPS 0 0.110835 0.115686 0.197796 0.051099 - OK TCONS_00000287 iPS 1 303.892 292.776 500.578 129.32 - OK TCONS_00000287 hESC 1 1851.72 1832.93 1211.41 316.026 - OK TCONS_00000287 hESC 0 1911.22 1930.81 1276.1 332.903 - OK TCONS_00000287 Fibroblasts 1 3396.65 2834.16 2316.94 599.416 - OK TCONS_00000287 Fibroblasts 0 1700.86 2023.83 1654.49 428.033 - OK TCONS_00000288 iPS 0 187.476 195.681 334.569 86.6863 - OK TCONS_00000288 iPS 1 0.033235 0.0320193 0.0547454 0.0141845 - OK TCONS_00000288 hESC 1 0 0 0 0 - OK TCONS_00000288 hESC 0 37.9419 38.3309 25.3334 6.62842 - OK TCONS_00000288 Fibroblasts 1 0.0380094 0.031715 0.0259271 0.00672731 - OK TCONS_00000288 Fibroblasts 0 0 0 0 0 - OK TCONS_00000289 iPS 0 0 0 0 0 - OK TCONS_00000289 iPS 1 0 0 0 0 - OK TCONS_00000289 hESC 1 0 0 0 0 - OK TCONS_00000289 hESC 0 0 0 0 0 - OK TCONS_00000289 Fibroblasts 1 0 0 0 0 - OK TCONS_00000289 Fibroblasts 0 0 0 0 0 - OK TCONS_00000290 iPS 0 0 0 0 0 - OK TCONS_00000290 iPS 1 0 0 0 0 - OK TCONS_00000290 hESC 1 0 0 0 0 - OK TCONS_00000290 hESC 0 10.1322 10.2361 6.76515 15.5261 - OK TCONS_00000290 Fibroblasts 1 7.13796 5.95591 4.86897 10.4083 - OK TCONS_00000290 Fibroblasts 0 9.24602 11.0017 8.99394 19.2261 - OK TCONS_00000291 iPS 0 0 0 0 0 - OK TCONS_00000291 iPS 1 3.33225 3.21037 5.48896 9.83419 - OK TCONS_00000291 hESC 1 0 0 0 0 - OK TCONS_00000291 hESC 0 0 0 0 0 - OK TCONS_00000291 Fibroblasts 1 0 0 0 0 - OK TCONS_00000291 Fibroblasts 0 0 0 0 0 - OK TCONS_00000292 iPS 0 0 0 0 0 - OK TCONS_00000292 iPS 1 0 0 0 0 - OK TCONS_00000292 hESC 1 1.04328 1.03269 0.682521 2.19742 - OK TCONS_00000292 hESC 0 0 0 0 0 - OK TCONS_00000292 Fibroblasts 1 0 0 0 0 - OK TCONS_00000292 Fibroblasts 0 0 0 0 0 - OK TCONS_00000293 iPS 0 0 0 0 0 - OK TCONS_00000293 iPS 1 0 0 0 0 - OK TCONS_00000293 hESC 1 0 0 0 0 - OK TCONS_00000293 hESC 0 0 0 0 0 - OK TCONS_00000293 Fibroblasts 1 0.790711 0.659769 0.539363 2.61533 - OK TCONS_00000293 Fibroblasts 0 0 0 0 0 - OK TCONS_00000294 iPS 0 0 0 0 0 - OK TCONS_00000294 iPS 1 0 0 0 0 - OK TCONS_00000294 hESC 1 0 0 0 0 - OK TCONS_00000294 hESC 0 0 0 0 0 - OK TCONS_00000294 Fibroblasts 1 0 0 0 0 - OK TCONS_00000294 Fibroblasts 0 0 0 0 0 - OK TCONS_00000295 iPS 0 1 1.04377 1.78459 3.29327 - OK TCONS_00000295 iPS 1 0 0 0 0 - OK TCONS_00000295 hESC 1 0 0 0 0 - OK TCONS_00000295 hESC 0 0 0 0 0 - OK TCONS_00000295 Fibroblasts 1 0 0 0 0 - OK TCONS_00000295 Fibroblasts 0 0 0 0 0 - OK TCONS_00000296 iPS 0 1312.71 1370.17 2342.66 1168.68 - OK TCONS_00000296 iPS 1 634.737 611.52 1045.55 521.593 - OK TCONS_00000296 hESC 1 3045.5 3014.59 1992.39 1012.93 - OK TCONS_00000296 hESC 0 2709.81 2737.6 1809.32 919.86 - OK TCONS_00000296 Fibroblasts 1 39954.5 33338.1 27253.9 13633.7 - OK TCONS_00000296 Fibroblasts 0 14095.2 16771.7 13710.9 6858.82 - OK TCONS_00000297 iPS 0 26.2864 27.4368 46.9105 22.2936 - OK TCONS_00000297 iPS 1 12.2631 11.8146 20.2001 9.59982 - OK TCONS_00000297 hESC 1 0 0 0 0 - OK TCONS_00000297 hESC 0 11.1863 11.3009 7.46896 3.61408 - OK TCONS_00000297 Fibroblasts 1 425.626 355.142 290.33 138.338 - OK TCONS_00000297 Fibroblasts 0 192.82 229.435 187.563 89.3714 - OK TCONS_00000298 iPS 0 1134.57 1184.23 2024.74 635.265 - OK TCONS_00000298 iPS 1 1001.92 965.277 1650.39 517.813 - OK TCONS_00000298 hESC 1 4152.63 4110.48 2716.68 862.533 - OK TCONS_00000298 hESC 0 3531.03 3567.23 2357.64 748.539 - OK TCONS_00000298 Fibroblasts 1 11869.2 9903.66 8096.26 2544.62 - OK TCONS_00000298 Fibroblasts 0 9358.24 11135.3 9103.1 2861.06 - OK TCONS_00000299 iPS 0 125.432 130.921 223.844 72.5652 - OK TCONS_00000299 iPS 1 122.075 117.61 201.085 65.1873 - OK TCONS_00000299 hESC 1 538.873 533.404 352.534 115.693 - OK TCONS_00000299 hESC 0 780.472 788.475 521.114 171.017 - OK TCONS_00000299 Fibroblasts 1 470.801 392.836 321.145 104.294 - OK TCONS_00000299 Fibroblasts 0 676.755 805.263 658.305 213.79 - OK TCONS_00000300 iPS 0 278 290.167 496.117 494.029 - OK TCONS_00000300 iPS 1 309 297.698 508.992 506.85 - OK TCONS_00000300 hESC 1 1805 1786.68 1180.84 1221.6 - OK TCONS_00000300 hESC 0 1856 1875.03 1239.23 1282.01 - OK TCONS_00000300 Fibroblasts 1 671 559.882 457.705 458.299 - OK TCONS_00000300 Fibroblasts 0 699 831.731 679.943 680.824 - OK TCONS_00000301 iPS 0 230.063 240.133 410.57 165.155 - OK TCONS_00000301 iPS 1 291.038 280.393 479.405 192.845 - OK TCONS_00000301 hESC 1 1656.07 1639.26 1083.41 442.502 - OK TCONS_00000301 hESC 0 1437.39 1452.13 959.732 391.988 - OK TCONS_00000301 Fibroblasts 1 0 0 0 0 - OK TCONS_00000301 Fibroblasts 0 22.9314 27.2857 22.3062 8.99283 - OK TCONS_00000302 iPS 0 27.9366 29.1593 49.8554 20.5876 - OK TCONS_00000302 iPS 1 27.0574 26.0677 44.5696 18.4048 - OK TCONS_00000302 hESC 1 70.0047 69.2942 45.7975 19.21 - OK TCONS_00000302 hESC 0 63.6062 64.2584 42.4693 17.814 - OK TCONS_00000302 Fibroblasts 1 0 0 0 0 - OK TCONS_00000302 Fibroblasts 0 0.00236986 0.00281987 0.00230525 0.000954117 - OK TCONS_00000303 iPS 0 0 0 0 0 - OK TCONS_00000303 iPS 1 0.0184538 0.0177788 0.0303975 0.0196205 - OK TCONS_00000303 hESC 1 22.4298 22.2022 14.6738 9.70689 - OK TCONS_00000303 hESC 0 0.624429 0.630832 0.416926 0.275802 - OK TCONS_00000303 Fibroblasts 1 0.000108526 9.05542e-05 7.40283e-05 4.79535e-05 - OK TCONS_00000303 Fibroblasts 0 0 0 0 0 - OK TCONS_00000304 iPS 0 0 0 0 0 - OK TCONS_00000304 iPS 1 7.38598 7.11582 12.1664 8.67643 - OK TCONS_00000304 hESC 1 0 0 0 0 - OK TCONS_00000304 hESC 0 22.5464 22.7776 15.054 11.0315 - OK TCONS_00000304 Fibroblasts 1 1.99989 1.66871 1.36417 0.976706 - OK TCONS_00000304 Fibroblasts 0 10.0663 11.9777 9.79182 7.01063 - OK TCONS_00000305 iPS 0 0 0 0 0 - OK TCONS_00000305 iPS 1 0.000940585 0.00090618 0.00154935 0.000625018 - OK TCONS_00000305 hESC 1 123.218 121.967 80.6097 33.0191 - OK TCONS_00000305 hESC 0 68.8983 69.6047 46.0028 18.8435 - OK TCONS_00000305 Fibroblasts 1 6047.37 5045.93 4125.06 1667.79 - OK TCONS_00000305 Fibroblasts 0 2304.16 2741.69 2241.34 906.189 - OK TCONS_00000306 iPS 0 0.0662282 0.0691268 0.11819 0.0490783 - OK TCONS_00000306 iPS 1 0 0 0 0 - OK TCONS_00000306 hESC 1 21.7825 21.5614 14.2502 6.01122 - OK TCONS_00000306 hESC 0 38.1005 38.4911 25.4393 10.7311 - OK TCONS_00000306 Fibroblasts 1 339.626 283.384 231.667 96.4203 - OK TCONS_00000306 Fibroblasts 0 256.838 305.608 249.836 103.982 - OK TCONS_00000307 iPS 0 18.9338 19.7624 33.7891 14.0846 - OK TCONS_00000307 iPS 1 23.9991 23.1212 39.5318 16.4784 - OK TCONS_00000307 hESC 1 0 0 0 0 - OK TCONS_00000307 hESC 0 0.00125084 0.00126366 0.000835172 0.000353674 - OK TCONS_00000307 Fibroblasts 1 0 0 0 0 - OK TCONS_00000307 Fibroblasts 0 0 0 0 0 - OK TCONS_00000308 iPS 0 0 0 0 0 - OK TCONS_00000308 iPS 1 400.093 385.459 659.043 57.6943 - OK TCONS_00000308 hESC 1 0.032763 0.0324305 0.0214338 0.00188256 - OK TCONS_00000308 hESC 0 0 0 0 0 - OK TCONS_00000308 Fibroblasts 1 0.203765 0.170021 0.138993 0.0121737 - OK TCONS_00000308 Fibroblasts 0 0 0 0 0 - OK TCONS_00000309 iPS 0 2341.65 2444.14 4178.9 367.537 - OK TCONS_00000309 iPS 1 1613.1 1554.1 2657.14 233.697 - OK TCONS_00000309 hESC 1 1111.11 1099.84 726.898 64.1432 - OK TCONS_00000309 hESC 0 1357.31 1371.23 906.263 79.9709 - OK TCONS_00000309 Fibroblasts 1 4503.14 3757.42 3071.7 270.289 - OK TCONS_00000309 Fibroblasts 0 1318.3 1568.63 1282.36 112.839 - OK TCONS_00000310 iPS 0 95.0463 99.2062 169.619 17.4137 - OK TCONS_00000310 iPS 1 103.377 99.5954 170.284 17.4821 - OK TCONS_00000310 hESC 1 877.351 868.447 573.969 59.1542 - OK TCONS_00000310 hESC 0 1067.43 1078.37 712.712 73.4533 - OK TCONS_00000310 Fibroblasts 1 1276.67 1065.25 870.844 89.4549 - OK TCONS_00000310 Fibroblasts 0 997.165 1186.51 969.979 99.6383 - OK TCONS_00000311 iPS 0 61.4648 64.1549 109.69 39.8411 - OK TCONS_00000311 iPS 1 66.4282 63.9984 109.422 39.7439 - OK TCONS_00000311 hESC 1 0 0 0 0 - OK TCONS_00000311 hESC 0 0 0 0 0 - OK TCONS_00000311 Fibroblasts 1 0 0 0 0 - OK TCONS_00000311 Fibroblasts 0 0 0 0 0 - OK TCONS_00000312 iPS 0 0 0 0 0 - OK TCONS_00000312 iPS 1 0 0 0 0 - OK TCONS_00000312 hESC 1 135.292 133.918 88.5086 22.971 - OK TCONS_00000312 hESC 0 99.8053 100.829 66.6391 17.2952 - OK TCONS_00000312 Fibroblasts 1 180.992 151.02 123.459 31.7774 - OK TCONS_00000312 Fibroblasts 0 393.634 468.38 382.902 98.556 - OK TCONS_00000313 iPS 0 0 0 0 0 - OK TCONS_00000313 iPS 1 0 0 0 0 - OK TCONS_00000313 hESC 1 17.2114 17.0367 11.2598 3.98354 - OK TCONS_00000313 hESC 0 24.4551 24.7058 16.3284 5.77674 - OK TCONS_00000313 Fibroblasts 1 0 0 0 0 - OK TCONS_00000313 Fibroblasts 0 15.898 18.9168 15.4646 5.40974 - OK TCONS_00000314 iPS 0 1.00229 1.04615 1.78867 333.137 - OK TCONS_00000314 iPS 1 1 0.963422 1.64722 306.792 - OK TCONS_00000314 hESC 1 1 0.989851 0.654207 585.268 - OK TCONS_00000314 hESC 0 1.00144 1.01171 0.668656 598.194 - OK TCONS_00000314 Fibroblasts 1 1 0.8344 0.682124 6.34805 - OK TCONS_00000314 Fibroblasts 0 0 0 0 0 - OK TCONS_00000315 iPS 0 1 1.04377 1.78459 1.60382 - OK TCONS_00000315 iPS 1 0 0 0 0 - OK TCONS_00000315 hESC 1 2 1.9797 1.30841 1.36757 - OK TCONS_00000315 hESC 0 2 2.02051 1.33538 1.39576 - OK TCONS_00000315 Fibroblasts 1 0 0 0 0 - OK TCONS_00000315 Fibroblasts 0 0 0 0 0 - OK TCONS_00000316 iPS 0 23.2557 24.2735 41.5019 16.0203 - OK TCONS_00000316 iPS 1 0.00117517 0.00113218 0.00193576 0.00074723 - OK TCONS_00000316 hESC 1 1.58661 1.5705 1.03797 0.406568 - OK TCONS_00000316 hESC 0 8.70479 8.79405 5.81211 2.27658 - OK TCONS_00000316 Fibroblasts 1 0 0 0 0 - OK TCONS_00000316 Fibroblasts 0 0 0 0 0 - OK TCONS_00000317 iPS 0 92.7443 96.8035 165.511 60.3176 - OK TCONS_00000317 iPS 1 59.9988 57.8042 98.8315 36.0174 - OK TCONS_00000317 hESC 1 35.4134 35.054 23.1677 8.56032 - OK TCONS_00000317 hESC 0 36.2952 36.6674 24.234 8.95431 - OK TCONS_00000317 Fibroblasts 1 0 0 0 0 - OK TCONS_00000317 Fibroblasts 0 0 0 0 0 - OK TCONS_00000318 iPS 0 0.999964 1.04373 1.78453 2.81418 - OK TCONS_00000318 iPS 1 0 0 0 0 - OK TCONS_00000318 hESC 1 0 0 0 0 - OK TCONS_00000318 hESC 0 1 1.01025 0.667691 1.39642 - OK TCONS_00000318 Fibroblasts 1 0 0 0 0 - OK TCONS_00000318 Fibroblasts 0 0 0 0 0 - OK TCONS_00000319 iPS 0 3.55362e-05 3.70915e-05 6.34177e-05 8.81218e-05 - OK TCONS_00000319 iPS 1 0 0 0 0 - OK TCONS_00000319 hESC 1 0 0 0 0 - OK TCONS_00000319 hESC 0 1 1.01025 0.667691 1.18451 - OK TCONS_00000319 Fibroblasts 1 0 0 0 0 - OK TCONS_00000319 Fibroblasts 0 0 0 0 0 - OK TCONS_00000320 iPS 0 0 0 0 0 - OK TCONS_00000320 iPS 1 5 4.81711 8.23612 7.21151 - OK TCONS_00000320 hESC 1 3 2.96955 1.96262 1.55706 - OK TCONS_00000320 hESC 0 0 0 0 0 - OK TCONS_00000320 Fibroblasts 1 0 0 0 0 - OK TCONS_00000320 Fibroblasts 0 0 0 0 0 - OK TCONS_00000321 iPS 0 0 0 0 0 - OK TCONS_00000321 iPS 1 1.33333 1.28456 2.1963 2.15969 - OK TCONS_00000321 hESC 1 0 0 0 0 - OK TCONS_00000321 hESC 0 0 0 0 0 - OK TCONS_00000321 Fibroblasts 1 0 0 0 0 - OK TCONS_00000321 Fibroblasts 0 0 0 0 0 - OK TCONS_00000322 iPS 0 0 0 0 0 - OK TCONS_00000322 iPS 1 0 0 0 0 - OK TCONS_00000322 hESC 1 0 0 0 0 - OK TCONS_00000322 hESC 0 0 0 0 0 - OK TCONS_00000322 Fibroblasts 1 0 0 0 0 - OK TCONS_00000322 Fibroblasts 0 0 0 0 0 - OK TCONS_00000323 iPS 0 0 0 0 0 - OK TCONS_00000323 iPS 1 0 0 0 0 - OK TCONS_00000323 hESC 1 0 0 0 0 - OK TCONS_00000323 hESC 0 0 0 0 0 - OK TCONS_00000323 Fibroblasts 1 0 0 0 0 - OK TCONS_00000323 Fibroblasts 0 0 0 0 0 - OK TCONS_00000324 iPS 0 0 0 0 0 - OK TCONS_00000324 iPS 1 0 0 0 0 - OK TCONS_00000324 hESC 1 0 0 0 0 - OK TCONS_00000324 hESC 0 0 0 0 0 - OK TCONS_00000324 Fibroblasts 1 0 0 0 0 - OK TCONS_00000324 Fibroblasts 0 0 0 0 0 - OK TCONS_00000325 iPS 0 0 0 0 0 - OK TCONS_00000325 iPS 1 0.45 0.43354 0.741251 0.621345 - OK TCONS_00000325 hESC 1 0 0 0 0 - OK TCONS_00000325 hESC 0 0 0 0 0 - OK TCONS_00000325 Fibroblasts 1 0 0 0 0 - OK TCONS_00000325 Fibroblasts 0 0 0 0 0 - OK TCONS_00000326 iPS 0 0 0 0 0 - OK TCONS_00000326 iPS 1 0.2 0.192684 0.329445 0.27485 - OK TCONS_00000326 hESC 1 0 0 0 0 - OK TCONS_00000326 hESC 0 0 0 0 0 - OK TCONS_00000326 Fibroblasts 1 0 0 0 0 - OK TCONS_00000326 Fibroblasts 0 0 0 0 0 - OK TCONS_00000327 iPS 0 0 0 0 0 - OK TCONS_00000327 iPS 1 0 0 0 0 - OK TCONS_00000327 hESC 1 0 0 0 0 - OK TCONS_00000327 hESC 0 0 0 0 0 - OK TCONS_00000327 Fibroblasts 1 0 0 0 0 - OK TCONS_00000327 Fibroblasts 0 0 0 0 0 - OK TCONS_00000328 iPS 0 0 0 0 0 - OK TCONS_00000328 iPS 1 0 0 0 0 - OK TCONS_00000328 hESC 1 0 0 0 0 - OK TCONS_00000328 hESC 0 0 0 0 0 - OK TCONS_00000328 Fibroblasts 1 0 0 0 0 - OK TCONS_00000328 Fibroblasts 0 0 0 0 0 - OK TCONS_00000329 iPS 0 0 0 0 0 - OK TCONS_00000329 iPS 1 0 0 0 0 - OK TCONS_00000329 hESC 1 0 0 0 0 - OK TCONS_00000329 hESC 0 0 0 0 0 - OK TCONS_00000329 Fibroblasts 1 0 0 0 0 - OK TCONS_00000329 Fibroblasts 0 0 0 0 0 - OK TCONS_00000330 iPS 0 0 0 0 0 - OK TCONS_00000330 iPS 1 0.2 0.192684 0.329445 0.27485 - OK TCONS_00000330 hESC 1 0 0 0 0 - OK TCONS_00000330 hESC 0 0 0 0 0 - OK TCONS_00000330 Fibroblasts 1 0 0 0 0 - OK TCONS_00000330 Fibroblasts 0 0 0 0 0 - OK TCONS_00000331 iPS 0 0 0 0 0 - OK TCONS_00000331 iPS 1 0 0 0 0 - OK TCONS_00000331 hESC 1 1 0.989851 0.654207 0.594357 - OK TCONS_00000331 hESC 0 0 0 0 0 - OK TCONS_00000331 Fibroblasts 1 0 0 0 0 - OK TCONS_00000331 Fibroblasts 0 0 0 0 0 - OK TCONS_00000332 iPS 0 0 0 0 0 - OK TCONS_00000332 iPS 1 0 0 0 0 - OK TCONS_00000332 hESC 1 0 0 0 0 - OK TCONS_00000332 hESC 0 0 0 0 0 - OK TCONS_00000332 Fibroblasts 1 0 0 0 0 - OK TCONS_00000332 Fibroblasts 0 0 0 0 0 - OK TCONS_00000333 iPS 0 452.657 472.468 807.808 433.406 - OK TCONS_00000333 iPS 1 1078.85 1039.39 1777.11 953.456 - OK TCONS_00000333 hESC 1 2369.32 2345.27 1550.02 848.737 - OK TCONS_00000333 hESC 0 2185.48 2207.89 1459.23 799.02 - OK TCONS_00000333 Fibroblasts 1 58.0335 48.4232 39.5861 21.3019 - OK TCONS_00000333 Fibroblasts 0 111.441 132.603 108.403 58.3333 - OK TCONS_00000334 iPS 0 469.343 489.885 837.587 448.363 - OK TCONS_00000334 iPS 1 854.149 822.907 1406.97 753.158 - OK TCONS_00000334 hESC 1 2420.46 2395.89 1583.48 865.048 - OK TCONS_00000334 hESC 0 2528.26 2554.18 1688.1 922.2 - OK TCONS_00000334 Fibroblasts 1 135.966 113.45 92.746 49.7944 - OK TCONS_00000334 Fibroblasts 0 175.559 208.895 170.772 91.6859 - OK TCONS_00000335 iPS 0 0 0 0 0 - OK TCONS_00000335 iPS 1 0 0 0 0 - OK TCONS_00000335 hESC 1 28.2243 27.9379 18.4645 10.5389 - OK TCONS_00000335 hESC 0 9.25743 9.35235 6.1811 3.52794 - OK TCONS_00000335 Fibroblasts 1 0 0 0 0 - OK TCONS_00000335 Fibroblasts 0 0 0 0 0 - OK TCONS_00000336 iPS 0 0 0 0 0 - OK TCONS_00000336 iPS 1 0 0 0 0 - OK TCONS_00000336 hESC 1 0 0 0 0 - OK TCONS_00000336 hESC 0 0 0 0 0 - OK TCONS_00000336 Fibroblasts 1 0 0 0 0 - OK TCONS_00000336 Fibroblasts 0 0 0 0 0 - OK TCONS_00000337 iPS 0 0 0 0 0 - OK TCONS_00000337 iPS 1 0 0 0 0 - OK TCONS_00000337 hESC 1 0 0 0 0 - OK TCONS_00000337 hESC 0 0 0 0 0 - OK TCONS_00000337 Fibroblasts 1 0 0 0 0 - OK TCONS_00000337 Fibroblasts 0 0 0 0 0 - OK TCONS_00000338 iPS 0 0 0 0 0 - OK TCONS_00000338 iPS 1 0 0 0 0 - OK TCONS_00000338 hESC 1 0 0 0 0 - OK TCONS_00000338 hESC 0 0 0 0 0 - OK TCONS_00000338 Fibroblasts 1 0 0 0 0 - OK TCONS_00000338 Fibroblasts 0 0 0 0 0 - OK TCONS_00000339 iPS 0 0 0 0 0 - OK TCONS_00000339 iPS 1 0 0 0 0 - OK TCONS_00000339 hESC 1 0 0 0 0 - OK TCONS_00000339 hESC 0 64.2026 64.8609 42.8675 24.4573 - OK TCONS_00000339 Fibroblasts 1 106.059 88.4955 72.3453 40.5337 - OK TCONS_00000339 Fibroblasts 0 38.8498 46.2269 37.7906 21.1734 - OK TCONS_00000340 iPS 0 79.8807 83.3769 142.555 27.667 - OK TCONS_00000340 iPS 1 205.722 198.197 338.869 65.7677 - OK TCONS_00000340 hESC 1 84.995 84.1324 55.6043 10.871 - OK TCONS_00000340 hESC 0 72.1575 72.8973 48.1789 9.41927 - OK TCONS_00000340 Fibroblasts 1 0 0 0 0 - OK TCONS_00000340 Fibroblasts 0 29.7662 35.4184 28.9547 5.62555 - OK TCONS_00000341 iPS 0 75.8187 79.137 135.305 24.5774 - OK TCONS_00000341 iPS 1 21.4942 20.708 35.4058 6.43124 - OK TCONS_00000341 hESC 1 189.022 187.103 123.659 22.6164 - OK TCONS_00000341 hESC 0 160.369 162.013 107.077 19.5836 - OK TCONS_00000341 Fibroblasts 1 48.7621 40.687 33.2618 6.04786 - OK TCONS_00000341 Fibroblasts 0 114.435 136.164 111.315 20.2399 - OK TCONS_00000342 iPS 0 0 0 0 0 - OK TCONS_00000342 iPS 1 0 0 0 0 - OK TCONS_00000342 hESC 1 3.76812 3.72987 2.46513 1.82725 - OK TCONS_00000342 hESC 0 3.3885 3.42324 2.26247 1.67704 - OK TCONS_00000342 Fibroblasts 1 0 0 0 0 - OK TCONS_00000342 Fibroblasts 0 0 0 0 0 - OK TCONS_00000343 iPS 0 5.73766 5.98878 10.2394 7.81858 - OK TCONS_00000343 iPS 1 0 0 0 0 - OK TCONS_00000343 hESC 1 0 0 0 0 - OK TCONS_00000343 hESC 0 0 0 0 0 - OK TCONS_00000343 Fibroblasts 1 193.668 161.596 132.105 101.3 - OK TCONS_00000343 Fibroblasts 0 3.56609 4.24325 3.46887 2.65997 - OK TCONS_00000344 iPS 0 456.2 476.167 814.132 188.653 - OK TCONS_00000344 iPS 1 413.582 398.454 681.262 157.864 - OK TCONS_00000344 hESC 1 784.447 776.485 513.19 119.963 - OK TCONS_00000344 hESC 0 648.291 654.938 432.858 101.184 - OK TCONS_00000344 Fibroblasts 1 2616.13 2182.9 1784.53 414.045 - OK TCONS_00000344 Fibroblasts 0 1299.6 1546.38 1264.17 293.311 - OK TCONS_00000345 iPS 0 0 0 0 0 - OK TCONS_00000345 iPS 1 0 0 0 0 - OK TCONS_00000345 hESC 1 3.52882 3.493 2.30858 1.56973 - OK TCONS_00000345 hESC 0 0 0 0 0 - OK TCONS_00000345 Fibroblasts 1 83.651 69.7984 57.0603 37.9706 - OK TCONS_00000345 Fibroblasts 0 20.263 24.1107 19.7105 13.1163 - OK TCONS_00000346 iPS 0 0 0 0 0 - OK TCONS_00000346 iPS 1 0 0 0 0 - OK TCONS_00000346 hESC 1 0 0 0 0 - OK TCONS_00000346 hESC 0 0 0 0 0 - OK TCONS_00000346 Fibroblasts 1 0 0 0 0 - OK TCONS_00000346 Fibroblasts 0 0 0 0 0 - OK TCONS_00000347 iPS 0 8.36264 8.72865 14.9239 5.43456 - OK TCONS_00000347 iPS 1 1.20228 1.15831 1.98043 0.721175 - OK TCONS_00000347 hESC 1 2.23947 2.21674 1.46508 0.540913 - OK TCONS_00000347 hESC 0 3.59162 3.62844 2.39809 0.885387 - OK TCONS_00000347 Fibroblasts 1 10.7267 8.95034 7.31693 2.66983 - OK TCONS_00000347 Fibroblasts 0 5.52004 6.56822 5.36954 1.95926 - OK TCONS_00000348 iPS 0 58.3242 60.8769 104.085 39.3934 - OK TCONS_00000348 iPS 1 72.7526 70.0915 119.84 45.3562 - OK TCONS_00000348 hESC 1 149.204 147.69 97.6105 37.4761 - OK TCONS_00000348 hESC 0 209.448 211.596 139.847 53.6921 - OK TCONS_00000348 Fibroblasts 1 0 0 0 0 - OK TCONS_00000348 Fibroblasts 0 51.7136 61.5333 50.3037 19.0785 - OK TCONS_00000349 iPS 0 0 0 0 0 - OK TCONS_00000349 iPS 1 5.2474 5.05546 8.64364 3.33565 - OK TCONS_00000349 hESC 1 0 0 0 0 - OK TCONS_00000349 hESC 0 0 0 0 0 - OK TCONS_00000349 Fibroblasts 1 0 0 0 0 - OK TCONS_00000349 Fibroblasts 0 0 0 0 0 - OK TCONS_00000350 iPS 0 6.33921 6.61666 11.3129 2.73386 - OK TCONS_00000350 iPS 1 0 0 0 0 - OK TCONS_00000350 hESC 1 76.0619 75.29 49.7602 12.1352 - OK TCONS_00000350 hESC 0 51.5183 52.0465 34.3983 8.38885 - OK TCONS_00000350 Fibroblasts 1 27.6455 23.0674 18.8577 4.56321 - OK TCONS_00000350 Fibroblasts 0 0 0 0 0 - OK TCONS_00000351 iPS 0 8.83086 9.21737 15.7595 6.06681 - OK TCONS_00000351 iPS 1 0 0 0 0 - OK TCONS_00000351 hESC 1 83.2965 82.4511 54.4931 21.2858 - OK TCONS_00000351 hESC 0 64.0713 64.7282 42.7798 16.7104 - OK TCONS_00000351 Fibroblasts 1 134.538 112.258 91.7715 35.4038 - OK TCONS_00000351 Fibroblasts 0 59.5045 70.8037 57.8822 22.3299 - OK TCONS_00000352 iPS 0 0 0 0 0 - OK TCONS_00000352 iPS 1 0 0 0 0 - OK TCONS_00000352 hESC 1 0 0 0 0 - OK TCONS_00000352 hESC 0 0.0140505 0.0141946 0.0093814 0.00387759 - OK TCONS_00000352 Fibroblasts 1 0 0 0 0 - OK TCONS_00000352 Fibroblasts 0 60.9357 72.5066 59.2744 24.1793 - OK TCONS_00000353 iPS 0 30.7741 32.121 54.9193 22.2883 - OK TCONS_00000353 iPS 1 0 0 0 0 - OK TCONS_00000353 hESC 1 0 0 0 0 - OK TCONS_00000353 hESC 0 0 0 0 0 - OK TCONS_00000353 Fibroblasts 1 889.777 742.43 606.938 246.871 - OK TCONS_00000353 Fibroblasts 0 384.865 457.946 374.372 152.275 - OK TCONS_00000354 iPS 0 2.45438 2.5618 4.38007 1.92088 - OK TCONS_00000354 iPS 1 0 0 0 0 - OK TCONS_00000354 hESC 1 307.106 303.989 200.911 89.5863 - OK TCONS_00000354 hESC 0 243.534 246.031 162.605 72.5057 - OK TCONS_00000354 Fibroblasts 1 1070.39 893.135 730.14 320.98 - OK TCONS_00000354 Fibroblasts 0 226.983 270.084 220.794 97.0643 - OK TCONS_00000355 iPS 0 6.78866 7.08578 12.115 3.9301 - OK TCONS_00000355 iPS 1 16.325 15.7279 26.8909 8.72341 - OK TCONS_00000355 hESC 1 14.1026 13.9595 9.22603 3.02987 - OK TCONS_00000355 hESC 0 31.3239 31.6451 20.9147 6.86848 - OK TCONS_00000355 Fibroblasts 1 100.757 84.0713 68.7285 22.3355 - OK TCONS_00000355 Fibroblasts 0 19.999 23.7966 19.4538 6.32212 - OK TCONS_00000356 iPS 0 0 0 0 0 - OK TCONS_00000356 iPS 1 27.9195 26.8983 45.9897 35.2118 - OK TCONS_00000356 hESC 1 0.0185966 0.0184079 0.012166 0.0095909 - OK TCONS_00000356 hESC 0 38.5278 38.9229 25.7247 20.2796 - OK TCONS_00000356 Fibroblasts 1 0 0 0 0 - OK TCONS_00000356 Fibroblasts 0 0.0119733 0.0142468 0.0116468 0.0089552 - OK TCONS_00000357 iPS 0 11.0687 11.5532 19.7532 15.7461 - OK TCONS_00000357 iPS 1 27.6695 26.6574 45.5778 36.332 - OK TCONS_00000357 hESC 1 181.161 179.322 118.517 97.393 - OK TCONS_00000357 hESC 0 50.969 51.4916 34.0316 27.966 - OK TCONS_00000357 Fibroblasts 1 34.2972 28.6176 23.3949 18.7315 - OK TCONS_00000357 Fibroblasts 0 56.126 66.7836 54.5958 43.713 - OK TCONS_00000358 iPS 0 0 0 0 0 - OK TCONS_00000358 iPS 1 0 0 0 0 - OK TCONS_00000358 hESC 1 0 0 0 0 - OK TCONS_00000358 hESC 0 41.8284 42.2573 27.9284 23.8225 - OK TCONS_00000358 Fibroblasts 1 166.919 139.277 113.859 94.5342 - OK TCONS_00000358 Fibroblasts 0 62.847 74.7809 61.1336 50.7576 - OK TCONS_00000359 iPS 0 53.9313 56.2917 96.2454 78.0853 - OK TCONS_00000359 iPS 1 47.1155 45.3921 77.6097 62.9659 - OK TCONS_00000359 hESC 1 113.607 112.454 74.3225 62.1958 - OK TCONS_00000359 hESC 0 59.5466 60.1572 39.7587 33.2716 - OK TCONS_00000359 Fibroblasts 1 990.318 826.321 675.52 550.526 - OK TCONS_00000359 Fibroblasts 0 259.08 308.276 252.016 205.385 - OK TCONS_00000360 iPS 0 0 0 0 0 - OK TCONS_00000360 iPS 1 47.2956 45.5656 77.9064 60.6666 - OK TCONS_00000360 hESC 1 158.213 156.608 103.504 83.0303 - OK TCONS_00000360 hESC 0 233.128 235.518 155.658 124.867 - OK TCONS_00000360 Fibroblasts 1 358.466 299.104 244.518 191.231 - OK TCONS_00000360 Fibroblasts 0 340.935 405.675 331.64 259.367 - OK TCONS_00000361 iPS 0 3.48482 3.63734 6.21899 1.78711 - OK TCONS_00000361 iPS 1 11.3592 10.9437 18.7112 5.37691 - OK TCONS_00000361 hESC 1 36.7099 36.3374 24.0159 6.97666 - OK TCONS_00000361 hESC 0 28.2328 28.5223 18.8508 5.47619 - OK TCONS_00000361 Fibroblasts 1 11.9829 9.99849 8.17379 2.35258 - OK TCONS_00000361 Fibroblasts 0 8.66672 10.3124 8.43043 2.42645 - OK TCONS_00000362 iPS 0 2.51518 2.62526 4.48857 1.90183 - OK TCONS_00000362 iPS 1 3.64078 3.50761 5.99718 2.54104 - OK TCONS_00000362 hESC 1 7.96989 7.889 5.21396 2.24494 - OK TCONS_00000362 hESC 0 4.77731 4.82629 3.18976 1.3734 - OK TCONS_00000362 Fibroblasts 1 4.87936 4.07134 3.32833 1.41354 - OK TCONS_00000362 Fibroblasts 0 0 0 0 0 - OK TCONS_00000363 iPS 0 0 0 0 0 - OK TCONS_00000363 iPS 1 0 0 0 0 - OK TCONS_00000363 hESC 1 0 0 0 0 - OK TCONS_00000363 hESC 0 0 0 0 0 - OK TCONS_00000363 Fibroblasts 1 0 0 0 0 - OK TCONS_00000363 Fibroblasts 0 0 0 0 0 - OK TCONS_00000364 iPS 0 0 0 0 0 - OK TCONS_00000364 iPS 1 0 0 0 0 - OK TCONS_00000364 hESC 1 0 0 0 0 - OK TCONS_00000364 hESC 0 0 0 0 0 - OK TCONS_00000364 Fibroblasts 1 0 0 0 0 - OK TCONS_00000364 Fibroblasts 0 0 0 0 0 - OK TCONS_00000365 iPS 0 0 0 0 0 - OK TCONS_00000365 iPS 1 0 0 0 0 - OK TCONS_00000365 hESC 1 0 0 0 0 - OK TCONS_00000365 hESC 0 1.11969 1.13117 0.74761 0.913746 - OK TCONS_00000365 Fibroblasts 1 0 0 0 0 - OK TCONS_00000365 Fibroblasts 0 1 1.18989 0.972737 1.14406 - OK TCONS_00000366 iPS 0 0 0 0 0 - OK TCONS_00000366 iPS 1 0 0 0 0 - OK TCONS_00000366 hESC 1 0 0 0 0 - OK TCONS_00000366 hESC 0 0 0 0 0 - OK TCONS_00000366 Fibroblasts 1 0 0 0 0 - OK TCONS_00000366 Fibroblasts 0 0 0 0 0 - OK TCONS_00000367 iPS 0 344 359.056 613.9 385.691 - OK TCONS_00000367 iPS 1 263 253.38 433.22 272.176 - OK TCONS_00000367 hESC 1 1184 1171.98 774.581 498.411 - OK TCONS_00000367 hESC 0 1055 1065.82 704.414 453.262 - OK TCONS_00000367 Fibroblasts 1 4284 3574.57 2922.22 1842.31 - OK TCONS_00000367 Fibroblasts 0 4116 4897.58 4003.78 2524.19 - OK TCONS_00000368 iPS 0 1.89533e-05 1.97828e-05 3.3824e-05 5.32213e-05 - OK TCONS_00000368 iPS 1 0 0 0 0 - OK TCONS_00000368 hESC 1 0 0 0 0 - OK TCONS_00000368 hESC 0 0 0 0 0 - OK TCONS_00000368 Fibroblasts 1 0 0 0 0 - OK TCONS_00000368 Fibroblasts 0 1.45312e-05 1.72905e-05 1.4135e-05 2.76276e-05 - OK TCONS_00000369 iPS 0 0.999981 1.04375 1.78456 3.35241 - OK TCONS_00000369 iPS 1 0 0 0 0 - OK TCONS_00000369 hESC 1 0 0 0 0 - OK TCONS_00000369 hESC 0 0 0 0 0 - OK TCONS_00000369 Fibroblasts 1 5 4.172 3.41062 8.35087 - OK TCONS_00000369 Fibroblasts 0 0.999985 1.18987 0.972722 2.3817 - OK TCONS_00000370 iPS 0 0 0 0 0 - OK TCONS_00000370 iPS 1 0 0 0 0 - OK TCONS_00000370 hESC 1 0 0 0 0 - OK TCONS_00000370 hESC 0 0 0 0 0 - OK TCONS_00000370 Fibroblasts 1 0 0 0 0 - OK TCONS_00000370 Fibroblasts 0 0 0 0 0 - OK TCONS_00000371 iPS 0 0 0 0 0 - OK TCONS_00000371 iPS 1 0 0 0 0 - OK TCONS_00000371 hESC 1 1 0.989851 0.654207 1.31945 - OK TCONS_00000371 hESC 0 1.00024 1.01049 0.667851 1.34697 - OK TCONS_00000371 Fibroblasts 1 0 0 0 0 - OK TCONS_00000371 Fibroblasts 0 0 0 0 0 - OK TCONS_00000372 iPS 0 98.327 102.63 175.474 115.636 - OK TCONS_00000372 iPS 1 93.9073 90.4724 154.686 101.938 - OK TCONS_00000372 hESC 1 21.3892 21.1721 13.9929 9.45551 - OK TCONS_00000372 hESC 0 77.6865 78.4831 51.8706 35.0507 - OK TCONS_00000372 Fibroblasts 1 63.286 52.8058 43.1689 28.552 - OK TCONS_00000372 Fibroblasts 0 15.7586 18.751 15.329 10.1386 - OK TCONS_00000373 iPS 0 534.107 557.483 953.164 230.262 - OK TCONS_00000373 iPS 1 733.957 707.11 1208.99 292.063 - OK TCONS_00000373 hESC 1 830.823 822.391 543.53 132.507 - OK TCONS_00000373 hESC 0 566.288 572.095 378.106 92.1784 - OK TCONS_00000373 Fibroblasts 1 2093.87 1747.12 1428.28 345.499 - OK TCONS_00000373 Fibroblasts 0 943.659 1122.85 917.931 222.047 - OK TCONS_00000374 iPS 0 231.591 241.727 413.296 103.1 - OK TCONS_00000374 iPS 1 208.566 200.937 343.554 85.7022 - OK TCONS_00000374 hESC 1 0.0474725 0.0469907 0.0310568 0.00782069 - OK TCONS_00000374 hESC 0 226.683 229.007 151.354 38.1138 - OK TCONS_00000374 Fibroblasts 1 391.444 326.621 267.013 66.7003 - OK TCONS_00000374 Fibroblasts 0 322.786 384.079 313.986 78.4341 - OK TCONS_00000375 iPS 0 4.97505 5.19279 8.87843 4.55115 - OK TCONS_00000375 iPS 1 10.5704 10.1838 17.4118 8.92541 - OK TCONS_00000375 hESC 1 7.76279 7.684 5.07847 2.65441 - OK TCONS_00000375 hESC 0 3.3424 3.37667 2.23169 1.16646 - OK TCONS_00000375 Fibroblasts 1 4.57777 3.81969 3.12261 1.60521 - OK TCONS_00000375 Fibroblasts 0 4.7962 5.70694 4.66544 2.39832 - OK TCONS_00000376 iPS 0 13.7 14.2997 24.449 26.7158 - OK TCONS_00000376 iPS 1 35.0923 33.8087 57.8049 63.1641 - OK TCONS_00000376 hESC 1 1.80746 1.78912 1.18245 1.34743 - OK TCONS_00000376 hESC 0 3.37536 3.40997 2.2537 2.56813 - OK TCONS_00000376 Fibroblasts 1 0 0 0 0 - OK TCONS_00000376 Fibroblasts 0 1.63442 1.94477 1.58986 1.7478 - OK TCONS_00000377 iPS 0 277.894 290.056 495.928 440.78 - OK TCONS_00000377 iPS 1 294.626 283.85 485.315 431.348 - OK TCONS_00000377 hESC 1 456.77 452.134 298.822 274.773 - OK TCONS_00000377 hESC 0 446.168 450.743 297.902 273.927 - OK TCONS_00000377 Fibroblasts 1 628.255 524.216 428.548 382.772 - OK TCONS_00000377 Fibroblasts 0 264.513 314.741 257.301 229.817 - OK TCONS_00000378 iPS 0 0 0 0 0 - OK TCONS_00000378 iPS 1 0 0 0 0 - OK TCONS_00000378 hESC 1 0 0 0 0 - OK TCONS_00000378 hESC 0 0 0 0 0 - OK TCONS_00000378 Fibroblasts 1 0 0 0 0 - OK TCONS_00000378 Fibroblasts 0 0 0 0 0 - OK TCONS_00000379 iPS 0 295.406 308.335 527.18 442.427 - OK TCONS_00000379 iPS 1 450.281 433.811 741.714 622.471 - OK TCONS_00000379 hESC 1 408.423 404.278 267.193 231.542 - OK TCONS_00000379 hESC 0 511.457 516.701 341.495 295.929 - OK TCONS_00000379 Fibroblasts 1 809.745 675.651 552.346 465.705 - OK TCONS_00000379 Fibroblasts 0 337.853 402.007 328.642 277.091 - OK TCONS_00000380 iPS 0 229 239.023 408.672 222.126 - OK TCONS_00000380 iPS 1 313 301.551 515.581 280.234 - OK TCONS_00000380 hESC 1 795 786.931 520.094 288.583 - OK TCONS_00000380 hESC 0 884 893.064 590.239 327.504 - OK TCONS_00000380 Fibroblasts 1 769 641.653 524.553 285.969 - OK TCONS_00000380 Fibroblasts 0 347 412.891 337.539 184.015 - OK TCONS_00000381 iPS 0 722 753.6 1288.48 461.128 - OK TCONS_00000381 iPS 1 446 429.686 734.662 262.925 - OK TCONS_00000381 hESC 1 3288.5 3255.12 2151.36 780.441 - OK TCONS_00000381 hESC 0 3265 3298.48 2180.01 790.835 - OK TCONS_00000381 Fibroblasts 1 9458 7891.75 6451.53 2313.48 - OK TCONS_00000381 Fibroblasts 0 6764.5 8048.99 6580.07 2359.58 - OK TCONS_00000382 iPS 0 6.58615 6.8744 11.7536 5.72814 - OK TCONS_00000382 iPS 1 8.74409 8.42425 14.4035 7.01957 - OK TCONS_00000382 hESC 1 10.937 10.826 7.15508 3.55212 - OK TCONS_00000382 hESC 0 33 33.3384 22.0338 10.9386 - OK TCONS_00000382 Fibroblasts 1 21.6547 18.0687 14.7712 7.2182 - OK TCONS_00000382 Fibroblasts 0 23.8815 28.4163 23.2304 11.3519 - OK TCONS_00000383 iPS 0 1.41385 1.47573 2.52316 2.26823 - OK TCONS_00000383 iPS 1 1.25591 1.20997 2.06876 1.85975 - OK TCONS_00000383 hESC 1 9.06297 8.97099 5.92906 5.51644 - OK TCONS_00000383 hESC 0 0 0 0 0 - OK TCONS_00000383 Fibroblasts 1 13.3453 11.1353 9.10315 8.22425 - OK TCONS_00000383 Fibroblasts 0 1.11848 1.33087 1.08799 0.982944 - OK TCONS_00000384 iPS 0 4 4.17507 7.13837 7.47676 - OK TCONS_00000384 iPS 1 9 8.6708 14.825 15.5278 - OK TCONS_00000384 hESC 1 53 52.4621 34.673 37.805 - OK TCONS_00000384 hESC 0 37 37.3794 24.7046 26.9362 - OK TCONS_00000384 Fibroblasts 1 0 0 0 0 - OK TCONS_00000384 Fibroblasts 0 0 0 0 0 - OK TCONS_00000385 iPS 0 44.3994 46.3427 79.235 33.7036 - OK TCONS_00000385 iPS 1 0 0 0 0 - OK TCONS_00000385 hESC 1 139.274 137.86 91.1138 39.3861 - OK TCONS_00000385 hESC 0 65.4972 66.1687 43.7319 18.9042 - OK TCONS_00000385 Fibroblasts 1 496.146 413.984 338.433 144.296 - OK TCONS_00000385 Fibroblasts 0 0 0 0 0 - OK TCONS_00000386 iPS 0 949.353 990.903 1694.21 753.27 - OK TCONS_00000386 iPS 1 511.806 493.085 843.059 374.836 - OK TCONS_00000386 hESC 1 2615.49 2588.94 1711.07 773.697 - OK TCONS_00000386 hESC 0 2856.85 2886.14 1907.49 862.515 - OK TCONS_00000386 Fibroblasts 1 8757.38 7307.15 5973.62 2662.49 - OK TCONS_00000386 Fibroblasts 0 3122.51 3715.43 3037.38 1353.79 - OK TCONS_00000387 iPS 0 0 0 0 0 - OK TCONS_00000387 iPS 1 0 0 0 0 - OK TCONS_00000387 hESC 1 0 0 0 0 - OK TCONS_00000387 hESC 0 0 0 0 0 - OK TCONS_00000387 Fibroblasts 1 0 0 0 0 - OK TCONS_00000387 Fibroblasts 0 0 0 0 0 - OK TCONS_00000388 iPS 0 10.9584 11.438 19.5563 20.3927 - OK TCONS_00000388 iPS 1 54.0127 52.037 88.9709 92.7763 - OK TCONS_00000388 hESC 1 43.4539 43.0129 28.4278 30.8531 - OK TCONS_00000388 hESC 0 24.9008 25.1561 16.626 18.0444 - OK TCONS_00000388 Fibroblasts 1 19.9801 16.6714 13.6289 14.2942 - OK TCONS_00000388 Fibroblasts 0 8.05004 9.57864 7.83056 8.21278 - OK TCONS_00000389 iPS 0 196.289 204.88 350.296 188.801 - OK TCONS_00000389 iPS 1 361.181 347.97 594.946 320.661 - OK TCONS_00000389 hESC 1 459.785 455.118 300.794 165.473 - OK TCONS_00000389 hESC 0 100.751 101.784 67.2704 37.0068 - OK TCONS_00000389 Fibroblasts 1 1386.5 1156.89 945.762 511.263 - OK TCONS_00000389 Fibroblasts 0 301.941 359.276 293.709 158.774 - OK TCONS_00000390 iPS 0 645.31 673.553 1151.62 135.082 - OK TCONS_00000390 iPS 1 806.699 777.191 1328.81 155.867 - OK TCONS_00000390 hESC 1 2973.2 2943.02 1945.09 229.165 - OK TCONS_00000390 hESC 0 3251.83 3285.17 2171.22 255.807 - OK TCONS_00000390 Fibroblasts 1 5098.49 4254.17 3477.8 408.203 - OK TCONS_00000390 Fibroblasts 0 1397.53 1662.91 1359.43 159.562 - OK TCONS_00000391 iPS 0 170.69 178.161 304.612 36.7262 - OK TCONS_00000391 iPS 1 220.301 212.243 362.886 43.7521 - OK TCONS_00000391 hESC 1 2008.8 1988.41 1314.17 159.167 - OK TCONS_00000391 hESC 0 1498.17 1513.53 1000.32 121.154 - OK TCONS_00000391 Fibroblasts 1 2166.51 1807.74 1477.83 178.297 - OK TCONS_00000391 Fibroblasts 0 1506.47 1792.53 1465.4 176.796 - OK TCONS_00000392 iPS 0 0 0 0 0 - OK TCONS_00000392 iPS 1 0 0 0 0 - OK TCONS_00000392 hESC 1 0 0 0 0 - OK TCONS_00000392 hESC 0 0 0 0 0 - OK TCONS_00000392 Fibroblasts 1 0 0 0 0 - OK TCONS_00000392 Fibroblasts 0 0 0 0 0 - OK TCONS_00000393 iPS 0 0 0 0 0 - OK TCONS_00000393 iPS 1 2.53558 2.44284 4.17667 2.04325 - OK TCONS_00000393 hESC 1 32.0838 31.7582 20.9894 10.4605 - OK TCONS_00000393 hESC 0 0 0 0 0 - OK TCONS_00000393 Fibroblasts 1 0 0 0 0 - OK TCONS_00000393 Fibroblasts 0 0 0 0 0 - OK TCONS_00000394 iPS 0 0 0 0 0 - OK TCONS_00000394 iPS 1 0 0 0 0 - OK TCONS_00000394 hESC 1 0 0 0 0 - OK TCONS_00000394 hESC 0 0 0 0 0 - OK TCONS_00000394 Fibroblasts 1 0 0 0 0 - OK TCONS_00000394 Fibroblasts 0 0 0 0 0 - OK TCONS_00000395 iPS 0 0 0 0 0 - OK TCONS_00000395 iPS 1 0 0 0 0 - OK TCONS_00000395 hESC 1 35.6546 35.2928 23.3255 14.2752 - OK TCONS_00000395 hESC 0 10.9562 11.0686 7.31538 4.47702 - OK TCONS_00000395 Fibroblasts 1 0 0 0 0 - OK TCONS_00000395 Fibroblasts 0 0 0 0 0 - OK TCONS_00000396 iPS 0 3.50019 3.65338 6.24642 3.94718 - OK TCONS_00000396 iPS 1 0 0 0 0 - OK TCONS_00000396 hESC 1 26.1685 25.9029 17.1196 11.0813 - OK TCONS_00000396 hESC 0 24.9246 25.1801 16.6419 10.7721 - OK TCONS_00000396 Fibroblasts 1 0 0 0 0 - OK TCONS_00000396 Fibroblasts 0 0.999999 1.18989 0.972735 0.616835 - OK TCONS_00000397 iPS 0 5.33666 5.57023 9.52378 5.69027 - OK TCONS_00000397 iPS 1 7.1705 6.90822 11.8114 7.0571 - OK TCONS_00000397 hESC 1 19.0515 18.8581 12.4636 7.61786 - OK TCONS_00000397 hESC 0 3.10907 3.14095 2.0759 1.26881 - OK TCONS_00000397 Fibroblasts 1 0 0 0 0 - OK TCONS_00000397 Fibroblasts 0 0 0 0 0 - OK TCONS_00000398 iPS 0 0 0 0 0 - OK TCONS_00000398 iPS 1 2.3248 2.23976 3.82946 7.36468 - OK TCONS_00000398 hESC 1 9.26048 9.16649 6.05827 12.5589 - OK TCONS_00000398 hESC 0 0 0 0 0 - OK TCONS_00000398 Fibroblasts 1 0 0 0 0 - OK TCONS_00000398 Fibroblasts 0 0 0 0 0 - OK TCONS_00000399 iPS 0 0 0 0 0 - OK TCONS_00000399 iPS 1 1.13975 1.09806 1.87742 2.85703 - OK TCONS_00000399 hESC 1 0 0 0 0 - OK TCONS_00000399 hESC 0 6.45269 6.51885 4.3084 6.95428 - OK TCONS_00000399 Fibroblasts 1 0 0 0 0 - OK TCONS_00000399 Fibroblasts 0 0 0 0 0 - OK TCONS_00000400 iPS 0 0 0 0 0 - OK TCONS_00000400 iPS 1 0 0 0 0 - OK TCONS_00000400 hESC 1 0 0 0 0 - OK TCONS_00000400 hESC 0 0 0 0 0 - OK TCONS_00000400 Fibroblasts 1 0 0 0 0 - OK TCONS_00000400 Fibroblasts 0 0 0 0 0 - OK TCONS_00000401 iPS 0 4.662 4.86605 8.31978 6.00285 - OK TCONS_00000401 iPS 1 15.3296 14.7689 25.2512 18.2192 - OK TCONS_00000401 hESC 1 132.114 130.773 86.4298 64.0989 - OK TCONS_00000401 hESC 0 85.2244 86.0982 56.9035 42.2014 - OK TCONS_00000401 Fibroblasts 1 3.00124 2.50423 2.04722 1.48301 - OK TCONS_00000401 Fibroblasts 0 3 3.56966 2.91821 2.11396 - OK TCONS_00000402 iPS 0 32.1368 33.5434 57.3512 60.9728 - OK TCONS_00000402 iPS 1 9.97849 9.6135 16.4368 17.4748 - OK TCONS_00000402 hESC 1 0 0 0 0 - OK TCONS_00000402 hESC 0 0 0 0 0 - OK TCONS_00000402 Fibroblasts 1 731.822 610.632 499.193 533.851 - OK TCONS_00000402 Fibroblasts 0 0 0 0 0 - OK TCONS_00000403 iPS 0 687.854 717.96 1227.54 508.391 - OK TCONS_00000403 iPS 1 422.342 406.894 695.692 288.124 - OK TCONS_00000403 hESC 1 1858.39 1839.53 1215.77 511.48 - OK TCONS_00000403 hESC 0 2010.07 2030.68 1342.11 564.628 - OK TCONS_00000403 Fibroblasts 1 5902.59 4925.12 4026.3 1671.33 - OK TCONS_00000403 Fibroblasts 0 5084.89 6050.45 4946.26 2053.21 - OK TCONS_00000404 iPS 0 597.814 623.978 1066.85 442.23 - OK TCONS_00000404 iPS 1 609.041 586.764 1003.23 415.855 - OK TCONS_00000404 hESC 1 2109.01 2087.6 1379.73 580.974 - OK TCONS_00000404 hESC 0 2041.53 2062.47 1363.11 573.979 - OK TCONS_00000404 Fibroblasts 1 4073.12 3398.61 2778.37 1154.33 - OK TCONS_00000404 Fibroblasts 0 5435.26 6467.35 5287.08 2196.62 - OK TCONS_00000405 iPS 0 554.195 578.451 989.013 403.694 - OK TCONS_00000405 iPS 1 443.65 427.422 730.79 298.293 - OK TCONS_00000405 hESC 1 839.599 831.078 549.271 227.694 - OK TCONS_00000405 hESC 0 1058.4 1069.25 706.682 292.947 - OK TCONS_00000405 Fibroblasts 1 6344.7 5294.02 4327.87 1770.54 - OK TCONS_00000405 Fibroblasts 0 3406.84 4053.76 3313.96 1355.74 - OK TCONS_00000406 iPS 0 0 0 0 0 - OK TCONS_00000406 iPS 1 0 0 0 0 - OK TCONS_00000406 hESC 1 0 0 0 0 - OK TCONS_00000406 hESC 0 0 0 0 0 - OK TCONS_00000406 Fibroblasts 1 997.182 832.048 680.201 824.687 - OK TCONS_00000406 Fibroblasts 0 0 0 0 0 - OK TCONS_00000407 iPS 0 363.838 379.762 649.302 480.491 - OK TCONS_00000407 iPS 1 48.8589 47.0718 80.4816 59.5572 - OK TCONS_00000407 hESC 1 1063.73 1052.93 695.899 529.708 - OK TCONS_00000407 hESC 0 1035.46 1046.08 691.366 526.257 - OK TCONS_00000407 Fibroblasts 1 6399.03 5339.35 4364.93 3243.35 - OK TCONS_00000407 Fibroblasts 0 4522.38 5381.12 4399.08 3268.72 - OK TCONS_00000408 iPS 0 0 0 0 0 - OK TCONS_00000408 iPS 1 0.00634246 0.00611046 0.0104474 0.00805133 - OK TCONS_00000408 hESC 1 12.2701 12.1455 8.02715 6.37068 - OK TCONS_00000408 hESC 0 52.5413 53.08 35.0814 27.842 - OK TCONS_00000408 Fibroblasts 1 206.788 172.544 141.055 109.169 - OK TCONS_00000408 Fibroblasts 0 124.621 148.285 121.224 93.8204 - OK TCONS_00000409 iPS 0 207.162 216.229 369.701 285.221 - OK TCONS_00000409 iPS 1 248.135 239.059 408.733 315.334 - OK TCONS_00000409 hESC 1 0 0 0 0 - OK TCONS_00000409 hESC 0 0 0 0 0 - OK TCONS_00000409 Fibroblasts 1 0 0 0 0 - OK TCONS_00000409 Fibroblasts 0 0 0 0 0 - OK TCONS_00000410 iPS 0 6.30573 6.58171 11.2532 7.08253 - OK TCONS_00000410 iPS 1 9.31634 8.97557 15.3461 9.65854 - OK TCONS_00000410 hESC 1 27.3525 27.0748 17.8942 11.5352 - OK TCONS_00000410 hESC 0 30.7399 31.0551 20.5247 13.2309 - OK TCONS_00000410 Fibroblasts 1 1 0.8344 0.682124 0.430813 - OK TCONS_00000410 Fibroblasts 0 3.75678 4.47014 3.65435 2.308 - OK TCONS_00000411 iPS 0 3.19423 3.33403 5.7004 5.77205 - OK TCONS_00000411 iPS 1 0 0 0 0 - OK TCONS_00000411 hESC 1 1.44323 1.42858 0.94417 1.13535 - OK TCONS_00000411 hESC 0 7.03341 7.10553 4.69614 5.64704 - OK TCONS_00000411 Fibroblasts 1 0 0 0 0 - OK TCONS_00000411 Fibroblasts 0 0 0 0 0 - OK TCONS_00000412 iPS 0 0.717353 0.74875 1.28018 1.1418 - OK TCONS_00000412 iPS 1 0 0 0 0 - OK TCONS_00000412 hESC 1 13.1608 13.0273 8.60991 8.92013 - OK TCONS_00000412 hESC 0 5.64108 5.69891 3.76649 3.9022 - OK TCONS_00000412 Fibroblasts 1 0 0 0 0 - OK TCONS_00000412 Fibroblasts 0 0 0 0 0 - OK TCONS_00000413 iPS 0 0 0 0 0 - OK TCONS_00000413 iPS 1 0 0 0 0 - OK TCONS_00000413 hESC 1 0 0 0 0 - OK TCONS_00000413 hESC 0 9.13727 9.23096 6.10087 3.57446 - OK TCONS_00000413 Fibroblasts 1 20.5904 17.1806 14.0452 8.0772 - OK TCONS_00000413 Fibroblasts 0 9.60665 11.4308 9.34474 5.37404 - OK TCONS_00000414 iPS 0 0 0 0 0 - OK TCONS_00000414 iPS 1 0 0 0 0 - OK TCONS_00000414 hESC 1 11.3188 11.2039 7.40483 8.859 - OK TCONS_00000414 hESC 0 8.10623 8.18935 5.41246 6.47536 - OK TCONS_00000414 Fibroblasts 1 0 0 0 0 - OK TCONS_00000414 Fibroblasts 0 4.8288 5.74573 4.69715 5.41195 - OK TCONS_00000415 iPS 0 1.95473 2.04028 3.4884 3.12207 - OK TCONS_00000415 iPS 1 0 0 0 0 - OK TCONS_00000415 hESC 1 13.0377 12.9054 8.52935 7.8994 - OK TCONS_00000415 hESC 0 0 0 0 0 - OK TCONS_00000415 Fibroblasts 1 3.45245 2.88072 2.355 2.11816 - OK TCONS_00000415 Fibroblasts 0 1.56964 1.86769 1.52684 1.37329 - OK TCONS_00000416 iPS 0 0 0 0 0 - OK TCONS_00000416 iPS 1 0 0 0 0 - OK TCONS_00000416 hESC 1 0.522185 0.516885 0.341617 0.192114 - OK TCONS_00000416 hESC 0 0 0 0 0 - OK TCONS_00000416 Fibroblasts 1 0 0 0 0 - OK TCONS_00000416 Fibroblasts 0 0 0 0 0 - OK TCONS_00000417 iPS 0 10.2439 10.6922 18.2812 11.5161 - OK TCONS_00000417 iPS 1 2.92605 2.81902 4.81986 3.03623 - OK TCONS_00000417 hESC 1 183.823 181.957 120.258 77.5931 - OK TCONS_00000417 hESC 0 118.143 119.354 78.8827 50.8967 - OK TCONS_00000417 Fibroblasts 1 5.30723 4.42835 3.62018 2.28847 - OK TCONS_00000417 Fibroblasts 0 6.58659 7.8373 6.40701 4.05013 - OK TCONS_00000418 iPS 0 1.88981 1.97252 3.37254 2.56689 - OK TCONS_00000418 iPS 1 2.57395 2.4798 4.23987 3.22702 - OK TCONS_00000418 hESC 1 81.1943 80.3702 53.1178 41.6194 - OK TCONS_00000418 hESC 0 49.4395 49.9464 33.0103 25.8646 - OK TCONS_00000418 Fibroblasts 1 0.149976 0.12514 0.102302 0.0781924 - OK TCONS_00000418 Fibroblasts 0 0.408318 0.485852 0.397185 0.303579 - OK TCONS_00000419 iPS 0 0 0 0 0 - OK TCONS_00000419 iPS 1 3.43769 3.31195 5.66264 5.33818 - OK TCONS_00000419 hESC 1 4.15042 4.1083 2.71523 2.65369 - OK TCONS_00000419 hESC 0 11.8214 11.9426 7.89306 7.71415 - OK TCONS_00000419 Fibroblasts 1 0 0 0 0 - OK TCONS_00000419 Fibroblasts 0 0 0 0 0 - OK TCONS_00000420 iPS 0 72.2641 75.4268 128.962 28.1148 - OK TCONS_00000420 iPS 1 73.9625 71.2572 121.833 26.5606 - OK TCONS_00000420 hESC 1 2885.41 2856.12 1887.65 414.925 - OK TCONS_00000420 hESC 0 3037.49 3068.63 2028.1 445.797 - OK TCONS_00000420 Fibroblasts 1 776.38 647.812 529.588 115.594 - OK TCONS_00000420 Fibroblasts 0 387.688 461.305 377.118 82.3142 - OK TCONS_00000421 iPS 0 46.9292 48.9832 83.7496 48.423 - OK TCONS_00000421 iPS 1 47.8798 46.1285 78.8687 45.6009 - OK TCONS_00000421 hESC 1 84.0245 83.1717 54.9694 32.4887 - OK TCONS_00000421 hESC 0 75.8964 76.6746 50.6754 29.9508 - OK TCONS_00000421 Fibroblasts 1 12.5398 10.4632 8.55368 4.96147 - OK TCONS_00000421 Fibroblasts 0 4.84492 5.76492 4.71283 2.73363 - OK TCONS_00000422 iPS 0 183.784 191.827 327.979 77.7189 - OK TCONS_00000422 iPS 1 137.034 132.021 225.725 53.4884 - OK TCONS_00000422 hESC 1 583.404 577.483 381.667 91.2537 - OK TCONS_00000422 hESC 0 688.408 695.467 459.644 109.897 - OK TCONS_00000422 Fibroblasts 1 83.2756 69.4851 56.8043 13.4781 - OK TCONS_00000422 Fibroblasts 0 84.8119 100.917 82.4996 19.5749 - OK TCONS_00000423 iPS 0 10.1897 10.6357 18.1845 11.3993 - OK TCONS_00000423 iPS 1 19.6863 18.9663 32.4278 20.3281 - OK TCONS_00000423 hESC 1 143.182 141.729 93.6708 60.1366 - OK TCONS_00000423 hESC 0 155.887 157.485 104.084 66.8221 - OK TCONS_00000423 Fibroblasts 1 123.471 103.024 84.2224 52.98 - OK TCONS_00000423 Fibroblasts 0 74.3219 88.4347 72.2956 45.4774 - OK TCONS_00000424 iPS 0 0 0 0 0 - OK TCONS_00000424 iPS 1 5 4.81711 8.23612 3.16629 - OK TCONS_00000424 hESC 1 2.9493 2.91937 1.92945 0.752634 - OK TCONS_00000424 hESC 0 5.99842 6.05992 4.00509 1.56229 - OK TCONS_00000424 Fibroblasts 1 0 0 0 0 - OK TCONS_00000424 Fibroblasts 0 0 0 0 0 - OK TCONS_00000425 iPS 0 14.6781 15.3206 26.1945 15.2325 - OK TCONS_00000425 iPS 1 0 0 0 0 - OK TCONS_00000425 hESC 1 7.50293 7.42678 4.90847 2.91814 - OK TCONS_00000425 hESC 0 0 0 0 0 - OK TCONS_00000425 Fibroblasts 1 0 0 0 0 - OK TCONS_00000425 Fibroblasts 0 0 0 0 0 - OK TCONS_00000426 iPS 0 0 0 0 0 - OK TCONS_00000426 iPS 1 0 0 0 0 - OK TCONS_00000426 hESC 1 0 0 0 0 - OK TCONS_00000426 hESC 0 0 0 0 0 - OK TCONS_00000426 Fibroblasts 1 0 0 0 0 - OK TCONS_00000426 Fibroblasts 0 0 0 0 0 - OK TCONS_00000427 iPS 0 12.3219 12.8612 21.9895 13.5978 - OK TCONS_00000427 iPS 1 0 0 0 0 - OK TCONS_00000427 hESC 1 0.000308552 0.000305421 0.000201857 0.000127794 - OK TCONS_00000427 hESC 0 0 0 0 0 - OK TCONS_00000427 Fibroblasts 1 2.82618e-05 2.35817e-05 1.92781e-05 1.11079e-05 - OK TCONS_00000427 Fibroblasts 0 0 0 0 0 - OK TCONS_00000428 iPS 0 0 0 0 0 - OK TCONS_00000428 iPS 1 0 0 0 0 - OK TCONS_00000428 hESC 1 6.54746 6.48101 4.28339 3.24822 - OK TCONS_00000428 hESC 0 0.00158422 0.00160047 0.00105777 0.000802138 - OK TCONS_00000428 Fibroblasts 1 1.99997 1.66878 1.36423 0.925111 - OK TCONS_00000428 Fibroblasts 0 0 0 0 0 - OK TCONS_00000429 iPS 0 3 3.1313 5.35378 2.50891 - OK TCONS_00000429 iPS 1 19 18.305 31.2972 14.6666 - OK TCONS_00000429 hESC 1 59 58.4012 38.5982 18.4124 - OK TCONS_00000429 hESC 0 23 23.2358 15.3569 7.32565 - OK TCONS_00000429 Fibroblasts 1 2 1.6688 1.36425 0.605715 - OK TCONS_00000429 Fibroblasts 0 0 0 0 0 - OK TCONS_00000430 iPS 0 0 0 0 0 - OK TCONS_00000430 iPS 1 0 0 0 0 - OK TCONS_00000430 hESC 1 4.75724 4.70896 3.11222 3.30918 - OK TCONS_00000430 hESC 0 0 0 0 0 - OK TCONS_00000430 Fibroblasts 1 0 0 0 0 - OK TCONS_00000430 Fibroblasts 0 0 0 0 0 - OK TCONS_00000431 iPS 0 4 4.17507 7.13837 4.81405 - OK TCONS_00000431 iPS 1 3 2.89027 4.94167 3.33261 - OK TCONS_00000431 hESC 1 6.24276 6.1794 4.08406 2.82588 - OK TCONS_00000431 hESC 0 7 7.07177 4.67384 3.23397 - OK TCONS_00000431 Fibroblasts 1 0 0 0 0 - OK TCONS_00000431 Fibroblasts 0 0 0 0 0 - OK TCONS_00000432 iPS 0 0 0 0 0 - OK TCONS_00000432 iPS 1 0 0 0 0 - OK TCONS_00000432 hESC 1 1 0.989851 0.654207 0.394296 - OK TCONS_00000432 hESC 0 0 0 0 0 - OK TCONS_00000432 Fibroblasts 1 0 0 0 0 - OK TCONS_00000432 Fibroblasts 0 0 0 0 0 - OK TCONS_00000433 iPS 0 52.493 54.7905 93.6787 37.8662 - OK TCONS_00000433 iPS 1 116.129 111.881 191.29 77.3218 - OK TCONS_00000433 hESC 1 179.391 177.571 117.359 48.1699 - OK TCONS_00000433 hESC 0 230.543 232.907 153.932 63.1812 - OK TCONS_00000433 Fibroblasts 1 60.8969 50.8123 41.5392 16.8283 - OK TCONS_00000433 Fibroblasts 0 10.4129 12.3902 10.129 4.10342 - OK TCONS_00000434 iPS 0 84.2079 87.8934 150.277 49.1443 - OK TCONS_00000434 iPS 1 11.7759 11.3452 19.3976 6.3435 - OK TCONS_00000434 hESC 1 295.767 292.765 193.493 64.0644 - OK TCONS_00000434 hESC 0 291.446 294.434 194.596 64.4296 - OK TCONS_00000434 Fibroblasts 1 41.7708 34.8535 28.4928 9.33472 - OK TCONS_00000434 Fibroblasts 0 83.0961 98.8751 80.8306 26.4814 - OK TCONS_00000435 iPS 0 0 0 0 0 - OK TCONS_00000435 iPS 1 0 0 0 0 - OK TCONS_00000435 hESC 1 0 0 0 0 - OK TCONS_00000435 hESC 0 0 0 0 0 - OK TCONS_00000435 Fibroblasts 1 1035.23 863.794 706.154 244.544 - OK TCONS_00000435 Fibroblasts 0 458.496 545.558 445.995 154.45 - OK TCONS_00000436 iPS 0 273.846 285.831 488.703 169.538 - OK TCONS_00000436 iPS 1 262.049 252.464 431.653 149.747 - OK TCONS_00000436 hESC 1 2154.78 2132.91 1409.67 495.497 - OK TCONS_00000436 hESC 0 2011.07 2031.69 1342.77 471.983 - OK TCONS_00000436 Fibroblasts 1 0.394163 0.328889 0.268868 0.0934533 - OK TCONS_00000436 Fibroblasts 0 268.325 319.276 261.009 90.7217 - OK TCONS_00000437 iPS 0 0 0 0 0 - OK TCONS_00000437 iPS 1 0 0 0 0 - OK TCONS_00000437 hESC 1 6.1377 6.0754 4.01532 3.17249 - OK TCONS_00000437 hESC 0 4.86669 4.91659 3.24944 2.56737 - OK TCONS_00000437 Fibroblasts 1 17.6226 14.7043 12.0208 9.2629 - OK TCONS_00000437 Fibroblasts 0 0 0 0 0 - OK TCONS_00000438 iPS 0 47.863 49.9578 85.416 27.265 - OK TCONS_00000438 iPS 1 41.9688 40.4337 69.1321 22.0671 - OK TCONS_00000438 hESC 1 120.46 119.237 78.8055 25.4604 - OK TCONS_00000438 hESC 0 121.37 122.614 81.0376 26.1816 - OK TCONS_00000438 Fibroblasts 1 0 0 0 0 - OK TCONS_00000438 Fibroblasts 0 0 0 0 0 - OK TCONS_00000439 iPS 0 0 0 0 0 - OK TCONS_00000439 iPS 1 0 0 0 0 - OK TCONS_00000439 hESC 1 39.7841 39.3803 26.027 11.2922 - OK TCONS_00000439 hESC 0 0 0 0 0 - OK TCONS_00000439 Fibroblasts 1 0 0 0 0 - OK TCONS_00000439 Fibroblasts 0 0 0 0 0 - OK TCONS_00000440 iPS 0 0 0 0 0 - OK TCONS_00000440 iPS 1 0 0 0 0 - OK TCONS_00000440 hESC 1 0 0 0 0 - OK TCONS_00000440 hESC 0 0 0 0 0 - OK TCONS_00000440 Fibroblasts 1 1878.36 1567.31 1281.28 515.524 - OK TCONS_00000440 Fibroblasts 0 611.75 727.914 595.072 239.428 - OK TCONS_00000441 iPS 0 4.83364 5.04519 8.62608 4.19671 - OK TCONS_00000441 iPS 1 0 0 0 0 - OK TCONS_00000441 hESC 1 14.4365 14.29 9.44447 4.68047 - OK TCONS_00000441 hESC 0 19.3789 19.5776 12.9391 6.41233 - OK TCONS_00000441 Fibroblasts 1 0 0 0 0 - OK TCONS_00000441 Fibroblasts 0 0 0 0 0 - OK TCONS_00000442 iPS 0 10.2567 10.7056 18.304 12.3676 - OK TCONS_00000442 iPS 1 11.5775 11.154 19.0707 12.8857 - OK TCONS_00000442 hESC 1 105.747 104.674 69.1806 47.962 - OK TCONS_00000442 hESC 0 91.8262 92.7677 61.3115 42.5065 - OK TCONS_00000442 Fibroblasts 1 45.7231 38.1513 31.1888 21.1525 - OK TCONS_00000442 Fibroblasts 0 11.4206 13.5892 11.1092 7.53435 - OK TCONS_00000443 iPS 0 10 10.4377 17.8459 14.9238 - OK TCONS_00000443 iPS 1 3 2.89027 4.94167 4.1325 - OK TCONS_00000443 hESC 1 28 27.7158 18.3178 15.8155 - OK TCONS_00000443 hESC 0 33 33.3384 22.0338 19.0239 - OK TCONS_00000443 Fibroblasts 1 14 11.6816 9.54973 8.02307 - OK TCONS_00000443 Fibroblasts 0 7 8.32921 6.80915 5.72061 - OK TCONS_00000444 iPS 0 36.7035 38.3099 65.5008 52.184 - OK TCONS_00000444 iPS 1 49 47.2077 80.7139 64.3042 - OK TCONS_00000444 hESC 1 761.22 753.494 497.995 408.998 - OK TCONS_00000444 hESC 0 736.058 743.605 491.459 403.63 - OK TCONS_00000444 Fibroblasts 1 0 0 0 0 - OK TCONS_00000444 Fibroblasts 0 0 0 0 0 - OK TCONS_00000445 iPS 0 3.29651 3.44079 5.88293 4.84798 - OK TCONS_00000445 iPS 1 0 0 0 0 - OK TCONS_00000445 hESC 1 6.77975 6.71094 4.43535 3.77191 - OK TCONS_00000445 hESC 0 4.94215 4.99282 3.29983 2.80624 - OK TCONS_00000445 Fibroblasts 1 0 0 0 0 - OK TCONS_00000445 Fibroblasts 0 0 0 0 0 - OK TCONS_00000446 iPS 0 1 1.04377 1.78459 2.2722 - OK TCONS_00000446 iPS 1 0 0 0 0 - OK TCONS_00000446 hESC 1 23 22.7666 15.0468 23.9054 - OK TCONS_00000446 hESC 0 13 13.1333 8.67998 13.7902 - OK TCONS_00000446 Fibroblasts 1 0 0 0 0 - OK TCONS_00000446 Fibroblasts 0 0 0 0 0 - OK TCONS_00000447 iPS 0 110 114.814 196.305 56.815 - OK TCONS_00000447 iPS 1 320 308.295 527.111 152.557 - OK TCONS_00000447 hESC 1 989.979 979.932 647.651 189.506 - OK TCONS_00000447 hESC 0 1176 1188.05 785.202 229.754 - OK TCONS_00000447 Fibroblasts 1 0 0 0 0 - OK TCONS_00000447 Fibroblasts 0 0 0 0 0 - OK TCONS_00000448 iPS 0 0 0 0 0 - OK TCONS_00000448 iPS 1 0 0 0 0 - OK TCONS_00000448 hESC 1 0.0207428 0.0205323 0.0135701 0.00495709 - OK TCONS_00000448 hESC 0 77.0041 77.7936 51.4149 18.7817 - OK TCONS_00000448 Fibroblasts 1 6 5.0064 4.09274 1.41447 - OK TCONS_00000448 Fibroblasts 0 0 0 0 0 - OK TCONS_00000449 iPS 0 0 0 0 0 - OK TCONS_00000449 iPS 1 9.11716e-05 8.78368e-05 0.00015018 0.00010157 - OK TCONS_00000449 hESC 1 0.143674 0.142216 0.0939927 0.0652279 - OK TCONS_00000449 hESC 0 0 0 0 0 - OK TCONS_00000449 Fibroblasts 1 0 0 0 0 - OK TCONS_00000449 Fibroblasts 0 0 0 0 0 - OK TCONS_00000450 iPS 0 0 0 0 0 - OK TCONS_00000450 iPS 1 0.000117386 0.000113092 0.00019336 0.000131151 - OK TCONS_00000450 hESC 1 0.856326 0.847635 0.560214 0.389918 - OK TCONS_00000450 hESC 0 0 0 0 0 - OK TCONS_00000450 Fibroblasts 1 0 0 0 0 - OK TCONS_00000450 Fibroblasts 0 0 0 0 0 - OK TCONS_00000451 iPS 0 0 0 0 0 - OK TCONS_00000451 iPS 1 2.99979 2.89007 4.94133 1.18782 - OK TCONS_00000451 hESC 1 0 0 0 0 - OK TCONS_00000451 hESC 0 11 11.1128 7.3446 1.78164 - OK TCONS_00000451 Fibroblasts 1 0 0 0 0 - OK TCONS_00000451 Fibroblasts 0 0 0 0 0 - OK TCONS_00000452 iPS 0 637.5 665.401 1137.68 764.687 - OK TCONS_00000452 iPS 1 699 673.432 1151.41 773.916 - OK TCONS_00000452 hESC 1 2168 2146 1418.32 978.03 - OK TCONS_00000452 hESC 0 2119.5 2141.23 1415.17 975.859 - OK TCONS_00000452 Fibroblasts 1 2660.5 2219.92 1814.79 1224.35 - OK TCONS_00000452 Fibroblasts 0 3138 3733.87 3052.45 2059.34 - OK TCONS_00000453 iPS 0 34.6091 36.1239 61.7633 50.8977 - OK TCONS_00000453 iPS 1 61.1856 58.9475 100.786 83.0556 - OK TCONS_00000453 hESC 1 406.433 402.308 265.891 226.119 - OK TCONS_00000453 hESC 0 372.029 375.844 248.4 211.245 - OK TCONS_00000453 Fibroblasts 1 350.471 292.433 239.065 197.908 - OK TCONS_00000453 Fibroblasts 0 493.658 587.397 480.199 397.53 - OK TCONS_00000454 iPS 0 5.99033 6.25251 10.6903 10.2555 - OK TCONS_00000454 iPS 1 0 0 0 0 - OK TCONS_00000454 hESC 1 6.22915 6.16593 4.07515 4.05564 - OK TCONS_00000454 hESC 0 0 0 0 0 - OK TCONS_00000454 Fibroblasts 1 167.557 139.81 114.295 110.23 - OK TCONS_00000454 Fibroblasts 0 17.0885 20.3334 16.6226 16.0314 - OK TCONS_00000455 iPS 0 20.1913 21.075 36.0333 24.4286 - OK TCONS_00000455 iPS 1 28.329 27.2928 46.6641 31.6357 - OK TCONS_00000455 hESC 1 62.9875 62.3483 41.2069 28.6665 - OK TCONS_00000455 hESC 0 62.6 63.2419 41.7975 29.0774 - OK TCONS_00000455 Fibroblasts 1 138.373 115.459 94.3878 64.2302 - OK TCONS_00000455 Fibroblasts 0 108.696 129.336 105.733 71.9504 - OK TCONS_00000456 iPS 0 0.00625638 0.0065302 0.0111651 0.010941 - OK TCONS_00000456 iPS 1 0 0 0 0 - OK TCONS_00000456 hESC 1 0 0 0 0 - OK TCONS_00000456 hESC 0 43.4967 43.9426 29.0423 29.5477 - OK TCONS_00000456 Fibroblasts 1 0 0 0 0 - OK TCONS_00000456 Fibroblasts 0 19.448 23.141 18.9178 18.6389 - OK TCONS_00000457 iPS 0 80.2029 83.7132 143.13 128.751 - OK TCONS_00000457 iPS 1 27.4855 26.4801 45.2747 40.7263 - OK TCONS_00000457 hESC 1 137.35 135.956 89.8556 83.6573 - OK TCONS_00000457 hESC 0 81.8742 82.7137 54.6667 50.8958 - OK TCONS_00000457 Fibroblasts 1 249.598 208.265 170.257 153.917 - OK TCONS_00000457 Fibroblasts 0 165.109 196.462 160.608 145.194 - OK TCONS_00000458 iPS 0 4.21114 4.39544 7.51516 4.98965 - OK TCONS_00000458 iPS 1 0 0 0 0 - OK TCONS_00000458 hESC 1 26.8685 26.5958 17.5775 11.9692 - OK TCONS_00000458 hESC 0 48.567 49.0649 32.4277 22.0813 - OK TCONS_00000458 Fibroblasts 1 122.75 102.422 83.7305 55.7969 - OK TCONS_00000458 Fibroblasts 0 182.967 217.71 177.979 118.603 - OK TCONS_00000459 iPS 0 242.291 252.895 432.391 252.584 - OK TCONS_00000459 iPS 1 248.502 239.412 409.338 239.118 - OK TCONS_00000459 hESC 1 1492.83 1477.68 976.619 583.308 - OK TCONS_00000459 hESC 0 1675.72 1692.9 1118.86 668.267 - OK TCONS_00000459 Fibroblasts 1 3482.48 2905.78 2375.48 1392.15 - OK TCONS_00000459 Fibroblasts 0 3484.33 4145.96 3389.33 1986.31 - OK TCONS_00000460 iPS 0 0 0 0 0 - OK TCONS_00000460 iPS 1 0 0 0 0 - OK TCONS_00000460 hESC 1 366.881 363.157 240.016 188.164 - OK TCONS_00000460 hESC 0 268.739 271.494 179.435 140.67 - OK TCONS_00000460 Fibroblasts 1 12536.2 10460.2 8551.23 6539.46 - OK TCONS_00000460 Fibroblasts 0 14479.3 17228.7 14084.5 10771 - OK TCONS_00000461 iPS 0 0 0 0 0 - OK TCONS_00000461 iPS 1 0 0 0 0 - OK TCONS_00000461 hESC 1 5.06918 5.01773 3.31629 2.55873 - OK TCONS_00000461 hESC 0 0 0 0 0 - OK TCONS_00000461 Fibroblasts 1 10.9015 9.09622 7.43618 5.59896 - OK TCONS_00000461 Fibroblasts 0 0 0 0 0 - OK TCONS_00000462 iPS 0 0 0 0 0 - OK TCONS_00000462 iPS 1 0 0 0 0 - OK TCONS_00000462 hESC 1 0 0 0 0 - OK TCONS_00000462 hESC 0 0 0 0 0 - OK TCONS_00000462 Fibroblasts 1 73.8844 61.6491 50.3983 37.2721 - OK TCONS_00000462 Fibroblasts 0 24.8472 29.5654 24.1698 17.8748 - OK TCONS_00000463 iPS 0 542.998 566.763 969.03 739.532 - OK TCONS_00000463 iPS 1 142.998 137.768 235.55 179.764 - OK TCONS_00000463 hESC 1 21.8518 21.6301 14.2956 11.2322 - OK TCONS_00000463 hESC 0 54.4715 55.03 36.3702 28.5763 - OK TCONS_00000463 Fibroblasts 1 1052.8 878.46 718.143 550.382 - OK TCONS_00000463 Fibroblasts 0 4872.27 5797.46 4739.44 3632.29 - OK TCONS_00000464 iPS 0 3 3.1313 5.35378 4.17135 - OK TCONS_00000464 iPS 1 2 1.92684 3.29445 2.56684 - OK TCONS_00000464 hESC 1 49 48.5027 32.0561 25.7298 - OK TCONS_00000464 hESC 0 37 37.3794 24.7046 19.8291 - OK TCONS_00000464 Fibroblasts 1 0 0 0 0 - OK TCONS_00000464 Fibroblasts 0 0 0 0 0 - OK TCONS_00000465 iPS 0 389 406.025 694.207 154.925 - OK TCONS_00000465 iPS 1 383 368.991 630.887 140.794 - OK TCONS_00000465 hESC 1 1009 998.759 660.095 148.558 - OK TCONS_00000465 hESC 0 1120 1131.48 747.814 168.3 - OK TCONS_00000465 Fibroblasts 1 633 528.175 431.784 96.4793 - OK TCONS_00000465 Fibroblasts 0 358 425.98 348.24 77.8118 - OK TCONS_00000466 iPS 0 0 0 0 0 - OK TCONS_00000466 iPS 1 0.000145026 0.000139722 0.000238891 0.000128707 - OK TCONS_00000466 hESC 1 0 0 0 0 - OK TCONS_00000466 hESC 0 0 0 0 0 - OK TCONS_00000466 Fibroblasts 1 0 0 0 0 - OK TCONS_00000466 Fibroblasts 0 7.85395 9.34532 7.63982 4.12838 - OK TCONS_00000467 iPS 0 0 0 0 0 - OK TCONS_00000467 iPS 1 0.999855 0.963283 1.64698 0.965287 - OK TCONS_00000467 hESC 1 0 0 0 0 - OK TCONS_00000467 hESC 0 0 0 0 0 - OK TCONS_00000467 Fibroblasts 1 0 0 0 0 - OK TCONS_00000467 Fibroblasts 0 0 0 0 0 - OK TCONS_00000468 iPS 0 0 0 0 0 - OK TCONS_00000468 iPS 1 0 0 0 0 - OK TCONS_00000468 hESC 1 0 0 0 0 - OK TCONS_00000468 hESC 0 3 3.03076 2.00307 1.69429 - OK TCONS_00000468 Fibroblasts 1 82 68.4208 55.9342 46.0621 - OK TCONS_00000468 Fibroblasts 0 309.146 367.849 300.718 247.643 - OK TCONS_00000469 iPS 0 0 0 0 0 - OK TCONS_00000469 iPS 1 0 0 0 0 - OK TCONS_00000469 hESC 1 2 1.9797 1.30841 0.680701 - OK TCONS_00000469 hESC 0 0 0 0 0 - OK TCONS_00000469 Fibroblasts 1 0 0 0 0 - OK TCONS_00000469 Fibroblasts 0 0 0 0 0 - OK TCONS_00000470 iPS 0 7 7.30637 12.4922 6.30307 - OK TCONS_00000470 iPS 1 22 21.1953 36.2389 18.2848 - OK TCONS_00000470 hESC 1 63 62.3606 41.215 21.1976 - OK TCONS_00000470 hESC 0 44 44.4511 29.3784 15.1098 - OK TCONS_00000470 Fibroblasts 1 0 0 0 0 - OK TCONS_00000470 Fibroblasts 0 2 2.37978 1.94547 0.984354 - OK TCONS_00000471 iPS 0 3.46186 3.61338 6.17801 2.44415 - OK TCONS_00000471 iPS 1 1.80182 1.73591 2.968 1.1742 - OK TCONS_00000471 hESC 1 53.6669 53.1222 35.1092 14.0996 - OK TCONS_00000471 hESC 0 35.8685 36.2362 23.949 9.61778 - OK TCONS_00000471 Fibroblasts 1 0 0 0 0 - OK TCONS_00000471 Fibroblasts 0 0 0 0 0 - OK TCONS_00000472 iPS 0 1.53814 1.60546 2.74495 0.90142 - OK TCONS_00000472 iPS 1 0.00593585 0.00571873 0.00977768 0.00321091 - OK TCONS_00000472 hESC 1 22.6823 22.4521 14.8389 4.93388 - OK TCONS_00000472 hESC 0 35.5613 35.9259 23.744 7.89476 - OK TCONS_00000472 Fibroblasts 1 0.00685096 0.00571644 0.00467321 0.00147721 - OK TCONS_00000472 Fibroblasts 0 0 0 0 0 - OK TCONS_00000473 iPS 0 0 0 0 0 - OK TCONS_00000473 iPS 1 3.19225 3.07548 5.25834 1.74954 - OK TCONS_00000473 hESC 1 0 0 0 0 - OK TCONS_00000473 hESC 0 0 0 0 0 - OK TCONS_00000473 Fibroblasts 1 4.99315 4.16628 3.40595 1.09027 - OK TCONS_00000473 Fibroblasts 0 0 0 0 0 - OK TCONS_00000474 iPS 0 0 0 0 0 - OK TCONS_00000474 iPS 1 0 0 0 0 - OK TCONS_00000474 hESC 1 2.65079 2.62389 1.73417 0.91282 - OK TCONS_00000474 hESC 0 3.57025 3.60685 2.38382 1.25478 - OK TCONS_00000474 Fibroblasts 1 0 0 0 0 - OK TCONS_00000474 Fibroblasts 0 0 0 0 0 - OK TCONS_00000475 iPS 0 0 0 0 0 - OK TCONS_00000475 iPS 1 0 0 0 0 - OK TCONS_00000475 hESC 1 0 0 0 0 - OK TCONS_00000475 hESC 0 0 0 0 0 - OK TCONS_00000475 Fibroblasts 1 0 0 0 0 - OK TCONS_00000475 Fibroblasts 0 0 0 0 0 - OK TCONS_00000476 iPS 0 1 1.04377 1.78459 1.04594 - OK TCONS_00000476 iPS 1 3 2.89027 4.94167 2.89628 - OK TCONS_00000476 hESC 1 92 91.0663 60.187 36.0699 - OK TCONS_00000476 hESC 0 115 116.179 76.7845 46.0167 - OK TCONS_00000476 Fibroblasts 1 2 1.6688 1.36425 0.802173 - OK TCONS_00000476 Fibroblasts 0 4 4.75955 3.89094 2.28786 - OK TCONS_00000477 iPS 0 74.0898 77.3324 132.22 236.889 - OK TCONS_00000477 iPS 1 69.0379 66.5126 113.721 203.746 - OK TCONS_00000477 hESC 1 128.138 126.838 83.8289 161.036 - OK TCONS_00000477 hESC 0 89 89.9125 59.4245 114.155 - OK TCONS_00000477 Fibroblasts 1 236 196.918 160.981 291.3 - OK TCONS_00000477 Fibroblasts 0 91 108.28 88.519 160.178 - OK TCONS_00000478 iPS 0 0 0 0 0 - OK TCONS_00000478 iPS 1 0 0 0 0 - OK TCONS_00000478 hESC 1 3.57258 3.53632 2.33721 3.85614 - OK TCONS_00000478 hESC 0 0 0 0 0 - OK TCONS_00000478 Fibroblasts 1 0 0 0 0 - OK TCONS_00000478 Fibroblasts 0 0 0 0 0 - OK TCONS_00000479 iPS 0 2.91024 3.03762 5.1936 11.8583 - OK TCONS_00000479 iPS 1 5.96212 5.74404 9.82095 22.4237 - OK TCONS_00000479 hESC 1 12.2892 12.1645 8.0397 20.0801 - OK TCONS_00000479 hESC 0 0 0 0 0 - OK TCONS_00000479 Fibroblasts 1 0 0 0 0 - OK TCONS_00000479 Fibroblasts 0 0 0 0 0 - OK TCONS_00000480 iPS 0 913.5 953.481 1630.23 925.553 - OK TCONS_00000480 iPS 1 366.279 352.881 603.343 342.545 - OK TCONS_00000480 hESC 1 924.831 915.445 605.031 350.994 - OK TCONS_00000480 hESC 0 805.87 814.133 538.072 312.15 - OK TCONS_00000480 Fibroblasts 1 6385.24 5327.84 4355.52 2480.6 - OK TCONS_00000480 Fibroblasts 0 3454.21 4110.12 3360.04 1913.64 - OK TCONS_00000481 iPS 0 0 0 0 0 - OK TCONS_00000481 iPS 1 4.72093 4.54825 7.77642 7.38003 - OK TCONS_00000481 hESC 1 195.169 193.188 127.681 125.655 - OK TCONS_00000481 hESC 0 167.13 168.843 111.591 109.82 - OK TCONS_00000481 Fibroblasts 1 1701.76 1419.95 1160.81 1107.44 - OK TCONS_00000481 Fibroblasts 0 573.79 682.746 558.146 532.486 - OK TCONS_00000482 iPS 0 3.0001 3.1314 5.35396 3.33702 - OK TCONS_00000482 iPS 1 1 0.963423 1.64722 1.02668 - OK TCONS_00000482 hESC 1 15 14.8478 9.8131 6.26305 - OK TCONS_00000482 hESC 0 21.0005 21.2159 14.0219 8.94923 - OK TCONS_00000482 Fibroblasts 1 14 11.6816 9.54973 5.97272 - OK TCONS_00000482 Fibroblasts 0 1 1.18989 0.972736 0.608381 - OK TCONS_00000483 iPS 0 0 0 0 0 - OK TCONS_00000483 iPS 1 0 0 0 0 - OK TCONS_00000483 hESC 1 12 11.8782 7.85048 52475.4 - OK TCONS_00000483 hESC 0 1 1.01025 0.667691 4463.09 - OK TCONS_00000483 Fibroblasts 1 12 10.0128 8.18549 18756.5 - OK TCONS_00000483 Fibroblasts 0 1.5 1.78483 1.4591 3343.43 - OK TCONS_00000484 iPS 0 22.8501 23.8502 40.7782 16.034 - OK TCONS_00000484 iPS 1 0.00476854 0.00459412 0.00785485 0.00308854 - OK TCONS_00000484 hESC 1 37.5733 37.192 24.5807 9.81018 - OK TCONS_00000484 hESC 0 0 0 0 0 - OK TCONS_00000484 Fibroblasts 1 708.466 591.144 483.261 190.433 - OK TCONS_00000484 Fibroblasts 0 0 0 0 0 - OK TCONS_00000485 iPS 0 131.9 137.673 235.388 80.6898 - OK TCONS_00000485 iPS 1 99.5269 95.8864 163.943 56.1989 - OK TCONS_00000485 hESC 1 198.427 196.413 129.812 45.0799 - OK TCONS_00000485 hESC 0 129.928 131.26 86.7515 30.1262 - OK TCONS_00000485 Fibroblasts 1 2241.22 1870.07 1528.79 525.055 - OK TCONS_00000485 Fibroblasts 0 882.669 1050.28 858.604 294.884 - OK TCONS_00000486 iPS 0 0 0 0 0 - OK TCONS_00000486 iPS 1 0 0 0 0 - OK TCONS_00000486 hESC 1 0 0 0 0 - OK TCONS_00000486 hESC 0 10.1583 10.2624 6.78258 2.73471 - OK TCONS_00000486 Fibroblasts 1 26.318 21.9597 17.9521 7.14582 - OK TCONS_00000486 Fibroblasts 0 39.877 47.4492 38.7898 15.4403 - OK TCONS_00000487 iPS 0 0 0 0 0 - OK TCONS_00000487 iPS 1 25.4683 24.5368 41.952 17.5182 - OK TCONS_00000487 hESC 1 0 0 0 0 - OK TCONS_00000487 hESC 0 112.581 113.735 75.1691 31.8895 - OK TCONS_00000487 Fibroblasts 1 0.33258 0.277505 0.226861 0.0949508 - OK TCONS_00000487 Fibroblasts 0 49.5371 58.9436 48.1865 20.1681 - OK TCONS_00000488 iPS 0 775.518 809.461 1383.99 806.467 - OK TCONS_00000488 iPS 1 975.649 939.962 1607.11 936.486 - OK TCONS_00000488 hESC 1 12318.4 12193.4 8058.79 4801.13 - OK TCONS_00000488 hESC 0 12138.1 12262.6 8104.53 4828.38 - OK TCONS_00000488 Fibroblasts 1 231.955 193.543 158.222 92.4958 - OK TCONS_00000488 Fibroblasts 0 19.9993 23.7969 19.4541 11.3727 - OK TCONS_00000489 iPS 0 14.9357 15.5894 26.6542 15.7986 - OK TCONS_00000489 iPS 1 12.9842 12.5092 21.3878 12.6771 - OK TCONS_00000489 hESC 1 25.3414 25.0842 16.5785 10.0504 - OK TCONS_00000489 hESC 0 156.539 158.144 104.52 63.3631 - OK TCONS_00000489 Fibroblasts 1 0 0 0 0 - OK TCONS_00000489 Fibroblasts 0 0 0 0 0 - OK TCONS_00000490 iPS 0 41.4551 43.2695 73.9805 46.2533 - OK TCONS_00000490 iPS 1 48.3666 46.5975 79.6706 49.8108 - OK TCONS_00000490 hESC 1 563.932 558.209 368.928 236.208 - OK TCONS_00000490 hESC 0 108.626 109.74 72.5287 46.4369 - OK TCONS_00000490 Fibroblasts 1 23.645 19.7294 16.1288 10.1188 - OK TCONS_00000490 Fibroblasts 0 0.000686051 0.000816323 0.000667346 0.000418676 - OK TCONS_00000491 iPS 0 26.5907 27.7545 47.4536 31.2717 - OK TCONS_00000491 iPS 1 0 0 0 0 - OK TCONS_00000491 hESC 1 316.803 313.587 207.254 140.049 - OK TCONS_00000491 hESC 0 236.193 238.614 157.704 106.566 - OK TCONS_00000491 Fibroblasts 1 0 0 0 0 - OK TCONS_00000491 Fibroblasts 0 0 0 0 0 - OK TCONS_00000492 iPS 0 0 0 0 0 - OK TCONS_00000492 iPS 1 0 0 0 0 - OK TCONS_00000492 hESC 1 0 0 0 0 - OK TCONS_00000492 hESC 0 0 0 0 0 - OK TCONS_00000492 Fibroblasts 1 45.3998 37.8815 30.9683 18.3927 - OK TCONS_00000492 Fibroblasts 0 0 0 0 0 - OK TCONS_00000493 iPS 0 18.4148 19.2207 32.8629 12.0916 - OK TCONS_00000493 iPS 1 15.6222 15.0508 25.7332 9.46828 - OK TCONS_00000493 hESC 1 102.993 101.948 67.3789 25.1391 - OK TCONS_00000493 hESC 0 77.795 78.5926 51.943 19.3799 - OK TCONS_00000493 Fibroblasts 1 92.7857 77.4203 63.2913 23.3348 - OK TCONS_00000493 Fibroblasts 0 23.9138 28.4547 23.2618 8.57636 - OK TCONS_00000494 iPS 0 4.94082 5.15706 8.81735 15.2191 - OK TCONS_00000494 iPS 1 3.03528 2.92425 4.99978 8.62985 - OK TCONS_00000494 hESC 1 10.028 9.92623 6.56039 12.1092 - OK TCONS_00000494 hESC 0 8.85521 8.94601 5.91255 10.9134 - OK TCONS_00000494 Fibroblasts 1 217.038 181.097 148.047 257.995 - OK TCONS_00000494 Fibroblasts 0 35.7461 42.5338 34.7715 60.5947 - OK TCONS_00000495 iPS 0 0 0 0 0 - OK TCONS_00000495 iPS 1 1 0.963422 1.64722 2.79543 - OK TCONS_00000495 hESC 1 0 0 0 0 - OK TCONS_00000495 hESC 0 0 0 0 0 - OK TCONS_00000495 Fibroblasts 1 0 0 0 0 - OK TCONS_00000495 Fibroblasts 0 0 0 0 0 - OK TCONS_00000496 iPS 0 0 0 0 0 - OK TCONS_00000496 iPS 1 0 0 0 0 - OK TCONS_00000496 hESC 1 0 0 0 0 - OK TCONS_00000496 hESC 0 0 0 0 0 - OK TCONS_00000496 Fibroblasts 1 0 0 0 0 - OK TCONS_00000496 Fibroblasts 0 0 0 0 0 - OK TCONS_00000497 iPS 0 0 0 0 0 - OK TCONS_00000497 iPS 1 0 0 0 0 - OK TCONS_00000497 hESC 1 0 0 0 0 - OK TCONS_00000497 hESC 0 0 0 0 0 - OK TCONS_00000497 Fibroblasts 1 0 0 0 0 - OK TCONS_00000497 Fibroblasts 0 0 0 0 0 - OK TCONS_00000498 iPS 0 18.6169 19.4317 33.2235 50.3965 - OK TCONS_00000498 iPS 1 0 0 0 0 - OK TCONS_00000498 hESC 1 8.84975 8.75993 5.78956 9.31318 - OK TCONS_00000498 hESC 0 0 0 0 0 - OK TCONS_00000498 Fibroblasts 1 11.5596 9.6453 7.88506 12.0618 - OK TCONS_00000498 Fibroblasts 0 0 0 0 0 - OK TCONS_00000499 iPS 0 205.383 214.372 366.525 596.948 - OK TCONS_00000499 iPS 1 124 119.464 204.256 332.665 - OK TCONS_00000499 hESC 1 389.15 385.201 254.585 441.674 - OK TCONS_00000499 hESC 0 386 389.958 257.729 447.128 - OK TCONS_00000499 Fibroblasts 1 526.44 439.262 359.098 590.158 - OK TCONS_00000499 Fibroblasts 0 276 328.409 268.475 441.225 - OK TCONS_00000500 iPS 0 0 0 0 0 - OK TCONS_00000500 iPS 1 0 0 0 0 - OK TCONS_00000500 hESC 1 0 0 0 0 - OK TCONS_00000500 hESC 0 0 0 0 0 - OK TCONS_00000500 Fibroblasts 1 0 0 0 0 - OK TCONS_00000500 Fibroblasts 0 0 0 0 0 - OK TCONS_00000501 iPS 0 4.79698 5.00693 8.56066 9.00648 - OK TCONS_00000501 iPS 1 9.83028 9.47072 16.1927 17.036 - OK TCONS_00000501 hESC 1 7.99083 7.90973 5.22766 5.72637 - OK TCONS_00000501 hESC 0 18.9929 19.1877 12.6814 13.8912 - OK TCONS_00000501 Fibroblasts 1 111.944 93.4057 76.3594 80.8054 - OK TCONS_00000501 Fibroblasts 0 57.6492 68.5961 56.0775 59.3426 - OK TCONS_00000502 iPS 0 363.151 379.045 648.077 431.299 - OK TCONS_00000502 iPS 1 222.176 214.05 365.974 243.558 - OK TCONS_00000502 hESC 1 218.468 216.251 142.924 97.557 - OK TCONS_00000502 hESC 0 90.874 91.8058 60.6758 41.4162 - OK TCONS_00000502 Fibroblasts 1 1364.29 1138.36 930.614 621.614 - OK TCONS_00000502 Fibroblasts 0 1083.27 1288.97 1053.73 703.854 - OK TCONS_00000503 iPS 0 27.907 29.1284 49.8027 35.2326 - OK TCONS_00000503 iPS 1 383.4 369.376 631.545 446.782 - OK TCONS_00000503 hESC 1 19.4666 19.269 12.7352 9.25552 - OK TCONS_00000503 hESC 0 119.16 120.382 79.5621 57.8233 - OK TCONS_00000503 Fibroblasts 1 0 0 0 0 - OK TCONS_00000503 Fibroblasts 0 0 0 0 0 - OK TCONS_00000504 iPS 0 2956.15 3085.54 5275.53 3873.55 - OK TCONS_00000504 iPS 1 1724.53 1661.45 2840.68 2085.77 - OK TCONS_00000504 hESC 1 2973.52 2943.34 1945.3 1468.87 - OK TCONS_00000504 hESC 0 3145.62 3177.87 2100.3 1585.92 - OK TCONS_00000504 Fibroblasts 1 16630 13876.1 11343.7 8363.04 - OK TCONS_00000504 Fibroblasts 0 13510.2 16075.6 13141.8 9688.65 - OK TCONS_00000505 iPS 0 10.3746 10.8286 18.5144 12.2695 - OK TCONS_00000505 iPS 1 0 0 0 0 - OK TCONS_00000505 hESC 1 0 0 0 0 - OK TCONS_00000505 hESC 0 15.7918 15.9537 10.5441 7.16606 - OK TCONS_00000505 Fibroblasts 1 0 0 0 0 - OK TCONS_00000505 Fibroblasts 0 0 0 0 0 - OK TCONS_00000506 iPS 0 17.6172 18.3882 31.4395 20.4423 - OK TCONS_00000506 iPS 1 62.0659 59.7957 102.236 66.4752 - OK TCONS_00000506 hESC 1 17.5566 17.3784 11.4856 7.65519 - OK TCONS_00000506 hESC 0 24.5622 24.814 16.3999 10.9306 - OK TCONS_00000506 Fibroblasts 1 121.727 101.569 83.0328 54.1834 - OK TCONS_00000506 Fibroblasts 0 86.9269 103.433 84.5569 55.1779 - OK TCONS_00000507 iPS 0 0 0 0 0 - OK TCONS_00000507 iPS 1 13.7297 13.2275 22.6158 3.62528 - OK TCONS_00000507 hESC 1 46.3022 45.8322 30.2912 4.88506 - OK TCONS_00000507 hESC 0 62.8171 63.4612 41.9424 6.76406 - OK TCONS_00000507 Fibroblasts 1 41.8368 34.9086 28.5379 4.57863 - OK TCONS_00000507 Fibroblasts 0 60.9086 72.4744 59.248 9.50577 - OK TCONS_00000508 iPS 0 305.149 318.504 544.567 90.2382 - OK TCONS_00000508 iPS 1 264.819 255.133 436.217 72.2839 - OK TCONS_00000508 hESC 1 561.718 556.017 367.48 61.2754 - OK TCONS_00000508 hESC 0 1534.26 1549.99 1024.41 170.816 - OK TCONS_00000508 Fibroblasts 1 2055.86 1715.41 1402.35 232.591 - OK TCONS_00000508 Fibroblasts 0 1083.45 1289.18 1053.91 174.799 - OK TCONS_00000509 iPS 0 36.9015 38.5166 65.8542 11.3596 - OK TCONS_00000509 iPS 1 0 0 0 0 - OK TCONS_00000509 hESC 1 508.309 503.15 332.539 57.736 - OK TCONS_00000509 hESC 0 826.584 835.059 551.902 95.8222 - OK TCONS_00000509 Fibroblasts 1 0 0 0 0 - OK TCONS_00000509 Fibroblasts 0 78.6883 93.6302 76.5429 13.2159 - OK TCONS_00000510 iPS 0 27.9495 29.1728 49.8785 35.4101 - OK TCONS_00000510 iPS 1 41.4509 39.9347 68.2788 48.4731 - OK TCONS_00000510 hESC 1 27.6707 27.3899 18.1024 13.2037 - OK TCONS_00000510 hESC 0 71.3361 72.0676 47.6305 34.7413 - OK TCONS_00000510 Fibroblasts 1 39.3039 32.7951 26.8101 19.1081 - OK TCONS_00000510 Fibroblasts 0 9.95743 11.8482 9.68596 6.90339 - OK TCONS_00000511 iPS 0 20.8347 21.7465 37.1814 31.3714 - OK TCONS_00000511 iPS 1 21.3347 20.5543 35.1429 29.6514 - OK TCONS_00000511 hESC 1 160.237 158.611 104.828 91.3447 - OK TCONS_00000511 hESC 0 87.5326 88.4301 58.4447 50.9272 - OK TCONS_00000511 Fibroblasts 1 0 0 0 0 - OK TCONS_00000511 Fibroblasts 0 0 0 0 0 - OK TCONS_00000512 iPS 0 4.16534 4.34765 7.43345 2.17769 - OK TCONS_00000512 iPS 1 6.66534 6.42154 10.9793 3.21648 - OK TCONS_00000512 hESC 1 116.763 115.578 76.3869 22.6273 - OK TCONS_00000512 hESC 0 58.4674 59.0669 39.0382 11.5639 - OK TCONS_00000512 Fibroblasts 1 0 0 0 0 - OK TCONS_00000512 Fibroblasts 0 0 0 0 0 - OK TCONS_00000513 iPS 0 0 0 0 0 - OK TCONS_00000513 iPS 1 0 0 0 0 - OK TCONS_00000513 hESC 1 0 0 0 0 - OK TCONS_00000513 hESC 0 0 0 0 0 - OK TCONS_00000513 Fibroblasts 1 0 0 0 0 - OK TCONS_00000513 Fibroblasts 0 0 0 0 0 - OK TCONS_00000514 iPS 0 0 0 0 0 - OK TCONS_00000514 iPS 1 0 0 0 0 - OK TCONS_00000514 hESC 1 0 0 0 0 - OK TCONS_00000514 hESC 0 0 0 0 0 - OK TCONS_00000514 Fibroblasts 1 0 0 0 0 - OK TCONS_00000514 Fibroblasts 0 0 0 0 0 - OK TCONS_00000515 iPS 0 0 0 0 0 - OK TCONS_00000515 iPS 1 0 0 0 0 - OK TCONS_00000515 hESC 1 0 0 0 0 - OK TCONS_00000515 hESC 0 0 0 0 0 - OK TCONS_00000515 Fibroblasts 1 0 0 0 0 - OK TCONS_00000515 Fibroblasts 0 0 0 0 0 - OK TCONS_00000516 iPS 0 0 0 0 0 - OK TCONS_00000516 iPS 1 0 0 0 0 - OK TCONS_00000516 hESC 1 0 0 0 0 - OK TCONS_00000516 hESC 0 0 0 0 0 - OK TCONS_00000516 Fibroblasts 1 0 0 0 0 - OK TCONS_00000516 Fibroblasts 0 0 0 0 0 - OK TCONS_00000517 iPS 0 0 0 0 0 - OK TCONS_00000517 iPS 1 0 0 0 0 - OK TCONS_00000517 hESC 1 0 0 0 0 - OK TCONS_00000517 hESC 0 0 0 0 0 - OK TCONS_00000517 Fibroblasts 1 0 0 0 0 - OK TCONS_00000517 Fibroblasts 0 0 0 0 0 - OK TCONS_00000518 iPS 0 0 0 0 0 - OK TCONS_00000518 iPS 1 0 0 0 0 - OK TCONS_00000518 hESC 1 0 0 0 0 - OK TCONS_00000518 hESC 0 0 0 0 0 - OK TCONS_00000518 Fibroblasts 1 0 0 0 0 - OK TCONS_00000518 Fibroblasts 0 0 0 0 0 - OK TCONS_00000519 iPS 0 14.3858 15.0154 25.6728 9.39718 - OK TCONS_00000519 iPS 1 0 0 0 0 - OK TCONS_00000519 hESC 1 514.682 509.458 336.708 124.967 - OK TCONS_00000519 hESC 0 168.792 170.523 112.701 41.8281 - OK TCONS_00000519 Fibroblasts 1 375.316 313.164 256.012 93.8993 - OK TCONS_00000519 Fibroblasts 0 219.86 261.609 213.866 78.441 - OK TCONS_00000520 iPS 0 0 0 0 0 - OK TCONS_00000520 iPS 1 0 0 0 0 - OK TCONS_00000520 hESC 1 77.0862 76.3039 50.4303 15.3499 - OK TCONS_00000520 hESC 0 284.968 287.889 190.27 57.9142 - OK TCONS_00000520 Fibroblasts 1 0 0 0 0 - OK TCONS_00000520 Fibroblasts 0 464.765 553.018 452.094 136.277 - OK TCONS_00000521 iPS 0 95.6142 99.7989 170.632 51.3821 - OK TCONS_00000521 iPS 1 59.8132 57.6254 98.5257 29.6688 - OK TCONS_00000521 hESC 1 985.732 975.728 644.872 196.412 - OK TCONS_00000521 hESC 0 848.24 856.938 566.362 172.5 - OK TCONS_00000521 Fibroblasts 1 571.271 476.668 389.677 117.538 - OK TCONS_00000521 Fibroblasts 0 4554.38 5419.19 4430.21 1336.28 - OK TCONS_00000522 iPS 0 0 0 0 0 - OK TCONS_00000522 iPS 1 55.1868 53.1682 90.905 28.822 - OK TCONS_00000522 hESC 1 0 0 0 0 - OK TCONS_00000522 hESC 0 0 0 0 0 - OK TCONS_00000522 Fibroblasts 1 650.413 542.705 443.662 140.913 - OK TCONS_00000522 Fibroblasts 0 0 0 0 0 - OK TCONS_00000523 iPS 0 1 1.04377 1.78459 0.743012 - OK TCONS_00000523 iPS 1 4 3.85369 6.58889 2.74327 - OK TCONS_00000523 hESC 1 26 25.7361 17.0094 7.19442 - OK TCONS_00000523 hESC 0 32 32.3281 21.3661 9.03718 - OK TCONS_00000523 Fibroblasts 1 45 37.548 30.6956 12.8095 - OK TCONS_00000523 Fibroblasts 0 59 70.2034 57.3914 23.9499 - OK TCONS_00000524 iPS 0 2089.68 2181.14 3729.24 1839.64 - OK TCONS_00000524 iPS 1 2806.11 2703.47 4622.29 2280.18 - OK TCONS_00000524 hESC 1 9150.75 9057.87 5986.48 3008.93 - OK TCONS_00000524 hESC 0 9743.98 9843.89 6505.97 3270.03 - OK TCONS_00000524 Fibroblasts 1 5306.04 4427.36 3619.38 1790.32 - OK TCONS_00000524 Fibroblasts 0 3526.24 4195.83 3430.1 1696.69 - OK TCONS_00000525 iPS 0 625.316 652.684 1115.93 537.008 - OK TCONS_00000525 iPS 1 715.887 689.702 1179.23 567.465 - OK TCONS_00000525 hESC 1 3304.75 3271.21 2161.99 1059.56 - OK TCONS_00000525 hESC 0 2512.02 2537.78 1677.25 821.993 - OK TCONS_00000525 Fibroblasts 1 1867.29 1558.07 1273.72 614.572 - OK TCONS_00000525 Fibroblasts 0 1224.76 1457.33 1191.37 574.837 - OK TCONS_00000526 iPS 0 3.47603 3.62816 6.2033 12.1952 - OK TCONS_00000526 iPS 1 0.170186 0.163961 0.280334 0.551116 - OK TCONS_00000526 hESC 1 4.30731 4.26359 2.81787 5.98178 - OK TCONS_00000526 hESC 0 0 0 0 0 - OK TCONS_00000526 Fibroblasts 1 83.1586 69.3875 56.7245 112.74 - OK TCONS_00000526 Fibroblasts 0 17.736 21.1039 17.2525 34.2893 - OK TCONS_00000527 iPS 0 15.8525 16.5463 28.2903 15.1153 - OK TCONS_00000527 iPS 1 3.03639 2.92532 5.00161 2.67232 - OK TCONS_00000527 hESC 1 12.693 12.5642 8.30387 4.52762 - OK TCONS_00000527 hESC 0 12.0003 12.1233 8.01248 4.36875 - OK TCONS_00000527 Fibroblasts 1 47.9909 40.0436 32.7357 17.5422 - OK TCONS_00000527 Fibroblasts 0 67.6602 80.508 65.8155 35.2688 - OK TCONS_00000528 iPS 0 2 2.08753 3.56919 2.51118 - OK TCONS_00000528 iPS 1 11 10.5976 18.1195 12.7483 - OK TCONS_00000528 hESC 1 2 1.9797 1.30841 0.945571 - OK TCONS_00000528 hESC 0 2 2.02051 1.33538 0.965061 - OK TCONS_00000528 Fibroblasts 1 0 0 0 0 - OK TCONS_00000528 Fibroblasts 0 0 0 0 0 - OK TCONS_00000529 iPS 0 8.3148e-05 8.67871e-05 0.000148385 0.000117987 - OK TCONS_00000529 iPS 1 0 0 0 0 - OK TCONS_00000529 hESC 1 0 0 0 0 - OK TCONS_00000529 hESC 0 0 0 0 0 - OK TCONS_00000529 Fibroblasts 1 0 0 0 0 - OK TCONS_00000529 Fibroblasts 0 0 0 0 0 - OK TCONS_00000530 iPS 0 0.999917 1.04368 1.78445 1.55335 - OK TCONS_00000530 iPS 1 0 0 0 0 - OK TCONS_00000530 hESC 1 0 0 0 0 - OK TCONS_00000530 hESC 0 0 0 0 0 - OK TCONS_00000530 Fibroblasts 1 0 0 0 0 - OK TCONS_00000530 Fibroblasts 0 0 0 0 0 - OK TCONS_00000531 iPS 0 1133.06 1182.65 2022.05 6507.56 - OK TCONS_00000531 iPS 1 1309.04 1261.16 2156.28 6939.53 - OK TCONS_00000531 hESC 1 3182.66 3150.36 2082.12 7623.06 - OK TCONS_00000531 hESC 0 2780.35 2808.85 1856.41 6796.7 - OK TCONS_00000531 Fibroblasts 1 24077.4 20090.2 16423.8 53812.7 - OK TCONS_00000531 Fibroblasts 0 17255.3 20531.9 16784.9 54995.8 - OK TCONS_00000532 iPS 0 163.08 170.218 291.032 943.061 - OK TCONS_00000532 iPS 1 87.1684 83.98 143.586 465.276 - OK TCONS_00000532 hESC 1 402.695 398.608 263.446 972.076 - OK TCONS_00000532 hESC 0 964.499 974.389 643.987 2376.22 - OK TCONS_00000532 Fibroblasts 1 3182.94 2655.85 2171.16 7163.62 - OK TCONS_00000532 Fibroblasts 0 2947.66 3507.39 2867.3 9460.49 - OK TCONS_00000533 iPS 0 6841.2 7140.62 12208.8 40488.9 - OK TCONS_00000533 iPS 1 5845.59 5631.78 9629 31933.4 - OK TCONS_00000533 hESC 1 30768.5 30456.2 20129 76262.2 - OK TCONS_00000533 hESC 0 27142.3 27420.6 18122.6 68660.9 - OK TCONS_00000533 Fibroblasts 1 28135.6 23476.3 19191.9 64834.9 - OK TCONS_00000533 Fibroblasts 0 13630.2 16218.4 13258.6 44790.6 - OK TCONS_00000534 iPS 0 120.157 125.416 214.432 167.812 - OK TCONS_00000534 iPS 1 220.2 212.145 362.718 283.859 - OK TCONS_00000534 hESC 1 313.465 310.283 205.071 165.35 - OK TCONS_00000534 hESC 0 418.4 422.689 279.362 225.252 - OK TCONS_00000534 Fibroblasts 1 127.937 106.75 87.2686 68.5918 - OK TCONS_00000534 Fibroblasts 0 131.861 156.9 128.266 100.815 - OK TCONS_00000535 iPS 0 1409.05 1470.72 2514.58 744.997 - OK TCONS_00000535 iPS 1 1562.26 1505.12 2573.4 762.424 - OK TCONS_00000535 hESC 1 2522.1 2496.5 1649.97 494.345 - OK TCONS_00000535 hESC 0 2794.38 2823.03 1865.78 559.003 - OK TCONS_00000535 Fibroblasts 1 5747.97 4796.1 3920.82 1163.53 - OK TCONS_00000535 Fibroblasts 0 4474.46 5324.1 4352.47 1291.62 - OK TCONS_00000536 iPS 0 574.799 599.956 1025.78 998.962 - OK TCONS_00000536 iPS 1 652.145 628.291 1074.23 1046.14 - OK TCONS_00000536 hESC 1 1574.86 1558.87 1030.28 1041.47 - OK TCONS_00000536 hESC 0 1922.91 1942.63 1283.91 1297.85 - OK TCONS_00000536 Fibroblasts 1 2045.18 1706.5 1395.07 1365.94 - OK TCONS_00000536 Fibroblasts 0 1824.71 2171.21 1774.97 1737.9 - OK TCONS_00000537 iPS 0 20.201 21.0851 36.0505 36.2046 - OK TCONS_00000537 iPS 1 30.8555 29.7268 50.8258 51.0431 - OK TCONS_00000537 hESC 1 152.145 150.601 99.5341 103.881 - OK TCONS_00000537 hESC 0 36.0897 36.4598 24.0968 25.1492 - OK TCONS_00000537 Fibroblasts 1 237.817 198.435 162.221 163.823 - OK TCONS_00000537 Fibroblasts 0 132.285 157.405 128.679 129.949 - OK TCONS_00000538 iPS 0 35.4679 37.0202 63.2958 58.9617 - OK TCONS_00000538 iPS 1 39.8368 38.3796 65.6201 61.1269 - OK TCONS_00000538 hESC 1 0.305029 0.301933 0.199552 0.192633 - OK TCONS_00000538 hESC 0 0 0 0 0 - OK TCONS_00000538 Fibroblasts 1 0 0 0 0 - OK TCONS_00000538 Fibroblasts 0 0 0 0 0 - OK TCONS_00000539 iPS 0 65.1589 68.0107 116.282 105.405 - OK TCONS_00000539 iPS 1 72.5887 69.9336 119.57 108.385 - OK TCONS_00000539 hESC 1 836.214 827.727 547.057 513.376 - OK TCONS_00000539 hESC 0 496.326 501.414 331.392 310.989 - OK TCONS_00000539 Fibroblasts 1 147.384 122.977 100.534 91.5879 - OK TCONS_00000539 Fibroblasts 0 209.582 249.38 203.868 185.727 - OK TCONS_00000540 iPS 0 456.902 476.899 815.384 792.973 - OK TCONS_00000540 iPS 1 395.028 380.579 650.699 632.814 - OK TCONS_00000540 hESC 1 945.604 936.007 618.62 624.445 - OK TCONS_00000540 hESC 0 1195.14 1207.39 797.984 805.497 - OK TCONS_00000540 Fibroblasts 1 297.928 248.591 203.224 198.705 - OK TCONS_00000540 Fibroblasts 0 307.485 365.873 299.102 292.451 - OK TCONS_00000541 iPS 0 50.4713 52.6803 90.0707 89.5655 - OK TCONS_00000541 iPS 1 141.047 135.888 232.336 231.032 - OK TCONS_00000541 hESC 1 2228.21 2205.6 1457.71 1505.82 - OK TCONS_00000541 hESC 0 2533.53 2559.51 1691.62 1747.45 - OK TCONS_00000541 Fibroblasts 1 670.688 559.622 457.492 457.438 - OK TCONS_00000541 Fibroblasts 0 1160.93 1381.38 1129.28 1129.15 - OK TCONS_00000542 iPS 0 1826 1905.92 3258.67 2053.69 - OK TCONS_00000542 iPS 1 1918 1847.84 3159.37 1991.11 - OK TCONS_00000542 hESC 1 2013.5 1993.06 1317.25 850.301 - OK TCONS_00000542 hESC 0 2796 2824.67 1866.86 1205.09 - OK TCONS_00000542 Fibroblasts 1 4027 3360.13 2746.91 1737.21 - OK TCONS_00000542 Fibroblasts 0 2970 3533.97 2889.03 1827.09 - OK TCONS_00000543 iPS 0 0 0 0 0 - OK TCONS_00000543 iPS 1 0 0 0 0 - OK TCONS_00000543 hESC 1 0 0 0 0 - OK TCONS_00000543 hESC 0 0 0 0 0 - OK TCONS_00000543 Fibroblasts 1 0 0 0 0 - OK TCONS_00000543 Fibroblasts 0 0 0 0 0 - OK TCONS_00000544 iPS 0 0.000560585 0.00058512 0.00100042 0.000537764 - OK TCONS_00000544 iPS 1 25.7499 24.8081 42.4159 22.8003 - OK TCONS_00000544 hESC 1 63.9885 63.339 41.8617 22.9664 - OK TCONS_00000544 hESC 0 72.9965 73.745 48.7391 26.7396 - OK TCONS_00000544 Fibroblasts 1 0 0 0 0 - OK TCONS_00000544 Fibroblasts 0 0 0 0 0 - OK TCONS_00000545 iPS 0 13.3768 13.9623 23.8722 13.3392 - OK TCONS_00000545 iPS 1 1.25006 1.20434 2.05913 1.15059 - OK TCONS_00000545 hESC 1 0.0115437 0.0114266 0.00755199 0.0043104 - OK TCONS_00000545 hESC 0 0.0034833 0.00351901 0.00232577 0.00132746 - OK TCONS_00000545 Fibroblasts 1 0.000192781 0.000160856 0.0001315 7.37064e-05 - OK TCONS_00000545 Fibroblasts 0 0.000129213 0.000153749 0.000125691 7.04501e-05 - OK TCONS_00000546 iPS 0 4.62262 4.82494 8.24951 4.97727 - OK TCONS_00000546 iPS 1 0 0 0 0 - OK TCONS_00000546 hESC 1 0 0 0 0 - OK TCONS_00000546 hESC 0 0 0 0 0 - OK TCONS_00000546 Fibroblasts 1 1.99981 1.66864 1.36412 0.82578 - OK TCONS_00000546 Fibroblasts 0 0.999871 1.18973 0.97261 0.588778 - OK TCONS_00000547 iPS 0 7.60848 7.94148 13.578 11.665 - OK TCONS_00000547 iPS 1 0 0 0 0 - OK TCONS_00000547 hESC 1 0 0 0 0 - OK TCONS_00000547 hESC 0 2.00717 2.02775 1.34017 1.18978 - OK TCONS_00000547 Fibroblasts 1 7.9145 6.60386 5.39867 4.66016 - OK TCONS_00000547 Fibroblasts 0 0 0 0 0 - OK TCONS_00000548 iPS 0 111.424 116.301 198.847 179.785 - OK TCONS_00000548 iPS 1 13.5374 13.0423 22.2992 20.1615 - OK TCONS_00000548 hESC 1 90.7633 89.8421 59.3779 55.5746 - OK TCONS_00000548 hESC 0 91.4322 92.3696 61.0484 57.1381 - OK TCONS_00000548 Fibroblasts 1 300.742 250.939 205.143 186.409 - OK TCONS_00000548 Fibroblasts 0 193.099 229.766 187.835 170.681 - OK TCONS_00000549 iPS 0 1177.14 1228.66 2100.71 565.204 - OK TCONS_00000549 iPS 1 253.933 244.645 418.284 112.541 - OK TCONS_00000549 hESC 1 402.089 398.008 263.049 71.4974 - OK TCONS_00000549 hESC 0 496.766 501.859 331.686 90.153 - OK TCONS_00000549 Fibroblasts 1 9681.61 8078.33 6604.05 1779.49 - OK TCONS_00000549 Fibroblasts 0 3746.35 4457.74 3644.21 981.947 - OK TCONS_00000550 iPS 0 0 0 0 0 - OK TCONS_00000550 iPS 1 0 0 0 0 - OK TCONS_00000550 hESC 1 30.5208 30.211 19.9669 5.31471 - OK TCONS_00000550 hESC 0 18.9029 19.0967 12.6213 3.35949 - OK TCONS_00000550 Fibroblasts 1 517.359 431.684 352.903 93.1394 - OK TCONS_00000550 Fibroblasts 0 119.944 142.719 116.674 30.7929 - OK TCONS_00000551 iPS 0 20.8286 21.7402 37.1706 20.4708 - OK TCONS_00000551 iPS 1 27.5297 26.5227 45.3475 24.974 - OK TCONS_00000551 hESC 1 11.627 11.509 7.60648 4.27763 - OK TCONS_00000551 hESC 0 18.8919 19.0856 12.614 7.09368 - OK TCONS_00000551 Fibroblasts 1 25.3773 21.1748 17.3105 9.56238 - OK TCONS_00000551 Fibroblasts 0 10.6042 12.6178 10.315 5.69808 - OK TCONS_00000552 iPS 0 218.353 227.909 389.671 360.378 - OK TCONS_00000552 iPS 1 146.317 140.965 241.016 222.898 - OK TCONS_00000552 hESC 1 154.955 153.383 101.373 97.129 - OK TCONS_00000552 hESC 0 204.471 206.567 136.523 130.808 - OK TCONS_00000552 Fibroblasts 1 366.42 305.741 249.944 232.342 - OK TCONS_00000552 Fibroblasts 0 213.8 254.398 207.971 193.325 - OK TCONS_00000553 iPS 0 0 0 0 0 - OK TCONS_00000553 iPS 1 45.5432 43.8774 75.0199 85.2002 - OK TCONS_00000553 hESC 1 0 0 0 0 - OK TCONS_00000553 hESC 0 0 0 0 0 - OK TCONS_00000553 Fibroblasts 1 134.565 112.281 91.7901 104.904 - OK TCONS_00000553 Fibroblasts 0 38.8009 46.1687 37.743 43.1353 - OK TCONS_00000554 iPS 0 7.44132 7.767 13.2797 17.0534 - OK TCONS_00000554 iPS 1 0.00313918 0.00302436 0.00517093 0.00664035 - OK TCONS_00000554 hESC 1 7.49381 7.41775 4.9025 6.61494 - OK TCONS_00000554 hESC 0 18.529 18.719 12.3717 16.6931 - OK TCONS_00000554 Fibroblasts 1 66.9558 55.8679 45.6721 59.0695 - OK TCONS_00000554 Fibroblasts 0 32.3924 38.5433 31.5092 40.7521 - OK TCONS_00000555 iPS 0 0 0 0 0 - OK TCONS_00000555 iPS 1 29.137 28.0713 47.9952 61.5222 - OK TCONS_00000555 hESC 1 14.0411 13.8986 9.18577 12.3708 - OK TCONS_00000555 hESC 0 0 0 0 0 - OK TCONS_00000555 Fibroblasts 1 116.866 97.5133 79.7173 102.913 - OK TCONS_00000555 Fibroblasts 0 0.00654386 0.00778646 0.00636545 0.00821765 - OK TCONS_00000556 iPS 0 4.20595 4.39003 7.50591 11.4224 - OK TCONS_00000556 iPS 1 0 0 0 0 - OK TCONS_00000556 hESC 1 6.5098 6.44373 4.25876 6.87415 - OK TCONS_00000556 hESC 0 0 0 0 0 - OK TCONS_00000556 Fibroblasts 1 20.1925 16.8486 13.7738 21.1384 - OK TCONS_00000556 Fibroblasts 0 0 0 0 0 - OK TCONS_00000557 iPS 0 3 3.1313 5.35378 2.00057 - OK TCONS_00000557 iPS 1 1 0.963422 1.64722 0.615525 - OK TCONS_00000557 hESC 1 10 9.89851 6.54207 2.47943 - OK TCONS_00000557 hESC 0 9 9.09228 6.00922 2.27748 - OK TCONS_00000557 Fibroblasts 1 1 0.8344 0.682124 0.244094 - OK TCONS_00000557 Fibroblasts 0 0 0 0 0 - OK TCONS_00000558 iPS 0 1056.49 1102.73 1885.41 708.271 - OK TCONS_00000558 iPS 1 1327.21 1278.66 2186.21 821.27 - OK TCONS_00000558 hESC 1 3040.53 3009.67 1989.13 757.939 - OK TCONS_00000558 hESC 0 3392.58 3427.36 2265.19 863.129 - OK TCONS_00000558 Fibroblasts 1 2986.33 2491.79 2037.04 766.825 - OK TCONS_00000558 Fibroblasts 0 2245.57 2671.98 2184.35 822.276 - OK TCONS_00000559 iPS 0 0 0 0 0 - OK TCONS_00000559 iPS 1 202.968 195.544 334.334 124.406 - OK TCONS_00000559 hESC 1 0 0 0 0 - OK TCONS_00000559 hESC 0 0 0 0 0 - OK TCONS_00000559 Fibroblasts 1 1830.94 1527.74 1248.93 465.686 - OK TCONS_00000559 Fibroblasts 0 1813.71 2158.11 1764.26 657.837 - OK TCONS_00000560 iPS 0 43.7934 45.7101 78.1534 49.6746 - OK TCONS_00000560 iPS 1 31.4446 30.2944 51.7962 32.9218 - OK TCONS_00000560 hESC 1 114.443 113.281 74.8691 48.7518 - OK TCONS_00000560 hESC 0 102.86 103.915 68.6787 44.7208 - OK TCONS_00000560 Fibroblasts 1 69.0144 57.5856 47.0764 30.0273 - OK TCONS_00000560 Fibroblasts 0 41.4381 49.3067 40.3084 25.7104 - OK TCONS_00000561 iPS 0 339.058 353.897 605.08 365.382 - OK TCONS_00000561 iPS 1 290.01 279.402 477.712 288.47 - OK TCONS_00000561 hESC 1 2523.02 2497.41 1650.58 1019.86 - OK TCONS_00000561 hESC 0 1865.68 1884.81 1245.7 769.696 - OK TCONS_00000561 Fibroblasts 1 338.896 282.775 231.169 140.06 - OK TCONS_00000561 Fibroblasts 0 285.895 340.183 278.101 168.495 - OK TCONS_00000562 iPS 0 35.6563 37.2168 63.6319 68.1109 - OK TCONS_00000562 iPS 1 54.3675 52.3789 89.5554 95.8591 - OK TCONS_00000562 hESC 1 105.011 103.945 68.6991 76.6175 - OK TCONS_00000562 hESC 0 81.3797 82.2141 54.3365 60.5994 - OK TCONS_00000562 Fibroblasts 1 202.82 169.233 138.348 148.967 - OK TCONS_00000562 Fibroblasts 0 32.3834 38.5326 31.5005 33.9183 - OK TCONS_00003803 iPS 0 11.7714 12.2866 21.0072 44.0537 - OK TCONS_00003803 iPS 1 0 0 0 0 - OK TCONS_00003803 hESC 1 308.23 305.101 201.646 459.054 - OK TCONS_00003803 hESC 0 183.028 184.905 122.206 278.207 - OK TCONS_00003803 Fibroblasts 1 269.295 224.699 183.692 389.73 - OK TCONS_00003803 Fibroblasts 0 349.578 415.959 340.048 721.461 - OK TCONS_00003804 iPS 0 34.9388 36.4679 62.3515 39.3128 - OK TCONS_00003804 iPS 1 0.183804 0.177081 0.302767 0.190896 - OK TCONS_00003804 hESC 1 0 0 0 0 - OK TCONS_00003804 hESC 0 0 0 0 0 - OK TCONS_00003804 Fibroblasts 1 0 0 0 0 - OK TCONS_00003804 Fibroblasts 0 0 0 0 0 - OK TCONS_00003805 iPS 0 0 0 0 0 - OK TCONS_00003805 iPS 1 0 0 0 0 - OK TCONS_00003805 hESC 1 0 0 0 0 - OK TCONS_00003805 hESC 0 0 0 0 0 - OK TCONS_00003805 Fibroblasts 1 0 0 0 0 - OK TCONS_00003805 Fibroblasts 0 0 0 0 0 - OK TCONS_00003806 iPS 0 0 0 0 0 - OK TCONS_00003806 iPS 1 0 0 0 0 - OK TCONS_00003806 hESC 1 0 0 0 0 - OK TCONS_00003806 hESC 0 0 0 0 0 - OK TCONS_00003806 Fibroblasts 1 0 0 0 0 - OK TCONS_00003806 Fibroblasts 0 0 0 0 0 - OK TCONS_00003807 iPS 0 41.2984 43.1059 73.7009 66.0867 - OK TCONS_00003807 iPS 1 67.9161 65.4319 111.873 100.315 - OK TCONS_00003807 hESC 1 0.0224971 0.0222688 0.0147178 0.0136576 - OK TCONS_00003807 hESC 0 0 0 0 0 - OK TCONS_00003807 Fibroblasts 1 10.3764 8.65805 7.07798 6.37832 - OK TCONS_00003807 Fibroblasts 0 0 0 0 0 - OK TCONS_00003808 iPS 0 8.6933 9.07378 15.514 13.9112 - OK TCONS_00003808 iPS 1 4.54569 4.37942 7.48776 6.71419 - OK TCONS_00003808 hESC 1 0 0 0 0 - OK TCONS_00003808 hESC 0 5.76269 5.82178 3.8477 3.57053 - OK TCONS_00003808 Fibroblasts 1 15.3167 12.7803 10.4479 9.41511 - OK TCONS_00003808 Fibroblasts 0 7.70326 9.16601 7.49324 6.75253 - OK TCONS_00003809 iPS 0 66.6488 69.5658 118.941 105.12 - OK TCONS_00003809 iPS 1 8.62896 8.31334 14.2138 12.5622 - OK TCONS_00003809 hESC 1 130.288 128.966 85.2353 77.9198 - OK TCONS_00003809 hESC 0 215.593 217.803 143.949 131.595 - OK TCONS_00003809 Fibroblasts 1 120.265 100.349 82.0354 72.8587 - OK TCONS_00003809 Fibroblasts 0 292.89 348.506 284.904 253.034 - OK TCONS_00003810 iPS 0 17.9855 18.7727 32.0968 30.917 - OK TCONS_00003810 iPS 1 36.988 35.6351 60.9276 58.6881 - OK TCONS_00003810 hESC 1 30.5784 30.2681 20.0046 19.9932 - OK TCONS_00003810 hESC 0 14.7622 14.9136 9.85659 9.85097 - OK TCONS_00003810 Fibroblasts 1 9.50678 7.93245 6.4848 6.27984 - OK TCONS_00003810 Fibroblasts 0 37.2012 44.2652 36.1869 35.0432 - OK TCONS_00003811 iPS 0 0 0 0 0 - OK TCONS_00003811 iPS 1 0 0 0 0 - OK TCONS_00003811 hESC 1 0 0 0 0 - OK TCONS_00003811 hESC 0 0 0 0 0 - OK TCONS_00003811 Fibroblasts 1 0 0 0 0 - OK TCONS_00003811 Fibroblasts 0 0 0 0 0 - OK TCONS_00003812 iPS 0 27.3522 28.5494 48.8126 22.9127 - OK TCONS_00003812 iPS 1 90.3956 87.0891 148.902 69.8946 - OK TCONS_00003812 hESC 1 61.7974 61.1702 40.4283 19.318 - OK TCONS_00003812 hESC 0 36.7092 37.0856 24.5104 11.7119 - OK TCONS_00003812 Fibroblasts 1 88.231 73.6199 60.1845 28.3241 - OK TCONS_00003812 Fibroblasts 0 127.232 151.391 123.763 58.2453 - OK TCONS_00003813 iPS 0 115.482 120.537 206.089 87.0344 - OK TCONS_00003813 iPS 1 69.2485 66.7156 114.068 48.1725 - OK TCONS_00003813 hESC 1 171.073 169.337 111.917 48.0267 - OK TCONS_00003813 hESC 0 180.309 182.158 120.391 51.6629 - OK TCONS_00003813 Fibroblasts 1 32.2044 26.8713 21.9674 9.29883 - OK TCONS_00003813 Fibroblasts 0 0 0 0 0 - OK TCONS_00003814 iPS 0 3.79331 3.95933 6.76952 9.37399 - OK TCONS_00003814 iPS 1 0 0 0 0 - OK TCONS_00003814 hESC 1 0 0 0 0 - OK TCONS_00003814 hESC 0 4.64749 4.69514 3.10309 4.5329 - OK TCONS_00003814 Fibroblasts 1 0 0 0 0 - OK TCONS_00003814 Fibroblasts 0 0 0 0 0 - OK TCONS_00003815 iPS 0 0 0 0 0 - OK TCONS_00003815 iPS 1 0 0 0 0 - OK TCONS_00003815 hESC 1 0 0 0 0 - OK TCONS_00003815 hESC 0 0 0 0 0 - OK TCONS_00003815 Fibroblasts 1 0 0 0 0 - OK TCONS_00003815 Fibroblasts 0 0 0 0 0 - OK TCONS_00003816 iPS 0 3.50979 3.6634 6.26354 9.1669 - OK TCONS_00003816 iPS 1 6.63614 6.39341 10.9312 15.9982 - OK TCONS_00003816 hESC 1 0 0 0 0 - OK TCONS_00003816 hESC 0 11.0443 11.1575 7.37417 11.4206 - OK TCONS_00003816 Fibroblasts 1 0 0 0 0 - OK TCONS_00003816 Fibroblasts 0 0 0 0 0 - OK TCONS_00003817 iPS 0 0 0 0 0 - OK TCONS_00003817 iPS 1 0 0 0 0 - OK TCONS_00003817 hESC 1 64.7815 64.124 42.3805 68.4073 - OK TCONS_00003817 hESC 0 0.0166873 0.0168584 0.011142 0.0179845 - OK TCONS_00003817 Fibroblasts 1 103.837 86.6416 70.8297 108.701 - OK TCONS_00003817 Fibroblasts 0 0 0 0 0 - OK TCONS_00003818 iPS 0 31.7356 33.1245 56.6351 145.784 - OK TCONS_00003818 iPS 1 45.5666 43.8999 75.0583 193.207 - OK TCONS_00003818 hESC 1 153.782 152.221 100.605 286.708 - OK TCONS_00003818 hESC 0 102.01 103.056 68.1115 194.107 - OK TCONS_00003818 Fibroblasts 1 104.383 87.0974 71.2023 185.924 - OK TCONS_00003818 Fibroblasts 0 96.1734 114.436 93.5513 244.282 - OK TCONS_00003819 iPS 0 281.813 294.147 502.922 504.713 - OK TCONS_00003819 iPS 1 269.947 260.073 444.663 446.247 - OK TCONS_00003819 hESC 1 145.071 143.599 94.9065 98.9784 - OK TCONS_00003819 hESC 0 130.874 132.216 87.3835 91.1326 - OK TCONS_00003819 Fibroblasts 1 101.753 84.9031 69.4085 70.0438 - OK TCONS_00003819 Fibroblasts 0 83.3839 99.2175 81.1105 81.853 - OK TCONS_00003820 iPS 0 0 0 0 0 - OK TCONS_00003820 iPS 1 14.6958 14.1583 24.2073 34.9223 - OK TCONS_00003820 hESC 1 50.8782 50.3619 33.2849 50.7712 - OK TCONS_00003820 hESC 0 33.6814 34.0268 22.4888 34.3034 - OK TCONS_00003820 Fibroblasts 1 5.74455 4.79325 3.9185 5.69836 - OK TCONS_00003820 Fibroblasts 0 11.2293 13.3616 10.9231 15.8846 - OK TCONS_00003821 iPS 0 35.4775 37.0302 63.3129 104.805 - OK TCONS_00003821 iPS 1 8.74769 8.42772 14.4094 23.8526 - OK TCONS_00003821 hESC 1 22.1603 21.9354 14.4974 25.5907 - OK TCONS_00003821 hESC 0 199.219 201.261 133.016 234.799 - OK TCONS_00003821 Fibroblasts 1 0 0 0 0 - OK TCONS_00003821 Fibroblasts 0 229.82 273.46 223.554 373.474 - OK TCONS_00003822 iPS 0 0 0 0 0 - OK TCONS_00003822 iPS 1 0 0 0 0 - OK TCONS_00003822 hESC 1 7.33765 7.26317 4.80034 11.6002 - OK TCONS_00003822 hESC 0 27.343 27.6234 18.2567 44.1181 - OK TCONS_00003822 Fibroblasts 1 36.0869 30.1109 24.6157 55.2067 - OK TCONS_00003822 Fibroblasts 0 23.7892 28.3064 23.1406 51.8984 - OK TCONS_00003823 iPS 0 0 0 0 0 - OK TCONS_00003823 iPS 1 0 0 0 0 - OK TCONS_00003823 hESC 1 0 0 0 0 - OK TCONS_00003823 hESC 0 0 0 0 0 - OK TCONS_00003823 Fibroblasts 1 0 0 0 0 - OK TCONS_00003823 Fibroblasts 0 0 0 0 0 - OK TCONS_00003824 iPS 0 3 3.1313 5.35378 7.87617 - OK TCONS_00003824 iPS 1 8 7.70738 13.1778 19.3864 - OK TCONS_00003824 hESC 1 25 24.7463 16.3552 25.4692 - OK TCONS_00003824 hESC 0 9 9.09228 6.00922 9.35791 - OK TCONS_00003824 Fibroblasts 1 0 0 0 0 - OK TCONS_00003824 Fibroblasts 0 6 7.13933 5.83642 8.65652 - OK TCONS_00003825 iPS 0 14 14.6127 24.9843 16.0241 - OK TCONS_00003825 iPS 1 9 8.6708 14.825 9.50827 - OK TCONS_00003825 hESC 1 6 5.9391 3.92524 2.57971 - OK TCONS_00003825 hESC 0 5.5 5.55639 3.6723 2.41348 - OK TCONS_00003825 Fibroblasts 1 37.6667 31.4291 25.6933 16.5374 - OK TCONS_00003825 Fibroblasts 0 16.5 19.6331 16.0501 10.3306 - OK TCONS_00003826 iPS 0 144.667 150.998 258.171 298.722 - OK TCONS_00003826 iPS 1 199.833 192.524 329.17 380.872 - OK TCONS_00003826 hESC 1 837.667 829.165 548.007 662.914 - OK TCONS_00003826 hESC 0 795.5 803.656 531.148 642.52 - OK TCONS_00003826 Fibroblasts 1 29.2667 24.4201 19.9635 23.2476 - OK TCONS_00003826 Fibroblasts 0 14.1667 16.8567 13.7804 16.0474 - OK TCONS_00003827 iPS 0 0 0 0 0 - OK TCONS_00003827 iPS 1 1 0.963422 1.64722 3.02791 - OK TCONS_00003827 hESC 1 0 0 0 0 - OK TCONS_00003827 hESC 0 0 0 0 0 - OK TCONS_00003827 Fibroblasts 1 0 0 0 0 - OK TCONS_00003827 Fibroblasts 0 0 0 0 0 - OK TCONS_00003828 iPS 0 15.5488 16.2293 27.7482 9.56295 - OK TCONS_00003828 iPS 1 38.7376 37.3207 63.8095 21.9908 - OK TCONS_00003828 hESC 1 97.058 96.073 63.496 22.17 - OK TCONS_00003828 hESC 0 66.4132 67.0942 44.3435 15.4828 - OK TCONS_00003828 Fibroblasts 1 23.2257 19.3795 15.8428 5.47035 - OK TCONS_00003828 Fibroblasts 0 1.64525 1.95767 1.6004 0.552601 - OK TCONS_00003829 iPS 0 243.238 253.883 434.08 148.765 - OK TCONS_00003829 iPS 1 307.386 296.143 506.334 173.527 - OK TCONS_00003829 hESC 1 1241.54 1228.94 812.223 281.992 - OK TCONS_00003829 hESC 0 1368.78 1382.81 913.919 317.299 - OK TCONS_00003829 Fibroblasts 1 181.629 151.551 123.893 42.5403 - OK TCONS_00003829 Fibroblasts 0 101.282 120.514 98.5202 33.8281 - OK TCONS_00003830 iPS 0 157.7 164.602 281.43 85.7135 - OK TCONS_00003830 iPS 1 211.98 204.226 349.179 106.347 - OK TCONS_00003830 hESC 1 1021.69 1011.32 668.394 205.926 - OK TCONS_00003830 hESC 0 876.674 885.663 585.347 180.34 - OK TCONS_00003830 Fibroblasts 1 137.185 114.467 93.5772 28.5482 - OK TCONS_00003830 Fibroblasts 0 58.7138 69.8629 57.1131 17.4239 - OK TCONS_00003831 iPS 0 0 0 0 0 - OK TCONS_00003831 iPS 1 0 0 0 0 - OK TCONS_00003831 hESC 1 4.33333 4.28935 2.8349 835811 - OK TCONS_00003831 hESC 0 7 7.07177 4.67384 1.37799e+06 - OK TCONS_00003831 Fibroblasts 1 0 0 0 0 - OK TCONS_00003831 Fibroblasts 0 0.333333 0.396629 0.324245 28475.5 - OK TCONS_00003832 iPS 0 0 0 0 0 - OK TCONS_00003832 iPS 1 0 0 0 0 - OK TCONS_00003832 hESC 1 0 0 0 0 - OK TCONS_00003832 hESC 0 0 0 0 0 - OK TCONS_00003832 Fibroblasts 1 0 0 0 0 - OK TCONS_00003832 Fibroblasts 0 0 0 0 0 - OK TCONS_00003833 iPS 0 0 0 0 0 - OK TCONS_00003833 iPS 1 0 0 0 0 - OK TCONS_00003833 hESC 1 4.33333 4.28935 2.8349 835811 - OK TCONS_00003833 hESC 0 7 7.07177 4.67384 1.37799e+06 - OK TCONS_00003833 Fibroblasts 1 0 0 0 0 - OK TCONS_00003833 Fibroblasts 0 0.333333 0.396629 0.324245 28475.5 - OK TCONS_00003834 iPS 0 0 0 0 0 - OK TCONS_00003834 iPS 1 0 0 0 0 - OK TCONS_00003834 hESC 1 0 0 0 0 - OK TCONS_00003834 hESC 0 0 0 0 0 - OK TCONS_00003834 Fibroblasts 1 0 0 0 0 - OK TCONS_00003834 Fibroblasts 0 0 0 0 0 - OK TCONS_00003835 iPS 0 24.5097 25.5824 43.7399 120.016 - OK TCONS_00003835 iPS 1 47.8312 46.0817 78.7887 216.185 - OK TCONS_00003835 hESC 1 283.85 280.969 185.697 568.121 - OK TCONS_00003835 hESC 0 268.657 271.411 179.38 548.794 - OK TCONS_00003835 Fibroblasts 1 31.3126 26.1273 21.3591 59.5078 - OK TCONS_00003835 Fibroblasts 0 10.1761 12.1084 9.89865 27.5783 - OK TCONS_00003836 iPS 0 110 114.814 196.305 241.563 - OK TCONS_00003836 iPS 1 123 118.501 202.608 249.319 - OK TCONS_00003836 hESC 1 291.5 288.542 190.701 246.048 - OK TCONS_00003836 hESC 0 278 280.85 185.618 239.489 - OK TCONS_00003836 Fibroblasts 1 71.8333 59.9377 48.9992 60.7083 - OK TCONS_00003836 Fibroblasts 0 32 38.0764 31.1276 38.5659 - OK TCONS_00003837 iPS 0 17 17.744 30.3381 37.3649 - OK TCONS_00003837 iPS 1 10 9.63422 16.4722 20.2875 - OK TCONS_00003837 hESC 1 18 17.8173 11.7757 15.2072 - OK TCONS_00003837 hESC 0 29 29.2973 19.363 25.0055 - OK TCONS_00003837 Fibroblasts 1 53 44.2232 36.1526 44.831 - OK TCONS_00003837 Fibroblasts 0 28 33.3169 27.2366 33.7748 - OK TCONS_00003838 iPS 0 9 9.3939 16.0613 14.7863 - OK TCONS_00003838 iPS 1 13 12.5245 21.4139 19.7139 - OK TCONS_00003838 hESC 1 3 2.96955 1.96262 1.87158 - OK TCONS_00003838 hESC 0 4 4.04101 2.67076 2.54688 - OK TCONS_00003838 Fibroblasts 1 16 13.3504 10.914 10.0989 - OK TCONS_00003838 Fibroblasts 0 5 5.94944 4.86368 4.50045 - OK TCONS_00003839 iPS 0 0 0 0 0 - OK TCONS_00003839 iPS 1 0 0 0 0 - OK TCONS_00003839 hESC 1 0 0 0 0 - OK TCONS_00003839 hESC 0 0 0 0 0 - OK TCONS_00003839 Fibroblasts 1 2 1.6688 1.36425 6.01699 - OK TCONS_00003839 Fibroblasts 0 2 2.37978 1.94547 8.58047 - OK TCONS_00003840 iPS 0 0 0 0 0 - OK TCONS_00003840 iPS 1 0 0 0 0 - OK TCONS_00003840 hESC 1 0 0 0 0 - OK TCONS_00003840 hESC 0 2 2.02051 1.33538 8.77096 - OK TCONS_00003840 Fibroblasts 1 0 0 0 0 - OK TCONS_00003840 Fibroblasts 0 0 0 0 0 - OK TCONS_00003841 iPS 0 51.5489 53.805 91.9938 31.627 - OK TCONS_00003841 iPS 1 71.938 69.3067 118.498 40.739 - OK TCONS_00003841 hESC 1 464.767 460.05 304.054 105.901 - OK TCONS_00003841 hESC 0 417.681 421.964 278.882 97.1336 - OK TCONS_00003841 Fibroblasts 1 137.552 114.773 93.8273 32.3187 - OK TCONS_00003841 Fibroblasts 0 235.171 279.827 228.76 78.796 - OK TCONS_00003842 iPS 0 366.046 382.067 653.243 351.145 - OK TCONS_00003842 iPS 1 332.157 320.007 547.136 294.108 - OK TCONS_00003842 hESC 1 1532.67 1517.12 1002.68 550.099 - OK TCONS_00003842 hESC 0 1548.82 1564.7 1034.13 567.353 - OK TCONS_00003842 Fibroblasts 1 803.577 670.504 548.139 295.524 - OK TCONS_00003842 Fibroblasts 0 1827.83 2174.91 1777.99 958.588 - OK TCONS_00003843 iPS 0 258.495 269.808 461.308 246.567 - OK TCONS_00003843 iPS 1 306.291 295.088 504.53 269.668 - OK TCONS_00003843 hESC 1 2754.34 2726.39 1801.91 982.856 - OK TCONS_00003843 hESC 0 3327.45 3361.57 2221.71 1211.84 - OK TCONS_00003843 Fibroblasts 1 2959.88 2469.72 2019 1082.34 - OK TCONS_00003843 Fibroblasts 0 3502.98 4168.16 3407.48 1826.67 - OK TCONS_00003844 iPS 0 5.50408 5.74498 9.82255 19.0719 - OK TCONS_00003844 iPS 1 20.774 20.0141 34.2194 66.4418 - OK TCONS_00003844 hESC 1 76.5525 75.7755 50.0811 104.896 - OK TCONS_00003844 hESC 0 72.5119 73.2554 48.4156 101.407 - OK TCONS_00003844 Fibroblasts 1 54.8435 45.7614 37.4101 73.4242 - OK TCONS_00003844 Fibroblasts 0 40.35 48.0119 39.2499 77.0351 - OK TCONS_00003845 iPS 0 5 5.21883 8.92297 12.0608 - OK TCONS_00003845 iPS 1 3 2.89027 4.94167 6.67944 - OK TCONS_00003845 hESC 1 24 23.7564 15.701 22.3583 - OK TCONS_00003845 hESC 0 8.90922 9.00057 5.9486 8.47086 - OK TCONS_00003845 Fibroblasts 1 35.3244 29.4746 24.0956 32.8138 - OK TCONS_00003845 Fibroblasts 0 29 34.5067 28.2093 38.416 - OK TCONS_00003846 iPS 0 0 0 0 0 - OK TCONS_00003846 iPS 1 0 0 0 0 - OK TCONS_00003846 hESC 1 0 0 0 0 - OK TCONS_00003846 hESC 0 3.09078 3.12247 2.06369 1.03541 - OK TCONS_00003846 Fibroblasts 1 12.6756 10.5766 8.64636 4.26944 - OK TCONS_00003846 Fibroblasts 0 0 0 0 0 - OK TCONS_00003847 iPS 0 26 27.1379 46.3994 82.6075 - OK TCONS_00003847 iPS 1 8 7.70738 13.1778 23.4611 - OK TCONS_00003847 hESC 1 23.4606 23.2225 15.3481 29.2849 - OK TCONS_00003847 hESC 0 17.9423 18.1263 11.9799 22.8582 - OK TCONS_00003847 Fibroblasts 1 36.4606 30.4227 24.8707 44.7182 - OK TCONS_00003847 Fibroblasts 0 6 7.13933 5.83642 10.4941 - OK TCONS_00003848 iPS 0 0 0 0 0 - OK TCONS_00003848 iPS 1 0 0 0 0 - OK TCONS_00003848 hESC 1 19.5394 19.341 12.7828 22.0683 - OK TCONS_00003848 hESC 0 4.05771 4.09931 2.70929 4.67735 - OK TCONS_00003848 Fibroblasts 1 8.53938 7.12525 5.82491 9.52865 - OK TCONS_00003848 Fibroblasts 0 0 0 0 0 - OK TCONS_00003849 iPS 0 0 0 0 0 - OK TCONS_00003849 iPS 1 2.80275 2.70024 4.61676 3.83585 - OK TCONS_00003849 hESC 1 0.00324721 0.00321426 0.00212435 0.00182192 - OK TCONS_00003849 hESC 0 0 0 0 0 - OK TCONS_00003849 Fibroblasts 1 39.4905 32.9509 26.9374 22.4842 - OK TCONS_00003849 Fibroblasts 0 0 0 0 0 - OK TCONS_00003850 iPS 0 0.000765592 0.0007991 0.00136627 0.00122125 - OK TCONS_00003850 iPS 1 26.4376 25.4706 43.5487 38.9262 - OK TCONS_00003850 hESC 1 20.333 20.1267 13.302 12.3034 - OK TCONS_00003850 hESC 0 56.6692 57.2502 37.8375 34.9971 - OK TCONS_00003850 Fibroblasts 1 38.238 31.9058 26.083 23.4301 - OK TCONS_00003850 Fibroblasts 0 35.5854 42.3427 34.6153 31.0945 - OK TCONS_00003851 iPS 0 11.8605 12.3796 21.1662 19.0277 - OK TCONS_00003851 iPS 1 0 0 0 0 - OK TCONS_00003851 hESC 1 27.0656 26.7909 17.7065 16.4742 - OK TCONS_00003851 hESC 0 10.377 10.4834 6.92861 6.44643 - OK TCONS_00003851 Fibroblasts 1 98.3237 82.0413 67.0689 60.5935 - OK TCONS_00003851 Fibroblasts 0 54.3856 64.7128 52.9029 47.7952 - OK TCONS_00003852 iPS 0 21.2136 22.142 37.8576 20.8086 - OK TCONS_00003852 iPS 1 14.5808 14.0475 24.0178 13.2015 - OK TCONS_00003852 hESC 1 43.2082 42.7697 28.2671 15.865 - OK TCONS_00003852 hESC 0 36.9024 37.2808 24.6394 13.8289 - OK TCONS_00003852 Fibroblasts 1 0 0 0 0 - OK TCONS_00003852 Fibroblasts 0 0 0 0 0 - OK TCONS_00003853 iPS 0 22.5467 23.5335 40.2368 31.4193 - OK TCONS_00003853 iPS 1 28.1245 27.0957 46.3273 36.1751 - OK TCONS_00003853 hESC 1 140.969 139.539 92.2232 74.1911 - OK TCONS_00003853 hESC 0 205.387 207.493 137.135 110.321 - OK TCONS_00003853 Fibroblasts 1 114.317 95.3864 77.9786 61.1541 - OK TCONS_00003853 Fibroblasts 0 1.43664 1.70943 1.39747 1.09595 - OK TCONS_00003854 iPS 0 0 0 0 0 - OK TCONS_00003854 iPS 1 0 0 0 0 - OK TCONS_00003854 hESC 1 8.33928 8.25464 5.45561 3.58549 - OK TCONS_00003854 hESC 0 9.81977 9.92045 6.55657 4.30905 - OK TCONS_00003854 Fibroblasts 1 26.316 21.958 17.9508 11.5539 - OK TCONS_00003854 Fibroblasts 0 0 0 0 0 - OK TCONS_00003855 iPS 0 0 0 0 0 - OK TCONS_00003855 iPS 1 0 0 0 0 - OK TCONS_00003855 hESC 1 45.627 45.1639 29.8495 20.5432 - OK TCONS_00003855 hESC 0 82.4841 83.3299 55.0739 37.9034 - OK TCONS_00003855 Fibroblasts 1 39.9421 33.3277 27.2455 18.3462 - OK TCONS_00003855 Fibroblasts 0 58.1012 69.1339 56.5172 38.0568 - OK TCONS_00003856 iPS 0 15.3784 16.0515 27.4442 15.3049 - OK TCONS_00003856 iPS 1 19.0544 18.3574 31.3868 17.5036 - OK TCONS_00003856 hESC 1 21.4542 21.2365 14.0355 7.99481 - OK TCONS_00003856 hESC 0 17.3608 17.5388 11.5917 6.60276 - OK TCONS_00003856 Fibroblasts 1 49.3723 41.1963 33.6781 18.8394 - OK TCONS_00003856 Fibroblasts 0 38.7842 46.1489 37.7268 21.1042 - OK TCONS_00003857 iPS 0 0 0 0 0 - OK TCONS_00003857 iPS 1 0 0 0 0 - OK TCONS_00003857 hESC 1 0 0 0 0 - OK TCONS_00003857 hESC 0 0 0 0 0 - OK TCONS_00003857 Fibroblasts 1 0 0 0 0 - OK TCONS_00003857 Fibroblasts 0 129.707 154.337 126.17 92.5354 - OK TCONS_00003858 iPS 0 0 0 0 0 - OK TCONS_00003858 iPS 1 1 0.963422 1.64722 0.692545 - OK TCONS_00003858 hESC 1 24 23.7564 15.701 6.70718 - OK TCONS_00003858 hESC 0 19 19.1948 12.6861 5.4193 - OK TCONS_00003858 Fibroblasts 1 0 0 0 0 - OK TCONS_00003858 Fibroblasts 0 0 0 0 0 - OK TCONS_00003859 iPS 0 0.999948 1.04371 1.7845 2.82188 - OK TCONS_00003859 iPS 1 1.00001 0.96343 1.64724 2.60482 - OK TCONS_00003859 hESC 1 16.6149 16.4462 10.8696 18.2746 - OK TCONS_00003859 hESC 0 0 0 0 0 - OK TCONS_00003859 Fibroblasts 1 0.000142285 0.000118723 9.70561e-05 0.00015483 - OK TCONS_00003859 Fibroblasts 0 0 0 0 0 - OK TCONS_00003860 iPS 0 5.17384e-05 5.40028e-05 9.23319e-05 0.000129247 - OK TCONS_00003860 iPS 1 0 0 0 0 - OK TCONS_00003860 hESC 1 0 0 0 0 - OK TCONS_00003860 hESC 0 0 0 0 0 - OK TCONS_00003860 Fibroblasts 1 0 0 0 0 - OK TCONS_00003860 Fibroblasts 0 14.998 17.846 14.5891 20.5811 - OK TCONS_00003861 iPS 0 0 0 0 0 - OK TCONS_00003861 iPS 1 0 0 0 0 - OK TCONS_00003861 hESC 1 20.3851 20.1782 13.3361 19.2818 - OK TCONS_00003861 hESC 0 36 36.3691 24.0369 34.7535 - OK TCONS_00003861 Fibroblasts 1 0 0 0 0 - OK TCONS_00003861 Fibroblasts 0 0.00195717 0.00232881 0.00190381 0.00263063 - OK TCONS_00003862 iPS 0 0 0 0 0 - OK TCONS_00003862 iPS 1 0.999992 0.963414 1.64721 2.83969 - OK TCONS_00003862 hESC 1 0 0 0 0 - OK TCONS_00003862 hESC 0 0 0 0 0 - OK TCONS_00003862 Fibroblasts 1 7.99986 6.67508 5.45689 9.49778 - OK TCONS_00003862 Fibroblasts 0 0 0 0 0 - OK TCONS_00003863 iPS 0 0 0 0 0 - OK TCONS_00003863 iPS 1 1 0.963422 1.64722 2.59032 - OK TCONS_00003863 hESC 1 0.553101 0.547488 0.361843 0.479707 - OK TCONS_00003863 hESC 0 0 0 0 0 - OK TCONS_00003863 Fibroblasts 1 5 4.172 3.41062 5.41031 - OK TCONS_00003863 Fibroblasts 0 4 4.75955 3.89094 6.17226 - OK TCONS_00003864 iPS 0 0 0 0 0 - OK TCONS_00003864 iPS 1 0 0 0 0 - OK TCONS_00003864 hESC 1 2.4469 2.42206 1.60078 1.53065 - OK TCONS_00003864 hESC 0 1 1.01025 0.667691 0.638442 - OK TCONS_00003864 Fibroblasts 1 0 0 0 0 - OK TCONS_00003864 Fibroblasts 0 0 0 0 0 - OK TCONS_00003865 iPS 0 78.2584 81.6836 139.659 58.5954 - OK TCONS_00003865 iPS 1 90.5319 87.2204 149.126 62.5672 - OK TCONS_00003865 hESC 1 401.707 397.63 262.799 112.027 - OK TCONS_00003865 hESC 0 355.653 359.3 237.466 101.228 - OK TCONS_00003865 Fibroblasts 1 216.96 181.032 147.994 62.2363 - OK TCONS_00003865 Fibroblasts 0 197.795 235.354 192.403 80.9116 - OK TCONS_00003866 iPS 0 724.556 756.268 1293.04 986.804 - OK TCONS_00003866 iPS 1 524.829 505.632 864.511 659.766 - OK TCONS_00003866 hESC 1 2865.89 2836.8 1874.88 1473.11 - OK TCONS_00003866 hESC 0 2915.19 2945.08 1946.44 1529.33 - OK TCONS_00003866 Fibroblasts 1 14050.4 11723.6 9584.09 7345.21 - OK TCONS_00003866 Fibroblasts 0 12450.5 14814.7 12111.1 9281.87 - OK TCONS_00003867 iPS 0 39.4876 41.2158 70.4692 50.6123 - OK TCONS_00003867 iPS 1 23.8212 22.9499 39.2389 28.1821 - OK TCONS_00003867 hESC 1 1.00906 0.998815 0.660132 0.487274 - OK TCONS_00003867 hESC 0 67.5082 68.2004 45.0746 33.2717 - OK TCONS_00003867 Fibroblasts 1 916.065 764.364 624.87 450.58 - OK TCONS_00003867 Fibroblasts 0 883.631 1051.42 859.539 619.795 - OK TCONS_00003868 iPS 0 0 0 0 0 - OK TCONS_00003868 iPS 1 0 0 0 0 - OK TCONS_00003868 hESC 1 0 0 0 0 - OK TCONS_00003868 hESC 0 0 0 0 0 - OK TCONS_00003868 Fibroblasts 1 0 0 0 0 - OK TCONS_00003868 Fibroblasts 0 0 0 0 0 - OK TCONS_00003869 iPS 0 0 0 0 0 - OK TCONS_00003869 iPS 1 0 0 0 0 - OK TCONS_00003869 hESC 1 26.5267 26.2575 17.3539 12.7037 - OK TCONS_00003869 hESC 0 0 0 0 0 - OK TCONS_00003869 Fibroblasts 1 36.4927 30.4495 24.8925 17.8042 - OK TCONS_00003869 Fibroblasts 0 88.0251 104.74 85.6252 61.2429 - OK TCONS_00003870 iPS 0 10.6976 11.1658 19.0909 44.7448 - OK TCONS_00003870 iPS 1 4.81789 4.64166 7.93614 18.6006 - OK TCONS_00003870 hESC 1 115.869 114.693 75.8022 194.828 - OK TCONS_00003870 hESC 0 146.151 147.649 97.5835 250.811 - OK TCONS_00003870 Fibroblasts 1 59.1226 49.3318 40.3289 95.7614 - OK TCONS_00003870 Fibroblasts 0 54.0399 64.3014 52.5665 124.82 - OK TCONS_00003871 iPS 0 7 7.30637 12.4922 20.3456 - OK TCONS_00003871 iPS 1 5 4.81711 8.23612 13.4139 - OK TCONS_00003871 hESC 1 49 48.5027 32.0561 55.6135 - OK TCONS_00003871 hESC 0 28 28.2871 18.6953 32.4342 - OK TCONS_00003871 Fibroblasts 1 30 25.032 20.4637 33.631 - OK TCONS_00003871 Fibroblasts 0 73 86.8618 71.0097 116.701 - OK TCONS_00003872 iPS 0 8.27318 8.63527 14.7643 9.97114 - OK TCONS_00003872 iPS 1 21.7352 20.9402 35.8027 24.1796 - OK TCONS_00003872 hESC 1 44.3818 43.9313 29.0348 20.1196 - OK TCONS_00003872 hESC 0 28.1807 28.4697 18.816 13.0385 - OK TCONS_00003872 Fibroblasts 1 0 0 0 0 - OK TCONS_00003872 Fibroblasts 0 70.7855 84.2268 68.8556 46.6761 - OK TCONS_00003873 iPS 0 28.4842 29.7309 50.8328 32.514 - OK TCONS_00003873 iPS 1 10.1541 9.78266 16.726 10.6984 - OK TCONS_00003873 hESC 1 61.0224 60.4031 39.9213 26.1638 - OK TCONS_00003873 hESC 0 67.9199 68.6163 45.3495 29.7214 - OK TCONS_00003873 Fibroblasts 1 48.8667 40.7743 33.3331 21.3963 - OK TCONS_00003873 Fibroblasts 0 103.044 122.611 100.235 64.3402 - OK TCONS_00003874 iPS 0 0 0 0 0 - OK TCONS_00003874 iPS 1 9.83626 9.47647 16.2025 10.7173 - OK TCONS_00003874 hESC 1 0 0 0 0 - OK TCONS_00003874 hESC 0 0 0 0 0 - OK TCONS_00003874 Fibroblasts 1 15.8571 13.2311 10.8165 7.1809 - OK TCONS_00003874 Fibroblasts 0 0 0 0 0 - OK TCONS_00003875 iPS 0 350.226 365.554 625.01 422.912 - OK TCONS_00003875 iPS 1 367.333 353.897 605.079 409.426 - OK TCONS_00003875 hESC 1 1179.8 1167.83 771.833 535.89 - OK TCONS_00003875 hESC 0 1433.72 1448.42 957.282 664.648 - OK TCONS_00003875 Fibroblasts 1 2694.04 2247.91 1837.67 1248.12 - OK TCONS_00003875 Fibroblasts 0 3094.81 3682.47 3010.43 2044.64 - OK TCONS_00003876 iPS 0 12.8416 13.4036 22.9171 14.6055 - OK TCONS_00003876 iPS 1 34.3211 33.0657 56.5345 36.0306 - OK TCONS_00003876 hESC 1 104.051 102.995 68.0707 44.4477 - OK TCONS_00003876 hESC 0 76.8951 77.6835 51.3422 33.5246 - OK TCONS_00003876 Fibroblasts 1 142.884 119.223 97.4648 62.3358 - OK TCONS_00003876 Fibroblasts 0 143.737 171.031 139.818 89.4237 - OK TCONS_00003877 iPS 0 0 0 0 0 - OK TCONS_00003877 iPS 1 0 0 0 0 - OK TCONS_00003877 hESC 1 50.4043 49.8927 32.9748 24.4679 - OK TCONS_00003877 hESC 0 31.4661 31.7887 21.0096 15.5895 - OK TCONS_00003877 Fibroblasts 1 216.875 180.961 147.936 107.22 - OK TCONS_00003877 Fibroblasts 0 120.153 142.969 116.878 84.7096 - OK TCONS_00003878 iPS 0 13.1753 13.752 23.5126 15.0325 - OK TCONS_00003878 iPS 1 4.62052 4.45151 7.61102 4.86601 - OK TCONS_00003878 hESC 1 41.3409 40.9214 27.0455 17.717 - OK TCONS_00003878 hESC 0 56.8183 57.4009 37.9371 24.8518 - OK TCONS_00003878 Fibroblasts 1 121.474 101.357 82.86 53.1632 - OK TCONS_00003878 Fibroblasts 0 211.471 251.627 205.705 131.981 - OK TCONS_00003879 iPS 0 18 18.7878 32.1227 13.5659 - OK TCONS_00003879 iPS 1 30 28.9027 49.4167 20.8694 - OK TCONS_00003879 hESC 1 143 141.549 93.5516 40.1455 - OK TCONS_00003879 hESC 0 121 122.241 80.7906 34.6694 - OK TCONS_00003879 Fibroblasts 1 55 45.892 37.5168 15.8809 - OK TCONS_00003879 Fibroblasts 0 60 71.3933 58.3642 24.7057 - OK TCONS_00003880 iPS 0 25.1584 26.2595 44.8974 20.8672 - OK TCONS_00003880 iPS 1 0 0 0 0 - OK TCONS_00003880 hESC 1 389.534 385.581 254.836 120.547 - OK TCONS_00003880 hESC 0 543.832 549.408 363.112 171.766 - OK TCONS_00003880 Fibroblasts 1 273.615 228.304 186.639 86.9683 - OK TCONS_00003880 Fibroblasts 0 253.495 301.631 246.584 114.901 - OK TCONS_00003881 iPS 0 65.7163 68.5925 117.277 32.1656 - OK TCONS_00003881 iPS 1 42.7309 41.1679 70.3873 19.3051 - OK TCONS_00003881 hESC 1 603.687 597.561 394.936 109.448 - OK TCONS_00003881 hESC 0 645.092 651.706 430.722 119.365 - OK TCONS_00003881 Fibroblasts 1 495.361 413.329 337.897 92.8157 - OK TCONS_00003881 Fibroblasts 0 305.242 363.204 296.92 81.5597 - OK TCONS_00003882 iPS 0 161.987 169.077 289.081 113.857 - OK TCONS_00003882 iPS 1 108.453 104.486 178.645 70.3611 - OK TCONS_00003882 hESC 1 811.742 803.504 531.047 212.301 - OK TCONS_00003882 hESC 0 539.414 544.944 360.162 143.984 - OK TCONS_00003882 Fibroblasts 1 2556.81 2133.4 1744.06 688.41 - OK TCONS_00003882 Fibroblasts 0 2407.08 2864.16 2341.46 924.213 - OK TCONS_00003883 iPS 0 26.1737 27.3193 46.7095 37.1504 - OK TCONS_00003883 iPS 1 10.9073 10.5084 17.9668 14.2899 - OK TCONS_00003883 hESC 1 208.706 206.588 136.537 111.941 - OK TCONS_00003883 hESC 0 235.687 238.103 157.366 129.018 - OK TCONS_00003883 Fibroblasts 1 211.874 176.788 144.525 115.455 - OK TCONS_00003883 Fibroblasts 0 187.616 223.242 182.501 145.793 - OK TCONS_00003884 iPS 0 104.87 109.46 187.151 97.5972 - OK TCONS_00003884 iPS 1 69.6447 67.0973 114.72 59.8254 - OK TCONS_00003884 hESC 1 304.914 301.819 199.477 106.105 - OK TCONS_00003884 hESC 0 239.672 242.13 160.027 85.1209 - OK TCONS_00003884 Fibroblasts 1 361.353 301.513 246.488 128.912 - OK TCONS_00003884 Fibroblasts 0 217.147 258.38 211.227 110.47 - OK TCONS_00003885 iPS 0 447.633 467.225 798.843 574.327 - OK TCONS_00003885 iPS 1 522.131 503.033 860.067 618.344 - OK TCONS_00003885 hESC 1 3429.1 3394.29 2243.34 1657.64 - OK TCONS_00003885 hESC 0 3190.17 3222.88 2130.05 1573.93 - OK TCONS_00003885 Fibroblasts 1 3873.42 3231.98 2642.15 1907.14 - OK TCONS_00003885 Fibroblasts 0 3921.06 4665.62 3814.16 2753.11 - OK TCONS_00003886 iPS 0 11.8077 12.3245 21.0719 12.2135 - OK TCONS_00003886 iPS 1 19.7221 19.0007 32.4868 18.8296 - OK TCONS_00003886 hESC 1 101.381 100.352 66.3239 39.2981 - OK TCONS_00003886 hESC 0 113.185 114.346 75.5729 44.7784 - OK TCONS_00003886 Fibroblasts 1 77.9182 65.0149 53.1498 30.905 - OK TCONS_00003886 Fibroblasts 0 12.8723 15.3165 12.5213 7.28077 - OK TCONS_00003887 iPS 0 5.80171 6.05563 10.3537 6.25215 - OK TCONS_00003887 iPS 1 16.9533 16.3332 27.9259 16.8633 - OK TCONS_00003887 hESC 1 99.9958 98.981 65.4179 40.4206 - OK TCONS_00003887 hESC 0 87.7413 88.6409 58.584 36.1981 - OK TCONS_00003887 Fibroblasts 1 105.645 88.1504 72.0632 43.6614 - OK TCONS_00003887 Fibroblasts 0 23.548 28.0195 22.906 13.8782 - OK TCONS_00003888 iPS 0 0 0 0 0 - OK TCONS_00003888 iPS 1 0 0 0 0 - OK TCONS_00003888 hESC 1 55.0225 54.4641 35.9961 31.5997 - OK TCONS_00003888 hESC 0 24.3848 24.6348 16.2815 14.2929 - OK TCONS_00003888 Fibroblasts 1 0 0 0 0 - OK TCONS_00003888 Fibroblasts 0 7.50965 8.93564 7.30491 6.23713 - OK TCONS_00003889 iPS 0 0 0 0 0 - OK TCONS_00003889 iPS 1 0 0 0 0 - OK TCONS_00003889 hESC 1 0 0 0 0 - OK TCONS_00003889 hESC 0 0 0 0 0 - OK TCONS_00003889 Fibroblasts 1 0 0 0 0 - OK TCONS_00003889 Fibroblasts 0 0 0 0 0 - OK TCONS_00003890 iPS 0 0 0 0 0 - OK TCONS_00003890 iPS 1 0 0 0 0 - OK TCONS_00003890 hESC 1 0 0 0 0 - OK TCONS_00003890 hESC 0 0 0 0 0 - OK TCONS_00003890 Fibroblasts 1 0 0 0 0 - OK TCONS_00003890 Fibroblasts 0 0 0 0 0 - OK TCONS_00003891 iPS 0 15.9255 16.6225 28.4205 22.9658 - OK TCONS_00003891 iPS 1 16.9574 16.3371 27.9325 22.5715 - OK TCONS_00003891 hESC 1 216.39 214.194 141.564 117.977 - OK TCONS_00003891 hESC 0 159.979 161.619 106.816 89.019 - OK TCONS_00003891 Fibroblasts 1 172.528 143.957 117.685 95.5243 - OK TCONS_00003891 Fibroblasts 0 68.8413 81.9134 66.9645 54.3546 - OK TCONS_00003892 iPS 0 28.6912 29.947 51.2022 38.0894 - OK TCONS_00003892 iPS 1 0.859475 0.828037 1.41575 1.05318 - OK TCONS_00003892 hESC 1 9.28771 9.19345 6.07608 4.65004 - OK TCONS_00003892 hESC 0 7.75954 7.8391 5.18098 3.96502 - OK TCONS_00003892 Fibroblasts 1 0 0 0 0 - OK TCONS_00003892 Fibroblasts 0 7.23716 8.61141 7.03985 5.25856 - OK TCONS_00003893 iPS 0 0 0 0 0 - OK TCONS_00003893 iPS 1 0 0 0 0 - OK TCONS_00003893 hESC 1 60.4223 59.809 39.5286 27.6623 - OK TCONS_00003893 hESC 0 165.152 166.845 110.27 77.1676 - OK TCONS_00003893 Fibroblasts 1 112.85 94.1619 76.9776 52.6869 - OK TCONS_00003893 Fibroblasts 0 147.294 175.263 143.278 98.0658 - OK TCONS_00003894 iPS 0 5.20238 5.43007 9.28413 9.36371 - OK TCONS_00003894 iPS 1 0 0 0 0 - OK TCONS_00003894 hESC 1 61.4199 60.7965 40.1813 42.1227 - OK TCONS_00003894 hESC 0 61.8249 62.4588 41.2799 43.2744 - OK TCONS_00003894 Fibroblasts 1 0 0 0 0 - OK TCONS_00003894 Fibroblasts 0 8.2092 9.76803 7.98539 8.09893 - OK TCONS_00003895 iPS 0 35.6427 37.2027 63.6078 96.074 - OK TCONS_00003895 iPS 1 47.9859 46.2307 79.0435 119.388 - OK TCONS_00003895 hESC 1 486.627 481.688 318.354 509.791 - OK TCONS_00003895 hESC 0 360.473 364.169 240.685 385.416 - OK TCONS_00003895 Fibroblasts 1 448.214 373.99 305.738 465.674 - OK TCONS_00003895 Fibroblasts 0 248.676 295.897 241.896 368.436 - OK TCONS_00003896 iPS 0 65.4244 68.2878 116.756 71.326 - OK TCONS_00003896 iPS 1 76.996 74.1796 126.83 77.48 - OK TCONS_00003896 hESC 1 321.575 318.311 210.376 131.539 - OK TCONS_00003896 hESC 0 324.129 327.452 216.418 135.317 - OK TCONS_00003896 Fibroblasts 1 19.6777 16.4191 13.4226 8.22763 - OK TCONS_00003896 Fibroblasts 0 31.4976 37.4787 30.6389 18.7806 - OK TCONS_00003897 iPS 0 73.7245 76.9513 131.568 92.384 - OK TCONS_00003897 iPS 1 28.932 27.8738 47.6575 33.4639 - OK TCONS_00003897 hESC 1 476.749 471.91 311.892 224.94 - OK TCONS_00003897 hESC 0 611.57 617.841 408.34 294.499 - OK TCONS_00003897 Fibroblasts 1 217.044 181.101 148.051 104.362 - OK TCONS_00003897 Fibroblasts 0 538.467 640.716 523.787 369.222 - OK TCONS_00003898 iPS 0 0 0 0 0 - OK TCONS_00003898 iPS 1 13.0975 12.6185 21.5746 15.0669 - OK TCONS_00003898 hESC 1 80.5605 79.7428 52.7032 37.7982 - OK TCONS_00003898 hESC 0 58.2973 58.8951 38.9246 27.9163 - OK TCONS_00003898 Fibroblasts 1 105.456 87.9923 71.9339 50.4304 - OK TCONS_00003898 Fibroblasts 0 79.7046 94.8395 77.5315 54.3547 - OK TCONS_00003899 iPS 0 222.901 232.656 397.787 204.205 - OK TCONS_00003899 iPS 1 168.483 162.32 277.529 142.47 - OK TCONS_00003899 hESC 1 2100.48 2079.16 1374.15 719.299 - OK TCONS_00003899 hESC 0 1870.48 1889.66 1248.91 653.742 - OK TCONS_00003899 Fibroblasts 1 2789.77 2327.78 1902.97 979.669 - OK TCONS_00003899 Fibroblasts 0 3112.67 3703.73 3027.81 1558.75 - OK TCONS_00003900 iPS 0 49.3747 51.5357 88.1137 29.4346 - OK TCONS_00003900 iPS 1 56.4872 54.421 93.047 31.0826 - OK TCONS_00003900 hESC 1 936.881 927.372 612.914 207.349 - OK TCONS_00003900 hESC 0 819.648 828.052 547.272 185.142 - OK TCONS_00003900 Fibroblasts 1 87.7291 73.2011 59.8421 20.0274 - OK TCONS_00003900 Fibroblasts 0 84.656 100.731 82.348 27.5594 - OK TCONS_00003901 iPS 0 9.58545 10.005 17.1061 13.1685 - OK TCONS_00003901 iPS 1 0 0 0 0 - OK TCONS_00003901 hESC 1 34.5364 34.1859 22.5939 17.9114 - OK TCONS_00003901 hESC 0 0 0 0 0 - OK TCONS_00003901 Fibroblasts 1 202.885 169.287 138.393 106.991 - OK TCONS_00003901 Fibroblasts 0 108.858 129.528 105.89 81.8632 - OK TCONS_00003902 iPS 0 115.644 120.705 206.377 160.443 - OK TCONS_00003902 iPS 1 29.2134 28.1448 48.121 37.4106 - OK TCONS_00003902 hESC 1 0 0 0 0 - OK TCONS_00003902 hESC 0 27.7222 28.0064 18.5099 14.8233 - OK TCONS_00003902 Fibroblasts 1 6717.48 5605.07 4582.16 3577.65 - OK TCONS_00003902 Fibroblasts 0 3388.16 4031.53 3295.79 2573.28 - OK TCONS_00003903 iPS 0 320.867 334.911 572.618 442.978 - OK TCONS_00003903 iPS 1 38.3439 36.9414 63.161 48.8614 - OK TCONS_00003903 hESC 1 141.068 139.636 92.2878 73.5322 - OK TCONS_00003903 hESC 0 71.0418 71.7702 47.434 37.794 - OK TCONS_00003903 Fibroblasts 1 8008.24 6682.07 5462.61 4244.01 - OK TCONS_00003903 Fibroblasts 0 2561.58 3047.99 2491.74 1935.88 - OK TCONS_00003904 iPS 0 1167.45 1218.54 2083.42 1382.63 - OK TCONS_00003904 iPS 1 43.4427 41.8536 71.5598 47.4894 - OK TCONS_00003904 hESC 1 137.916 136.517 90.2258 61.4087 - OK TCONS_00003904 hESC 0 154.248 155.83 102.99 70.0963 - OK TCONS_00003904 Fibroblasts 1 11568.8 9652.97 7891.33 5256.21 - OK TCONS_00003904 Fibroblasts 0 16556.2 19700.1 16104.9 10727 - OK TCONS_00003905 iPS 0 4.45588 4.6509 7.95193 4.39301 - OK TCONS_00003905 iPS 1 0 0 0 0 - OK TCONS_00003905 hESC 1 42.479 42.0479 27.7901 15.6781 - OK TCONS_00003905 hESC 0 57.9877 58.5823 38.7179 21.8431 - OK TCONS_00003905 Fibroblasts 1 76.2886 63.6552 52.0383 28.8363 - OK TCONS_00003905 Fibroblasts 0 17.4931 20.8148 17.0162 9.42927 - OK TCONS_00003906 iPS 0 345.475 360.596 616.533 1421.47 - OK TCONS_00003906 iPS 1 393.813 379.408 648.698 1495.62 - OK TCONS_00003906 hESC 1 1477.45 1462.46 966.561 2439.94 - OK TCONS_00003906 hESC 0 1000.85 1011.11 668.257 1686.92 - OK TCONS_00003906 Fibroblasts 1 1664.9 1389.19 1135.67 2652.13 - OK TCONS_00003906 Fibroblasts 0 1539.62 1831.98 1497.65 3497.47 - OK TCONS_00003907 iPS 0 18.8254 19.6493 33.5957 73.6178 - OK TCONS_00003907 iPS 1 0 0 0 0 - OK TCONS_00003907 hESC 1 107.087 106 70.0569 167.295 - OK TCONS_00003907 hESC 0 143.201 144.669 95.6137 228.324 - OK TCONS_00003907 Fibroblasts 1 403.006 336.268 274.9 609.763 - OK TCONS_00003907 Fibroblasts 0 133.082 158.353 129.454 287.146 - OK TCONS_00003908 iPS 0 123.644 129.055 220.654 420.92 - OK TCONS_00003908 iPS 1 68.2766 65.7792 112.467 214.542 - OK TCONS_00003908 hESC 1 471.556 466.77 308.495 633.943 - OK TCONS_00003908 hESC 0 532.368 537.827 355.458 730.45 - OK TCONS_00003908 Fibroblasts 1 712.53 594.535 486.034 937.029 - OK TCONS_00003908 Fibroblasts 0 1143.42 1360.54 1112.24 2144.31 - OK TCONS_00003909 iPS 0 273.055 285.006 487.293 838.021 - OK TCONS_00003909 iPS 1 198.91 191.635 327.649 563.475 - OK TCONS_00003909 hESC 1 705.903 698.739 461.807 849.081 - OK TCONS_00003909 hESC 0 803.584 811.823 536.545 986.496 - OK TCONS_00003909 Fibroblasts 1 923.565 770.622 629.986 1093.8 - OK TCONS_00003909 Fibroblasts 0 1528.87 1819.19 1487.19 2582.12 - OK TCONS_00003910 iPS 0 8.90054 9.29009 15.8838 8.18071 - OK TCONS_00003910 iPS 1 3.01497 2.90469 4.96633 2.55783 - OK TCONS_00003910 hESC 1 46.5548 46.0823 30.4565 15.9958 - OK TCONS_00003910 hESC 0 42.8177 43.2568 28.589 15.015 - OK TCONS_00003910 Fibroblasts 1 13.2597 11.0639 9.04479 4.67165 - OK TCONS_00003910 Fibroblasts 0 15.9027 18.9224 15.4691 7.98983 - OK TCONS_00003911 iPS 0 120.615 125.894 215.25 72.5904 - OK TCONS_00003911 iPS 1 279.181 268.969 459.874 155.087 - OK TCONS_00003911 hESC 1 490.114 485.14 320.636 109.519 - OK TCONS_00003911 hESC 0 475.318 480.192 317.366 108.402 - OK TCONS_00003911 Fibroblasts 1 545.242 454.949 371.922 125.66 - OK TCONS_00003911 Fibroblasts 0 329.234 391.752 320.258 108.205 - OK TCONS_00003912 iPS 0 6.45637 6.73894 11.522 6.03529 - OK TCONS_00003912 iPS 1 8.53526 8.22306 14.0595 7.36444 - OK TCONS_00003912 hESC 1 229.648 227.317 150.237 80.2757 - OK TCONS_00003912 hESC 0 378.395 382.275 252.651 134.998 - OK TCONS_00003912 Fibroblasts 1 99.7203 83.2066 68.0216 35.7335 - OK TCONS_00003912 Fibroblasts 0 26.8704 31.9727 26.1378 13.7309 - OK TCONS_00003913 iPS 0 634.503 662.273 1132.33 313.973 - OK TCONS_00003913 iPS 1 840.827 810.071 1385.03 384.042 - OK TCONS_00003913 hESC 1 1975.54 1955.49 1292.41 362.136 - OK TCONS_00003913 hESC 0 1889.76 1909.14 1261.78 353.551 - OK TCONS_00003913 Fibroblasts 1 4584.83 3825.58 3127.42 868.503 - OK TCONS_00003913 Fibroblasts 0 1880.69 2237.81 1829.42 508.04 - OK TCONS_00003914 iPS 0 158.248 165.174 282.409 135.531 - OK TCONS_00003914 iPS 1 266.125 256.391 438.367 210.378 - OK TCONS_00003914 hESC 1 1367.47 1353.59 894.609 437.221 - OK TCONS_00003914 hESC 0 1417.91 1432.45 946.728 462.693 - OK TCONS_00003914 Fibroblasts 1 740.323 617.725 504.992 242.996 - OK TCONS_00003914 Fibroblasts 0 715.986 851.942 696.465 335.13 - OK TCONS_00003915 iPS 0 18.1219 18.915 32.3402 15.4471 - OK TCONS_00003915 iPS 1 24.3475 23.4569 40.1057 19.1562 - OK TCONS_00003915 hESC 1 302.689 299.616 198.021 96.3126 - OK TCONS_00003915 hESC 0 308.993 312.161 206.312 100.345 - OK TCONS_00003915 Fibroblasts 1 129.419 107.987 88.2797 42.2777 - OK TCONS_00003915 Fibroblasts 0 19.4567 23.1513 18.9263 9.06391 - OK TCONS_00003916 iPS 0 178.155 185.952 317.934 122.493 - OK TCONS_00003916 iPS 1 65.9694 63.5564 108.666 41.8666 - OK TCONS_00003916 hESC 1 371.98 368.204 243.352 95.1355 - OK TCONS_00003916 hESC 0 485.801 490.782 324.365 126.807 - OK TCONS_00003916 Fibroblasts 1 580.208 484.125 395.774 152.808 - OK TCONS_00003916 Fibroblasts 0 171.857 204.49 167.171 64.5446 - OK TCONS_00003917 iPS 0 750.602 783.454 1339.52 3356.43 - OK TCONS_00003917 iPS 1 622.375 599.61 1025.19 2568.81 - OK TCONS_00003917 hESC 1 2365.75 2341.74 1547.69 4281.29 - OK TCONS_00003917 hESC 0 2580.43 2606.88 1722.93 4766.04 - OK TCONS_00003917 Fibroblasts 1 4306.95 3593.72 2937.88 7464.7 - OK TCONS_00003917 Fibroblasts 0 3837.09 4565.7 3732.47 9483.65 - OK TCONS_00003918 iPS 0 42.4165 44.273 75.6963 109.202 - OK TCONS_00003918 iPS 1 43.5855 41.9912 71.795 103.574 - OK TCONS_00003918 hESC 1 99.5118 98.5019 65.1013 99.3025 - OK TCONS_00003918 hESC 0 82.8222 83.6714 55.2997 84.3515 - OK TCONS_00003918 Fibroblasts 1 41.0189 34.2262 27.98 40.6891 - OK TCONS_00003918 Fibroblasts 0 24.0582 28.6265 23.4023 34.032 - OK TCONS_00003919 iPS 0 24.4244 25.4934 43.5876 47.8505 - OK TCONS_00003919 iPS 1 26.6862 25.7101 43.9581 48.2573 - OK TCONS_00003919 hESC 1 27.602 27.3219 18.0574 20.6767 - OK TCONS_00003919 hESC 0 0.00428648 0.00433043 0.00286205 0.0032772 - OK TCONS_00003919 Fibroblasts 1 58.7495 49.0205 40.0744 44.2621 - OK TCONS_00003919 Fibroblasts 0 116.513 138.638 113.337 125.18 - OK TCONS_00003920 iPS 0 0.00440098 0.0045936 0.00785396 0.0084968 - OK TCONS_00003920 iPS 1 0.00485799 0.0046803 0.00800219 0.00865717 - OK TCONS_00003920 hESC 1 54.2718 53.721 35.505 40.0393 - OK TCONS_00003920 hESC 0 99.0933 100.109 66.1637 74.6134 - OK TCONS_00003920 Fibroblasts 1 0.00529645 0.00441935 0.00361283 0.00393203 - OK TCONS_00003920 Fibroblasts 0 0.00387995 0.00461671 0.00377417 0.00410762 - OK TCONS_00003921 iPS 0 6.57122 6.85883 11.727 8.97384 - OK TCONS_00003921 iPS 1 3.30897 3.18793 5.45061 4.17097 - OK TCONS_00003921 hESC 1 15.1262 14.9726 9.89563 7.79672 - OK TCONS_00003921 hESC 0 11.9024 12.0245 7.94715 6.26152 - OK TCONS_00003921 Fibroblasts 1 3.24524 2.70782 2.21365 1.70114 - OK TCONS_00003921 Fibroblasts 0 39.4829 46.9802 38.4065 29.5145 - OK TCONS_00003922 iPS 0 19 19.8316 33.9073 50.5661 - OK TCONS_00003922 iPS 1 5 4.81711 8.23612 12.2826 - OK TCONS_00003922 hESC 1 107 105.914 70.0001 110.591 - OK TCONS_00003922 hESC 0 60 60.6152 40.0615 63.2919 - OK TCONS_00003922 Fibroblasts 1 235 196.084 160.299 241.04 - OK TCONS_00003922 Fibroblasts 0 149 177.293 144.938 217.941 - OK TCONS_00003923 iPS 0 959.119 1001.1 1711.64 2134.1 - OK TCONS_00003923 iPS 1 847.497 816.498 1396.02 1740.58 - OK TCONS_00003923 hESC 1 3779.09 3740.73 2472.3 3234.08 - OK TCONS_00003923 hESC 0 3765.05 3803.65 2513.89 3288.48 - OK TCONS_00003923 Fibroblasts 1 7270.01 6066.1 4959.05 6225.88 - OK TCONS_00003923 Fibroblasts 0 4963.75 5906.3 4828.42 6061.88 - OK TCONS_00003924 iPS 0 9.30683 9.71416 16.6089 17.671 - OK TCONS_00003924 iPS 1 9.1948 8.85848 15.1459 16.1144 - OK TCONS_00003924 hESC 1 11.5186 11.4017 7.53555 8.35143 - OK TCONS_00003924 hESC 0 19.7756 19.9784 13.204 14.6336 - OK TCONS_00003924 Fibroblasts 1 6.76923 5.64825 4.61746 4.94176 - OK TCONS_00003924 Fibroblasts 0 3.16165 3.76201 3.07545 3.29146 - OK TCONS_00003925 iPS 0 364.574 380.53 650.616 328.393 - OK TCONS_00003925 iPS 1 579.308 558.118 954.25 481.65 - OK TCONS_00003925 hESC 1 670.394 663.59 438.577 225.649 - OK TCONS_00003925 hESC 0 732.179 739.686 488.869 251.525 - OK TCONS_00003925 Fibroblasts 1 1141.22 952.231 778.451 394.015 - OK TCONS_00003925 Fibroblasts 0 937.089 1115.03 911.54 461.378 - OK TCONS_00003926 iPS 0 23.3991 24.4232 41.7579 40.4156 - OK TCONS_00003926 iPS 1 13.7098 13.2083 22.5831 21.8572 - OK TCONS_00003926 hESC 1 239.531 237.1 156.703 157.392 - OK TCONS_00003926 hESC 0 334.844 338.278 223.573 224.556 - OK TCONS_00003926 Fibroblasts 1 178.778 149.173 121.949 118.663 - OK TCONS_00003926 Fibroblasts 0 496.144 590.356 482.618 469.614 - OK TCONS_00003927 iPS 0 0 0 0 0 - OK TCONS_00003927 iPS 1 0 0 0 0 - OK TCONS_00003927 hESC 1 488.881 483.92 319.829 246.904 - OK TCONS_00003927 hESC 0 98.897 99.911 66.0326 50.9762 - OK TCONS_00003927 Fibroblasts 1 210.396 175.554 143.516 108.116 - OK TCONS_00003927 Fibroblasts 0 349.073 415.358 339.556 255.8 - OK TCONS_00003928 iPS 0 0 0 0 0 - OK TCONS_00003928 iPS 1 13.0039 12.5283 21.4204 17.7243 - OK TCONS_00003928 hESC 1 231.064 228.719 151.164 129.096 - OK TCONS_00003928 hESC 0 370.563 374.362 247.421 211.301 - OK TCONS_00003928 Fibroblasts 1 149.158 124.457 101.744 84.5745 - OK TCONS_00003928 Fibroblasts 0 338.329 402.573 329.105 273.568 - OK TCONS_00003929 iPS 0 12.7983 13.3585 22.8398 14.1421 - OK TCONS_00003929 iPS 1 11.4524 11.0335 18.8647 11.6808 - OK TCONS_00003929 hESC 1 0 0 0 0 - OK TCONS_00003929 hESC 0 0 0 0 0 - OK TCONS_00003929 Fibroblasts 1 0 0 0 0 - OK TCONS_00003929 Fibroblasts 0 0.119056 0.141664 0.11581 0.0719544 - OK TCONS_00003930 iPS 0 0 0 0 0 - OK TCONS_00003930 iPS 1 0 0 0 0 - OK TCONS_00003930 hESC 1 0 0 0 0 - OK TCONS_00003930 hESC 0 0 0 0 0 - OK TCONS_00003930 Fibroblasts 1 0 0 0 0 - OK TCONS_00003930 Fibroblasts 0 0 0 0 0 - OK TCONS_00003931 iPS 0 0 0 0 0 - OK TCONS_00003931 iPS 1 0 0 0 0 - OK TCONS_00003931 hESC 1 0 0 0 0 - OK TCONS_00003931 hESC 0 0 0 0 0 - OK TCONS_00003931 Fibroblasts 1 0 0 0 0 - OK TCONS_00003931 Fibroblasts 0 0 0 0 0 - OK TCONS_00003932 iPS 0 0 0 0 0 - OK TCONS_00003932 iPS 1 0 0 0 0 - OK TCONS_00003932 hESC 1 90.4075 89.4899 59.1452 37.8509 - OK TCONS_00003932 hESC 0 13.5062 13.6447 9.01797 5.77119 - OK TCONS_00003932 Fibroblasts 1 0 0 0 0 - OK TCONS_00003932 Fibroblasts 0 0 0 0 0 - OK TCONS_00003933 iPS 0 0 0 0 0 - OK TCONS_00003933 iPS 1 0 0 0 0 - OK TCONS_00003933 hESC 1 0 0 0 0 - OK TCONS_00003933 hESC 0 0 0 0 0 - OK TCONS_00003933 Fibroblasts 1 0 0 0 0 - OK TCONS_00003933 Fibroblasts 0 0 0 0 0 - OK TCONS_00003934 iPS 0 22.96 23.9649 40.9743 24.8594 - OK TCONS_00003934 iPS 1 22.2147 21.4022 36.5926 22.201 - OK TCONS_00003934 hESC 1 274.047 271.266 179.284 111.311 - OK TCONS_00003934 hESC 0 261.255 263.934 174.438 108.302 - OK TCONS_00003934 Fibroblasts 1 421.219 351.465 287.324 174.907 - OK TCONS_00003934 Fibroblasts 0 316.23 376.278 307.608 187.255 - OK TCONS_00003935 iPS 0 2.66719 2.78393 4.75986 69.6961 - OK TCONS_00003935 iPS 1 2.83334 2.7297 4.66714 68.3386 - OK TCONS_00003935 hESC 1 64.4625 63.8083 42.1718 1431.38 - OK TCONS_00003935 hESC 0 64.5588 65.2207 43.1053 1463.07 - OK TCONS_00003935 Fibroblasts 1 47.1615 39.3515 32.17 524.22 - OK TCONS_00003935 Fibroblasts 0 57.5295 68.4536 55.961 911.904 - OK TCONS_00003936 iPS 0 4.33386 4.52354 7.73418 65.2115 - OK TCONS_00003936 iPS 1 6.50001 6.26225 10.707 90.2768 - OK TCONS_00003936 hESC 1 42.5834 42.1512 27.8583 344.309 - OK TCONS_00003936 hESC 0 37.3333 37.7161 24.9271 308.081 - OK TCONS_00003936 Fibroblasts 1 46.3343 38.6613 31.6057 279.885 - OK TCONS_00003936 Fibroblasts 0 62.9169 74.864 61.2015 541.972 - OK TCONS_00003937 iPS 0 13.9941 14.6066 24.9737 17.0782 - OK TCONS_00003937 iPS 1 20.8555 20.0927 34.3537 23.4926 - OK TCONS_00003937 hESC 1 40.685 40.2721 26.6164 18.6817 - OK TCONS_00003937 hESC 0 27.1366 27.4148 18.1188 12.7174 - OK TCONS_00003937 Fibroblasts 1 7.0856 5.91222 4.83326 3.31772 - OK TCONS_00003937 Fibroblasts 0 18.5825 22.111 18.0758 12.4079 - OK TCONS_00003938 iPS 0 57.0396 59.536 101.792 28.9515 - OK TCONS_00003938 iPS 1 216.467 208.55 356.57 101.415 - OK TCONS_00003938 hESC 1 928.282 918.86 607.288 174.59 - OK TCONS_00003938 hESC 0 1445 1459.81 964.81 277.374 - OK TCONS_00003938 Fibroblasts 1 756.72 631.407 516.177 147.04 - OK TCONS_00003938 Fibroblasts 0 1574.18 1873.09 1531.26 436.201 - OK TCONS_00003939 iPS 0 124.075 129.505 221.423 50.0943 - OK TCONS_00003939 iPS 1 69.4657 66.9248 114.425 25.8873 - OK TCONS_00003939 hESC 1 448.067 443.52 293.129 66.8855 - OK TCONS_00003939 hESC 0 614.297 620.596 410.161 93.5897 - OK TCONS_00003939 Fibroblasts 1 152.205 127 103.823 23.518 - OK TCONS_00003939 Fibroblasts 0 322.613 383.873 313.817 71.0861 - OK TCONS_00003940 iPS 0 142.888 149.142 254.997 61.8229 - OK TCONS_00003940 iPS 1 39.3269 37.8885 64.7802 15.7057 - OK TCONS_00003940 hESC 1 449.746 445.182 294.227 71.9901 - OK TCONS_00003940 hESC 0 135.823 137.215 90.6876 22.189 - OK TCONS_00003940 Fibroblasts 1 281.996 235.298 192.357 46.6985 - OK TCONS_00003940 Fibroblasts 0 2189.34 2605.07 2129.65 517.017 - OK TCONS_00003941 iPS 0 0 0 0 0 - OK TCONS_00003941 iPS 1 94.7758 91.3092 156.117 38.4228 - OK TCONS_00003941 hESC 1 1427.81 1413.32 934.085 232.039 - OK TCONS_00003941 hESC 0 1369.55 1383.59 914.435 227.158 - OK TCONS_00003941 Fibroblasts 1 1488.98 1242.41 1015.67 250.313 - OK TCONS_00003941 Fibroblasts 0 233.746 278.132 227.373 56.0363 - OK TCONS_00003942 iPS 0 17.391 18.1522 31.0359 41.2793 - OK TCONS_00003942 iPS 1 23.2414 22.3912 38.2837 50.9193 - OK TCONS_00003942 hESC 1 120.065 118.847 78.5474 109.97 - OK TCONS_00003942 hESC 0 151.857 153.414 101.393 141.955 - OK TCONS_00003942 Fibroblasts 1 472.23 394.028 322.119 431.605 - OK TCONS_00003942 Fibroblasts 0 235.572 280.304 229.15 307.035 - OK TCONS_00003943 iPS 0 14.6301 15.2705 26.1089 17.4908 - OK TCONS_00003943 iPS 1 22.979 22.1385 37.8515 25.3574 - OK TCONS_00003943 hESC 1 76.2565 75.4826 49.8875 34.2839 - OK TCONS_00003943 hESC 0 90.1585 91.0829 60.198 41.3696 - OK TCONS_00003943 Fibroblasts 1 56.7995 47.3935 38.7443 26.0519 - OK TCONS_00003943 Fibroblasts 0 37.8149 44.9955 36.7839 24.7337 - OK TCONS_00003944 iPS 0 0 0 0 0 - OK TCONS_00003944 iPS 1 6.42392 6.18895 10.5816 9.29978 - OK TCONS_00003944 hESC 1 218.266 216.051 142.791 129.781 - OK TCONS_00003944 hESC 0 166.04 167.743 110.864 100.762 - OK TCONS_00003944 Fibroblasts 1 51.4805 42.9553 35.1161 31.0126 - OK TCONS_00003944 Fibroblasts 0 11.8055 14.0472 11.4837 10.1417 - OK TCONS_00003945 iPS 0 16.6664 17.3959 29.7428 30.2784 - OK TCONS_00003945 iPS 1 8.95682 8.6292 14.7539 15.0196 - OK TCONS_00003945 hESC 1 241.949 239.493 158.284 167.546 - OK TCONS_00003945 hESC 0 199.318 201.361 133.083 140.87 - OK TCONS_00003945 Fibroblasts 1 480.311 400.771 327.632 335.417 - OK TCONS_00003945 Fibroblasts 0 9.16173 10.9014 8.91194 9.1237 - OK TCONS_00003946 iPS 0 14.4058 15.0363 25.7085 27.2092 - OK TCONS_00003946 iPS 1 8.99357 8.66461 14.8144 15.6792 - OK TCONS_00003946 hESC 1 161.306 159.668 105.527 116.315 - OK TCONS_00003946 hESC 0 121.679 122.926 81.2438 89.5491 - OK TCONS_00003946 Fibroblasts 1 79.2034 66.0873 54.0265 57.5165 - OK TCONS_00003946 Fibroblasts 0 95.7791 113.966 93.1678 99.1861 - OK TCONS_00003947 iPS 0 12.5487 13.0979 22.3944 13.0495 - OK TCONS_00003947 iPS 1 3.17701 3.0608 5.23324 3.04948 - OK TCONS_00003947 hESC 1 250.525 247.983 163.895 97.6427 - OK TCONS_00003947 hESC 0 719.375 726.751 480.32 286.157 - OK TCONS_00003947 Fibroblasts 1 405.059 337.981 276.3 161.524 - OK TCONS_00003947 Fibroblasts 0 541.912 644.814 527.137 308.162 - OK TCONS_00003948 iPS 0 51.1682 53.4077 91.3144 52.5606 - OK TCONS_00003948 iPS 1 41.4415 39.9257 68.2634 39.2924 - OK TCONS_00003948 hESC 1 1608.23 1591.91 1052.12 618.991 - OK TCONS_00003948 hESC 0 1639.18 1655.99 1094.47 643.906 - OK TCONS_00003948 Fibroblasts 1 2190.42 1827.68 1494.13 862.766 - OK TCONS_00003948 Fibroblasts 0 2050.62 2440 1994.71 1151.82 - OK TCONS_00003949 iPS 0 3.00465 3.13616 5.36209 4.21731 - OK TCONS_00003949 iPS 1 13.9312 13.4216 22.9478 18.0486 - OK TCONS_00003949 hESC 1 378.536 374.694 247.641 200.704 - OK TCONS_00003949 hESC 0 247.681 250.22 165.374 134.03 - OK TCONS_00003949 Fibroblasts 1 356.11 297.138 242.911 191.884 - OK TCONS_00003949 Fibroblasts 0 117.295 139.568 114.097 90.1292 - OK TCONS_00003950 iPS 0 0 0 0 0 - OK TCONS_00003950 iPS 1 0 0 0 0 - OK TCONS_00003950 hESC 1 0 0 0 0 - OK TCONS_00003950 hESC 0 0 0 0 0 - OK TCONS_00003950 Fibroblasts 1 138.359 115.446 94.3778 76.5179 - OK TCONS_00003950 Fibroblasts 0 119.571 142.276 116.311 94.3006 - OK TCONS_00003951 iPS 0 3.16246 3.30087 5.6437 7.1952 - OK TCONS_00003951 iPS 1 6.47218 6.23544 10.6611 13.592 - OK TCONS_00003951 hESC 1 51.8761 51.3496 33.9377 45.4453 - OK TCONS_00003951 hESC 0 40.3937 40.8079 26.9705 36.1157 - OK TCONS_00003951 Fibroblasts 1 147.876 123.387 100.869 129.511 - OK TCONS_00003951 Fibroblasts 0 56.2717 66.9569 54.7375 70.28 - OK TCONS_00003952 iPS 0 0 0 0 0 - OK TCONS_00003952 iPS 1 0 0 0 0 - OK TCONS_00003952 hESC 1 11.8416 11.7215 7.74689 12.3494 - OK TCONS_00003952 hESC 0 29.8539 30.16 19.9332 31.7757 - OK TCONS_00003952 Fibroblasts 1 21.6997 18.1062 14.8019 22.4483 - OK TCONS_00003952 Fibroblasts 0 5.24021 6.23526 5.09734 7.73054 - OK TCONS_00003953 iPS 0 0.274124 0.286122 0.489201 0.726484 - OK TCONS_00003953 iPS 1 0 0 0 0 - OK TCONS_00003953 hESC 1 0.159912 0.158289 0.104615 0.164544 - OK TCONS_00003953 hESC 0 1.96468 1.98483 1.3118 2.06326 - OK TCONS_00003953 Fibroblasts 1 1.11351 0.929115 0.759554 1.1373 - OK TCONS_00003953 Fibroblasts 0 2.7661 3.29135 2.69069 4.02882 - OK TCONS_00003954 iPS 0 5.20601 5.43386 9.29061 13.3757 - OK TCONS_00003954 iPS 1 0 0 0 0 - OK TCONS_00003954 hESC 1 29.0048 28.7104 18.9751 28.8815 - OK TCONS_00003954 hESC 0 22.249 22.4771 14.8554 22.611 - OK TCONS_00003954 Fibroblasts 1 114.165 95.2593 77.8747 113.015 - OK TCONS_00003954 Fibroblasts 0 88.3815 105.164 85.9719 124.765 - OK TCONS_00003955 iPS 0 0 0 0 0 - OK TCONS_00003955 iPS 1 3.85723 3.71614 6.35371 12.4909 - OK TCONS_00003955 hESC 1 11.3752 11.2597 7.44172 15.7973 - OK TCONS_00003955 hESC 0 14.5607 14.71 9.72203 20.6379 - OK TCONS_00003955 Fibroblasts 1 105.077 87.6759 71.6753 142.455 - OK TCONS_00003955 Fibroblasts 0 41.8924 49.8472 40.7502 80.9911 - OK TCONS_00003956 iPS 0 0 0 0 0 - OK TCONS_00003956 iPS 1 0 0 0 0 - OK TCONS_00003956 hESC 1 0 0 0 0 - OK TCONS_00003956 hESC 0 5.85256 5.91257 3.9077 11.4358 - OK TCONS_00003956 Fibroblasts 1 0 0 0 0 - OK TCONS_00003956 Fibroblasts 0 0 0 0 0 - OK TCONS_00003957 iPS 0 2.56821 2.68062 4.58322 11.4436 - OK TCONS_00003957 iPS 1 8.14383 7.84595 13.4147 33.4945 - OK TCONS_00003957 hESC 1 8.14984 8.06713 5.33168 14.6913 - OK TCONS_00003957 hESC 0 0 0 0 0 - OK TCONS_00003957 Fibroblasts 1 15.3444 12.8033 10.4668 26.4992 - OK TCONS_00003957 Fibroblasts 0 6.19973 7.37698 6.0307 15.2683 - OK TCONS_00003958 iPS 0 0 0 0 0 - OK TCONS_00003958 iPS 1 1.38848 1.3377 2.28714 6.60888 - OK TCONS_00003958 hESC 1 0 0 0 0 - OK TCONS_00003958 hESC 0 0 0 0 0 - OK TCONS_00003958 Fibroblasts 1 0 0 0 0 - OK TCONS_00003958 Fibroblasts 0 0 0 0 0 - OK TCONS_00003959 iPS 0 69.5144 72.5568 124.055 88.5589 - OK TCONS_00003959 iPS 1 82.2082 79.2012 135.415 96.6688 - OK TCONS_00003959 hESC 1 261.59 258.935 171.134 125.536 - OK TCONS_00003959 hESC 0 273.116 275.916 182.357 133.768 - OK TCONS_00003959 Fibroblasts 1 284.035 236.999 193.747 138.858 - OK TCONS_00003959 Fibroblasts 0 121.805 144.934 118.484 84.9166 - OK TCONS_00003960 iPS 0 0 0 0 0 - OK TCONS_00003960 iPS 1 0 0 0 0 - OK TCONS_00003960 hESC 1 0 0 0 0 - OK TCONS_00003960 hESC 0 0 0 0 0 - OK TCONS_00003960 Fibroblasts 1 0 0 0 0 - OK TCONS_00003960 Fibroblasts 0 0 0 0 0 - OK TCONS_00003961 iPS 0 445.569 465.07 795.16 306.19 - OK TCONS_00003961 iPS 1 307.933 296.67 507.235 195.32 - OK TCONS_00003961 hESC 1 1247.64 1234.98 816.213 318.913 - OK TCONS_00003961 hESC 0 1417.38 1431.92 946.374 369.77 - OK TCONS_00003961 Fibroblasts 1 5392.79 4499.74 3678.55 1419.51 - OK TCONS_00003961 Fibroblasts 0 1589.62 1891.47 1546.28 596.692 - OK TCONS_00003962 iPS 0 57.3033 59.8113 102.263 114.576 - OK TCONS_00003962 iPS 1 42.8468 41.2796 70.5783 79.0766 - OK TCONS_00003962 hESC 1 343.996 340.505 225.044 263.228 - OK TCONS_00003962 hESC 0 382.236 386.155 255.216 298.518 - OK TCONS_00003962 Fibroblasts 1 619.586 516.983 422.635 476.471 - OK TCONS_00003962 Fibroblasts 0 336.683 400.615 327.504 369.223 - OK TCONS_00003963 iPS 0 14.0896 14.7063 25.1443 12.4645 - OK TCONS_00003963 iPS 1 8.7504 8.43033 14.4139 7.14525 - OK TCONS_00003963 hESC 1 11.913 11.792 7.79354 3.93678 - OK TCONS_00003963 hESC 0 66.4 67.0808 44.3346 22.3949 - OK TCONS_00003963 Fibroblasts 1 13.3676 11.1539 9.11837 4.53257 - OK TCONS_00003963 Fibroblasts 0 0 0 0 0 - OK TCONS_00003964 iPS 0 0 0 0 0 - OK TCONS_00003964 iPS 1 0.00636567 0.00613283 0.0104857 0.0050118 - OK TCONS_00003964 hESC 1 0.121063 0.119834 0.0792002 0.0385476 - OK TCONS_00003964 hESC 0 0 0 0 0 - OK TCONS_00003964 Fibroblasts 1 1556.4 1298.66 1061.66 508.78 - OK TCONS_00003964 Fibroblasts 0 0.159429 0.189702 0.155082 0.0743201 - OK TCONS_00003965 iPS 0 413.924 432.041 738.687 341.416 - OK TCONS_00003965 iPS 1 397.792 383.242 655.252 302.853 - OK TCONS_00003965 hESC 1 1418.84 1404.44 928.211 436.598 - OK TCONS_00003965 hESC 0 1913.28 1932.9 1277.48 600.882 - OK TCONS_00003965 Fibroblasts 1 1956.87 1632.82 1334.83 618.528 - OK TCONS_00003965 Fibroblasts 0 2821.56 3357.33 2744.63 1271.79 - OK TCONS_00003966 iPS 0 22.8299 23.8291 40.7421 19.3102 - OK TCONS_00003966 iPS 1 95.532 92.0377 157.363 74.5839 - OK TCONS_00003966 hESC 1 1117.49 1106.14 731.067 352.783 - OK TCONS_00003966 hESC 0 965.977 975.881 644.974 311.239 - OK TCONS_00003966 Fibroblasts 1 0 0 0 0 - OK TCONS_00003966 Fibroblasts 0 0 0 0 0 - OK TCONS_00003967 iPS 0 76.0915 79.4218 135.792 55.2204 - OK TCONS_00003967 iPS 1 56.0422 53.9924 92.3141 37.5398 - OK TCONS_00003967 hESC 1 332.249 328.877 217.359 89.762 - OK TCONS_00003967 hESC 0 342.775 346.29 228.868 94.5147 - OK TCONS_00003967 Fibroblasts 1 6.11291 5.10061 4.16976 1.69946 - OK TCONS_00003967 Fibroblasts 0 8.82647 10.5025 8.58583 3.49931 - OK TCONS_00003968 iPS 0 27.5645 28.7709 49.1913 55.0708 - OK TCONS_00003968 iPS 1 31.877 30.7111 52.5086 58.7846 - OK TCONS_00003968 hESC 1 288.396 285.469 188.67 220.5 - OK TCONS_00003968 hESC 0 277.066 279.907 184.995 216.204 - OK TCONS_00003968 Fibroblasts 1 72.2432 60.2797 49.2788 55.5119 - OK TCONS_00003968 Fibroblasts 0 26.9589 32.078 26.2239 29.5408 - OK TCONS_00003969 iPS 0 5762.82 6015.04 10284.3 4915.54 - OK TCONS_00003969 iPS 1 4569.69 4402.54 7527.29 3597.79 - OK TCONS_00003969 hESC 1 15988.8 15826.5 10460 5090.99 - OK TCONS_00003969 hESC 0 14323.7 14470.5 9563.79 4654.8 - OK TCONS_00003969 Fibroblasts 1 52386.5 43711.3 35734.1 17124.9 - OK TCONS_00003969 Fibroblasts 0 34492.5 41042.2 33552.1 16079.2 - OK TCONS_00003970 iPS 0 14.1799 14.8005 25.3054 12.7227 - OK TCONS_00003970 iPS 1 17.3141 16.6808 28.5202 14.3391 - OK TCONS_00003970 hESC 1 18.1848 18.0003 11.8966 6.09647 - OK TCONS_00003970 hESC 0 9.32753 9.42317 6.22791 3.19151 - OK TCONS_00003970 Fibroblasts 1 14.8101 12.3576 10.1023 5.09328 - OK TCONS_00003970 Fibroblasts 0 28.696 34.145 27.9136 14.0732 - OK TCONS_00003971 iPS 0 25.1105 26.2095 44.812 66.6878 - OK TCONS_00003971 iPS 1 38 36.6101 62.5945 93.1511 - OK TCONS_00003971 hESC 1 210.282 208.148 137.568 216.855 - OK TCONS_00003971 hESC 0 210.024 212.177 140.231 221.053 - OK TCONS_00003971 Fibroblasts 1 0 0 0 0 - OK TCONS_00003971 Fibroblasts 0 0 0 0 0 - OK TCONS_00003972 iPS 0 12.8895 13.4536 23.0025 41.1599 - OK TCONS_00003972 iPS 1 0 0 0 0 - OK TCONS_00003972 hESC 1 78.7182 77.9192 51.4979 98.7936 - OK TCONS_00003972 hESC 0 54.9763 55.54 36.7072 70.419 - OK TCONS_00003972 Fibroblasts 1 20 16.688 13.6425 24.6549 - OK TCONS_00003972 Fibroblasts 0 12 14.2787 11.6728 21.0954 - OK TCONS_00003973 iPS 0 0 0 0 0 - OK TCONS_00003973 iPS 1 0 0 0 0 - OK TCONS_00003973 hESC 1 3.0775 3.04627 2.01332 1.51781 - OK TCONS_00003973 hESC 0 4.61746 4.66481 3.08304 2.32425 - OK TCONS_00003973 Fibroblasts 1 0 0 0 0 - OK TCONS_00003973 Fibroblasts 0 0 0 0 0 - OK TCONS_00003974 iPS 0 0 0 0 0 - OK TCONS_00003974 iPS 1 0 0 0 0 - OK TCONS_00003974 hESC 1 3.9225 3.88269 2.56612 1.43229 - OK TCONS_00003974 hESC 0 2.38254 2.40697 1.5908 0.887906 - OK TCONS_00003974 Fibroblasts 1 0 0 0 0 - OK TCONS_00003974 Fibroblasts 0 0 0 0 0 - OK TCONS_00003975 iPS 0 1.99944 2.08695 3.56818 1.11114 - OK TCONS_00003975 iPS 1 0 0 0 0 - OK TCONS_00003975 hESC 1 3.99971 3.95912 2.61664 0.824479 - OK TCONS_00003975 hESC 0 4.99978 5.05105 3.33831 1.05187 - OK TCONS_00003975 Fibroblasts 1 0 0 0 0 - OK TCONS_00003975 Fibroblasts 0 0 0 0 0 - OK TCONS_00003976 iPS 0 0.000563651 0.000588321 0.00100589 0.000591751 - OK TCONS_00003976 iPS 1 1 0.963422 1.64722 0.96904 - OK TCONS_00003976 hESC 1 0.00028917 0.000286235 0.000189177 0.000113807 - OK TCONS_00003976 hESC 0 0 0 0 0 - OK TCONS_00003976 Fibroblasts 1 0 0 0 0 - OK TCONS_00003976 Fibroblasts 0 0 0 0 0 - OK TCONS_00003977 iPS 0 1 1.04377 1.78459 1.17688 - OK TCONS_00003977 iPS 1 0 0 0 0 - OK TCONS_00003977 hESC 1 0 0 0 0 - OK TCONS_00003977 hESC 0 0.000216592 0.000218813 0.000144617 0.000106305 - OK TCONS_00003977 Fibroblasts 1 0 0 0 0 - OK TCONS_00003977 Fibroblasts 0 0 0 0 0 - OK TCONS_00003978 iPS 0 6 6.2626 10.7076 7.75152 - OK TCONS_00003978 iPS 1 0 0 0 0 - OK TCONS_00003978 hESC 1 17 16.8275 11.1215 9.07601 - OK TCONS_00003978 hESC 0 14 14.1435 9.34767 7.62842 - OK TCONS_00003978 Fibroblasts 1 0 0 0 0 - OK TCONS_00003978 Fibroblasts 0 0 0 0 0 - OK TCONS_00003979 iPS 0 0 0 0 0 - OK TCONS_00003979 iPS 1 11.4567 11.0377 18.8718 24.5918 - OK TCONS_00003979 hESC 1 53.3133 52.7722 34.8779 47.7902 - OK TCONS_00003979 hESC 0 23.713 23.9562 15.833 21.6946 - OK TCONS_00003979 Fibroblasts 1 26.7216 22.2965 18.2274 23.9242 - OK TCONS_00003979 Fibroblasts 0 23.3972 27.84 22.7593 29.8724 - OK TCONS_00003980 iPS 0 41.6967 43.5216 74.4116 48.2944 - OK TCONS_00003980 iPS 1 32.2937 31.1125 53.195 34.5245 - OK TCONS_00003980 hESC 1 171.766 170.023 112.371 74.7542 - OK TCONS_00003980 hESC 0 169.562 171.301 113.215 75.316 - OK TCONS_00003980 Fibroblasts 1 311.244 259.702 212.307 138.287 - OK TCONS_00003980 Fibroblasts 0 202.68 241.167 197.154 128.417 - OK TCONS_00003981 iPS 0 0 0 0 0 - OK TCONS_00003981 iPS 1 0 0 0 0 - OK TCONS_00003981 hESC 1 0 0 0 0 - OK TCONS_00003981 hESC 0 0 0 0 0 - OK TCONS_00003981 Fibroblasts 1 120.378 100.443 82.1125 56.9174 - OK TCONS_00003981 Fibroblasts 0 44.8101 53.319 43.5884 30.2139 - OK TCONS_00003982 iPS 0 5.48239 5.72233 9.78383 6.59497 - OK TCONS_00003982 iPS 1 7.0498 6.79193 11.6126 7.82769 - OK TCONS_00003982 hESC 1 66.7793 66.1015 43.6874 30.2139 - OK TCONS_00003982 hESC 0 46.9877 47.4695 31.3733 21.6975 - OK TCONS_00003982 Fibroblasts 1 147.776 123.305 100.802 68.2012 - OK TCONS_00003982 Fibroblasts 0 131.727 156.74 128.136 86.695 - OK TCONS_00003983 iPS 0 112.905 117.847 201.49 508.474 - OK TCONS_00003983 iPS 1 54.7279 52.7261 90.1491 227.498 - OK TCONS_00003983 hESC 1 1090.48 1079.41 713.4 1989 - OK TCONS_00003983 hESC 0 966.267 976.175 645.168 1798.76 - OK TCONS_00003983 Fibroblasts 1 1213.06 1012.18 827.458 2117.66 - OK TCONS_00003983 Fibroblasts 0 1175.61 1398.84 1143.55 2926.63 - OK TCONS_00003984 iPS 0 0 0 0 0 - OK TCONS_00003984 iPS 1 6.17628 5.95037 10.1737 9.7665 - OK TCONS_00003984 hESC 1 143.407 141.952 93.818 93.4345 - OK TCONS_00003984 hESC 0 49.884 50.3954 33.3071 33.1709 - OK TCONS_00003984 Fibroblasts 1 29.3574 24.4958 20.0254 19.3263 - OK TCONS_00003984 Fibroblasts 0 20.5254 24.4229 19.9658 19.2688 - OK TCONS_00003985 iPS 0 1.66018 1.73285 2.96276 2.52692 - OK TCONS_00003985 iPS 1 0 0 0 0 - OK TCONS_00003985 hESC 1 6.57566 6.50892 4.30184 3.79054 - OK TCONS_00003985 hESC 0 0 0 0 0 - OK TCONS_00003985 Fibroblasts 1 0 0 0 0 - OK TCONS_00003985 Fibroblasts 0 0 0 0 0 - OK TCONS_00003986 iPS 0 42 43.8382 74.9529 50.9605 - OK TCONS_00003986 iPS 1 51 49.1345 84.0084 57.1173 - OK TCONS_00003986 hESC 1 2183 2160.84 1428.13 996.455 - OK TCONS_00003986 hESC 0 1847 1865.94 1233.23 860.461 - OK TCONS_00003986 Fibroblasts 1 250 208.6 170.531 116.381 - OK TCONS_00003986 Fibroblasts 0 357 424.79 347.267 236.997 - OK TCONS_00003987 iPS 0 20.5375 21.4364 36.6511 44.0284 - OK TCONS_00003987 iPS 1 19.2578 18.5534 31.7219 38.107 - OK TCONS_00003987 hESC 1 24.451 24.2028 15.996 20.1245 - OK TCONS_00003987 hESC 0 75.6997 76.4759 50.544 63.5892 - OK TCONS_00003987 Fibroblasts 1 69.0549 57.6194 47.104 56.9632 - OK TCONS_00003987 Fibroblasts 0 58.8329 70.0046 57.2289 69.2073 - OK TCONS_00003988 iPS 0 4.80232 5.01251 8.57019 8.8974 - OK TCONS_00003988 iPS 1 3.56593 3.43549 5.87388 6.09814 - OK TCONS_00003988 hESC 1 12.066 11.9436 7.89369 8.52786 - OK TCONS_00003988 hESC 0 7.41634 7.49238 4.95182 5.34965 - OK TCONS_00003988 Fibroblasts 1 27.5876 23.0191 18.8182 19.6493 - OK TCONS_00003988 Fibroblasts 0 17.6416 20.9916 17.1607 17.9186 - OK TCONS_00003989 iPS 0 0 0 0 0 - OK TCONS_00003989 iPS 1 0 0 0 0 - OK TCONS_00003989 hESC 1 18.0513 17.8681 11.8093 9.02304 - OK TCONS_00003989 hESC 0 19.9981 20.2031 13.3525 10.2022 - OK TCONS_00003989 Fibroblasts 1 28.5231 23.7996 19.4563 14.5103 - OK TCONS_00003989 Fibroblasts 0 41.89 49.8444 40.748 30.3894 - OK TCONS_00003990 iPS 0 237.448 247.841 423.749 324.969 - OK TCONS_00003990 iPS 1 199.411 192.117 328.474 251.904 - OK TCONS_00003990 hESC 1 852.987 844.329 558.029 440.65 - OK TCONS_00003990 hESC 0 909.606 918.933 607.336 479.585 - OK TCONS_00003990 Fibroblasts 1 1444.33 1205.15 985.214 758.764 - OK TCONS_00003990 Fibroblasts 0 1355.39 1612.76 1318.43 1015.4 - OK TCONS_00003991 iPS 0 186 194.141 331.934 189.749 - OK TCONS_00003991 iPS 1 168 161.855 276.734 158.193 - OK TCONS_00003991 hESC 1 993 982.922 649.627 379.511 - OK TCONS_00003991 hESC 0 905 914.279 604.26 353.008 - OK TCONS_00003991 Fibroblasts 1 1064 887.801 725.78 416.203 - OK TCONS_00003991 Fibroblasts 0 1040 1237.48 1011.65 580.134 - OK TCONS_00003992 iPS 0 0 0 0 0 - OK TCONS_00003992 iPS 1 0 0 0 0 - OK TCONS_00003992 hESC 1 0 0 0 0 - OK TCONS_00003992 hESC 0 0 0 0 0 - OK TCONS_00003992 Fibroblasts 1 0 0 0 0 - OK TCONS_00003992 Fibroblasts 0 0 0 0 0 - OK TCONS_00003993 iPS 0 2 2.08753 3.56919 4.43838 - OK TCONS_00003993 iPS 1 4 3.85369 6.58889 8.19347 - OK TCONS_00003993 hESC 1 3 2.96955 1.96262 2.56025 - OK TCONS_00003993 hESC 0 4 4.04101 2.67076 3.48402 - OK TCONS_00003993 Fibroblasts 1 0 0 0 0 - OK TCONS_00003993 Fibroblasts 0 0 0 0 0 - OK TCONS_00003994 iPS 0 0 0 0 0 - OK TCONS_00003994 iPS 1 0 0 0 0 - OK TCONS_00003994 hESC 1 0 0 0 0 - OK TCONS_00003994 hESC 0 0 0 0 0 - OK TCONS_00003994 Fibroblasts 1 0 0 0 0 - OK TCONS_00003994 Fibroblasts 0 0 0 0 0 - OK TCONS_00003995 iPS 0 1.45105 1.51456 2.58953 1.65824 - OK TCONS_00003995 iPS 1 0 0 0 0 - OK TCONS_00003995 hESC 1 0 0 0 0 - OK TCONS_00003995 hESC 0 1.99961 2.02011 1.33512 0.949827 - OK TCONS_00003995 Fibroblasts 1 19.823 16.5403 13.5217 9.40505 - OK TCONS_00003995 Fibroblasts 0 4.68468 5.57424 4.55695 3.16959 - OK TCONS_00003996 iPS 0 0 0 0 0 - OK TCONS_00003996 iPS 1 0 0 0 0 - OK TCONS_00003996 hESC 1 0 0 0 0 - OK TCONS_00003996 hESC 0 0.000393678 0.000397715 0.000262856 0.000178559 - OK TCONS_00003996 Fibroblasts 1 0 0 0 0 - OK TCONS_00003996 Fibroblasts 0 0 0 0 0 - OK TCONS_00003997 iPS 0 2.74854 2.86883 4.90502 2.08863 - OK TCONS_00003997 iPS 1 0 0 0 0 - OK TCONS_00003997 hESC 1 4.44265 4.39756 2.90641 1.23759 - OK TCONS_00003997 hESC 0 0 0 0 0 - OK TCONS_00003997 Fibroblasts 1 44.0376 36.7449 30.0391 13.5036 - OK TCONS_00003997 Fibroblasts 0 13.922 16.5656 13.5424 6.08777 - OK TCONS_00003998 iPS 0 1.05904 1.10539 1.88996 1.0336 - OK TCONS_00003998 iPS 1 0 0 0 0 - OK TCONS_00003998 hESC 1 0 0 0 0 - OK TCONS_00003998 hESC 0 0 0 0 0 - OK TCONS_00003998 Fibroblasts 1 0 0 0 0 - OK TCONS_00003998 Fibroblasts 0 3.31306 3.94217 3.22274 1.76783 - OK TCONS_00003999 iPS 0 0 0 0 0 - OK TCONS_00003999 iPS 1 1.03182 0.994078 1.69964 0.879212 - OK TCONS_00003999 hESC 1 41.9443 41.5186 27.4402 14.4761 - OK TCONS_00003999 hESC 0 32.3442 32.6758 21.5959 11.393 - OK TCONS_00003999 Fibroblasts 1 14.3432 11.968 9.78387 5.07563 - OK TCONS_00003999 Fibroblasts 0 0 0 0 0 - OK TCONS_00004000 iPS 0 1 1.04377 1.78459 1.1361 - OK TCONS_00004000 iPS 1 0 0 0 0 - OK TCONS_00004000 hESC 1 0 0 0 0 - OK TCONS_00004000 hESC 0 0 0 0 0 - OK TCONS_00004000 Fibroblasts 1 0 0 0 0 - OK TCONS_00004000 Fibroblasts 0 1 1.18989 0.972736 0.672289 - OK TCONS_00004001 iPS 0 0 0 0 0 - OK TCONS_00004001 iPS 1 0 0 0 0 - OK TCONS_00004001 hESC 1 0 0 0 0 - OK TCONS_00004001 hESC 0 0 0 0 0 - OK TCONS_00004001 Fibroblasts 1 7 5.8408 4.77487 15.1876 - OK TCONS_00004001 Fibroblasts 0 1 1.18989 0.972736 3.09402 - OK TCONS_00004002 iPS 0 335.942 350.645 599.52 134.515 - OK TCONS_00004002 iPS 1 0 0 0 0 - OK TCONS_00004002 hESC 1 301.021 297.966 196.93 44.5614 - OK TCONS_00004002 hESC 0 261.833 264.517 174.823 39.559 - OK TCONS_00004002 Fibroblasts 1 932.526 778.099 636.098 142.899 - OK TCONS_00004002 Fibroblasts 0 186.661 222.105 181.572 40.79 - OK TCONS_00004003 iPS 0 189.058 197.332 337.391 65.6972 - OK TCONS_00004003 iPS 1 80 77.0738 131.778 25.6599 - OK TCONS_00004003 hESC 1 1455.98 1441.2 952.511 186.841 - OK TCONS_00004003 hESC 0 1300.67 1314 868.444 170.351 - OK TCONS_00004003 Fibroblasts 1 546.474 455.978 372.763 72.663 - OK TCONS_00004003 Fibroblasts 0 301.839 359.155 293.61 57.2336 - OK TCONS_00004004 iPS 0 140.95 147.119 251.539 232.478 - OK TCONS_00004004 iPS 1 79.2816 76.3817 130.595 120.699 - OK TCONS_00004004 hESC 1 453.906 449.299 296.948 284.324 - OK TCONS_00004004 hESC 0 573.054 578.929 382.623 366.357 - OK TCONS_00004004 Fibroblasts 1 531.399 443.399 362.48 336.731 - OK TCONS_00004004 Fibroblasts 0 510.852 607.857 496.924 461.625 - OK TCONS_00004005 iPS 0 38.6068 40.2965 68.8974 52.019 - OK TCONS_00004005 iPS 1 59.7459 57.5605 98.4149 74.3052 - OK TCONS_00004005 hESC 1 392.063 388.084 256.49 199.312 - OK TCONS_00004005 hESC 0 415.468 419.728 277.404 215.564 - OK TCONS_00004005 Fibroblasts 1 143.645 119.857 97.9835 74.2892 - OK TCONS_00004005 Fibroblasts 0 164.911 196.226 160.415 121.624 - OK TCONS_00004006 iPS 0 46.4427 48.4754 82.8814 21.0996 - OK TCONS_00004006 iPS 1 58.9725 56.8154 97.1408 24.7297 - OK TCONS_00004006 hESC 1 464.031 459.322 303.572 78.0288 - OK TCONS_00004006 hESC 0 420.978 425.295 281.083 72.2483 - OK TCONS_00004006 Fibroblasts 1 111.957 93.4166 76.3684 19.4689 - OK TCONS_00004006 Fibroblasts 0 72.2369 85.9538 70.2675 17.9136 - OK TCONS_00004007 iPS 0 0 0 0 0 - OK TCONS_00004007 iPS 1 0 0 0 0 - OK TCONS_00004007 hESC 1 33.9276 33.5832 22.1957 10.1236 - OK TCONS_00004007 hESC 0 40.4666 40.8815 27.0192 12.3237 - OK TCONS_00004007 Fibroblasts 1 154.919 129.265 105.674 47.5041 - OK TCONS_00004007 Fibroblasts 0 57.1672 68.0225 55.6086 24.9979 - OK TCONS_00004008 iPS 0 468 488.483 835.19 190.905 - OK TCONS_00004008 iPS 1 562 541.443 925.74 211.603 - OK TCONS_00004008 hESC 1 2740.07 2712.26 1792.57 413.292 - OK TCONS_00004008 hESC 0 2830.53 2859.56 1889.92 435.737 - OK TCONS_00004008 Fibroblasts 1 1274.08 1063.09 869.081 198.903 - OK TCONS_00004008 Fibroblasts 0 1116.83 1328.91 1086.38 248.636 - OK TCONS_00004009 iPS 0 851 888.246 1518.69 866.052 - OK TCONS_00004009 iPS 1 918 884.422 1512.15 862.324 - OK TCONS_00004009 hESC 1 3442 3407.07 2251.78 1312.24 - OK TCONS_00004009 hESC 0 3632 3669.24 2425.05 1413.21 - OK TCONS_00004009 Fibroblasts 1 3434 2865.33 2342.41 1340.01 - OK TCONS_00004009 Fibroblasts 0 2628 3127.02 2556.35 1462.4 - OK TCONS_00004010 iPS 0 44.4106 46.3543 79.2548 17.8221 - OK TCONS_00004010 iPS 1 33.3941 32.1726 55.0076 12.3696 - OK TCONS_00004010 hESC 1 267.326 264.613 174.886 39.6621 - OK TCONS_00004010 hESC 0 132.339 133.695 88.3613 20.0393 - OK TCONS_00004010 Fibroblasts 1 608.537 507.763 415.097 93.4593 - OK TCONS_00004010 Fibroblasts 0 349.963 416.417 340.422 76.646 - OK TCONS_00004011 iPS 0 396.719 414.083 707.983 174.946 - OK TCONS_00004011 iPS 1 253.829 244.545 418.114 103.318 - OK TCONS_00004011 hESC 1 536.364 530.92 350.893 87.5201 - OK TCONS_00004011 hESC 0 685.089 692.114 457.428 114.092 - OK TCONS_00004011 Fibroblasts 1 1705.07 1422.71 1163.07 287.792 - OK TCONS_00004011 Fibroblasts 0 1333.13 1586.28 1296.79 320.88 - OK TCONS_00004012 iPS 0 88.37 92.2377 157.705 109.325 - OK TCONS_00004012 iPS 1 98.7766 95.1636 162.707 112.793 - OK TCONS_00004012 hESC 1 90.8101 89.8885 59.4086 42.2856 - OK TCONS_00004012 hESC 0 133.572 134.941 89.1848 63.4796 - OK TCONS_00004012 Fibroblasts 1 522.395 435.886 356.338 247.973 - OK TCONS_00004012 Fibroblasts 0 154.904 184.318 150.681 104.858 - OK TCONS_00004013 iPS 0 286.769 299.32 511.766 485.029 - OK TCONS_00004013 iPS 1 290.843 280.205 479.084 454.054 - OK TCONS_00004013 hESC 1 880.514 871.577 576.038 566.111 - OK TCONS_00004013 hESC 0 815.858 824.223 544.741 535.353 - OK TCONS_00004013 Fibroblasts 1 1979.18 1651.43 1350.04 1286.24 - OK TCONS_00004013 Fibroblasts 0 1123.48 1336.81 1092.85 1041.2 - OK TCONS_00004014 iPS 0 9.23079 9.6348 16.4732 9.96875 - OK TCONS_00004014 iPS 1 22.1566 21.3462 36.4969 22.0861 - OK TCONS_00004014 hESC 1 26.486 26.2172 17.3273 10.7297 - OK TCONS_00004014 hESC 0 36.1417 36.5123 24.1315 14.9431 - OK TCONS_00004014 Fibroblasts 1 11.8219 9.86422 8.06402 4.8963 - OK TCONS_00004014 Fibroblasts 0 6.52258 7.76114 6.34475 3.85239 - OK TCONS_00004015 iPS 0 0 0 0 0 - OK TCONS_00004015 iPS 1 0 0 0 0 - OK TCONS_00004015 hESC 1 1 0.989851 0.654207 1.09258 - OK TCONS_00004015 hESC 0 0 0 0 0 - OK TCONS_00004015 Fibroblasts 1 0 0 0 0 - OK TCONS_00004015 Fibroblasts 0 0 0 0 0 - OK TCONS_00004016 iPS 0 49.2302 51.3848 87.8558 25.7061 - OK TCONS_00004016 iPS 1 103.108 99.3361 169.841 49.6945 - OK TCONS_00004016 hESC 1 700.538 693.428 458.297 135.586 - OK TCONS_00004016 hESC 0 745.457 753.1 497.735 147.254 - OK TCONS_00004016 Fibroblasts 1 463.361 386.628 316.07 92.6298 - OK TCONS_00004016 Fibroblasts 0 365.644 435.075 355.675 104.237 - OK TCONS_00004017 iPS 0 12.225 12.76 21.8166 7.34337 - OK TCONS_00004017 iPS 1 31.5486 30.3946 51.9676 17.4921 - OK TCONS_00004017 hESC 1 146.191 144.708 95.6394 32.6044 - OK TCONS_00004017 hESC 0 146.592 148.095 97.8783 33.3677 - OK TCONS_00004017 Fibroblasts 1 35.9814 30.0229 24.5438 8.27673 - OK TCONS_00004017 Fibroblasts 0 28.0237 33.3451 27.2597 9.1926 - OK TCONS_00004018 iPS 0 15.5449 16.2252 27.7413 11.3332 - OK TCONS_00004018 iPS 1 12.8708 12.4 21.2011 8.66134 - OK TCONS_00004018 hESC 1 25.2704 25.0139 16.532 6.85921 - OK TCONS_00004018 hESC 0 43.6724 44.1202 29.1596 12.0984 - OK TCONS_00004018 Fibroblasts 1 15.1019 12.601 10.3013 4.21795 - OK TCONS_00004018 Fibroblasts 0 9.34839 11.1235 9.09351 3.72339 - OK TCONS_00004019 iPS 0 0 0 0 0 - OK TCONS_00004019 iPS 1 0 0 0 0 - OK TCONS_00004019 hESC 1 0 0 0 0 - OK TCONS_00004019 hESC 0 0 0 0 0 - OK TCONS_00004019 Fibroblasts 1 0 0 0 0 - OK TCONS_00004019 Fibroblasts 0 0 0 0 0 - OK TCONS_00004020 iPS 0 0 0 0 0 - OK TCONS_00004020 iPS 1 0 0 0 0 - OK TCONS_00004020 hESC 1 0 0 0 0 - OK TCONS_00004020 hESC 0 19.193 19.3898 12.815 7.10227 - OK TCONS_00004020 Fibroblasts 1 0 0 0 0 - OK TCONS_00004020 Fibroblasts 0 0 0 0 0 - OK TCONS_00004021 iPS 0 0 0 0 0 - OK TCONS_00004021 iPS 1 1.47307 1.41919 2.42648 2.90503 - OK TCONS_00004021 hESC 1 0 0 0 0 - OK TCONS_00004021 hESC 0 13.0856 13.2197 8.73712 10.9532 - OK TCONS_00004021 Fibroblasts 1 4.55571 3.80128 3.10756 3.74518 - OK TCONS_00004021 Fibroblasts 0 2.98438 3.55108 2.90301 3.49867 - OK TCONS_00004022 iPS 0 0 0 0 0 - OK TCONS_00004022 iPS 1 0 0 0 0 - OK TCONS_00004022 hESC 1 25.0147 24.7608 16.3648 3.78105 - OK TCONS_00004022 hESC 0 21.6419 21.8638 14.4501 3.33866 - OK TCONS_00004022 Fibroblasts 1 20.1399 16.8047 13.7379 3.15076 - OK TCONS_00004022 Fibroblasts 0 7.73821 9.2076 7.52724 1.72636 - OK TCONS_00004023 iPS 0 11.8401 12.3583 21.1298 3.94968 - OK TCONS_00004023 iPS 1 12.21 11.7634 20.1126 3.75955 - OK TCONS_00004023 hESC 1 11.7261 11.6071 7.67132 1.4441 - OK TCONS_00004023 hESC 0 0 0 0 0 - OK TCONS_00004023 Fibroblasts 1 0 0 0 0 - OK TCONS_00004023 Fibroblasts 0 12.3032 14.6394 11.9677 2.23938 - OK TCONS_00004024 iPS 0 29.6942 30.9939 52.9921 7.90844 - OK TCONS_00004024 iPS 1 22.7733 21.9403 37.5126 5.59831 - OK TCONS_00004024 hESC 1 168.426 166.716 110.185 16.5366 - OK TCONS_00004024 hESC 0 108.905 110.022 72.715 10.9131 - OK TCONS_00004024 Fibroblasts 1 2.86014 2.3865 1.95097 0.291399 - OK TCONS_00004024 Fibroblasts 0 4.95861 5.90019 4.82342 0.720431 - OK TCONS_00004025 iPS 0 3.46516 3.61682 6.18391 2.63199 - OK TCONS_00004025 iPS 1 5.60457 5.39957 9.23198 3.9293 - OK TCONS_00004025 hESC 1 23.589 23.3496 15.4321 6.67497 - OK TCONS_00004025 hESC 0 15.98 16.1439 10.6697 4.61506 - OK TCONS_00004025 Fibroblasts 1 0 0 0 0 - OK TCONS_00004025 Fibroblasts 0 0 0 0 0 - OK TCONS_00004026 iPS 0 0.000455821 0.000475771 0.000813456 0.000566688 - OK TCONS_00004026 iPS 1 1.41214 1.36049 2.32612 1.62047 - OK TCONS_00004026 hESC 1 2.2445 2.22172 1.46836 1.05043 - OK TCONS_00004026 hESC 0 14.4729 14.6213 9.66343 6.91298 - OK TCONS_00004026 Fibroblasts 1 0 0 0 0 - OK TCONS_00004026 Fibroblasts 0 0 0 0 0 - OK TCONS_00004027 iPS 0 1685.86 1759.64 3008.57 2220.57 - OK TCONS_00004027 iPS 1 1796.63 1730.91 2959.45 2184.31 - OK TCONS_00004027 hESC 1 8262.62 8178.76 5405.46 4103.51 - OK TCONS_00004027 hESC 0 9006.28 9098.63 6013.41 4565.03 - OK TCONS_00004027 Fibroblasts 1 17739.8 14802.1 12100.8 8967.88 - OK TCONS_00004027 Fibroblasts 0 8060.11 9590.62 7840.36 5810.49 - OK TCONS_00004028 iPS 0 146.143 152.539 260.805 194.218 - OK TCONS_00004028 iPS 1 193.372 186.299 318.526 237.202 - OK TCONS_00004028 hESC 1 348.384 344.848 227.915 174.613 - OK TCONS_00004028 hESC 0 105.718 106.802 70.5872 54.0791 - OK TCONS_00004028 Fibroblasts 1 3538.66 2952.66 2413.81 1804.95 - OK TCONS_00004028 Fibroblasts 0 4093.73 4871.07 3982.11 2977.67 - OK TCONS_00004029 iPS 0 2272.3 2371.75 4055.13 1234.78 - OK TCONS_00004029 iPS 1 2455.14 2365.34 4044.16 1231.44 - OK TCONS_00004029 hESC 1 5785.9 5727.18 3785.17 1165.92 - OK TCONS_00004029 hESC 0 6058.78 6120.91 4045.4 1246.08 - OK TCONS_00004029 Fibroblasts 1 11436.7 9542.77 7801.24 2379.46 - OK TCONS_00004029 Fibroblasts 0 7575 9013.4 7368.48 2247.47 - OK TCONS_00004030 iPS 0 454.701 474.602 811.457 241.524 - OK TCONS_00004030 iPS 1 498.862 480.615 821.737 244.584 - OK TCONS_00004030 hESC 1 580.099 574.212 379.505 114.235 - OK TCONS_00004030 hESC 0 796.214 804.378 531.625 160.025 - OK TCONS_00004030 Fibroblasts 1 1368.75 1142.08 933.657 278.354 - OK TCONS_00004030 Fibroblasts 0 1005.99 1197.02 978.565 291.742 - OK TCONS_00004031 iPS 0 91.013 94.9963 162.421 90.3642 - OK TCONS_00004031 iPS 1 74.9379 72.1969 123.439 68.6764 - OK TCONS_00004031 hESC 1 533.642 528.226 349.112 198.38 - OK TCONS_00004031 hESC 0 412.488 416.717 275.414 156.502 - OK TCONS_00004031 Fibroblasts 1 822.026 685.898 560.724 312.924 - OK TCONS_00004031 Fibroblasts 0 1253.01 1490.94 1218.85 680.205 - OK TCONS_00004032 iPS 0 43.987 45.9122 78.4989 45.0556 - OK TCONS_00004032 iPS 1 32.0621 30.8893 52.8134 30.3131 - OK TCONS_00004032 hESC 1 278.358 275.533 182.104 106.826 - OK TCONS_00004032 hESC 0 230.512 232.876 153.911 90.2876 - OK TCONS_00004032 Fibroblasts 1 410.974 342.916 280.335 161.414 - OK TCONS_00004032 Fibroblasts 0 665.989 792.452 647.832 373.015 - OK TCONS_00004033 iPS 0 118.206 123.379 210.949 239.575 - OK TCONS_00004033 iPS 1 124.064 119.526 204.361 232.093 - OK TCONS_00004033 hESC 1 969.031 959.196 633.946 752.081 - OK TCONS_00004033 hESC 0 2082.37 2103.72 1390.38 1649.47 - OK TCONS_00004033 Fibroblasts 1 1460.89 1218.97 996.511 1138.88 - OK TCONS_00004033 Fibroblasts 0 3943.33 4692.12 3835.82 4383.84 - OK TCONS_00004034 iPS 0 0.00569922 0.00594866 0.0101708 0.0114045 - OK TCONS_00004034 iPS 1 0.00634237 0.00611038 0.0104473 0.0117145 - OK TCONS_00004034 hESC 1 0 0 0 0 - OK TCONS_00004034 hESC 0 0 0 0 0 - OK TCONS_00004034 Fibroblasts 1 26.3826 22.0136 17.9962 20.3048 - OK TCONS_00004034 Fibroblasts 0 55.1981 65.6795 53.6932 60.5811 - OK TCONS_00004035 iPS 0 75.1316 78.4199 134.079 130.215 - OK TCONS_00004035 iPS 1 76.0136 73.2332 125.211 121.603 - OK TCONS_00004035 hESC 1 110.669 109.546 72.4003 72.9778 - OK TCONS_00004035 hESC 0 175.149 176.944 116.945 117.878 - OK TCONS_00004035 Fibroblasts 1 82.6222 68.94 56.3586 55.0294 - OK TCONS_00004035 Fibroblasts 0 175.932 209.34 171.136 167.1 - OK TCONS_00004036 iPS 0 174.021 181.637 310.556 389.956 - OK TCONS_00004036 iPS 1 257.062 247.66 423.439 531.699 - OK TCONS_00004036 hESC 1 1906.97 1887.61 1247.55 1644.11 - OK TCONS_00004036 hESC 0 1020.03 1030.49 681.068 897.561 - OK TCONS_00004036 Fibroblasts 1 1039.27 867.17 708.914 896.376 - OK TCONS_00004036 Fibroblasts 0 299.251 356.075 291.092 368.067 - OK TCONS_00004037 iPS 0 103.136 107.65 184.056 159.091 - OK TCONS_00004037 iPS 1 76.8536 74.0425 126.595 109.424 - OK TCONS_00004037 hESC 1 702.031 694.906 459.273 410.309 - OK TCONS_00004037 hESC 0 1702.22 1719.67 1136.56 1015.39 - OK TCONS_00004037 Fibroblasts 1 49.691 41.4621 33.8954 29.4384 - OK TCONS_00004037 Fibroblasts 0 146.878 174.768 142.874 124.087 - OK TCONS_00004038 iPS 0 0 0 0 0 - OK TCONS_00004038 iPS 1 0 0 0 0 - OK TCONS_00004038 hESC 1 0 0 0 0 - OK TCONS_00004038 hESC 0 15.8932 16.0562 10.6117 9.06258 - OK TCONS_00004038 Fibroblasts 1 0 0 0 0 - OK TCONS_00004038 Fibroblasts 0 0 0 0 0 - OK TCONS_00004039 iPS 0 0 0 0 0 - OK TCONS_00004039 iPS 1 0 0 0 0 - OK TCONS_00004039 hESC 1 1036.3 1025.79 677.956 606.444 - OK TCONS_00004039 hESC 0 248.838 251.389 166.147 148.621 - OK TCONS_00004039 Fibroblasts 1 441.135 368.083 300.908 261.662 - OK TCONS_00004039 Fibroblasts 0 1909.41 2271.98 1857.35 1615.1 - OK TCONS_00004040 iPS 0 0 0 0 0 - OK TCONS_00004040 iPS 1 0 0 0 0 - OK TCONS_00004040 hESC 1 5 4.94925 3.27103 3.85589 - OK TCONS_00004040 hESC 0 0 0 0 0 - OK TCONS_00004040 Fibroblasts 1 1 0.8344 0.682124 0.804087 - OK TCONS_00004040 Fibroblasts 0 0 0 0 0 - OK TCONS_00004041 iPS 0 9 9.3939 16.0613 5.55285 - OK TCONS_00004041 iPS 1 11 10.5976 18.1195 6.2644 - OK TCONS_00004041 hESC 1 25 24.7463 16.3552 5.72889 - OK TCONS_00004041 hESC 0 31 31.3179 20.6984 7.25024 - OK TCONS_00004041 Fibroblasts 1 2 1.6688 1.36425 0.47256 - OK TCONS_00004041 Fibroblasts 0 7 8.32921 6.80915 2.35862 - OK TCONS_00004042 iPS 0 0 0 0 0 - OK TCONS_00004042 iPS 1 0 0 0 0 - OK TCONS_00004042 hESC 1 55.2071 54.6468 36.1169 60.4348 - OK TCONS_00004042 hESC 0 0 0 0 0 - OK TCONS_00004042 Fibroblasts 1 1.98095 1.6529 1.35125 2.14592 - OK TCONS_00004042 Fibroblasts 0 0.401821 0.478122 0.390866 0.620732 - OK TCONS_00004043 iPS 0 4.87847 5.09199 8.70609 8.85012 - OK TCONS_00004043 iPS 1 0 0 0 0 - OK TCONS_00004043 hESC 1 0 0 0 0 - OK TCONS_00004043 hESC 0 0 0 0 0 - OK TCONS_00004043 Fibroblasts 1 0 0 0 0 - OK TCONS_00004043 Fibroblasts 0 0 0 0 0 - OK TCONS_00004044 iPS 0 0 0 0 0 - OK TCONS_00004044 iPS 1 0 0 0 0 - OK TCONS_00004044 hESC 1 40.1912 39.7833 26.2934 30.3036 - OK TCONS_00004044 hESC 0 51.3557 51.8823 34.2897 39.5195 - OK TCONS_00004044 Fibroblasts 1 0 0 0 0 - OK TCONS_00004044 Fibroblasts 0 17.367 20.6648 16.8935 18.7761 - OK TCONS_00004045 iPS 0 0 0 0 0 - OK TCONS_00004045 iPS 1 0 0 0 0 - OK TCONS_00004045 hESC 1 0 0 0 0 - OK TCONS_00004045 hESC 0 0 0 0 0 - OK TCONS_00004045 Fibroblasts 1 0 0 0 0 - OK TCONS_00004045 Fibroblasts 0 0 0 0 0 - OK TCONS_00004046 iPS 0 12.7404 13.298 22.7364 22.2184 - OK TCONS_00004046 iPS 1 15.428 14.8637 25.4134 24.8344 - OK TCONS_00004046 hESC 1 224.092 221.818 146.603 148.726 - OK TCONS_00004046 hESC 0 249.248 251.803 166.42 168.831 - OK TCONS_00004046 Fibroblasts 1 3.33138 2.7797 2.27242 2.23269 - OK TCONS_00004046 Fibroblasts 0 0 0 0 0 - OK TCONS_00004047 iPS 0 0 0 0 0 - OK TCONS_00004047 iPS 1 0 0 0 0 - OK TCONS_00004047 hESC 1 0 0 0 0 - OK TCONS_00004047 hESC 0 0 0 0 0 - OK TCONS_00004047 Fibroblasts 1 0 0 0 0 - OK TCONS_00004047 Fibroblasts 0 0 0 0 0 - OK TCONS_00004048 iPS 0 0 0 0 0 - OK TCONS_00004048 iPS 1 0 0 0 0 - OK TCONS_00004048 hESC 1 0 0 0 0 - OK TCONS_00004048 hESC 0 0 0 0 0 - OK TCONS_00004048 Fibroblasts 1 3.17465 2.64893 2.16551 2.3478 - OK TCONS_00004048 Fibroblasts 0 0 0 0 0 - OK TCONS_00004049 iPS 0 0 0 0 0 - OK TCONS_00004049 iPS 1 0 0 0 0 - OK TCONS_00004049 hESC 1 14.1316 13.9881 9.24496 9.20069 - OK TCONS_00004049 hESC 0 17.1476 17.3234 11.4493 11.3945 - OK TCONS_00004049 Fibroblasts 1 0 0 0 0 - OK TCONS_00004049 Fibroblasts 0 0 0 0 0 - OK TCONS_00004050 iPS 0 0 0 0 0 - OK TCONS_00004050 iPS 1 0 0 0 0 - OK TCONS_00004050 hESC 1 0 0 0 0 - OK TCONS_00004050 hESC 0 0 0 0 0 - OK TCONS_00004050 Fibroblasts 1 0 0 0 0 - OK TCONS_00004050 Fibroblasts 0 0 0 0 0 - OK TCONS_00004051 iPS 0 8.38116 8.74798 14.957 29.121 - OK TCONS_00004051 iPS 1 4.57204 4.4048 7.53117 14.6631 - OK TCONS_00004051 hESC 1 116.528 115.346 76.2337 160.147 - OK TCONS_00004051 hESC 0 60.2496 60.8674 40.2281 84.5086 - OK TCONS_00004051 Fibroblasts 1 3.51306 2.93129 2.39634 4.71635 - OK TCONS_00004051 Fibroblasts 0 7.23174 8.60496 7.03458 13.8451 - OK TCONS_00004052 iPS 0 27.9492 29.1724 49.8779 20.0069 - OK TCONS_00004052 iPS 1 9.53459 9.18583 15.7056 6.2998 - OK TCONS_00004052 hESC 1 130.122 128.801 85.1264 34.6685 - OK TCONS_00004052 hESC 0 140.503 141.944 93.8129 38.2061 - OK TCONS_00004052 Fibroblasts 1 0 0 0 0 - OK TCONS_00004052 Fibroblasts 0 8.13245 9.6767 7.91072 3.18018 - OK TCONS_00004053 iPS 0 0 0 0 0 - OK TCONS_00004053 iPS 1 9.64219 9.2895 15.8828 4.61288 - OK TCONS_00004053 hESC 1 264.739 262.052 173.194 50.8563 - OK TCONS_00004053 hESC 0 144.831 146.316 96.7022 28.3954 - OK TCONS_00004053 Fibroblasts 1 9.01567 7.52268 6.14981 1.78897 - OK TCONS_00004053 Fibroblasts 0 11.5347 13.7249 11.2202 3.26393 - OK TCONS_00004054 iPS 0 0 0 0 0 - OK TCONS_00004054 iPS 1 56.005 53.9564 92.2527 28.6332 - OK TCONS_00004054 hESC 1 372.156 368.379 243.467 76.4587 - OK TCONS_00004054 hESC 0 226.295 228.616 151.095 47.4503 - OK TCONS_00004054 Fibroblasts 1 0 0 0 0 - OK TCONS_00004054 Fibroblasts 0 0 0 0 0 - OK TCONS_00004055 iPS 0 0 0 0 0 - OK TCONS_00004055 iPS 1 0.00402203 0.00387491 0.00662518 0.00206856 - OK TCONS_00004055 hESC 1 420.455 416.188 275.064 86.9026 - OK TCONS_00004055 hESC 0 292.018 295.013 194.978 61.6005 - OK TCONS_00004055 Fibroblasts 1 0 0 0 0 - OK TCONS_00004055 Fibroblasts 0 0 0 0 0 - OK TCONS_00004056 iPS 0 63.1812 65.9465 112.753 35.0729 - OK TCONS_00004056 iPS 1 0 0 0 0 - OK TCONS_00004056 hESC 1 255.222 252.632 166.968 52.5516 - OK TCONS_00004056 hESC 0 163.568 165.246 109.213 34.3738 - OK TCONS_00004056 Fibroblasts 1 123.233 102.825 84.0599 26.1927 - OK TCONS_00004056 Fibroblasts 0 127.931 152.223 124.443 38.7758 - OK TCONS_00004057 iPS 0 0 0 0 0 - OK TCONS_00004057 iPS 1 0 0 0 0 - OK TCONS_00004057 hESC 1 0 0 0 0 - OK TCONS_00004057 hESC 0 0 0 0 0 - OK TCONS_00004057 Fibroblasts 1 0 0 0 0 - OK TCONS_00004057 Fibroblasts 0 0 0 0 0 - OK TCONS_00004058 iPS 0 41.5735 43.393 74.1918 23.4494 - OK TCONS_00004058 iPS 1 27.6967 26.6836 45.6227 14.4197 - OK TCONS_00004058 hESC 1 70.6144 69.8977 46.1964 14.7766 - OK TCONS_00004058 hESC 0 0 0 0 0 - OK TCONS_00004058 Fibroblasts 1 0 0 0 0 - OK TCONS_00004058 Fibroblasts 0 26 30.9371 25.2911 8.0076 - OK TCONS_00004059 iPS 0 0.0254435 0.0265571 0.0454063 0.013916 - OK TCONS_00004059 iPS 1 0 0 0 0 - OK TCONS_00004059 hESC 1 0.0441982 0.0437497 0.0289148 0.00896501 - OK TCONS_00004059 hESC 0 66.6777 67.3614 44.5201 13.8034 - OK TCONS_00004059 Fibroblasts 1 0.0513583 0.0428534 0.0350327 0.0107549 - OK TCONS_00004059 Fibroblasts 0 0.0287989 0.0342674 0.0280137 0.00860012 - OK TCONS_00004060 iPS 0 28.4645 29.7103 50.7975 15.6429 - OK TCONS_00004060 iPS 1 0 0 0 0 - OK TCONS_00004060 hESC 1 230.114 227.779 150.542 46.9017 - OK TCONS_00004060 hESC 0 285.068 287.991 190.337 59.2999 - OK TCONS_00004060 Fibroblasts 1 57.9464 48.3504 39.5266 12.1928 - OK TCONS_00004060 Fibroblasts 0 69.4901 82.6854 67.5955 20.8512 - OK TCONS_00004061 iPS 0 0.0242793 0.0253419 0.0433287 0.0121283 - OK TCONS_00004061 iPS 1 43.7443 42.1442 72.0566 20.1697 - OK TCONS_00004061 hESC 1 0 0 0 0 - OK TCONS_00004061 hESC 0 0 0 0 0 - OK TCONS_00004061 Fibroblasts 1 32.754 27.3299 22.3423 6.2636 - OK TCONS_00004061 Fibroblasts 0 0 0 0 0 - OK TCONS_00004062 iPS 0 9.8951 10.3282 17.6587 5.72849 - OK TCONS_00004062 iPS 1 0 0 0 0 - OK TCONS_00004062 hESC 1 37.0334 36.6575 24.2275 7.95641 - OK TCONS_00004062 hESC 0 26.6604 26.9337 17.8009 5.84589 - OK TCONS_00004062 Fibroblasts 1 0 0 0 0 - OK TCONS_00004062 Fibroblasts 0 8.42733 10.0276 8.19757 2.66406 - OK TCONS_00004063 iPS 0 19.8868 20.7572 35.4899 36.3645 - OK TCONS_00004063 iPS 1 14.8732 14.3292 24.4995 25.1033 - OK TCONS_00004063 hESC 1 134.349 132.986 87.8923 93.6659 - OK TCONS_00004063 hESC 0 94.3768 95.3445 63.0145 67.1539 - OK TCONS_00004063 Fibroblasts 1 0 0 0 0 - OK TCONS_00004063 Fibroblasts 0 20.4554 24.3396 19.8977 20.504 - OK TCONS_00004064 iPS 0 492 513.533 878.02 466.126 - OK TCONS_00004064 iPS 1 615 592.505 1013.04 537.807 - OK TCONS_00004064 hESC 1 474 469.189 310.094 167.976 - OK TCONS_00004064 hESC 0 596 602.111 397.944 215.563 - OK TCONS_00004064 Fibroblasts 1 968.82 808.383 660.855 351.868 - OK TCONS_00004064 Fibroblasts 0 700 832.921 680.915 362.549 - OK TCONS_00004065 iPS 0 0 0 0 0 - OK TCONS_00004065 iPS 1 0 0 0 0 - OK TCONS_00004065 hESC 1 0 0 0 0 - OK TCONS_00004065 hESC 0 0 0 0 0 - OK TCONS_00004065 Fibroblasts 1 24.1802 20.1759 16.4939 8.67754 - OK TCONS_00004065 Fibroblasts 0 0 0 0 0 - OK TCONS_00004066 iPS 0 215.751 225.193 385.027 88.5521 - OK TCONS_00004066 iPS 1 341.428 328.939 562.408 129.348 - OK TCONS_00004066 hESC 1 314.369 311.179 205.663 47.7127 - OK TCONS_00004066 hESC 0 494.678 499.75 330.292 76.6261 - OK TCONS_00004066 Fibroblasts 1 463.607 386.833 316.237 72.8236 - OK TCONS_00004066 Fibroblasts 0 362.14 430.906 352.267 81.1207 - OK TCONS_00004067 iPS 0 163.152 170.292 291.16 124.522 - OK TCONS_00004067 iPS 1 198.572 191.309 327.092 139.89 - OK TCONS_00004067 hESC 1 511.487 506.296 334.618 145.447 - OK TCONS_00004067 hESC 0 553.181 558.853 369.354 160.545 - OK TCONS_00004067 Fibroblasts 1 2240.67 1869.62 1528.42 655.216 - OK TCONS_00004067 Fibroblasts 0 1299.14 1545.84 1263.72 541.745 - OK TCONS_00004068 iPS 0 6.09771 6.36459 10.8819 3.56443 - OK TCONS_00004068 iPS 1 0 0 0 0 - OK TCONS_00004068 hESC 1 756.144 748.469 494.674 164.053 - OK TCONS_00004068 hESC 0 668.141 674.991 446.112 147.948 - OK TCONS_00004068 Fibroblasts 1 1518.72 1267.22 1035.96 339.947 - OK TCONS_00004068 Fibroblasts 0 1295.72 1541.76 1260.39 413.595 - OK TCONS_00004069 iPS 0 0 0 0 0 - OK TCONS_00004069 iPS 1 11.2802 10.8676 18.5811 22.096 - OK TCONS_00004069 hESC 1 0 0 0 0 - OK TCONS_00004069 hESC 0 0 0 0 0 - OK TCONS_00004069 Fibroblasts 1 0 0 0 0 - OK TCONS_00004069 Fibroblasts 0 0 0 0 0 - OK TCONS_00004070 iPS 0 830.223 866.56 1481.61 670.549 - OK TCONS_00004070 iPS 1 1032.52 994.749 1700.78 769.743 - OK TCONS_00004070 hESC 1 4375.89 4331.48 2862.74 1318.04 - OK TCONS_00004070 hESC 0 4494.8 4540.89 3001.14 1381.76 - OK TCONS_00004070 Fibroblasts 1 4600.14 3838.35 3137.86 1423.69 - OK TCONS_00004070 Fibroblasts 0 4282.39 5095.56 4165.63 1890.01 - OK TCONS_00004071 iPS 0 16.647 17.3756 29.7082 14.1517 - OK TCONS_00004071 iPS 1 12.7741 12.3068 21.0417 10.0234 - OK TCONS_00004071 hESC 1 59.05 58.4507 38.6309 18.7376 - OK TCONS_00004071 hESC 0 110.862 111.999 74.0218 35.9037 - OK TCONS_00004071 Fibroblasts 1 97.541 81.3882 66.535 31.778 - OK TCONS_00004071 Fibroblasts 0 63.1853 75.1834 61.4627 29.3553 - OK TCONS_00004072 iPS 0 0 0 0 0 - OK TCONS_00004072 iPS 1 13.2297 12.7458 21.7922 10.1019 - OK TCONS_00004072 hESC 1 0 0 0 0 - OK TCONS_00004072 hESC 0 55.8378 56.4103 37.2824 17.589 - OK TCONS_00004072 Fibroblasts 1 174.485 145.59 119.021 55.3143 - OK TCONS_00004072 Fibroblasts 0 35.886 42.7003 34.9076 16.2231 - OK TCONS_00004073 iPS 0 0 0 0 0 - OK TCONS_00004073 iPS 1 0 0 0 0 - OK TCONS_00004073 hESC 1 0 0 0 0 - OK TCONS_00004073 hESC 0 0 0 0 0 - OK TCONS_00004073 Fibroblasts 1 0 0 0 0 - OK TCONS_00004073 Fibroblasts 0 0 0 0 0 - OK TCONS_00004074 iPS 0 0 0 0 0 - OK TCONS_00004074 iPS 1 0.995479 0.959067 1.63978 4.87776 - OK TCONS_00004074 hESC 1 1.00016 0.990007 0.65431 1.43944 - OK TCONS_00004074 hESC 0 0 0 0 0 - OK TCONS_00004074 Fibroblasts 1 0 0 0 0 - OK TCONS_00004074 Fibroblasts 0 0 0 0 0 - OK TCONS_00004075 iPS 0 0 0 0 0 - OK TCONS_00004075 iPS 1 0.00452118 0.00435581 0.00744739 0.0219686 - OK TCONS_00004075 hESC 1 0 0 0 0 - OK TCONS_00004075 hESC 0 0 0 0 0 - OK TCONS_00004075 Fibroblasts 1 0 0 0 0 - OK TCONS_00004075 Fibroblasts 0 0 0 0 0 - OK TCONS_00004076 iPS 0 0 0 0 0 - OK TCONS_00004076 iPS 1 0 0 0 0 - OK TCONS_00004076 hESC 1 1 0.989851 0.654207 0.491457 - OK TCONS_00004076 hESC 0 0 0 0 0 - OK TCONS_00004076 Fibroblasts 1 2 1.6688 1.36425 1.13004 - OK TCONS_00004076 Fibroblasts 0 2 2.37978 1.94547 1.61149 - OK TCONS_00004077 iPS 0 559.152 583.624 997.859 476.782 - OK TCONS_00004077 iPS 1 1019.36 982.072 1679.11 802.286 - OK TCONS_00004077 hESC 1 1242.94 1230.33 813.142 395.628 - OK TCONS_00004077 hESC 0 1530.98 1546.67 1022.22 497.354 - OK TCONS_00004077 Fibroblasts 1 7990.59 6667.34 5450.57 2611.2 - OK TCONS_00004077 Fibroblasts 0 3945.58 4694.8 3838.01 1838.67 - OK TCONS_00004078 iPS 0 74.8479 78.1238 133.573 95.0181 - OK TCONS_00004078 iPS 1 152.642 147.059 251.436 178.861 - OK TCONS_00004078 hESC 1 42.057 41.6302 27.514 20.11 - OK TCONS_00004078 hESC 0 48.0231 48.5155 32.0646 23.436 - OK TCONS_00004078 Fibroblasts 1 221.414 184.748 151.032 107.861 - OK TCONS_00004078 Fibroblasts 0 50.4173 59.9909 49.0427 35.0244 - OK TCONS_00004079 iPS 0 6.46822 6.75132 11.5431 2.65999 - OK TCONS_00004079 iPS 1 0 0 0 0 - OK TCONS_00004079 hESC 1 1734.34 1716.74 1134.62 263.745 - OK TCONS_00004079 hESC 0 2441.25 2466.28 1630 378.897 - OK TCONS_00004079 Fibroblasts 1 13661.1 11398.8 9318.59 2150.1 - OK TCONS_00004079 Fibroblasts 0 5458.83 6495.4 5310.01 1225.19 - OK TCONS_00004080 iPS 0 0 0 0 0 - OK TCONS_00004080 iPS 1 130.72 125.939 215.325 37.9573 - OK TCONS_00004080 hESC 1 187.856 185.95 122.897 21.8087 - OK TCONS_00004080 hESC 0 221.647 223.92 147.992 26.2619 - OK TCONS_00004080 Fibroblasts 1 0 0 0 0 - OK TCONS_00004080 Fibroblasts 0 112.629 134.015 109.558 19.3316 - OK TCONS_00004081 iPS 0 588.782 614.551 1050.74 189.594 - OK TCONS_00004081 iPS 1 490.317 472.383 807.662 145.734 - OK TCONS_00004081 hESC 1 5444.24 5388.98 3561.66 647.051 - OK TCONS_00004081 hESC 0 5243.33 5297.09 3500.92 636.017 - OK TCONS_00004081 Fibroblasts 1 2016.47 1682.54 1375.48 248.438 - OK TCONS_00004081 Fibroblasts 0 1609.77 1915.44 1565.88 282.827 - OK TCONS_00004082 iPS 0 0 0 0 0 - OK TCONS_00004082 iPS 1 0 0 0 0 - OK TCONS_00004082 hESC 1 7.97023 7.88934 5.21418 3.11034 - OK TCONS_00004082 hESC 0 0 0 0 0 - OK TCONS_00004082 Fibroblasts 1 247.921 206.865 169.113 98.9852 - OK TCONS_00004082 Fibroblasts 0 10.8285 12.8847 10.5333 6.16535 - OK TCONS_00004083 iPS 0 3.00026 3.13157 5.35424 18.183 - OK TCONS_00004083 iPS 1 4 3.85369 6.58889 22.3758 - OK TCONS_00004083 hESC 1 0 0 0 0 - OK TCONS_00004083 hESC 0 0 0 0 0 - OK TCONS_00004083 Fibroblasts 1 0 0 0 0 - OK TCONS_00004083 Fibroblasts 0 0 0 0 0 - OK TCONS_00004084 iPS 0 66.7494 69.6708 119.121 66.2735 - OK TCONS_00004084 iPS 1 114.963 110.758 189.369 105.357 - OK TCONS_00004084 hESC 1 4.59208 4.54547 3.00417 1.70709 - OK TCONS_00004084 hESC 0 15.7819 15.9437 10.5374 5.98779 - OK TCONS_00004084 Fibroblasts 1 22.4705 18.7494 15.3277 8.55394 - OK TCONS_00004084 Fibroblasts 0 6.94078 8.25875 6.75155 3.76784 - OK TCONS_00004085 iPS 0 237.189 247.57 423.286 285.188 - OK TCONS_00004085 iPS 1 542.967 523.107 894.388 602.592 - OK TCONS_00004085 hESC 1 477.018 472.176 312.068 215.718 - OK TCONS_00004085 hESC 0 464.441 469.203 310.103 214.36 - OK TCONS_00004085 Fibroblasts 1 433.088 361.369 295.42 199.782 - OK TCONS_00004085 Fibroblasts 0 238.539 283.835 232.036 156.917 - OK TCONS_00004086 iPS 0 12791.4 13351.2 22827.4 19635.1 - OK TCONS_00004086 iPS 1 13402.4 12912.2 22076.8 18989.5 - OK TCONS_00004086 hESC 1 51956.7 51429.3 33990.4 30213.9 - OK TCONS_00004086 hESC 0 51603.2 52132.3 34455 30626.9 - OK TCONS_00004086 Fibroblasts 1 31892.6 26611.2 21754.7 18801.7 - OK TCONS_00004086 Fibroblasts 0 49086.1 58407 47747.9 41266.6 - OK TCONS_00004087 iPS 0 0 0 0 0 - OK TCONS_00004087 iPS 1 0 0 0 0 - OK TCONS_00004087 hESC 1 12438.9 12312.6 8137.6 7283.83 - OK TCONS_00004087 hESC 0 16204.6 16370.8 10819.7 9684.53 - OK TCONS_00004087 Fibroblasts 1 2375.69 1982.27 1620.51 1410.02 - OK TCONS_00004087 Fibroblasts 0 26963.7 32083.8 26228.6 22821.7 - OK TCONS_00004088 iPS 0 0 0 0 0 - OK TCONS_00004088 iPS 1 0 0 0 0 - OK TCONS_00004088 hESC 1 55.4661 54.9032 36.2863 33.4967 - OK TCONS_00004088 hESC 0 110.918 112.055 74.0588 68.3653 - OK TCONS_00004088 Fibroblasts 1 0 0 0 0 - OK TCONS_00004088 Fibroblasts 0 0 0 0 0 - OK TCONS_00004089 iPS 0 0 0 0 0 - OK TCONS_00004089 iPS 1 0 0 0 0 - OK TCONS_00004089 hESC 1 0 0 0 0 - OK TCONS_00004089 hESC 0 5266.04 5320.03 3516.09 3401.14 - OK TCONS_00004089 Fibroblasts 1 5303.04 4424.85 3617.33 3393.8 - OK TCONS_00004089 Fibroblasts 0 0 0 0 0 - OK TCONS_00004090 iPS 0 10.3688 10.8226 18.504 17.7273 - OK TCONS_00004090 iPS 1 0 0 0 0 - OK TCONS_00004090 hESC 1 0 0 0 0 - OK TCONS_00004090 hESC 0 10.0359 10.1388 6.70087 6.65942 - OK TCONS_00004090 Fibroblasts 1 10138.4 8459.47 6915.63 6660.58 - OK TCONS_00004090 Fibroblasts 0 0 0 0 0 - OK TCONS_00004091 iPS 0 1465.54 1529.68 2615.4 2877.89 - OK TCONS_00004091 iPS 1 799.214 769.981 1316.48 1448.61 - OK TCONS_00004091 hESC 1 19024.4 18831.4 12445.9 14285.9 - OK TCONS_00004091 hESC 0 14403.5 14551.2 9617.1 11038.9 - OK TCONS_00004091 Fibroblasts 1 36050.9 30080.9 24591.2 27224.7 - OK TCONS_00004091 Fibroblasts 0 19156 22793.5 18633.7 20629.2 - OK TCONS_00004092 iPS 0 0 0 0 0 - OK TCONS_00004092 iPS 1 12.3037 11.8536 20.2669 22.388 - OK TCONS_00004092 hESC 1 20.2645 20.0588 13.2572 15.2791 - OK TCONS_00004092 hESC 0 6.25669 6.32085 4.17754 4.81468 - OK TCONS_00004092 Fibroblasts 1 0 0 0 0 - OK TCONS_00004092 Fibroblasts 0 0 0 0 0 - OK TCONS_00004093 iPS 0 100.511 104.91 179.371 228.887 - OK TCONS_00004093 iPS 1 221.104 213.017 364.208 464.75 - OK TCONS_00004093 hESC 1 246.428 243.927 161.215 216.085 - OK TCONS_00004093 hESC 0 242.31 244.794 161.788 216.853 - OK TCONS_00004093 Fibroblasts 1 221.797 185.068 151.293 194.429 - OK TCONS_00004093 Fibroblasts 0 84.4504 100.486 82.148 105.569 - OK TCONS_00004094 iPS 0 0 0 0 0 - OK TCONS_00004094 iPS 1 0 0 0 0 - OK TCONS_00004094 hESC 1 0 0 0 0 - OK TCONS_00004094 hESC 0 1 1.01025 0.667691 0.716409 - OK TCONS_00004094 Fibroblasts 1 2 1.6688 1.36425 1.25394 - OK TCONS_00004094 Fibroblasts 0 0 0 0 0 - OK TCONS_00004095 iPS 0 0.00061045 0.000637168 0.00108941 0.000835455 - OK TCONS_00004095 iPS 1 0 0 0 0 - OK TCONS_00004095 hESC 1 0.000663217 0.000656486 0.000433881 0.000342616 - OK TCONS_00004095 hESC 0 0.000625617 0.000632031 0.000417719 0.000329853 - OK TCONS_00004095 Fibroblasts 1 25.5048 21.2812 17.3974 13.3987 - OK TCONS_00004095 Fibroblasts 0 0 0 0 0 - OK TCONS_00004096 iPS 0 2.99939 3.13066 5.35269 4.26686 - OK TCONS_00004096 iPS 1 0 0 0 0 - OK TCONS_00004096 hESC 1 6.99934 6.9283 4.57901 3.76288 - OK TCONS_00004096 hESC 0 3.99937 4.04038 2.67035 2.1944 - OK TCONS_00004096 Fibroblasts 1 0 0 0 0 - OK TCONS_00004096 Fibroblasts 0 3.59756 4.2807 3.49948 2.80192 - OK TCONS_00004097 iPS 0 0 0 0 0 - OK TCONS_00004097 iPS 1 0.00844287 0.00813405 0.0139073 0.00867196 - OK TCONS_00004097 hESC 1 0 0 0 0 - OK TCONS_00004097 hESC 0 0 0 0 0 - OK TCONS_00004097 Fibroblasts 1 226.806 189.247 154.71 96.8034 - OK TCONS_00004097 Fibroblasts 0 0 0 0 0 - OK TCONS_00004098 iPS 0 0 0 0 0 - OK TCONS_00004098 iPS 1 0 0 0 0 - OK TCONS_00004098 hESC 1 0 0 0 0 - OK TCONS_00004098 hESC 0 0 0 0 0 - OK TCONS_00004098 Fibroblasts 1 0 0 0 0 - OK TCONS_00004098 Fibroblasts 0 19.3779 23.0575 18.8496 11.996 - OK TCONS_00004099 iPS 0 0 0 0 0 - OK TCONS_00004099 iPS 1 3.9319 3.78808 6.47672 4.08359 - OK TCONS_00004099 hESC 1 0 0 0 0 - OK TCONS_00004099 hESC 0 0 0 0 0 - OK TCONS_00004099 Fibroblasts 1 258.848 215.983 176.567 111.715 - OK TCONS_00004099 Fibroblasts 0 0.0245503 0.0292121 0.023881 0.0151097 - OK TCONS_00004100 iPS 0 1 1.04377 1.78459 3.35453 - OK TCONS_00004100 iPS 1 0 0 0 0 - OK TCONS_00004100 hESC 1 0 0 0 0 - OK TCONS_00004100 hESC 0 0 0 0 0 - OK TCONS_00004100 Fibroblasts 1 6.84072 5.7079 4.66622 8.86318 - OK TCONS_00004100 Fibroblasts 0 0 0 0 0 - OK TCONS_00004101 iPS 0 0 0 0 0 - OK TCONS_00004101 iPS 1 0.0596582 0.057476 0.0982703 0.12506 - OK TCONS_00004101 hESC 1 0 0 0 0 - OK TCONS_00004101 hESC 0 0 0 0 0 - OK TCONS_00004101 Fibroblasts 1 0 0 0 0 - OK TCONS_00004101 Fibroblasts 0 0 0 0 0 - OK TCONS_00004102 iPS 0 7.0171 7.32422 12.5227 17.974 - OK TCONS_00004102 iPS 1 1.35657 1.30695 2.23458 3.20733 - OK TCONS_00004102 hESC 1 7.95004 7.86935 5.20097 7.89077 - OK TCONS_00004102 hESC 0 4.22241 4.2657 2.81926 4.27731 - OK TCONS_00004102 Fibroblasts 1 21.004 17.5258 14.3274 20.7286 - OK TCONS_00004102 Fibroblasts 0 19.9894 23.7851 19.4444 28.1319 - OK TCONS_00004103 iPS 0 3.53144 3.686 6.30219 11.2769 - OK TCONS_00004103 iPS 1 5.94541 5.72794 9.79342 17.524 - OK TCONS_00004103 hESC 1 49.7501 49.2452 32.5468 62.4378 - OK TCONS_00004103 hESC 0 34.6462 35.0014 23.1329 44.3782 - OK TCONS_00004103 Fibroblasts 1 43.0065 35.8846 29.3357 53.0161 - OK TCONS_00004103 Fibroblasts 0 50.6085 60.2184 49.2287 88.9671 - OK TCONS_00004104 iPS 0 2.51199 2.62193 4.48288 2.30967 - OK TCONS_00004104 iPS 1 1.10439 1.06399 1.81917 0.937275 - OK TCONS_00004104 hESC 1 4.84292 4.79377 3.16827 1.6646 - OK TCONS_00004104 hESC 0 4.24395 4.28746 2.83364 1.48879 - OK TCONS_00004104 Fibroblasts 1 4.70539 3.92617 3.20966 1.6584 - OK TCONS_00004104 Fibroblasts 0 2.33582 2.77936 2.27214 1.17399 - OK TCONS_00004105 iPS 0 8.93947 9.33072 15.9533 10.1263 - OK TCONS_00004105 iPS 1 8.59363 8.27929 14.1556 8.98525 - OK TCONS_00004105 hESC 1 4.45697 4.41173 2.91578 1.89602 - OK TCONS_00004105 hESC 0 18.8875 19.0811 12.611 8.20045 - OK TCONS_00004105 Fibroblasts 1 4.28411 3.57466 2.92229 1.86144 - OK TCONS_00004105 Fibroblasts 0 1.06629 1.26876 1.03722 0.660685 - OK TCONS_00004106 iPS 0 169 176.397 301.596 113.267 - OK TCONS_00004106 iPS 1 126 121.391 207.55 77.9474 - OK TCONS_00004106 hESC 1 735 727.54 480.842 183.171 - OK TCONS_00004106 hESC 0 965 974.894 644.322 245.446 - OK TCONS_00004106 Fibroblasts 1 321 267.842 218.962 82.404 - OK TCONS_00004106 Fibroblasts 0 152 180.863 147.856 55.6441 - OK TCONS_00004107 iPS 0 0 0 0 0 - OK TCONS_00004107 iPS 1 0 0 0 0 - OK TCONS_00004107 hESC 1 0 0 0 0 - OK TCONS_00004107 hESC 0 2.00011 2.02062 1.33545 1.17967 - OK TCONS_00004107 Fibroblasts 1 0 0 0 0 - OK TCONS_00004107 Fibroblasts 0 0 0 0 0 - OK TCONS_00004108 iPS 0 30 31.313 53.5378 96.6544 - OK TCONS_00004108 iPS 1 25 24.0856 41.1806 74.3453 - OK TCONS_00004108 hESC 1 203 200.94 132.804 257.213 - OK TCONS_00004108 hESC 0 175 176.794 116.846 226.306 - OK TCONS_00004108 Fibroblasts 1 61 50.8984 41.6096 75.8761 - OK TCONS_00004108 Fibroblasts 0 25 29.7472 24.3184 44.3453 - OK TCONS_00004109 iPS 0 5.46781 5.70712 9.75782 6.67606 - OK TCONS_00004109 iPS 1 0 0 0 0 - OK TCONS_00004109 hESC 1 379.326 375.476 248.157 174.265 - OK TCONS_00004109 hESC 0 262.114 264.802 175.011 122.899 - OK TCONS_00004109 Fibroblasts 1 1586.09 1323.44 1081.91 743.025 - OK TCONS_00004109 Fibroblasts 0 957.557 1139.39 931.45 639.692 - OK TCONS_00004110 iPS 0 0.0558852 0.0583312 0.0997324 0.0280833 - OK TCONS_00004110 iPS 1 0 0 0 0 - OK TCONS_00004110 hESC 1 0 0 0 0 - OK TCONS_00004110 hESC 0 0 0 0 0 - OK TCONS_00004110 Fibroblasts 1 15137.9 12631.1 10325.9 2912.17 - OK TCONS_00004110 Fibroblasts 0 8096.36 9633.76 7875.62 2221.12 - OK TCONS_00004111 iPS 0 677.887 707.556 1209.75 342.696 - OK TCONS_00004111 iPS 1 724.402 697.905 1193.25 338.022 - OK TCONS_00004111 hESC 1 5741.51 5683.24 3756.14 1075.48 - OK TCONS_00004111 hESC 0 5566.04 5623.11 3716.39 1064.1 - OK TCONS_00004111 Fibroblasts 1 6967.89 5814.01 4752.97 1348.52 - OK TCONS_00004111 Fibroblasts 0 6294.32 7489.53 6122.71 1737.15 - OK TCONS_00004112 iPS 0 197.59 206.238 352.617 100.432 - OK TCONS_00004112 iPS 1 354.598 341.628 584.102 166.363 - OK TCONS_00004112 hESC 1 2820.13 2791.51 1844.95 531.162 - OK TCONS_00004112 hESC 0 2699.84 2727.52 1802.66 518.985 - OK TCONS_00004112 Fibroblasts 1 91.9707 76.7403 62.7354 17.8963 - OK TCONS_00004112 Fibroblasts 0 106.186 126.35 103.291 29.4655 - OK TCONS_00004113 iPS 0 31.087 32.4476 55.4777 27.7543 - OK TCONS_00004113 iPS 1 152.783 147.195 251.668 125.904 - OK TCONS_00004113 hESC 1 174.794 173.02 114.351 58.304 - OK TCONS_00004113 hESC 0 596.402 602.517 398.212 203.036 - OK TCONS_00004113 Fibroblasts 1 251.385 209.755 171.475 86.0232 - OK TCONS_00004113 Fibroblasts 0 203.641 242.31 198.089 99.3743 - OK TCONS_00004114 iPS 0 439.413 458.645 784.174 397.081 - OK TCONS_00004114 iPS 1 485.217 467.469 799.26 404.72 - OK TCONS_00004114 hESC 1 1824.21 1805.69 1193.41 616.029 - OK TCONS_00004114 hESC 0 1304.6 1317.97 871.068 449.64 - OK TCONS_00004114 Fibroblasts 1 1257.62 1049.35 857.849 435.606 - OK TCONS_00004114 Fibroblasts 0 794.359 945.198 772.702 392.369 - OK TCONS_00004115 iPS 0 3.41925 3.5689 6.10197 7.3302 - OK TCONS_00004115 iPS 1 10.5268 10.1417 17.3399 20.8302 - OK TCONS_00004115 hESC 1 8.67217 8.58416 5.67339 7.13768 - OK TCONS_00004115 hESC 0 0 0 0 0 - OK TCONS_00004115 Fibroblasts 1 7.66318 6.39415 5.22724 6.32133 - OK TCONS_00004115 Fibroblasts 0 5.98425 7.12059 5.8211 7.03949 - OK TCONS_00004116 iPS 0 117.126 122.253 209.023 221.889 - OK TCONS_00004116 iPS 1 118.817 114.471 195.718 207.765 - OK TCONS_00004116 hESC 1 193.591 191.627 126.649 140.032 - OK TCONS_00004116 hESC 0 266.669 269.403 178.053 196.868 - OK TCONS_00004116 Fibroblasts 1 886.803 739.948 604.91 645.93 - OK TCONS_00004116 Fibroblasts 0 613.095 729.514 596.38 636.821 - OK TCONS_00004117 iPS 0 59.4544 62.0565 106.102 117.943 - OK TCONS_00004117 iPS 1 33.6561 32.425 55.439 61.6263 - OK TCONS_00004117 hESC 1 66.7365 66.0591 43.6594 50.6484 - OK TCONS_00004117 hESC 0 13.3309 13.4676 8.90091 10.3258 - OK TCONS_00004117 Fibroblasts 1 573.444 478.481 391.16 437.5 - OK TCONS_00004117 Fibroblasts 0 247.921 294.998 241.162 269.732 - OK TCONS_00004118 iPS 0 0 0 0 0 - OK TCONS_00004118 iPS 1 0 0 0 0 - OK TCONS_00004118 hESC 1 0 0 0 0 - OK TCONS_00004118 hESC 0 0 0 0 0 - OK TCONS_00004118 Fibroblasts 1 18.0895 15.0939 12.3393 14.4525 - OK TCONS_00004118 Fibroblasts 0 0 0 0 0 - OK TCONS_00004119 iPS 0 392.689 409.875 700.79 530.526 - OK TCONS_00004119 iPS 1 348.202 335.466 573.567 434.213 - OK TCONS_00004119 hESC 1 1804.75 1786.43 1180.68 920.003 - OK TCONS_00004119 hESC 0 1592.79 1609.12 1063.49 828.687 - OK TCONS_00004119 Fibroblasts 1 1589.8 1326.53 1084.44 824.41 - OK TCONS_00004119 Fibroblasts 0 1161 1381.47 1129.35 858.553 - OK TCONS_00004120 iPS 0 381.311 398 680.486 298.612 - OK TCONS_00004120 iPS 1 409.798 394.808 675.029 296.217 - OK TCONS_00004120 hESC 1 945.25 935.657 618.389 275.914 - OK TCONS_00004120 hESC 0 895.212 904.391 597.725 266.694 - OK TCONS_00004120 Fibroblasts 1 946.202 789.511 645.427 283.915 - OK TCONS_00004120 Fibroblasts 0 806.995 960.234 784.994 345.309 - OK TCONS_00004121 iPS 0 35.2149 36.7562 62.8443 11.4506 - OK TCONS_00004121 iPS 1 19.7988 19.0746 32.6131 5.94228 - OK TCONS_00004121 hESC 1 110.512 109.39 72.2976 13.2639 - OK TCONS_00004121 hESC 0 239.83 242.289 160.133 29.3782 - OK TCONS_00004121 Fibroblasts 1 4.51912 3.77075 3.0826 0.562232 - OK TCONS_00004121 Fibroblasts 0 0 0 0 0 - OK TCONS_00004122 iPS 0 1.48905 1.55422 2.65735 0.887067 - OK TCONS_00004122 iPS 1 1.91788 1.84772 3.15917 1.05458 - OK TCONS_00004122 hESC 1 176.433 174.643 115.424 39.02 - OK TCONS_00004122 hESC 0 158.591 160.218 105.89 35.797 - OK TCONS_00004122 Fibroblasts 1 5.23771 4.37034 3.57277 1.19485 - OK TCONS_00004122 Fibroblasts 0 7.67741 9.13526 7.4681 2.49757 - OK TCONS_00004123 iPS 0 17.8811 18.6637 31.9105 14.6435 - OK TCONS_00004123 iPS 1 3.65457 3.5209 6.0199 2.7625 - OK TCONS_00004123 hESC 1 169.673 167.951 111.001 51.8319 - OK TCONS_00004123 hESC 0 156.907 158.516 104.766 48.9202 - OK TCONS_00004123 Fibroblasts 1 20.2432 16.8909 13.8084 6.35267 - OK TCONS_00004123 Fibroblasts 0 12.3226 14.6625 11.9866 5.51457 - OK TCONS_00004124 iPS 0 1.41494 1.47687 2.5251 1.70128 - OK TCONS_00004124 iPS 1 3.62872 3.49599 5.97731 4.0272 - OK TCONS_00004124 hESC 1 4.38197 4.3375 2.86672 1.98163 - OK TCONS_00004124 hESC 0 1.67078 1.68791 1.11556 0.771137 - OK TCONS_00004124 Fibroblasts 1 0 0 0 0 - OK TCONS_00004124 Fibroblasts 0 0 0 0 0 - OK TCONS_00004125 iPS 0 0 0 0 0 - OK TCONS_00004125 iPS 1 2.99846 2.88879 4.93914 3.33568 - OK TCONS_00004125 hESC 1 0 0 0 0 - OK TCONS_00004125 hESC 0 3.99858 4.03958 2.66981 1.85004 - OK TCONS_00004125 Fibroblasts 1 0 0 0 0 - OK TCONS_00004125 Fibroblasts 0 0.00623317 0.00741678 0.00606323 0.00411017 - OK TCONS_00004126 iPS 0 0 0 0 0 - OK TCONS_00004126 iPS 1 0 0 0 0 - OK TCONS_00004126 hESC 1 15.9993 15.8369 10.4668 7.33925 - OK TCONS_00004126 hESC 0 0 0 0 0 - OK TCONS_00004126 Fibroblasts 1 0 0 0 0 - OK TCONS_00004126 Fibroblasts 0 0.993767 1.18247 0.966673 0.662916 - OK TCONS_00004127 iPS 0 0 0 0 0 - OK TCONS_00004127 iPS 1 0.00153566 0.00147949 0.00252957 0.00166542 - OK TCONS_00004127 hESC 1 0.000732167 0.000724736 0.000478989 0.00032336 - OK TCONS_00004127 hESC 0 0.0014216 0.00143618 0.000949189 0.000640787 - OK TCONS_00004127 Fibroblasts 1 0 0 0 0 - OK TCONS_00004127 Fibroblasts 0 0 0 0 0 - OK TCONS_00004128 iPS 0 48 50.1008 85.6605 53.2497 - OK TCONS_00004128 iPS 1 80.9467 77.9859 133.337 82.8874 - OK TCONS_00004128 hESC 1 120.29 119.069 78.6945 50.0899 - OK TCONS_00004128 hESC 0 99.1599 100.177 66.2081 42.1422 - OK TCONS_00004128 Fibroblasts 1 33 27.5352 22.5101 14.0413 - OK TCONS_00004128 Fibroblasts 0 26 30.9371 25.2911 15.7761 - OK TCONS_00004129 iPS 0 0 0 0 0 - OK TCONS_00004129 iPS 1 0 0 0 0 - OK TCONS_00004129 hESC 1 0 0 0 0 - OK TCONS_00004129 hESC 0 1.10899 1.12036 0.74046 2.09752 - OK TCONS_00004129 Fibroblasts 1 0 0 0 0 - OK TCONS_00004129 Fibroblasts 0 0 0 0 0 - OK TCONS_00004130 iPS 0 7 7.30637 12.4922 8.73699 - OK TCONS_00004130 iPS 1 4.05327 3.90501 6.67663 4.66962 - OK TCONS_00004130 hESC 1 17.7101 17.5303 11.586 8.32204 - OK TCONS_00004130 hESC 0 29.7312 30.036 19.8512 14.2588 - OK TCONS_00004130 Fibroblasts 1 0 0 0 0 - OK TCONS_00004130 Fibroblasts 0 0 0 0 0 - OK TCONS_00004131 iPS 0 0 0 0 0 - OK TCONS_00004131 iPS 1 0 0 0 0 - OK TCONS_00004131 hESC 1 0 0 0 0 - OK TCONS_00004131 hESC 0 0 0 0 0 - OK TCONS_00004131 Fibroblasts 1 0 0 0 0 - OK TCONS_00004131 Fibroblasts 0 0 0 0 0 - OK TCONS_00004132 iPS 0 318.944 332.903 569.185 1218.93 - OK TCONS_00004132 iPS 1 307.708 296.453 506.864 1085.46 - OK TCONS_00004132 hESC 1 497.229 492.183 325.291 757.606 - OK TCONS_00004132 hESC 0 97.0452 98.0402 64.7962 150.911 - OK TCONS_00004132 Fibroblasts 1 2743.89 2289.5 1871.68 4056.21 - OK TCONS_00004132 Fibroblasts 0 874.884 1041.01 851.031 1844.31 - OK TCONS_00004133 iPS 0 384.056 400.865 685.384 876.963 - OK TCONS_00004133 iPS 1 527.292 508.005 868.568 1111.35 - OK TCONS_00004133 hESC 1 4608.77 4562 3015.09 4052.8 - OK TCONS_00004133 hESC 0 5754.45 5813.46 3842.2 5164.57 - OK TCONS_00004133 Fibroblasts 1 5327.11 4444.94 3633.75 4682.54 - OK TCONS_00004133 Fibroblasts 0 8593.12 10224.8 8358.84 10771.4 - OK TCONS_00004134 iPS 0 1513.69 1579.94 2701.32 1448.77 - OK TCONS_00004134 iPS 1 1379.25 1328.8 2271.94 1218.48 - OK TCONS_00004134 hESC 1 3364.37 3330.23 2201 1204.72 - OK TCONS_00004134 hESC 0 3775.28 3813.99 2520.72 1379.72 - OK TCONS_00004134 Fibroblasts 1 3976.42 3317.93 2712.41 1459.04 - OK TCONS_00004134 Fibroblasts 0 3301.68 3928.63 3211.66 1727.59 - OK TCONS_00004135 iPS 0 0 0 0 0 - OK TCONS_00004135 iPS 1 0 0 0 0 - OK TCONS_00004135 hESC 1 0 0 0 0 - OK TCONS_00004135 hESC 0 20.5783 20.7893 13.7399 7.74536 - OK TCONS_00004135 Fibroblasts 1 0 0 0 0 - OK TCONS_00004135 Fibroblasts 0 21.5059 25.5896 20.9196 11.5832 - OK TCONS_00004136 iPS 0 85.8088 89.5644 153.134 85.9066 - OK TCONS_00004136 iPS 1 102.248 98.5084 168.426 94.4853 - OK TCONS_00004136 hESC 1 169.627 167.906 110.971 63.5949 - OK TCONS_00004136 hESC 0 189.639 191.583 126.62 72.5627 - OK TCONS_00004136 Fibroblasts 1 102.077 85.1732 69.6293 39.1828 - OK TCONS_00004136 Fibroblasts 0 50.313 59.8668 48.9413 27.5409 - OK TCONS_00004137 iPS 0 85.3722 89.1087 152.355 55.9409 - OK TCONS_00004137 iPS 1 102.021 98.2893 168.051 61.7044 - OK TCONS_00004137 hESC 1 642.931 636.406 420.61 156.599 - OK TCONS_00004137 hESC 0 464.712 469.477 310.284 115.523 - OK TCONS_00004137 Fibroblasts 1 425.555 355.083 290.281 106.801 - OK TCONS_00004137 Fibroblasts 0 655.066 779.455 637.206 234.442 - OK TCONS_00004138 iPS 0 1783.63 1861.69 3183.05 526.219 - OK TCONS_00004138 iPS 1 2313.98 2229.34 3811.64 630.137 - OK TCONS_00004138 hESC 1 7868.07 7788.21 5147.34 856.275 - OK TCONS_00004138 hESC 0 8422.29 8508.64 5623.49 935.482 - OK TCONS_00004138 Fibroblasts 1 5758.95 4805.26 3928.31 650.018 - OK TCONS_00004138 Fibroblasts 0 3857.93 4590.51 3752.75 620.968 - OK TCONS_00004139 iPS 0 171.409 178.911 305.895 316.644 - OK TCONS_00004139 iPS 1 166.494 160.404 274.252 283.89 - OK TCONS_00004139 hESC 1 2513.24 2487.73 1644.18 1770.86 - OK TCONS_00004139 hESC 0 1794.7 1813.11 1198.31 1290.64 - OK TCONS_00004139 Fibroblasts 1 133.851 111.685 91.3029 95.0546 - OK TCONS_00004139 Fibroblasts 0 47.9997 57.1143 46.6911 48.6097 - OK TCONS_00004140 iPS 0 0 0 0 0 - OK TCONS_00004140 iPS 1 0 0 0 0 - OK TCONS_00004140 hESC 1 11.8943 11.7736 7.78133 8.32384 - OK TCONS_00004140 hESC 0 8.59557 8.6837 5.73918 6.13931 - OK TCONS_00004140 Fibroblasts 1 0 0 0 0 - OK TCONS_00004140 Fibroblasts 0 0 0 0 0 - OK TCONS_00004141 iPS 0 1.59271 1.66242 2.84234 3.95914 - OK TCONS_00004141 iPS 1 3.50637 3.37811 5.77577 8.04516 - OK TCONS_00004141 hESC 1 6.78983 6.72092 4.44195 6.52912 - OK TCONS_00004141 hESC 0 2.09052 2.11195 1.39582 2.05169 - OK TCONS_00004141 Fibroblasts 1 0 0 0 0 - OK TCONS_00004141 Fibroblasts 0 0 0 0 0 - OK TCONS_00004142 iPS 0 91.7081 95.7219 163.662 139.25 - OK TCONS_00004142 iPS 1 53.0288 51.0891 87.3502 74.3213 - OK TCONS_00004142 hESC 1 543.149 537.636 355.332 312.32 - OK TCONS_00004142 hESC 0 542.49 548.052 362.216 318.371 - OK TCONS_00004142 Fibroblasts 1 293.188 244.636 199.99 170.964 - OK TCONS_00004142 Fibroblasts 0 518.904 617.438 504.757 431.496 - OK TCONS_00004143 iPS 0 1497.13 1562.65 2671.76 3842.62 - OK TCONS_00004143 iPS 1 2038.97 1964.39 3358.64 4830.52 - OK TCONS_00004143 hESC 1 6998.52 6927.49 4578.48 6961.28 - OK TCONS_00004143 hESC 0 6307.84 6372.52 4211.69 6403.6 - OK TCONS_00004143 Fibroblasts 1 1793.31 1496.34 1223.26 1773.42 - OK TCONS_00004143 Fibroblasts 0 1628.43 1937.65 1584.03 2296.45 - OK TCONS_00004144 iPS 0 0.00410908 0.00428892 0.00733303 0.00147752 - OK TCONS_00004144 iPS 1 85.5158 82.3878 140.864 28.3824 - OK TCONS_00004144 hESC 1 327.75 324.424 214.416 43.5322 - OK TCONS_00004144 hESC 0 628.709 635.156 419.784 85.2271 - OK TCONS_00004144 Fibroblasts 1 2821.72 2354.44 1924.76 388.25 - OK TCONS_00004144 Fibroblasts 0 789.537 939.461 768.012 154.918 - OK TCONS_00004145 iPS 0 308.038 321.52 549.723 112.088 - OK TCONS_00004145 iPS 1 242.655 233.779 399.707 81.5 - OK TCONS_00004145 hESC 1 719.435 712.133 470.659 96.7082 - OK TCONS_00004145 hESC 0 664.419 671.231 443.626 91.1537 - OK TCONS_00004145 Fibroblasts 1 1743.12 1454.46 1189.02 242.714 - OK TCONS_00004145 Fibroblasts 0 1482.05 1763.48 1441.65 294.282 - OK TCONS_00004146 iPS 0 26.8507 28.0259 47.9176 54.5076 - OK TCONS_00004146 iPS 1 41.6733 40.149 68.6453 78.0859 - OK TCONS_00004146 hESC 1 34.4024 34.0533 22.5063 26.7451 - OK TCONS_00004146 hESC 0 37.3111 37.6936 24.9123 29.6043 - OK TCONS_00004146 Fibroblasts 1 171.462 143.068 116.958 133.884 - OK TCONS_00004146 Fibroblasts 0 71.993 85.6636 70.0302 80.1649 - OK TCONS_00004147 iPS 0 0 0 0 0 - OK TCONS_00004147 iPS 1 0 0 0 0 - OK TCONS_00004147 hESC 1 0 0 0 0 - OK TCONS_00004147 hESC 0 0 0 0 0 - OK TCONS_00004147 Fibroblasts 1 0 0 0 0 - OK TCONS_00004147 Fibroblasts 0 0 0 0 0 - OK TCONS_00004148 iPS 0 0 0 0 0 - OK TCONS_00004148 iPS 1 2 1.92684 3.29445 6.80779 - OK TCONS_00004148 hESC 1 11.0013 10.8896 7.19712 16.125 - OK TCONS_00004148 hESC 0 4 4.04102 2.67077 5.9838 - OK TCONS_00004148 Fibroblasts 1 16.0001 13.3505 10.914 22.8136 - OK TCONS_00004148 Fibroblasts 0 6.00085 7.14034 5.83725 12.2016 - OK TCONS_00004149 iPS 0 41 42.7944 73.1683 195.455 - OK TCONS_00004149 iPS 1 304 292.88 500.756 1337.67 - OK TCONS_00004149 hESC 1 5 4.94925 3.27103 9.7133 - OK TCONS_00004149 hESC 0 3 3.03076 2.00307 5.9481 - OK TCONS_00004149 Fibroblasts 1 0 0 0 0 - OK TCONS_00004149 Fibroblasts 0 0 0 0 0 - OK TCONS_00004150 iPS 0 530.752 553.982 947.177 616.999 - OK TCONS_00004150 iPS 1 422.16 406.719 695.392 452.985 - OK TCONS_00004150 hESC 1 1633.29 1616.71 1068.51 713.507 - OK TCONS_00004150 hESC 0 1390.04 1404.29 928.116 619.759 - OK TCONS_00004150 Fibroblasts 1 1681 1402.62 1146.65 749.632 - OK TCONS_00004150 Fibroblasts 0 3000.15 3569.84 2918.36 1907.91 - OK TCONS_00004151 iPS 0 141.248 147.43 252.07 150.671 - OK TCONS_00004151 iPS 1 121.84 117.383 200.697 119.963 - OK TCONS_00004151 hESC 1 201.711 199.664 131.961 80.6904 - OK TCONS_00004151 hESC 0 289.961 292.934 193.604 118.384 - OK TCONS_00004151 Fibroblasts 1 232.004 193.584 158.256 94.9078 - OK TCONS_00004151 Fibroblasts 0 210.848 250.885 205.099 123.001 - OK TCONS_00004152 iPS 0 306.66 320.081 547.263 644.824 - OK TCONS_00004152 iPS 1 345.585 332.945 569.256 670.738 - OK TCONS_00004152 hESC 1 392.059 388.08 256.488 316.218 - OK TCONS_00004152 hESC 0 450.116 454.731 300.538 370.526 - OK TCONS_00004152 Fibroblasts 1 345.983 288.688 236.003 279.897 - OK TCONS_00004152 Fibroblasts 0 262.062 311.824 254.917 302.328 - OK TCONS_00004153 iPS 0 465.041 485.394 829.909 716.903 - OK TCONS_00004153 iPS 1 377.62 363.807 622.024 537.324 - OK TCONS_00004153 hESC 1 511.122 505.935 334.38 298.542 - OK TCONS_00004153 hESC 0 533.928 539.403 356.499 318.291 - OK TCONS_00004153 Fibroblasts 1 523.086 436.463 356.81 309.701 - OK TCONS_00004153 Fibroblasts 0 702.408 835.786 683.257 593.049 - OK TCONS_00004154 iPS 0 11.2592 11.752 20.0931 25.968 - OK TCONS_00004154 iPS 1 20.08 19.3455 33.0762 42.747 - OK TCONS_00004154 hESC 1 7.0794 7.00755 4.63139 6.29114 - OK TCONS_00004154 hESC 0 17.3923 17.5706 11.6127 15.7743 - OK TCONS_00004154 Fibroblasts 1 0 0 0 0 - OK TCONS_00004154 Fibroblasts 0 0 0 0 0 - OK TCONS_00004155 iPS 0 9.04016 9.43582 16.133 21.6408 - OK TCONS_00004155 iPS 1 16.5432 15.9381 27.2503 36.5537 - OK TCONS_00004155 hESC 1 31.7393 31.4172 20.7641 29.332 - OK TCONS_00004155 hESC 0 30.5638 30.8772 20.4072 28.8278 - OK TCONS_00004155 Fibroblasts 1 0 0 0 0 - OK TCONS_00004155 Fibroblasts 0 1.95106 2.32154 1.89787 2.5648 - OK TCONS_00004156 iPS 0 0 0 0 0 - OK TCONS_00004156 iPS 1 1.172 1.12913 1.93054 31.3204 - OK TCONS_00004156 hESC 1 0 0 0 0 - OK TCONS_00004156 hESC 0 0 0 0 0 - OK TCONS_00004156 Fibroblasts 1 11.9303 9.9546 8.13791 149.845 - OK TCONS_00004156 Fibroblasts 0 1.57958 1.87952 1.53651 28.2921 - OK TCONS_00004157 iPS 0 0 0 0 0 - OK TCONS_00004157 iPS 1 0 0 0 0 - OK TCONS_00004157 hESC 1 0 0 0 0 - OK TCONS_00004157 hESC 0 0 0 0 0 - OK TCONS_00004157 Fibroblasts 1 0 0 0 0 - OK TCONS_00004157 Fibroblasts 0 0 0 0 0 - OK TCONS_00004158 iPS 0 46 48.0133 82.0913 139.146 - OK TCONS_00004158 iPS 1 65.5 63.1042 107.893 182.881 - OK TCONS_00004158 hESC 1 1657 1640.18 1084.02 1962.48 - OK TCONS_00004158 hESC 0 2121 2142.75 1416.17 2563.8 - OK TCONS_00004158 Fibroblasts 1 1112 927.852 758.522 1297.86 - OK TCONS_00004158 Fibroblasts 0 1533 1824.1 1491.2 2551.5 - OK TCONS_00004159 iPS 0 0 0 0 0 - OK TCONS_00004159 iPS 1 0 0 0 0 - OK TCONS_00004159 hESC 1 0 0 0 0 - OK TCONS_00004159 hESC 0 0 0 0 0 - OK TCONS_00004159 Fibroblasts 1 0 0 0 0 - OK TCONS_00004159 Fibroblasts 0 0 0 0 0 - OK TCONS_00004160 iPS 0 0 0 0 0 - OK TCONS_00004160 iPS 1 0.25 0.240856 0.411806 0.348287 - OK TCONS_00004160 hESC 1 0 0 0 0 - OK TCONS_00004160 hESC 0 0 0 0 0 - OK TCONS_00004160 Fibroblasts 1 0 0 0 0 - OK TCONS_00004160 Fibroblasts 0 0 0 0 0 - OK TCONS_00004161 iPS 0 0 0 0 0 - OK TCONS_00004161 iPS 1 0 0 0 0 - OK TCONS_00004161 hESC 1 0 0 0 0 - OK TCONS_00004161 hESC 0 0 0 0 0 - OK TCONS_00004161 Fibroblasts 1 0 0 0 0 - OK TCONS_00004161 Fibroblasts 0 0 0 0 0 - OK TCONS_00004162 iPS 0 0 0 0 0 - OK TCONS_00004162 iPS 1 0.45 0.43354 0.741251 0.675373 - OK TCONS_00004162 hESC 1 0 0 0 0 - OK TCONS_00004162 hESC 0 0 0 0 0 - OK TCONS_00004162 Fibroblasts 1 0 0 0 0 - OK TCONS_00004162 Fibroblasts 0 0 0 0 0 - OK TCONS_00004163 iPS 0 0 0 0 0 - OK TCONS_00004163 iPS 1 0.449822 0.433368 0.740957 0.669072 - OK TCONS_00004163 hESC 1 0 0 0 0 - OK TCONS_00004163 hESC 0 0 0 0 0 - OK TCONS_00004163 Fibroblasts 1 0 0 0 0 - OK TCONS_00004163 Fibroblasts 0 0 0 0 0 - OK TCONS_00004164 iPS 0 0 0 0 0 - OK TCONS_00004164 iPS 1 0.000178204 0.000171686 0.000293542 0.000246058 - OK TCONS_00004164 hESC 1 0 0 0 0 - OK TCONS_00004164 hESC 0 0 0 0 0 - OK TCONS_00004164 Fibroblasts 1 0 0 0 0 - OK TCONS_00004164 Fibroblasts 0 0 0 0 0 - OK TCONS_00004165 iPS 0 5 5.21883 8.92297 15.0345 - OK TCONS_00004165 iPS 1 10.5 10.1159 17.2958 29.1422 - OK TCONS_00004165 hESC 1 211 208.859 138.038 248.31 - OK TCONS_00004165 hESC 0 269 271.758 179.609 323.091 - OK TCONS_00004165 Fibroblasts 1 175 146.02 119.372 203.021 - OK TCONS_00004165 Fibroblasts 0 123 146.356 119.647 203.489 - OK TCONS_00004166 iPS 0 0 0 0 0 - OK TCONS_00004166 iPS 1 0 0 0 0 - OK TCONS_00004166 hESC 1 0 0 0 0 - OK TCONS_00004166 hESC 0 0 0 0 0 - OK TCONS_00004166 Fibroblasts 1 0 0 0 0 - OK TCONS_00004166 Fibroblasts 0 0 0 0 0 - OK TCONS_00004167 iPS 0 0 0 0 0 - OK TCONS_00004167 iPS 1 0 0 0 0 - OK TCONS_00004167 hESC 1 0 0 0 0 - OK TCONS_00004167 hESC 0 0 0 0 0 - OK TCONS_00004167 Fibroblasts 1 0 0 0 0 - OK TCONS_00004167 Fibroblasts 0 0 0 0 0 - OK TCONS_00004168 iPS 0 0 0 0 0 - OK TCONS_00004168 iPS 1 0 0 0 0 - OK TCONS_00004168 hESC 1 0 0 0 0 - OK TCONS_00004168 hESC 0 0 0 0 0 - OK TCONS_00004168 Fibroblasts 1 0 0 0 0 - OK TCONS_00004168 Fibroblasts 0 0 0 0 0 - OK TCONS_00004169 iPS 0 0 0 0 0 - OK TCONS_00004169 iPS 1 0.332352 0.320195 0.547457 0.400722 - OK TCONS_00004169 hESC 1 0 0 0 0 - OK TCONS_00004169 hESC 0 0 0 0 0 - OK TCONS_00004169 Fibroblasts 1 0 0 0 0 - OK TCONS_00004169 Fibroblasts 0 0 0 0 0 - OK TCONS_00004170 iPS 0 0 0 0 0 - OK TCONS_00004170 iPS 1 0.000981826 0.000945913 0.00161729 0.00114586 - OK TCONS_00004170 hESC 1 0 0 0 0 - OK TCONS_00004170 hESC 0 0 0 0 0 - OK TCONS_00004170 Fibroblasts 1 0 0 0 0 - OK TCONS_00004170 Fibroblasts 0 0 0 0 0 - OK TCONS_00004171 iPS 0 0 0 0 0 - OK TCONS_00004171 iPS 1 0 0 0 0 - OK TCONS_00004171 hESC 1 0 0 0 0 - OK TCONS_00004171 hESC 0 0 0 0 0 - OK TCONS_00004171 Fibroblasts 1 0 0 0 0 - OK TCONS_00004171 Fibroblasts 0 0 0 0 0 - OK TCONS_00004172 iPS 0 0 0 0 0 - OK TCONS_00004172 iPS 1 1 0.963422 1.64722 1.38982 - OK TCONS_00004172 hESC 1 0 0 0 0 - OK TCONS_00004172 hESC 0 0 0 0 0 - OK TCONS_00004172 Fibroblasts 1 0 0 0 0 - OK TCONS_00004172 Fibroblasts 0 0 0 0 0 - OK TCONS_00004173 iPS 0 0 0 0 0 - OK TCONS_00004173 iPS 1 1.33333 1.28456 2.1963 1.60762 - OK TCONS_00004173 hESC 1 0 0 0 0 - OK TCONS_00004173 hESC 0 0 0 0 0 - OK TCONS_00004173 Fibroblasts 1 0 0 0 0 - OK TCONS_00004173 Fibroblasts 0 0 0 0 0 - OK TCONS_00004174 iPS 0 0 0 0 0 - OK TCONS_00004174 iPS 1 0 0 0 0 - OK TCONS_00004174 hESC 1 0 0 0 0 - OK TCONS_00004174 hESC 0 0 0 0 0 - OK TCONS_00004174 Fibroblasts 1 0 0 0 0 - OK TCONS_00004174 Fibroblasts 0 0 0 0 0 - OK TCONS_00004175 iPS 0 4 4.17507 7.13837 5.80813 - OK TCONS_00004175 iPS 1 6 5.78053 9.88334 8.04156 - OK TCONS_00004175 hESC 1 15 14.8478 9.8131 8.23632 - OK TCONS_00004175 hESC 0 15 15.1538 10.0154 8.40609 - OK TCONS_00004175 Fibroblasts 1 0 0 0 0 - OK TCONS_00004175 Fibroblasts 0 0 0 0 0 - OK TCONS_00004176 iPS 0 8.48853 8.86004 15.1486 3.14638 - OK TCONS_00004176 iPS 1 37.6717 36.2937 62.0537 12.8886 - OK TCONS_00004176 hESC 1 89.2283 88.3227 58.3737 12.2197 - OK TCONS_00004176 hESC 0 45.0907 45.553 30.1067 6.3024 - OK TCONS_00004176 Fibroblasts 1 11.8905 9.92146 8.11082 1.68656 - OK TCONS_00004176 Fibroblasts 0 0 0 0 0 - OK TCONS_00004177 iPS 0 0 0 0 0 - OK TCONS_00004177 iPS 1 0.00332906 0.00320729 0.00548371 0.00111909 - OK TCONS_00004177 hESC 1 0 0 0 0 - OK TCONS_00004177 hESC 0 0 0 0 0 - OK TCONS_00004177 Fibroblasts 1 0 0 0 0 - OK TCONS_00004177 Fibroblasts 0 0 0 0 0 - OK TCONS_00004178 iPS 0 1 1.04377 1.78459 0.813015 - OK TCONS_00004178 iPS 1 0 0 0 0 - OK TCONS_00004178 hESC 1 10.3202 10.2154 6.75152 3.3111 - OK TCONS_00004178 hESC 0 12.8702 13.0021 8.59329 4.21435 - OK TCONS_00004178 Fibroblasts 1 1.13779 0.949372 0.776114 0.374731 - OK TCONS_00004178 Fibroblasts 0 10.3333 12.2954 10.0516 4.85319 - OK TCONS_00004179 iPS 0 111.69 116.579 199.322 67.9643 - OK TCONS_00004179 iPS 1 147.272 141.885 242.589 82.7175 - OK TCONS_00004179 hESC 1 167.511 165.811 109.587 37.8519 - OK TCONS_00004179 hESC 0 123.936 125.207 82.7509 28.5825 - OK TCONS_00004179 Fibroblasts 1 111.6 93.1194 76.1253 26.006 - OK TCONS_00004179 Fibroblasts 0 76.3382 90.8339 74.2569 25.3677 - OK TCONS_00004180 iPS 0 0 0 0 0 - OK TCONS_00004180 iPS 1 0 0 0 0 - OK TCONS_00004180 hESC 1 470.831 466.053 308.021 246.673 - OK TCONS_00004180 hESC 0 320.637 323.924 214.086 171.447 - OK TCONS_00004180 Fibroblasts 1 310.255 258.877 211.632 165.238 - OK TCONS_00004180 Fibroblasts 0 136.143 161.995 132.431 103.4 - OK TCONS_00004181 iPS 0 61.9634 64.6754 110.58 114.215 - OK TCONS_00004181 iPS 1 102.57 98.8183 168.956 174.51 - OK TCONS_00004181 hESC 1 181.272 179.433 118.59 127.436 - OK TCONS_00004181 hESC 0 195.452 197.456 130.502 140.236 - OK TCONS_00004181 Fibroblasts 1 21.7397 18.1396 14.8291 15.4045 - OK TCONS_00004181 Fibroblasts 0 68.8986 81.9816 67.0201 69.6204 - OK TCONS_00004182 iPS 0 0 0 0 0 - OK TCONS_00004182 iPS 1 0 0 0 0 - OK TCONS_00004182 hESC 1 33.0558 32.7203 21.6253 16.7676 - OK TCONS_00004182 hESC 0 36.7083 37.0847 24.5098 19.0042 - OK TCONS_00004182 Fibroblasts 1 28.2809 23.5975 19.2911 14.5948 - OK TCONS_00004182 Fibroblasts 0 7.1254 8.47843 6.93114 5.24381 - OK TCONS_00004183 iPS 0 0 0 0 0 - OK TCONS_00004183 iPS 1 0 0 0 0 - OK TCONS_00004183 hESC 1 0 0 0 0 - OK TCONS_00004183 hESC 0 0 0 0 0 - OK TCONS_00004183 Fibroblasts 1 0 0 0 0 - OK TCONS_00004183 Fibroblasts 0 0 0 0 0 - OK TCONS_00004184 iPS 0 0 0 0 0 - OK TCONS_00004184 iPS 1 0 0 0 0 - OK TCONS_00004184 hESC 1 0 0 0 0 - OK TCONS_00004184 hESC 0 0 0 0 0 - OK TCONS_00004184 Fibroblasts 1 57.1239 47.6642 38.9656 31.8842 - OK TCONS_00004184 Fibroblasts 0 37.0946 44.1384 36.0832 29.5257 - OK TCONS_00004185 iPS 0 91.3461 95.3441 163.016 141.423 - OK TCONS_00004185 iPS 1 142.158 136.958 234.166 203.149 - OK TCONS_00004185 hESC 1 32.3289 32.0008 21.1498 18.9668 - OK TCONS_00004185 hESC 0 120.267 121.5 80.3009 72.0127 - OK TCONS_00004185 Fibroblasts 1 0 0 0 0 - OK TCONS_00004185 Fibroblasts 0 90.4002 107.566 87.9355 76.6549 - OK TCONS_00004186 iPS 0 80 83.5014 142.767 99.5559 - OK TCONS_00004186 iPS 1 125 120.428 205.903 143.582 - OK TCONS_00004186 hESC 1 247.477 244.966 161.901 115.938 - OK TCONS_00004186 hESC 0 250 252.563 166.923 119.533 - OK TCONS_00004186 Fibroblasts 1 72.824 60.7643 49.675 34.7737 - OK TCONS_00004186 Fibroblasts 0 75 89.2416 72.9552 51.0704 - OK TCONS_00004187 iPS 0 1175 1226.43 2096.9 8005.09 - OK TCONS_00004187 iPS 1 1170 1127.2 1927.25 7357.45 - OK TCONS_00004187 hESC 1 7386 7311.04 4831.97 21537.1 - OK TCONS_00004187 hESC 0 4898 4948.22 3270.35 14576.6 - OK TCONS_00004187 Fibroblasts 1 5609 4680.15 3826.03 14920.7 - OK TCONS_00004187 Fibroblasts 0 6791 8080.53 6605.85 25761.5 - OK TCONS_00004188 iPS 0 70 73.0637 124.922 68.9048 - OK TCONS_00004188 iPS 1 75 72.2567 123.542 68.1437 - OK TCONS_00004188 hESC 1 155 153.427 101.402 57.116 - OK TCONS_00004188 hESC 0 162 163.661 108.166 60.9259 - OK TCONS_00004188 Fibroblasts 1 105 87.612 71.623 39.6268 - OK TCONS_00004188 Fibroblasts 0 74 88.0517 71.9825 39.8257 - OK TCONS_00004189 iPS 0 161.646 168.721 288.472 158.069 - OK TCONS_00004189 iPS 1 67.045 64.5927 110.438 60.5148 - OK TCONS_00004189 hESC 1 707.047 699.871 462.555 258.788 - OK TCONS_00004189 hESC 0 715.329 722.664 477.619 267.216 - OK TCONS_00004189 Fibroblasts 1 1343.11 1120.69 916.164 503.537 - OK TCONS_00004189 Fibroblasts 0 1132.17 1347.16 1101.31 605.295 - OK TCONS_00004190 iPS 0 0 0 0 0 - OK TCONS_00004190 iPS 1 0.00429962 0.00414235 0.00708244 0.00418041 - OK TCONS_00004190 hESC 1 32.665 32.3335 21.3697 12.8997 - OK TCONS_00004190 hESC 0 0 0 0 0 - OK TCONS_00004190 Fibroblasts 1 0 0 0 0 - OK TCONS_00004190 Fibroblasts 0 12.6994 15.1108 12.3531 7.31529 - OK TCONS_00004191 iPS 0 32.3972 33.8151 57.8159 31.4247 - OK TCONS_00004191 iPS 1 34.9294 33.6518 57.5365 31.2729 - OK TCONS_00004191 hESC 1 103.517 102.466 67.7213 37.5763 - OK TCONS_00004191 hESC 0 38.7215 39.1185 25.854 14.3455 - OK TCONS_00004191 Fibroblasts 1 168.977 140.994 115.263 62.8375 - OK TCONS_00004191 Fibroblasts 0 81.4323 96.8953 79.2122 43.1838 - OK TCONS_00004192 iPS 0 0 0 0 0 - OK TCONS_00004192 iPS 1 0 0 0 0 - OK TCONS_00004192 hESC 1 0 0 0 0 - OK TCONS_00004192 hESC 0 32.5577 32.8916 21.7385 12.1814 - OK TCONS_00004192 Fibroblasts 1 0 0 0 0 - OK TCONS_00004192 Fibroblasts 0 0 0 0 0 - OK TCONS_00004193 iPS 0 6.97416 7.2794 12.446 10.1971 - OK TCONS_00004193 iPS 1 0 0 0 0 - OK TCONS_00004193 hESC 1 0 0 0 0 - OK TCONS_00004193 hESC 0 6.67349 6.74191 4.45583 3.76668 - OK TCONS_00004193 Fibroblasts 1 5.67647 4.73645 3.87206 3.18681 - OK TCONS_00004193 Fibroblasts 0 27.0622 32.201 26.3244 21.6657 - OK TCONS_00004194 iPS 0 0 0 0 0 - OK TCONS_00004194 iPS 1 7.8009 7.51556 12.8498 10.3246 - OK TCONS_00004194 hESC 1 16.3456 16.1798 10.6934 8.85955 - OK TCONS_00004194 hESC 0 12.9326 13.0652 8.635 7.15413 - OK TCONS_00004194 Fibroblasts 1 20.6633 17.2414 14.0949 11.3755 - OK TCONS_00004194 Fibroblasts 0 10.6826 12.7111 10.3914 8.38648 - OK TCONS_00004195 iPS 0 0 0 0 0 - OK TCONS_00004195 iPS 1 0 0 0 0 - OK TCONS_00004195 hESC 1 0 0 0 0 - OK TCONS_00004195 hESC 0 0 0 0 0 - OK TCONS_00004195 Fibroblasts 1 0 0 0 0 - OK TCONS_00004195 Fibroblasts 0 0 0 0 0 - OK TCONS_00004196 iPS 0 7.79567 8.13686 13.9121 19.7083 - OK TCONS_00004196 iPS 1 2.05566 1.98047 3.38614 4.7969 - OK TCONS_00004196 hESC 1 7.97197 7.89107 5.21532 7.80374 - OK TCONS_00004196 hESC 0 9.4159 9.51244 6.28691 9.40717 - OK TCONS_00004196 Fibroblasts 1 21.5783 18.0049 14.7191 21.0158 - OK TCONS_00004196 Fibroblasts 0 21.9001 26.0587 21.303 30.4164 - OK TCONS_00004197 iPS 0 3.18713 3.32662 5.68773 10.9088 - OK TCONS_00004197 iPS 1 6.16469 5.9392 10.1546 19.476 - OK TCONS_00004197 hESC 1 17.9536 17.7714 11.7454 24.2773 - OK TCONS_00004197 hESC 0 13.3696 13.5067 8.92679 18.4514 - OK TCONS_00004197 Fibroblasts 1 0 0 0 0 - OK TCONS_00004197 Fibroblasts 0 2.0486 2.4376 1.99274 3.86289 - OK TCONS_00004198 iPS 0 0 0 0 0 - OK TCONS_00004198 iPS 1 0 0 0 0 - OK TCONS_00004198 hESC 1 0 0 0 0 - OK TCONS_00004198 hESC 0 0 0 0 0 - OK TCONS_00004198 Fibroblasts 1 0 0 0 0 - OK TCONS_00004198 Fibroblasts 0 0 0 0 0 - OK TCONS_00004199 iPS 0 226.147 236.045 403.58 209.536 - OK TCONS_00004199 iPS 1 0.0328916 0.0316885 0.0541799 0.0281298 - OK TCONS_00004199 hESC 1 13.0413 12.909 8.53172 4.51777 - OK TCONS_00004199 hESC 0 0.0295799 0.0298832 0.0197502 0.0104583 - OK TCONS_00004199 Fibroblasts 1 636.05 530.72 433.865 225.907 - OK TCONS_00004199 Fibroblasts 0 503.256 598.818 489.535 254.894 - OK TCONS_00004200 iPS 0 24.5568 25.6315 43.8239 22.879 - OK TCONS_00004200 iPS 1 12.1382 11.6942 19.9943 10.4384 - OK TCONS_00004200 hESC 1 0 0 0 0 - OK TCONS_00004200 hESC 0 7.33392 7.40912 4.89679 2.60762 - OK TCONS_00004200 Fibroblasts 1 54.8425 45.7606 37.4094 19.5866 - OK TCONS_00004200 Fibroblasts 0 31.8817 37.9356 31.0125 16.2374 - OK TCONS_00004201 iPS 0 17.3255 18.0838 30.919 15.9825 - OK TCONS_00004201 iPS 1 0 0 0 0 - OK TCONS_00004201 hESC 1 0 0 0 0 - OK TCONS_00004201 hESC 0 0 0 0 0 - OK TCONS_00004201 Fibroblasts 1 0 0 0 0 - OK TCONS_00004201 Fibroblasts 0 72.4522 86.2099 70.4769 36.5348 - OK TCONS_00004202 iPS 0 0 0 0 0 - OK TCONS_00004202 iPS 1 0 0 0 0 - OK TCONS_00004202 hESC 1 0 0 0 0 - OK TCONS_00004202 hESC 0 0 0 0 0 - OK TCONS_00004202 Fibroblasts 1 156.876 130.897 107.009 55.4118 - OK TCONS_00004202 Fibroblasts 0 133.322 158.638 129.687 67.1553 - OK TCONS_00004203 iPS 0 94.9715 99.1282 169.486 106.671 - OK TCONS_00004203 iPS 1 12.8287 12.3594 21.1317 13.2999 - OK TCONS_00004203 hESC 1 15.9588 15.7968 10.4404 6.73019 - OK TCONS_00004203 hESC 0 1.63616 1.65293 1.09245 0.704227 - OK TCONS_00004203 Fibroblasts 1 702.228 585.939 479.006 302.529 - OK TCONS_00004203 Fibroblasts 0 792.088 942.496 770.493 486.625 - OK TCONS_00004204 iPS 0 4.90082 5.11531 8.74597 17.0753 - OK TCONS_00004204 iPS 1 0 0 0 0 - OK TCONS_00004204 hESC 1 5.33778 5.2836 3.49201 7.35763 - OK TCONS_00004204 hESC 0 1.80908 1.82763 1.20791 2.54505 - OK TCONS_00004204 Fibroblasts 1 5.64787 4.71258 3.85255 7.60353 - OK TCONS_00004204 Fibroblasts 0 3.81507 4.5395 3.71105 7.32427 - OK TCONS_00004205 iPS 0 1.59956 1.66957 2.85457 2.63482 - OK TCONS_00004205 iPS 1 5.50004 5.29886 9.0598 8.36235 - OK TCONS_00004205 hESC 1 44.1626 43.7144 28.8915 27.6258 - OK TCONS_00004205 hESC 0 25.691 25.9544 17.1537 16.4022 - OK TCONS_00004205 Fibroblasts 1 48.6213 40.5696 33.1657 30.7694 - OK TCONS_00004205 Fibroblasts 0 51.1849 60.9043 49.7894 46.1919 - OK TCONS_00004206 iPS 0 321.228 335.287 573.262 214.61 - OK TCONS_00004206 iPS 1 410.145 395.143 675.601 252.922 - OK TCONS_00004206 hESC 1 2049 2028.2 1340.47 508.99 - OK TCONS_00004206 hESC 0 2550.08 2576.23 1702.67 646.52 - OK TCONS_00004206 Fibroblasts 1 2259 1884.91 1540.92 578.063 - OK TCONS_00004206 Fibroblasts 0 3461 4118.2 3366.64 1262.97 - OK TCONS_00004207 iPS 0 10.7718 11.2432 19.2232 18.5799 - OK TCONS_00004207 iPS 1 17.8549 17.2018 29.4111 28.4268 - OK TCONS_00004207 hESC 1 0 0 0 0 - OK TCONS_00004207 hESC 0 7.41611 7.49215 4.95167 4.9664 - OK TCONS_00004207 Fibroblasts 1 0 0 0 0 - OK TCONS_00004207 Fibroblasts 0 0 0 0 0 - OK TCONS_00004208 iPS 0 0 0 0 0 - OK TCONS_00004208 iPS 1 44.2745 42.655 72.93 56.0509 - OK TCONS_00004208 hESC 1 703.736 696.594 460.389 364.361 - OK TCONS_00004208 hESC 0 561.01 566.762 374.581 296.452 - OK TCONS_00004208 Fibroblasts 1 233.766 195.054 159.457 123.074 - OK TCONS_00004208 Fibroblasts 0 181.559 216.035 176.609 136.313 - OK TCONS_00004209 iPS 0 0 0 0 0 - OK TCONS_00004209 iPS 1 0.0381138 0.0367196 0.0627819 0.048889 - OK TCONS_00004209 hESC 1 0 0 0 0 - OK TCONS_00004209 hESC 0 0 0 0 0 - OK TCONS_00004209 Fibroblasts 1 82.9927 69.2491 56.6113 44.2742 - OK TCONS_00004209 Fibroblasts 0 48.1022 57.2362 46.7907 36.5938 - OK TCONS_00004210 iPS 0 182 189.966 324.796 160.558 - OK TCONS_00004210 iPS 1 167.687 161.554 276.219 136.545 - OK TCONS_00004210 hESC 1 2105.76 2084.39 1377.6 693.892 - OK TCONS_00004210 hESC 0 2017.99 2038.68 1347.39 678.675 - OK TCONS_00004210 Fibroblasts 1 38.2415 31.9087 26.0854 12.9302 - OK TCONS_00004210 Fibroblasts 0 4.33866 5.16252 4.22037 2.09199 - OK TCONS_00004211 iPS 0 17 17.744 30.3381 30.84 - OK TCONS_00004211 iPS 1 15 14.4513 24.7084 25.1171 - OK TCONS_00004211 hESC 1 97 96.0155 63.458 67.0708 - OK TCONS_00004211 hESC 0 61 61.6254 40.7291 43.0479 - OK TCONS_00004211 Fibroblasts 1 253 211.103 172.577 176.423 - OK TCONS_00004211 Fibroblasts 0 185 220.129 179.956 183.966 - OK TCONS_00004212 iPS 0 23.4303 24.4558 41.8136 25.6435 - OK TCONS_00004212 iPS 1 18.3519 17.6806 30.2297 18.5393 - OK TCONS_00004212 hESC 1 5.04507 4.99386 3.30052 2.07191 - OK TCONS_00004212 hESC 0 5.98566 6.04703 3.99657 2.50886 - OK TCONS_00004212 Fibroblasts 1 44.414 37.059 30.2959 18.643 - OK TCONS_00004212 Fibroblasts 0 20.706 24.6378 20.1415 12.3944 - OK TCONS_00004213 iPS 0 6.1265 6.39464 10.9333 5.35606 - OK TCONS_00004213 iPS 1 23.4595 22.6014 38.643 18.9306 - OK TCONS_00004213 hESC 1 15.7593 15.5994 10.3098 5.14538 - OK TCONS_00004213 hESC 0 37.8755 38.2638 25.2891 12.6211 - OK TCONS_00004213 Fibroblasts 1 133.25 111.184 90.8932 44.6479 - OK TCONS_00004213 Fibroblasts 0 39.8427 47.4083 38.7564 19.0376 - OK TCONS_00004214 iPS 0 373.274 389.611 666.143 335.631 - OK TCONS_00004214 iPS 1 295.849 285.028 487.33 245.538 - OK TCONS_00004214 hESC 1 774.747 766.884 506.845 260.3 - OK TCONS_00004214 hESC 0 752.693 760.411 502.566 258.103 - OK TCONS_00004214 Fibroblasts 1 1645.34 1372.87 1122.32 567.052 - OK TCONS_00004214 Fibroblasts 0 996.451 1185.67 969.284 489.73 - OK TCONS_00004215 iPS 0 34.5024 36.0125 61.5728 31.1562 - OK TCONS_00004215 iPS 1 27.3395 26.3395 45.0342 22.7876 - OK TCONS_00004215 hESC 1 2.44885 2.424 1.60205 0.826367 - OK TCONS_00004215 hESC 0 3.44577 3.4811 2.30071 1.18674 - OK TCONS_00004215 Fibroblasts 1 0 0 0 0 - OK TCONS_00004215 Fibroblasts 0 0 0 0 0 - OK TCONS_00004216 iPS 0 0 0 0 0 - OK TCONS_00004216 iPS 1 0 0 0 0 - OK TCONS_00004216 hESC 1 0 0 0 0 - OK TCONS_00004216 hESC 0 0 0 0 0 - OK TCONS_00004216 Fibroblasts 1 1.26129 1.05242 0.860354 0.350249 - OK TCONS_00004216 Fibroblasts 0 0 0 0 0 - OK TCONS_00004217 iPS 0 0 0 0 0 - OK TCONS_00004217 iPS 1 1.98872 1.91597 3.27586 2.50951 - OK TCONS_00004217 hESC 1 0 0 0 0 - OK TCONS_00004217 hESC 0 0 0 0 0 - OK TCONS_00004217 Fibroblasts 1 0 0 0 0 - OK TCONS_00004217 Fibroblasts 0 0 0 0 0 - OK TCONS_00004218 iPS 0 0 0 0 0 - OK TCONS_00004218 iPS 1 0 0 0 0 - OK TCONS_00004218 hESC 1 0 0 0 0 - OK TCONS_00004218 hESC 0 0 0 0 0 - OK TCONS_00004218 Fibroblasts 1 0 0 0 0 - OK TCONS_00004218 Fibroblasts 0 0 0 0 0 - OK TCONS_00004219 iPS 0 94.3451 98.4743 168.368 45.7964 - OK TCONS_00004219 iPS 1 72.8546 70.1897 120.008 32.6424 - OK TCONS_00004219 hESC 1 266.512 263.807 174.354 47.9146 - OK TCONS_00004219 hESC 0 268.711 271.466 179.416 49.3056 - OK TCONS_00004219 Fibroblasts 1 116.113 96.8847 79.2035 21.5759 - OK TCONS_00004219 Fibroblasts 0 45.3856 54.0037 44.1482 12.0265 - OK TCONS_00004220 iPS 0 0 0 0 0 - OK TCONS_00004220 iPS 1 0 0 0 0 - OK TCONS_00004220 hESC 1 19.9255 19.7233 13.0354 52.1823 - OK TCONS_00004220 hESC 0 42.5912 43.0279 28.4378 113.84 - OK TCONS_00004220 Fibroblasts 1 17.2834 14.4212 11.7894 41.8251 - OK TCONS_00004220 Fibroblasts 0 6.5016 7.73618 6.32434 22.4368 - OK TCONS_00004221 iPS 0 4.15492 4.33676 7.41484 10.9883 - OK TCONS_00004221 iPS 1 1.64543 1.58525 2.7104 4.01662 - OK TCONS_00004221 hESC 1 61.3959 60.7728 40.1656 63.034 - OK TCONS_00004221 hESC 0 36.0315 36.401 24.0579 37.7553 - OK TCONS_00004221 Fibroblasts 1 21.7702 18.165 14.85 22.1882 - OK TCONS_00004221 Fibroblasts 0 8.2795 9.85167 8.05377 12.0336 - OK TCONS_00004222 iPS 0 17.6943 18.4687 31.5771 19.2987 - OK TCONS_00004222 iPS 1 26.6837 25.7076 43.9539 26.863 - OK TCONS_00004222 hESC 1 29.1475 28.8517 19.0685 11.928 - OK TCONS_00004222 hESC 0 29.7601 30.0653 19.8706 12.4297 - OK TCONS_00004222 Fibroblasts 1 2 1.6688 1.36425 0.8366 - OK TCONS_00004222 Fibroblasts 0 1.24322 1.47929 1.20933 0.741598 - OK TCONS_00004223 iPS 0 112 116.902 199.874 284.86 - OK TCONS_00004223 iPS 1 66.5 64.0676 109.54 156.116 - OK TCONS_00004223 hESC 1 188.5 186.587 123.318 185.701 - OK TCONS_00004223 hESC 0 177.667 179.488 118.626 178.636 - OK TCONS_00004223 Fibroblasts 1 2219.83 1852.23 1514.2 2175.15 - OK TCONS_00004223 Fibroblasts 0 915.167 1088.95 890.216 1278.79 - OK TCONS_00004224 iPS 0 343.717 358.76 613.394 211.602 - OK TCONS_00004224 iPS 1 163.521 157.54 269.355 92.9192 - OK TCONS_00004224 hESC 1 497.016 491.971 325.151 113.641 - OK TCONS_00004224 hESC 0 450.044 454.659 300.491 105.022 - OK TCONS_00004224 Fibroblasts 1 2981.32 2487.61 2033.63 702.878 - OK TCONS_00004224 Fibroblasts 0 1414.92 1683.59 1376.34 475.701 - OK TCONS_00004225 iPS 0 0 0 0 0 - OK TCONS_00004225 iPS 1 0 0 0 0 - OK TCONS_00004225 hESC 1 110.791 109.666 72.4801 79.3946 - OK TCONS_00004225 hESC 0 222.251 224.529 148.395 162.551 - OK TCONS_00004225 Fibroblasts 1 898.256 749.505 612.722 648.398 - OK TCONS_00004225 Fibroblasts 0 431.539 513.483 419.774 444.215 - OK TCONS_00004226 iPS 0 32.771 34.2053 58.4829 61.5286 - OK TCONS_00004226 iPS 1 36.9033 35.5535 60.788 63.9537 - OK TCONS_00004226 hESC 1 35.8705 35.5064 23.4667 25.7054 - OK TCONS_00004226 hESC 0 44.1596 44.6124 29.485 32.2978 - OK TCONS_00004226 Fibroblasts 1 293.223 244.665 200.015 211.661 - OK TCONS_00004226 Fibroblasts 0 232.748 276.944 226.402 239.585 - OK TCONS_00004227 iPS 0 2.68826 2.80591 4.79744 3.31274 - OK TCONS_00004227 iPS 1 6.202 5.97515 10.2161 7.05442 - OK TCONS_00004227 hESC 1 2.28495 2.26176 1.49483 1.05972 - OK TCONS_00004227 hESC 0 18.7197 18.9116 12.4989 8.86078 - OK TCONS_00004227 Fibroblasts 1 3.87295 3.23159 2.64183 1.83122 - OK TCONS_00004227 Fibroblasts 0 9.53692 11.3479 9.27691 6.43042 - OK TCONS_00004228 iPS 0 132.645 138.451 236.718 134.18 - OK TCONS_00004228 iPS 1 71.6675 69.046 118.052 66.9162 - OK TCONS_00004228 hESC 1 152.936 151.384 100.052 57.9475 - OK TCONS_00004228 hESC 0 161.005 162.655 107.501 62.2622 - OK TCONS_00004228 Fibroblasts 1 270.038 225.319 184.199 104.738 - OK TCONS_00004228 Fibroblasts 0 166.781 198.451 162.234 92.2487 - OK TCONS_00004229 iPS 0 17.4175 18.1798 31.0831 15.3816 - OK TCONS_00004229 iPS 1 0 0 0 0 - OK TCONS_00004229 hESC 1 5.21766 5.1647 3.41342 1.72116 - OK TCONS_00004229 hESC 0 5.20691 5.2603 3.47661 1.75302 - OK TCONS_00004229 Fibroblasts 1 123.259 102.847 84.078 41.7203 - OK TCONS_00004229 Fibroblasts 0 83.2424 99.049 80.9729 40.1795 - OK TCONS_00004230 iPS 0 127.211 132.779 227.02 127.004 - OK TCONS_00004230 iPS 1 120.94 116.516 199.215 111.448 - OK TCONS_00004230 hESC 1 125.885 124.607 82.3545 47.0618 - OK TCONS_00004230 hESC 0 161.876 163.536 108.083 61.7647 - OK TCONS_00004230 Fibroblasts 1 370.314 308.99 252.6 141.752 - OK TCONS_00004230 Fibroblasts 0 462.487 550.307 449.878 252.458 - OK TCONS_00004231 iPS 0 75.398 78.6979 134.555 153.926 - OK TCONS_00004231 iPS 1 74.885 72.1459 123.352 141.111 - OK TCONS_00004231 hESC 1 60.2547 59.6432 39.4191 47.1204 - OK TCONS_00004231 hESC 0 43.2814 43.7252 28.8986 34.5445 - OK TCONS_00004231 Fibroblasts 1 218.458 182.281 149.015 171.552 - OK TCONS_00004231 Fibroblasts 0 114.965 136.795 111.831 128.744 - OK TCONS_00004232 iPS 0 27.0809 28.2661 48.3284 34.0873 - OK TCONS_00004232 iPS 1 9.43622 9.09107 15.5436 10.9633 - OK TCONS_00004232 hESC 1 222.95 220.687 145.855 105.678 - OK TCONS_00004232 hESC 0 237.172 239.604 158.357 114.736 - OK TCONS_00004232 Fibroblasts 1 129.447 108.01 88.2989 62.523 - OK TCONS_00004232 Fibroblasts 0 84.8306 100.939 82.5178 58.4296 - OK TCONS_00004233 iPS 0 0 0 0 0 - OK TCONS_00004233 iPS 1 0.10902 0.105032 0.179581 0.141241 - OK TCONS_00004233 hESC 1 96.5415 95.5617 63.1581 51.1875 - OK TCONS_00004233 hESC 0 64.8972 65.5626 43.3312 35.1185 - OK TCONS_00004233 Fibroblasts 1 33.9082 28.293 23.1296 18.2709 - OK TCONS_00004233 Fibroblasts 0 32.1468 38.2511 31.2703 24.7015 - OK TCONS_00004234 iPS 0 72.5743 75.7507 129.516 71.0509 - OK TCONS_00004234 iPS 1 60.2374 58.0341 99.2245 54.4335 - OK TCONS_00004234 hESC 1 432.17 427.784 282.729 158.368 - OK TCONS_00004234 hESC 0 381.228 385.137 254.543 142.58 - OK TCONS_00004234 Fibroblasts 1 70.4689 58.7992 48.0685 26.45 - OK TCONS_00004234 Fibroblasts 0 111.873 133.117 108.823 59.8807 - OK TCONS_00004235 iPS 0 40.0466 41.7993 71.4668 57.9489 - OK TCONS_00004235 iPS 1 46.0631 44.3782 75.8761 61.5242 - OK TCONS_00004235 hESC 1 302.894 299.82 198.156 165.726 - OK TCONS_00004235 hESC 0 265.473 268.195 177.254 148.245 - OK TCONS_00004235 Fibroblasts 1 138.439 115.513 94.4326 76.915 - OK TCONS_00004235 Fibroblasts 0 87.4405 104.044 85.0566 69.2783 - OK TCONS_00004236 iPS 0 12.8628 13.4257 22.9548 17.443 - OK TCONS_00004236 iPS 1 11.8729 11.4386 19.5574 14.8614 - OK TCONS_00004236 hESC 1 53.9602 53.4126 35.3011 27.6136 - OK TCONS_00004236 hESC 0 74.3187 75.0807 49.6219 38.8158 - OK TCONS_00004236 Fibroblasts 1 23.3259 19.4631 15.9111 12.1416 - OK TCONS_00004236 Fibroblasts 0 26.31 31.306 25.5927 19.5295 - OK TCONS_00004237 iPS 0 20.0375 20.9145 35.7588 118.036 - OK TCONS_00004237 iPS 1 11.8964 11.4612 19.596 64.6843 - OK TCONS_00004237 hESC 1 112.062 110.925 73.3117 276.275 - OK TCONS_00004237 hESC 0 75.2958 76.0678 50.2743 189.458 - OK TCONS_00004237 Fibroblasts 1 91.6198 76.4475 62.496 210.123 - OK TCONS_00004237 Fibroblasts 0 63.1003 75.0823 61.3799 206.37 - OK TCONS_00004238 iPS 0 3 3.1313 5.35378 3.75843 - OK TCONS_00004238 iPS 1 0 0 0 0 - OK TCONS_00004238 hESC 1 23.6706 23.4304 15.4855 12.2077 - OK TCONS_00004238 hESC 0 19.9057 20.1098 13.2909 10.4776 - OK TCONS_00004238 Fibroblasts 1 0 0 0 0 - OK TCONS_00004238 Fibroblasts 0 0 0 0 0 - OK TCONS_00004239 iPS 0 0 0 0 0 - OK TCONS_00004239 iPS 1 0 0 0 0 - OK TCONS_00004239 hESC 1 6.32936 6.26512 4.14071 6.16319 - OK TCONS_00004239 hESC 0 1.09428 1.1055 0.730644 1.08752 - OK TCONS_00004239 Fibroblasts 1 0 0 0 0 - OK TCONS_00004239 Fibroblasts 0 0 0 0 0 - OK TCONS_00004240 iPS 0 31 32.3567 55.3223 19.5518 - OK TCONS_00004240 iPS 1 15.1729 14.6179 24.9931 8.83296 - OK TCONS_00004240 hESC 1 163.257 161.601 106.804 38.2544 - OK TCONS_00004240 hESC 0 162.04 163.702 108.193 38.7518 - OK TCONS_00004240 Fibroblasts 1 7.14659 5.96311 4.87486 1.72622 - OK TCONS_00004240 Fibroblasts 0 3.1165 3.70828 3.03153 1.07348 - OK TCONS_00004241 iPS 0 0 0 0 0 - OK TCONS_00004241 iPS 1 6.82711 6.57739 11.2458 3.7629 - OK TCONS_00004241 hESC 1 18.7425 18.5523 12.2615 4.15502 - OK TCONS_00004241 hESC 0 10.4596 10.5669 6.98379 2.36658 - OK TCONS_00004241 Fibroblasts 1 5.35341 4.46688 3.65169 1.22414 - OK TCONS_00004241 Fibroblasts 0 6.8835 8.19059 6.69583 2.24461 - OK TCONS_00004242 iPS 0 5.00001 5.21884 8.92298 65.8754 - OK TCONS_00004242 iPS 1 16 15.4148 26.3556 194.575 - OK TCONS_00004242 hESC 1 96 95.0257 62.8038 641.809 - OK TCONS_00004242 hESC 0 62 62.6357 41.3968 423.045 - OK TCONS_00004242 Fibroblasts 1 96 80.1024 65.4839 504.172 - OK TCONS_00004242 Fibroblasts 0 28 33.3169 27.2366 209.699 - OK TCONS_00004243 iPS 0 648.699 677.09 1157.66 1756.05 - OK TCONS_00004243 iPS 1 564.629 543.976 930.07 1410.82 - OK TCONS_00004243 hESC 1 4206.59 4163.89 2751.98 4426.87 - OK TCONS_00004243 hESC 0 3675.22 3712.91 2453.91 3947.4 - OK TCONS_00004243 Fibroblasts 1 831.447 693.759 567.15 867.572 - OK TCONS_00004243 Fibroblasts 0 2031.07 2416.75 1975.7 3022.24 - OK TCONS_00004244 iPS 0 100.301 104.691 178.997 272.396 - OK TCONS_00004244 iPS 1 163.371 157.395 269.109 409.526 - OK TCONS_00004244 hESC 1 828.415 820.007 541.954 874.78 - OK TCONS_00004244 hESC 0 796.278 804.442 531.667 858.176 - OK TCONS_00004244 Fibroblasts 1 189.889 158.443 129.528 198.784 - OK TCONS_00004244 Fibroblasts 0 402.122 478.48 391.158 600.304 - OK TCONS_00004245 iPS 0 0 0 0 0 - OK TCONS_00004245 iPS 1 0 0 0 0 - OK TCONS_00004245 hESC 1 0 0 0 0 - OK TCONS_00004245 hESC 0 0 0 0 0 - OK TCONS_00004245 Fibroblasts 1 4.80632 4.0104 3.27851 5.12036 - OK TCONS_00004245 Fibroblasts 0 37.2874 44.3678 36.2708 56.6475 - OK TCONS_00004246 iPS 0 0 0 0 0 - OK TCONS_00004246 iPS 1 0 0 0 0 - OK TCONS_00004246 hESC 1 0 0 0 0 - OK TCONS_00004246 hESC 0 0 0 0 0 - OK TCONS_00004246 Fibroblasts 1 0.857269 0.715305 0.584764 0.916315 - OK TCONS_00004246 Fibroblasts 0 13.5171 16.0838 13.1486 20.6036 - OK TCONS_00004247 iPS 0 24.23 25.2905 43.2408 57.8935 - OK TCONS_00004247 iPS 1 33.4064 32.1845 55.0278 73.6747 - OK TCONS_00004247 hESC 1 422.062 417.778 276.116 389.272 - OK TCONS_00004247 hESC 0 391.511 395.526 261.409 368.538 - OK TCONS_00004247 Fibroblasts 1 257.075 214.504 175.357 236.528 - OK TCONS_00004247 Fibroblasts 0 167.737 199.589 163.164 220.082 - OK TCONS_00004248 iPS 0 184.417 192.489 329.11 121.599 - OK TCONS_00004248 iPS 1 189.23 182.308 311.704 115.167 - OK TCONS_00004248 hESC 1 2109.66 2088.25 1380.16 517.118 - OK TCONS_00004248 hESC 0 2270.87 2294.15 1516.24 568.106 - OK TCONS_00004248 Fibroblasts 1 743.354 620.254 507.059 187.73 - OK TCONS_00004248 Fibroblasts 0 480.937 572.261 467.825 173.204 - OK TCONS_00004249 iPS 0 146.318 152.721 261.117 96.8565 - OK TCONS_00004249 iPS 1 271.859 261.915 447.813 166.107 - OK TCONS_00004249 hESC 1 2014.49 1994.05 1317.89 495.76 - OK TCONS_00004249 hESC 0 1821.32 1839.99 1216.08 457.459 - OK TCONS_00004249 Fibroblasts 1 773.229 645.182 527.438 196.045 - OK TCONS_00004249 Fibroblasts 0 620.142 737.899 603.235 224.217 - OK TCONS_00004250 iPS 0 0 0 0 0 - OK TCONS_00004250 iPS 1 14.4864 13.9566 23.8624 9.57165 - OK TCONS_00004250 hESC 1 13.9818 13.8399 9.14698 3.72519 - OK TCONS_00004250 hESC 0 76.5545 77.3394 51.1147 20.8169 - OK TCONS_00004250 Fibroblasts 1 0.0776685 0.0648066 0.0529795 0.0212982 - OK TCONS_00004250 Fibroblasts 0 73.8879 87.9183 71.8735 28.8937 - OK TCONS_00004251 iPS 0 0.371325 0.387577 0.662664 1.02722 - OK TCONS_00004251 iPS 1 0 0 0 0 - OK TCONS_00004251 hESC 1 23.4869 23.2485 15.3653 25.292 - OK TCONS_00004251 hESC 0 20.591 20.8022 13.7484 22.6306 - OK TCONS_00004251 Fibroblasts 1 25.2638 21.0801 17.2331 26.9443 - OK TCONS_00004251 Fibroblasts 0 40.2952 47.9467 39.1966 61.2846 - OK TCONS_00004252 iPS 0 10.6637 11.1304 19.0304 18.2935 - OK TCONS_00004252 iPS 1 21.0184 20.2496 34.622 33.2814 - OK TCONS_00004252 hESC 1 25.3149 25.058 16.5612 16.5167 - OK TCONS_00004252 hESC 0 31.1574 31.4769 20.8035 20.7477 - OK TCONS_00004252 Fibroblasts 1 0 0 0 0 - OK TCONS_00004252 Fibroblasts 0 0 0 0 0 - OK TCONS_00004253 iPS 0 678.5 708.196 1210.85 1755.76 - OK TCONS_00004253 iPS 1 557.5 537.108 918.327 1331.6 - OK TCONS_00004253 hESC 1 1528 1512.49 999.628 1533.05 - OK TCONS_00004253 hESC 0 1629 1645.7 1087.67 1668.07 - OK TCONS_00004253 Fibroblasts 1 5250 4380.6 3581.15 5234.69 - OK TCONS_00004253 Fibroblasts 0 3746.5 4457.91 3644.36 5327.08 - OK TCONS_00004254 iPS 0 46.544 48.5811 83.0622 28.0117 - OK TCONS_00004254 iPS 1 35.891 34.5782 59.1205 19.9377 - OK TCONS_00004254 hESC 1 287.592 284.673 188.144 64.2642 - OK TCONS_00004254 hESC 0 275.084 277.905 183.671 62.7363 - OK TCONS_00004254 Fibroblasts 1 0.00015203 0.000126854 0.000103703 3.363e-05 - OK TCONS_00004254 Fibroblasts 0 0 0 0 0 - OK TCONS_00004255 iPS 0 0 0 0 0 - OK TCONS_00004255 iPS 1 4.10899 3.95869 6.76842 2.48908 - OK TCONS_00004255 hESC 1 0 0 0 0 - OK TCONS_00004255 hESC 0 0 0 0 0 - OK TCONS_00004255 Fibroblasts 1 6.99985 5.84067 4.77476 1.68266 - OK TCONS_00004255 Fibroblasts 0 0 0 0 0 - OK TCONS_00004256 iPS 0 7.45596 7.78229 13.3059 12.9135 - OK TCONS_00004256 iPS 1 0 0 0 0 - OK TCONS_00004256 hESC 1 6.4082 6.34316 4.19229 4.22272 - OK TCONS_00004256 hESC 0 0.915695 0.925084 0.611401 0.615839 - OK TCONS_00004256 Fibroblasts 1 0 0 0 0 - OK TCONS_00004256 Fibroblasts 0 0 0 0 0 - OK TCONS_00004257 iPS 0 0 0 0 0 - OK TCONS_00004257 iPS 1 0 0 0 0 - OK TCONS_00004257 hESC 1 0 0 0 0 - OK TCONS_00004257 hESC 0 0 0 0 0 - OK TCONS_00004257 Fibroblasts 1 0 0 0 0 - OK TCONS_00004257 Fibroblasts 0 0 0 0 0 - OK TCONS_00004258 iPS 0 2150.25 2244.36 3837.33 1435.05 - OK TCONS_00004258 iPS 1 5599.22 5394.41 9223.16 3449.19 - OK TCONS_00004258 hESC 1 19452.6 19255.2 12726 4827.01 - OK TCONS_00004258 hESC 0 13822.6 13964.3 9229.22 3500.67 - OK TCONS_00004258 Fibroblasts 1 2552.99 2130.22 1741.46 652.602 - OK TCONS_00004258 Fibroblasts 0 2961.64 3524.02 2880.9 1079.6 - OK TCONS_00004259 iPS 0 1174.75 1226.16 2096.45 755.835 - OK TCONS_00004259 iPS 1 1740.28 1676.63 2866.63 1033.51 - OK TCONS_00004259 hESC 1 4406.9 4362.18 2883.03 1053.7 - OK TCONS_00004259 hESC 0 6689.41 6758 4466.46 1632.42 - OK TCONS_00004259 Fibroblasts 1 674.005 562.39 459.755 166.087 - OK TCONS_00004259 Fibroblasts 0 542.356 645.343 527.569 190.585 - OK TCONS_00004260 iPS 0 1 1.04377 1.78459 1.00135 - OK TCONS_00004260 iPS 1 0 0 0 0 - OK TCONS_00004260 hESC 1 0 0 0 0 - OK TCONS_00004260 hESC 0 0 0 0 0 - OK TCONS_00004260 Fibroblasts 1 0 0 0 0 - OK TCONS_00004260 Fibroblasts 0 0 0 0 0 - OK TCONS_00004261 iPS 0 0.0237338 0.0247726 0.0423552 0.0194935 - OK TCONS_00004261 iPS 1 239.448 230.69 394.425 181.529 - OK TCONS_00004261 hESC 1 915.163 905.875 598.706 280.398 - OK TCONS_00004261 hESC 0 520.382 525.718 347.454 162.727 - OK TCONS_00004261 Fibroblasts 1 651.249 543.402 444.232 204.973 - OK TCONS_00004261 Fibroblasts 0 122.173 145.373 118.842 54.8351 - OK TCONS_00004262 iPS 0 14.0616 14.677 25.0942 16.1311 - OK TCONS_00004262 iPS 1 12.4829 12.0263 20.5622 13.2179 - OK TCONS_00004262 hESC 1 49.8419 49.3361 32.6069 21.4795 - OK TCONS_00004262 hESC 0 17.5431 17.723 11.7134 7.71609 - OK TCONS_00004262 Fibroblasts 1 0 0 0 0 - OK TCONS_00004262 Fibroblasts 0 0 0 0 0 - OK TCONS_00004263 iPS 0 340.915 355.836 608.394 267.807 - OK TCONS_00004263 iPS 1 66.0686 63.652 108.83 47.9055 - OK TCONS_00004263 hESC 1 1169 1157.13 764.765 342.304 - OK TCONS_00004263 hESC 0 1687.07 1704.37 1126.44 504.189 - OK TCONS_00004263 Fibroblasts 1 1089.75 909.288 743.345 328.008 - OK TCONS_00004263 Fibroblasts 0 1118.83 1331.28 1088.32 480.233 - OK TCONS_00004264 iPS 0 280 292.255 499.686 124.716 - OK TCONS_00004264 iPS 1 192 184.977 316.267 78.9369 - OK TCONS_00004264 hESC 1 524 518.682 342.804 86.3707 - OK TCONS_00004264 hESC 0 557 562.711 371.904 93.7024 - OK TCONS_00004264 Fibroblasts 1 2194.5 1831.09 1496.92 374.131 - OK TCONS_00004264 Fibroblasts 0 951 1131.58 925.072 231.207 - OK TCONS_00004265 iPS 0 18.0176 18.8062 32.1541 14.0619 - OK TCONS_00004265 iPS 1 22.2537 21.4397 36.6568 16.0311 - OK TCONS_00004265 hESC 1 34.9016 34.5474 22.8329 10.1524 - OK TCONS_00004265 hESC 0 50.4418 50.959 33.6796 14.9752 - OK TCONS_00004265 Fibroblasts 1 31.1545 25.9953 21.2512 9.31627 - OK TCONS_00004265 Fibroblasts 0 23.2981 27.7221 22.6629 9.93512 - OK TCONS_00004266 iPS 0 3.11566 3.25202 5.56018 10.1678 - OK TCONS_00004266 iPS 1 6.24469 6.01627 10.2864 18.8106 - OK TCONS_00004266 hESC 1 24.9557 24.7024 16.3262 32.0592 - OK TCONS_00004266 hESC 0 78.9506 79.7601 52.7146 103.514 - OK TCONS_00004266 Fibroblasts 1 188.005 156.871 128.243 236.908 - OK TCONS_00004266 Fibroblasts 0 112.582 133.96 109.513 202.307 - OK TCONS_00004267 iPS 0 3.31221 3.45717 5.91094 3.53168 - OK TCONS_00004267 iPS 1 0 0 0 0 - OK TCONS_00004267 hESC 1 320.851 317.594 209.903 128.294 - OK TCONS_00004267 hESC 0 159.865 161.505 106.741 65.2408 - OK TCONS_00004267 Fibroblasts 1 910.05 759.345 620.767 372.124 - OK TCONS_00004267 Fibroblasts 0 351.089 417.756 341.517 204.725 - OK TCONS_00004268 iPS 0 0 0 0 0 - OK TCONS_00004268 iPS 1 0 0 0 0 - OK TCONS_00004268 hESC 1 32.0869 31.7613 20.9915 11.0166 - OK TCONS_00004268 hESC 0 103.332 104.392 68.9939 36.2088 - OK TCONS_00004268 Fibroblasts 1 41.6399 34.7443 28.4036 14.6598 - OK TCONS_00004268 Fibroblasts 0 49.6479 59.0755 48.2943 24.9259 - OK TCONS_00004269 iPS 0 0 0 0 0 - OK TCONS_00004269 iPS 1 0 0 0 0 - OK TCONS_00004269 hESC 1 394.998 390.989 258.41 137.04 - OK TCONS_00004269 hESC 0 536.685 542.188 358.34 190.035 - OK TCONS_00004269 Fibroblasts 1 0 0 0 0 - OK TCONS_00004269 Fibroblasts 0 32.0309 38.1131 31.1576 16.2472 - OK TCONS_00004270 iPS 0 27.995 29.2203 49.9598 21.328 - OK TCONS_00004270 iPS 1 49.1172 47.3206 80.907 34.5394 - OK TCONS_00004270 hESC 1 1511.72 1496.38 988.977 429.082 - OK TCONS_00004270 hESC 0 2427.85 2452.75 1621.06 703.319 - OK TCONS_00004270 Fibroblasts 1 1489.18 1242.57 1015.8 434.674 - OK TCONS_00004270 Fibroblasts 0 1208.18 1437.59 1175.24 502.897 - OK TCONS_00004271 iPS 0 10.4191 10.8751 18.5939 7.94738 - OK TCONS_00004271 iPS 1 3.13978 3.02494 5.17192 2.21058 - OK TCONS_00004271 hESC 1 1698.86 1681.61 1111.4 482.791 - OK TCONS_00004271 hESC 0 1274.82 1287.89 851.183 369.752 - OK TCONS_00004271 Fibroblasts 1 335.621 280.042 228.935 98.0826 - OK TCONS_00004271 Fibroblasts 0 940.238 1118.78 914.604 391.844 - OK TCONS_00004272 iPS 0 3686.95 3848.32 6579.71 592.354 - OK TCONS_00004272 iPS 1 4388.19 4227.68 7228.32 650.747 - OK TCONS_00004272 hESC 1 11372.1 11256.6 7439.68 672.049 - OK TCONS_00004272 hESC 0 14294.2 14440.8 9544.13 862.15 - OK TCONS_00004272 Fibroblasts 1 13155.3 10976.7 8973.52 808.264 - OK TCONS_00004272 Fibroblasts 0 5958.27 7089.67 5795.83 522.042 - OK TCONS_00004273 iPS 0 41.4309 43.2442 73.9373 34.9265 - OK TCONS_00004273 iPS 1 55.7358 53.6971 91.8093 43.3688 - OK TCONS_00004273 hESC 1 11.1148 11.0019 7.27135 3.49693 - OK TCONS_00004273 hESC 0 22.0004 22.226 14.6895 7.06446 - OK TCONS_00004273 Fibroblasts 1 21.2268 17.7116 14.4793 6.85761 - OK TCONS_00004273 Fibroblasts 0 9.36491 11.1432 9.10958 4.31444 - OK TCONS_00004274 iPS 0 51.4174 53.6678 91.7592 43.9023 - OK TCONS_00004274 iPS 1 44.1163 42.5026 72.6694 34.7687 - OK TCONS_00004274 hESC 1 593.921 587.893 388.547 189.305 - OK TCONS_00004274 hESC 0 617.353 623.683 412.201 200.83 - OK TCONS_00004274 Fibroblasts 1 548.362 457.553 374.051 179.439 - OK TCONS_00004274 Fibroblasts 0 341.659 406.535 332.344 159.431 - OK TCONS_00004275 iPS 0 0 0 0 0 - OK TCONS_00004275 iPS 1 0 0 0 0 - OK TCONS_00004275 hESC 1 0 0 0 0 - OK TCONS_00004275 hESC 0 0 0 0 0 - OK TCONS_00004275 Fibroblasts 1 0 0 0 0 - OK TCONS_00004275 Fibroblasts 0 2.30952 2.74808 2.24656 1.59155 - OK TCONS_00004276 iPS 0 187.34 195.54 334.326 84.6997 - OK TCONS_00004276 iPS 1 351.708 338.843 579.341 146.773 - OK TCONS_00004276 hESC 1 29.5369 29.2371 19.3232 4.9425 - OK TCONS_00004276 hESC 0 26.4732 26.7446 17.6759 4.52114 - OK TCONS_00004276 Fibroblasts 1 31.0003 25.8666 21.146 5.36473 - OK TCONS_00004276 Fibroblasts 0 26.3342 31.3348 25.6162 6.49883 - OK TCONS_00004277 iPS 0 30.7025 32.0462 54.7915 30.9091 - OK TCONS_00004277 iPS 1 65.0197 62.6414 107.102 60.4186 - OK TCONS_00004277 hESC 1 31.7283 31.4063 20.7568 11.9631 - OK TCONS_00004277 hESC 0 38.1927 38.5843 25.5009 14.6973 - OK TCONS_00004277 Fibroblasts 1 19.4119 16.1973 13.2413 7.49306 - OK TCONS_00004277 Fibroblasts 0 10.8097 12.8623 10.515 5.95027 - OK TCONS_00004278 iPS 0 454.478 474.369 811.058 281.921 - OK TCONS_00004278 iPS 1 412.035 396.964 678.714 235.919 - OK TCONS_00004278 hESC 1 2013.84 1993.4 1317.47 464.011 - OK TCONS_00004278 hESC 0 1918.98 1938.65 1281.28 451.266 - OK TCONS_00004278 Fibroblasts 1 8466.08 7064.09 5774.91 2011.2 - OK TCONS_00004278 Fibroblasts 0 6065.61 7217.39 5900.24 2054.85 - OK TCONS_00004279 iPS 0 0 0 0 0 - OK TCONS_00004279 iPS 1 0 0 0 0 - OK TCONS_00004279 hESC 1 141.726 140.288 92.7184 32.6797 - OK TCONS_00004279 hESC 0 83.3899 84.2449 55.6787 19.6246 - OK TCONS_00004279 Fibroblasts 1 346.219 288.885 236.165 82.3087 - OK TCONS_00004279 Fibroblasts 0 125.122 148.881 121.711 42.4189 - OK TCONS_00004280 iPS 0 38.4159 40.0972 68.5567 23.8477 - OK TCONS_00004280 iPS 1 97.9453 94.3627 161.338 56.1219 - OK TCONS_00004280 hESC 1 351.41 347.844 229.895 81.0293 - OK TCONS_00004280 hESC 0 612.438 618.717 408.919 144.128 - OK TCONS_00004280 Fibroblasts 1 963.689 804.102 657.355 229.103 - OK TCONS_00004280 Fibroblasts 0 761.309 905.872 740.553 258.099 - OK TCONS_00004281 iPS 0 27.4039 28.6033 48.9048 17.2794 - OK TCONS_00004281 iPS 1 0 0 0 0 - OK TCONS_00004281 hESC 1 27.2916 27.0147 17.8544 6.39335 - OK TCONS_00004281 hESC 0 10.0032 10.1058 6.67904 2.39165 - OK TCONS_00004281 Fibroblasts 1 38.6013 32.2089 26.3309 9.32161 - OK TCONS_00004281 Fibroblasts 0 54.1513 64.4339 52.6749 18.6479 - OK TCONS_00004282 iPS 0 9.23083e-05 9.63483e-05 0.000164733 0.000108558 - OK TCONS_00004282 iPS 1 8.5 8.18909 14.0014 9.22686 - OK TCONS_00004282 hESC 1 22.4996 22.2712 14.7194 9.94638 - OK TCONS_00004282 hESC 0 30.5 30.8127 20.3646 13.761 - OK TCONS_00004282 Fibroblasts 1 22 18.3568 15.0067 9.92548 - OK TCONS_00004282 Fibroblasts 0 17 20.2281 16.5365 10.9373 - OK TCONS_00004283 iPS 0 6.49991 6.78439 11.5997 8.41658 - OK TCONS_00004283 iPS 1 0 0 0 0 - OK TCONS_00004283 hESC 1 0.000435114 0.000430698 0.000284655 0.000212333 - OK TCONS_00004283 hESC 0 0 0 0 0 - OK TCONS_00004283 Fibroblasts 1 0 0 0 0 - OK TCONS_00004283 Fibroblasts 0 0 0 0 0 - OK TCONS_00004284 iPS 0 8.5 8.87202 15.169 19.9877 - OK TCONS_00004284 iPS 1 5.5 5.29882 9.05973 11.9377 - OK TCONS_00004284 hESC 1 22 21.7767 14.3925 19.9528 - OK TCONS_00004284 hESC 0 17 17.1743 11.3507 15.7358 - OK TCONS_00004284 Fibroblasts 1 14 11.6816 9.54973 12.6755 - OK TCONS_00004284 Fibroblasts 0 13.5 16.0635 13.1319 17.4303 - OK TCONS_00004285 iPS 0 193.662 202.139 345.609 409.266 - OK TCONS_00004285 iPS 1 135.649 130.688 223.445 264.601 - OK TCONS_00004285 hESC 1 892.424 883.367 583.83 723.574 - OK TCONS_00004285 hESC 0 849.422 858.131 567.151 702.903 - OK TCONS_00004285 Fibroblasts 1 2370.41 1977.87 1616.91 1927.33 - OK TCONS_00004285 Fibroblasts 0 2911.97 3464.91 2832.57 3376.38 - OK TCONS_00004286 iPS 0 0 0 0 0 - OK TCONS_00004286 iPS 1 0 0 0 0 - OK TCONS_00004286 hESC 1 0 0 0 0 - OK TCONS_00004286 hESC 0 0 0 0 0 - OK TCONS_00004286 Fibroblasts 1 1138.09 949.621 776.318 1015.18 - OK TCONS_00004286 Fibroblasts 0 75.8846 90.2942 73.8157 96.5278 - OK TCONS_00004287 iPS 0 11.3375 11.8337 20.2328 33.105 - OK TCONS_00004287 iPS 1 4.35077 4.19163 7.16669 11.7262 - OK TCONS_00004287 hESC 1 2.07585 2.05479 1.35804 2.36764 - OK TCONS_00004287 hESC 0 2.07823 2.09954 1.38762 2.41922 - OK TCONS_00004287 Fibroblasts 1 0 0 0 0 - OK TCONS_00004287 Fibroblasts 0 4.15034 4.93844 4.03719 6.66589 - OK TCONS_00004288 iPS 0 537.003 560.506 958.331 963.112 - OK TCONS_00004288 iPS 1 977.092 941.352 1609.49 1617.52 - OK TCONS_00004288 hESC 1 0 0 0 0 - OK TCONS_00004288 hESC 0 0 0 0 0 - OK TCONS_00004288 Fibroblasts 1 0 0 0 0 - OK TCONS_00004288 Fibroblasts 0 0 0 0 0 - OK TCONS_00004289 iPS 0 33.7947 35.2738 60.3099 44.5135 - OK TCONS_00004289 iPS 1 33.7739 32.5385 55.6331 41.0617 - OK TCONS_00004289 hESC 1 128.835 127.528 84.2849 63.9842 - OK TCONS_00004289 hESC 0 153.557 155.131 102.528 77.8337 - OK TCONS_00004289 Fibroblasts 1 37.2376 31.0711 25.4007 18.8245 - OK TCONS_00004289 Fibroblasts 0 179.712 213.837 174.812 129.553 - OK TCONS_00004290 iPS 0 1672.22 1745.41 2984.23 2888.3 - OK TCONS_00004290 iPS 1 1130.23 1088.89 1861.74 1801.89 - OK TCONS_00004290 hESC 1 8310.66 8226.32 5436.89 5460.8 - OK TCONS_00004290 hESC 0 7638.42 7716.74 5100.11 5122.54 - OK TCONS_00004290 Fibroblasts 1 29821.5 24883.1 20342 19793.9 - OK TCONS_00004290 Fibroblasts 0 19357.2 23032.9 18829.5 18322.2 - OK TCONS_00004291 iPS 0 2.48512 2.59388 4.43492 3.33422 - OK TCONS_00004291 iPS 1 25.9071 24.9594 42.6747 32.0833 - OK TCONS_00004291 hESC 1 0 0 0 0 - OK TCONS_00004291 hESC 0 31.0195 31.3375 20.7114 16.0239 - OK TCONS_00004291 Fibroblasts 1 324.545 270.801 221.38 167.13 - OK TCONS_00004291 Fibroblasts 0 9.04181 10.7587 8.7953 6.63996 - OK TCONS_00004292 iPS 0 20 20.8753 35.6919 26.2203 - OK TCONS_00004292 iPS 1 40 38.5369 65.8889 48.404 - OK TCONS_00004292 hESC 1 32.0002 31.6754 20.9347 15.816 - OK TCONS_00004292 hESC 0 32 32.3281 21.3661 16.142 - OK TCONS_00004292 Fibroblasts 1 40.001 33.3768 27.2856 20.1265 - OK TCONS_00004292 Fibroblasts 0 18.0001 21.4181 17.5093 12.9153 - OK TCONS_00004293 iPS 0 18.9247 19.7529 33.7728 23.1401 - OK TCONS_00004293 iPS 1 0 0 0 0 - OK TCONS_00004293 hESC 1 0 0 0 0 - OK TCONS_00004293 hESC 0 0 0 0 0 - OK TCONS_00004293 Fibroblasts 1 249.738 208.381 170.352 117.163 - OK TCONS_00004293 Fibroblasts 0 0 0 0 0 - OK TCONS_00004294 iPS 0 66.3241 69.2269 118.362 59.6782 - OK TCONS_00004294 iPS 1 34.9776 33.6982 57.616 29.0501 - OK TCONS_00004294 hESC 1 192.671 190.715 126.047 64.7807 - OK TCONS_00004294 hESC 0 142.694 144.157 95.2754 48.9661 - OK TCONS_00004294 Fibroblasts 1 1083.26 903.871 738.917 373.604 - OK TCONS_00004294 Fibroblasts 0 1045.22 1243.7 1016.73 514.068 - OK TCONS_00004295 iPS 0 0 0 0 0 - OK TCONS_00004295 iPS 1 0 0 0 0 - OK TCONS_00004295 hESC 1 0.0516596 0.0511353 0.033796 0.0219259 - OK TCONS_00004295 hESC 0 8.52494 8.61235 5.69202 3.69282 - OK TCONS_00004295 Fibroblasts 1 0 0 0 0 - OK TCONS_00004295 Fibroblasts 0 0 0 0 0 - OK TCONS_00004296 iPS 0 3.81222 3.97907 6.80327 4.55332 - OK TCONS_00004296 iPS 1 0 0 0 0 - OK TCONS_00004296 hESC 1 0 0 0 0 - OK TCONS_00004296 hESC 0 0 0 0 0 - OK TCONS_00004296 Fibroblasts 1 221.595 184.899 151.155 101.541 - OK TCONS_00004296 Fibroblasts 0 77.6445 92.3882 75.5276 50.737 - OK TCONS_00004297 iPS 0 13.3657 13.9506 23.8523 21.8027 - OK TCONS_00004297 iPS 1 6.94564 6.69159 11.441 10.4579 - OK TCONS_00004297 hESC 1 16.2776 16.1124 10.6489 10.0802 - OK TCONS_00004297 hESC 0 13.7653 13.9065 9.19098 8.70014 - OK TCONS_00004297 Fibroblasts 1 50.7223 42.3227 34.5989 31.7863 - OK TCONS_00004297 Fibroblasts 0 36.4009 43.313 35.4085 32.53 - OK TCONS_00004298 iPS 0 2.57336 2.68599 4.59241 7.40279 - OK TCONS_00004298 iPS 1 2.07672 2.00076 3.42083 5.51425 - OK TCONS_00004298 hESC 1 0 0 0 0 - OK TCONS_00004298 hESC 0 0.0159428 0.0161062 0.0106448 0.0182659 - OK TCONS_00004298 Fibroblasts 1 8.68604 7.24763 5.92496 9.63659 - OK TCONS_00004298 Fibroblasts 0 16.7297 19.9065 16.2736 26.468 - OK TCONS_00004299 iPS 0 0 0 0 0 - OK TCONS_00004299 iPS 1 1 0.963422 1.64722 2.15443 - OK TCONS_00004299 hESC 1 1 0.989851 0.654207 0.740923 - OK TCONS_00004299 hESC 0 0 0 0 0 - OK TCONS_00004299 Fibroblasts 1 0 0 0 0 - OK TCONS_00004299 Fibroblasts 0 0 0 0 0 - OK TCONS_00004300 iPS 0 0 0 0 0 - OK TCONS_00004300 iPS 1 0 0 0 0 - OK TCONS_00004300 hESC 1 0 0 0 0 - OK TCONS_00004300 hESC 0 0 0 0 0 - OK TCONS_00004300 Fibroblasts 1 0 0 0 0 - OK TCONS_00004300 Fibroblasts 0 0 0 0 0 - OK TCONS_00004301 iPS 0 0 0 0 0 - OK TCONS_00004301 iPS 1 0 0 0 0 - OK TCONS_00004301 hESC 1 0 0 0 0 - OK TCONS_00004301 hESC 0 0 0 0 0 - OK TCONS_00004301 Fibroblasts 1 0.000514113 0.000428976 0.000350689 0.000664325 - OK TCONS_00004301 Fibroblasts 0 0 0 0 0 - OK TCONS_00004302 iPS 0 0 0 0 0 - OK TCONS_00004302 iPS 1 0.000636428 0.000613149 0.00104834 0.00178337 - OK TCONS_00004302 hESC 1 0.000665097 0.000658346 0.000435111 0.000790747 - OK TCONS_00004302 hESC 0 0.00114057 0.00115226 0.000761546 0.00138399 - OK TCONS_00004302 Fibroblasts 1 0 0 0 0 - OK TCONS_00004302 Fibroblasts 0 0.000582916 0.000693605 0.000567024 0.000973731 - OK TCONS_00004303 iPS 0 29.1921 30.4698 52.096 92.0543 - OK TCONS_00004303 iPS 1 10.0225 9.6559 16.5093 29.1721 - OK TCONS_00004303 hESC 1 20.2385 20.0331 13.2402 25.06 - OK TCONS_00004303 hESC 0 24.9989 25.2552 16.6915 31.5925 - OK TCONS_00004303 Fibroblasts 1 0 0 0 0 - OK TCONS_00004303 Fibroblasts 0 11.9994 14.278 11.6723 20.8282 - OK TCONS_00004304 iPS 0 34.8079 36.3313 62.118 121.95 - OK TCONS_00004304 iPS 1 5.97686 5.75824 9.84523 19.3281 - OK TCONS_00004304 hESC 1 13.7608 13.6212 9.00243 19.0817 - OK TCONS_00004304 hESC 0 0 0 0 0 - OK TCONS_00004304 Fibroblasts 1 3.99949 3.33717 2.72814 5.41459 - OK TCONS_00004304 Fibroblasts 0 0 0 0 0 - OK TCONS_00004305 iPS 0 0 0 0 0 - OK TCONS_00004305 iPS 1 0 0 0 0 - OK TCONS_00004305 hESC 1 0 0 0 0 - OK TCONS_00004305 hESC 0 0 0 0 0 - OK TCONS_00004305 Fibroblasts 1 0 0 0 0 - OK TCONS_00004305 Fibroblasts 0 0 0 0 0 - OK TCONS_00004306 iPS 0 0 0 0 0 - OK TCONS_00004306 iPS 1 0 0 0 0 - OK TCONS_00004306 hESC 1 0 0 0 0 - OK TCONS_00004306 hESC 0 0 0 0 0 - OK TCONS_00004306 Fibroblasts 1 0 0 0 0 - OK TCONS_00004306 Fibroblasts 0 0 0 0 0 - OK TCONS_00004307 iPS 0 0 0 0 0 - OK TCONS_00004307 iPS 1 0 0 0 0 - OK TCONS_00004307 hESC 1 0 0 0 0 - OK TCONS_00004307 hESC 0 0 0 0 0 - OK TCONS_00004307 Fibroblasts 1 0 0 0 0 - OK TCONS_00004307 Fibroblasts 0 0 0 0 0 - OK TCONS_00004308 iPS 0 0 0 0 0 - OK TCONS_00004308 iPS 1 0 0 0 0 - OK TCONS_00004308 hESC 1 1 0.989851 0.654207 0.751535 - OK TCONS_00004308 hESC 0 1 1.01025 0.667691 0.767025 - OK TCONS_00004308 Fibroblasts 1 0 0 0 0 - OK TCONS_00004308 Fibroblasts 0 0 0 0 0 - OK TCONS_00004309 iPS 0 0 0 0 0 - OK TCONS_00004309 iPS 1 0 0 0 0 - OK TCONS_00004309 hESC 1 0 0 0 0 - OK TCONS_00004309 hESC 0 0 0 0 0 - OK TCONS_00004309 Fibroblasts 1 12 10.0128 8.18549 4.69349 - OK TCONS_00004309 Fibroblasts 0 0 0 0 0 - OK TCONS_00004310 iPS 0 163.814 170.984 292.342 287.269 - OK TCONS_00004310 iPS 1 21.8198 21.0217 35.9421 35.3185 - OK TCONS_00004310 hESC 1 9.38461 9.28936 6.13947 6.26433 - OK TCONS_00004310 hESC 0 10.187 10.2914 6.80174 6.94006 - OK TCONS_00004310 Fibroblasts 1 7482.52 6243.42 5104.01 5042.8 - OK TCONS_00004310 Fibroblasts 0 756.316 899.931 735.696 726.874 - OK TCONS_00004311 iPS 0 272.186 284.099 485.741 314.821 - OK TCONS_00004311 iPS 1 24.1802 23.2957 39.8301 25.8149 - OK TCONS_00004311 hESC 1 320.615 317.361 209.749 139.338 - OK TCONS_00004311 hESC 0 255.813 258.436 170.804 113.467 - OK TCONS_00004311 Fibroblasts 1 19175.5 16000 13080 8507.96 - OK TCONS_00004311 Fibroblasts 0 10520.7 12518.4 10233.9 6656.64 - OK TCONS_00004312 iPS 0 386.5 403.416 689.745 426.336 - OK TCONS_00004312 iPS 1 348 335.271 573.234 354.319 - OK TCONS_00004312 hESC 1 842 833.454 550.842 348.578 - OK TCONS_00004312 hESC 0 864 872.859 576.885 365.058 - OK TCONS_00004312 Fibroblasts 1 3250 2711.8 2216.9 1374.97 - OK TCONS_00004312 Fibroblasts 0 2690 3200.8 2616.66 1622.91 - OK TCONS_00004313 iPS 0 3735.55 3899.05 6666.44 4814.86 - OK TCONS_00004313 iPS 1 3345.05 3222.69 5510.04 3979.64 - OK TCONS_00004313 hESC 1 10359.9 10254.8 6777.52 5031.68 - OK TCONS_00004313 hESC 0 10246.7 10351.8 6841.66 5079.3 - OK TCONS_00004313 Fibroblasts 1 25871 21586.8 17647.2 12796.8 - OK TCONS_00004313 Fibroblasts 0 17574.2 20911.3 17095.1 12396.4 - OK TCONS_00004314 iPS 0 0 0 0 0 - OK TCONS_00004314 iPS 1 9.04952 8.71851 14.9066 10.7171 - OK TCONS_00004314 hESC 1 0 0 0 0 - OK TCONS_00004314 hESC 0 0 0 0 0 - OK TCONS_00004314 Fibroblasts 1 0 0 0 0 - OK TCONS_00004314 Fibroblasts 0 0 0 0 0 - OK TCONS_00004315 iPS 0 0 0 0 0 - OK TCONS_00004315 iPS 1 8.25276 7.95089 13.5941 10.0915 - OK TCONS_00004315 hESC 1 0 0 0 0 - OK TCONS_00004315 hESC 0 0 0 0 0 - OK TCONS_00004315 Fibroblasts 1 0 0 0 0 - OK TCONS_00004315 Fibroblasts 0 0 0 0 0 - OK TCONS_00004316 iPS 0 29.4466 30.7354 52.5503 40.2349 - OK TCONS_00004316 iPS 1 14.6518 14.1159 24.1348 18.4787 - OK TCONS_00004316 hESC 1 53.1 52.5611 34.7384 27.3855 - OK TCONS_00004316 hESC 0 25.7538 26.0178 17.1956 13.5558 - OK TCONS_00004316 Fibroblasts 1 0 0 0 0 - OK TCONS_00004316 Fibroblasts 0 25.801 30.7003 25.0975 19.2974 - OK TCONS_00004317 iPS 0 4.70673 4.91273 8.3996 7.22497 - OK TCONS_00004317 iPS 1 0 0 0 0 - OK TCONS_00004317 hESC 1 0 0 0 0 - OK TCONS_00004317 hESC 0 9.68437 9.78366 6.46616 5.74775 - OK TCONS_00004317 Fibroblasts 1 22.6568 18.9048 15.4548 13.3569 - OK TCONS_00004317 Fibroblasts 0 0 0 0 0 - OK TCONS_00004318 iPS 0 0 0 0 0 - OK TCONS_00004318 iPS 1 0.054298 0.052312 0.089441 0.0841479 - OK TCONS_00004318 hESC 1 41.2764 40.8575 27.0033 26.3366 - OK TCONS_00004318 hESC 0 0 0 0 0 - OK TCONS_00004318 Fibroblasts 1 211.764 176.695 144.449 136.61 - OK TCONS_00004318 Fibroblasts 0 22.9773 27.3404 22.3509 21.1379 - OK TCONS_00004319 iPS 0 0 0 0 0 - OK TCONS_00004319 iPS 1 0 0 0 0 - OK TCONS_00004319 hESC 1 31.4543 31.135 20.5776 16.5636 - OK TCONS_00004319 hESC 0 0 0 0 0 - OK TCONS_00004319 Fibroblasts 1 36.0383 30.0703 24.5826 19.2894 - OK TCONS_00004319 Fibroblasts 0 4.97463 5.91925 4.839 3.79706 - OK TCONS_00004320 iPS 0 0 0 0 0 - OK TCONS_00004320 iPS 1 37.8353 36.4514 62.3231 24.4309 - OK TCONS_00004320 hESC 1 72.5104 71.7745 47.4368 18.8735 - OK TCONS_00004320 hESC 0 231.95 234.328 154.871 61.6179 - OK TCONS_00004320 Fibroblasts 1 0 0 0 0 - OK TCONS_00004320 Fibroblasts 0 0.00512307 0.00609588 0.0049834 0.00195775 - OK TCONS_00004321 iPS 0 66.2933 69.1947 118.307 46.4151 - OK TCONS_00004321 iPS 1 77.1104 74.2899 127.018 49.8329 - OK TCONS_00004321 hESC 1 620.759 614.459 406.105 161.712 - OK TCONS_00004321 hESC 0 229.366 231.717 153.145 60.9828 - OK TCONS_00004321 Fibroblasts 1 103.541 86.3948 70.628 27.7696 - OK TCONS_00004321 Fibroblasts 0 84.0429 100.002 81.7516 32.1432 - OK TCONS_00004322 iPS 0 0.954074 0.995831 1.70263 0.680834 - OK TCONS_00004322 iPS 1 0 0 0 0 - OK TCONS_00004322 hESC 1 0.0373524 0.0369733 0.0244362 0.00992042 - OK TCONS_00004322 hESC 0 221.496 223.767 147.891 60.0397 - OK TCONS_00004322 Fibroblasts 1 182.822 152.546 124.707 49.9771 - OK TCONS_00004322 Fibroblasts 0 330.73 393.532 321.713 128.928 - OK TCONS_00004323 iPS 0 27.5431 28.7486 49.1533 18.9634 - OK TCONS_00004323 iPS 1 23.6936 22.827 39.0287 15.0573 - OK TCONS_00004323 hESC 1 648.361 641.781 424.162 166.051 - OK TCONS_00004323 hESC 0 279.403 282.267 186.555 73.0323 - OK TCONS_00004323 Fibroblasts 1 168.79 140.838 115.136 44.5145 - OK TCONS_00004323 Fibroblasts 0 339.613 404.101 330.354 127.723 - OK TCONS_00004324 iPS 0 55.5028 57.932 99.0499 48.3889 - OK TCONS_00004324 iPS 1 79.3064 76.4056 130.635 63.8193 - OK TCONS_00004324 hESC 1 541.602 536.105 354.32 176.334 - OK TCONS_00004324 hESC 0 435.101 439.563 290.513 144.58 - OK TCONS_00004324 Fibroblasts 1 300.388 250.644 204.902 100.372 - OK TCONS_00004324 Fibroblasts 0 341.657 406.534 332.342 162.799 - OK TCONS_00004325 iPS 0 92.6496 96.7046 165.342 78.7086 - OK TCONS_00004325 iPS 1 12.9241 12.4513 21.2888 10.1342 - OK TCONS_00004325 hESC 1 201.9 199.851 132.085 64.0226 - OK TCONS_00004325 hESC 0 163.894 165.574 109.43 53.0419 - OK TCONS_00004325 Fibroblasts 1 360.578 300.866 245.959 117.394 - OK TCONS_00004325 Fibroblasts 0 140.412 167.074 136.584 65.1901 - OK TCONS_00004326 iPS 0 599.67 625.916 1070.17 328.552 - OK TCONS_00004326 iPS 1 549.096 529.011 904.483 277.685 - OK TCONS_00004326 hESC 1 506.223 501.085 331.174 102.861 - OK TCONS_00004326 hESC 0 547.604 553.219 365.63 113.563 - OK TCONS_00004326 Fibroblasts 1 820.563 684.677 559.726 172.133 - OK TCONS_00004326 Fibroblasts 0 405.524 482.527 394.467 121.311 - OK TCONS_00004327 iPS 0 133.832 139.69 238.836 81.4182 - OK TCONS_00004327 iPS 1 192.774 185.722 317.541 108.248 - OK TCONS_00004327 hESC 1 685.743 678.783 448.617 154.917 - OK TCONS_00004327 hESC 0 929.993 939.528 620.948 214.426 - OK TCONS_00004327 Fibroblasts 1 135.118 112.742 92.1672 31.4786 - OK TCONS_00004327 Fibroblasts 0 485.031 577.132 471.807 161.14 - OK TCONS_00004328 iPS 0 473.307 494.022 844.66 318.319 - OK TCONS_00004328 iPS 1 313.274 301.815 516.032 194.472 - OK TCONS_00004328 hESC 1 30.476 30.1667 19.9376 7.62166 - OK TCONS_00004328 hESC 0 157.96 159.58 105.469 40.3181 - OK TCONS_00004328 Fibroblasts 1 3060.24 2553.46 2087.46 788.321 - OK TCONS_00004328 Fibroblasts 0 3070.25 3653.26 2986.55 1127.86 - OK TCONS_00004329 iPS 0 792.448 827.131 1414.2 551.163 - OK TCONS_00004329 iPS 1 296.416 285.574 488.263 190.293 - OK TCONS_00004329 hESC 1 233.873 231.499 153.001 60.5164 - OK TCONS_00004329 hESC 0 211.121 213.286 140.964 55.7553 - OK TCONS_00004329 Fibroblasts 1 7385.69 6162.62 5037.95 1967.7 - OK TCONS_00004329 Fibroblasts 0 2573.28 3061.92 2503.13 977.66 - OK TCONS_00004330 iPS 0 434.903 453.937 776.125 648.655 - OK TCONS_00004330 iPS 1 218.285 210.3 359.564 300.51 - OK TCONS_00004330 hESC 1 867.547 858.742 567.555 489.726 - OK TCONS_00004330 hESC 0 906.99 916.289 605.589 522.544 - OK TCONS_00004330 Fibroblasts 1 2562.85 2138.44 1748.18 1467.83 - OK TCONS_00004330 Fibroblasts 0 1001.46 1191.63 974.161 817.941 - OK TCONS_00004331 iPS 0 65.7493 68.627 117.336 69.8404 - OK TCONS_00004331 iPS 1 88.0529 84.8321 145.043 86.3321 - OK TCONS_00004331 hESC 1 15.8882 15.727 10.3942 6.32839 - OK TCONS_00004331 hESC 0 44.765 45.224 29.8892 18.1978 - OK TCONS_00004331 Fibroblasts 1 0 0 0 0 - OK TCONS_00004331 Fibroblasts 0 33.0805 39.3621 32.1786 19.2164 - OK TCONS_00004332 iPS 0 65.9066 68.7912 117.617 70.2143 - OK TCONS_00004332 iPS 1 91.6782 88.3248 151.014 90.1521 - OK TCONS_00004332 hESC 1 59.5546 58.9501 38.961 23.7927 - OK TCONS_00004332 hESC 0 37.6326 38.0185 25.127 15.3445 - OK TCONS_00004332 Fibroblasts 1 585.494 488.536 399.38 239.209 - OK TCONS_00004332 Fibroblasts 0 391.381 465.7 380.711 228.027 - OK TCONS_00004333 iPS 0 70.0345 73.0998 124.983 232.768 - OK TCONS_00004333 iPS 1 52.0011 50.099 85.6574 159.528 - OK TCONS_00004333 hESC 1 61.7957 61.1685 40.4272 80.959 - OK TCONS_00004333 hESC 0 106.041 107.128 70.8027 141.789 - OK TCONS_00004333 Fibroblasts 1 208.474 173.951 142.205 267.594 - OK TCONS_00004333 Fibroblasts 0 156.068 185.704 151.813 285.674 - OK TCONS_00004334 iPS 0 39.7499 41.4896 70.9374 20.099 - OK TCONS_00004334 iPS 1 0 0 0 0 - OK TCONS_00004334 hESC 1 0 0 0 0 - OK TCONS_00004334 hESC 0 74.3082 75.0701 49.6149 14.2089 - OK TCONS_00004334 Fibroblasts 1 3245.28 2707.86 2213.68 628.196 - OK TCONS_00004334 Fibroblasts 0 1274.4 1516.39 1239.65 351.787 - OK TCONS_00004335 iPS 0 17.1769 17.9287 30.6538 9.06855 - OK TCONS_00004335 iPS 1 0 0 0 0 - OK TCONS_00004335 hESC 1 0 0 0 0 - OK TCONS_00004335 hESC 0 0 0 0 0 - OK TCONS_00004335 Fibroblasts 1 242.123 202.028 165.158 48.9399 - OK TCONS_00004335 Fibroblasts 0 184.843 219.943 179.804 53.2798 - OK TCONS_00004336 iPS 0 1026.06 1070.96 1831.09 461.008 - OK TCONS_00004336 iPS 1 1344.85 1295.65 2215.26 557.728 - OK TCONS_00004336 hESC 1 1455.75 1440.97 952.36 242.063 - OK TCONS_00004336 hESC 0 1499.2 1514.57 1001 254.426 - OK TCONS_00004336 Fibroblasts 1 4665.7 3893.06 3182.59 802.383 - OK TCONS_00004336 Fibroblasts 0 2111.03 2511.89 2053.48 517.716 - OK TCONS_00004337 iPS 0 1.78751 1.86575 3.18998 0.794085 - OK TCONS_00004337 iPS 1 4.50145 4.3368 7.4149 1.8458 - OK TCONS_00004337 hESC 1 0 0 0 0 - OK TCONS_00004337 hESC 0 0 0 0 0 - OK TCONS_00004337 Fibroblasts 1 1272.82 1062.04 868.219 216.424 - OK TCONS_00004337 Fibroblasts 0 824.255 980.77 801.782 199.863 - OK TCONS_00004338 iPS 0 378.69 395.264 675.807 159.128 - OK TCONS_00004338 iPS 1 0 0 0 0 - OK TCONS_00004338 hESC 1 1477.21 1462.22 966.402 229.585 - OK TCONS_00004338 hESC 0 1850.99 1869.97 1235.89 293.607 - OK TCONS_00004338 Fibroblasts 1 1951.63 1628.44 1331.26 313.871 - OK TCONS_00004338 Fibroblasts 0 1679.19 1998.04 1633.41 385.109 - OK TCONS_00004339 iPS 0 0 0 0 0 - OK TCONS_00004339 iPS 1 0 0 0 0 - OK TCONS_00004339 hESC 1 0 0 0 0 - OK TCONS_00004339 hESC 0 0 0 0 0 - OK TCONS_00004339 Fibroblasts 1 0 0 0 0 - OK TCONS_00004339 Fibroblasts 0 0 0 0 0 - OK TCONS_00004340 iPS 0 343.196 358.216 612.465 141.667 - OK TCONS_00004340 iPS 1 418.006 402.717 688.55 159.265 - OK TCONS_00004340 hESC 1 1092.85 1081.76 714.951 166.823 - OK TCONS_00004340 hESC 0 885.349 894.427 591.14 137.933 - OK TCONS_00004340 Fibroblasts 1 1973.1 1646.35 1345.9 311.711 - OK TCONS_00004340 Fibroblasts 0 1300.52 1547.48 1265.07 292.991 - OK TCONS_00004341 iPS 0 0 0 0 0 - OK TCONS_00004341 iPS 1 0 0 0 0 - OK TCONS_00004341 hESC 1 0 0 0 0 - OK TCONS_00004341 hESC 0 0 0 0 0 - OK TCONS_00004341 Fibroblasts 1 0 0 0 0 - OK TCONS_00004341 Fibroblasts 0 0 0 0 0 - OK TCONS_00004342 iPS 0 239.383 249.86 427.201 345.801 - OK TCONS_00004342 iPS 1 194.31 187.203 320.072 259.085 - OK TCONS_00004342 hESC 1 49.7573 49.2523 32.5516 27.176 - OK TCONS_00004342 hESC 0 0 0 0 0 - OK TCONS_00004342 Fibroblasts 1 0 0 0 0 - OK TCONS_00004342 Fibroblasts 0 0 0 0 0 - OK TCONS_00004343 iPS 0 60.9611 63.6292 108.791 80.1291 - OK TCONS_00004343 iPS 1 98.337 94.74 161.983 119.307 - OK TCONS_00004343 hESC 1 57.4308 56.8479 37.5716 28.4611 - OK TCONS_00004343 hESC 0 82.1529 82.9952 54.8527 41.5518 - OK TCONS_00004343 Fibroblasts 1 168.346 140.468 114.833 84.9247 - OK TCONS_00004343 Fibroblasts 0 39.2618 46.7172 38.1914 28.2445 - OK TCONS_00004344 iPS 0 0 0 0 0 - OK TCONS_00004344 iPS 1 0 0 0 0 - OK TCONS_00004344 hESC 1 23.2977 23.0612 15.2415 4.2945 - OK TCONS_00004344 hESC 0 43.8355 44.285 29.2686 8.24683 - OK TCONS_00004344 Fibroblasts 1 813.754 678.996 555.081 155.001 - OK TCONS_00004344 Fibroblasts 0 372.389 443.101 362.236 101.151 - OK TCONS_00004345 iPS 0 146.278 152.68 261.047 75.0611 - OK TCONS_00004345 iPS 1 400.012 385.38 658.908 189.462 - OK TCONS_00004345 hESC 1 214.735 212.555 140.481 40.8351 - OK TCONS_00004345 hESC 0 0 0 0 0 - OK TCONS_00004345 Fibroblasts 1 5020.8 4189.35 3424.81 986.331 - OK TCONS_00004345 Fibroblasts 0 3499.15 4163.6 3403.75 980.268 - OK TCONS_00004346 iPS 0 61.2465 63.927 109.3 31.3706 - OK TCONS_00004346 iPS 1 0.0221086 0.0212999 0.0364178 0.0104524 - OK TCONS_00004346 hESC 1 543.511 537.995 355.568 103.166 - OK TCONS_00004346 hESC 0 482.977 487.929 322.479 93.5654 - OK TCONS_00004346 Fibroblasts 1 9036.69 7540.21 6164.14 1772 - OK TCONS_00004346 Fibroblasts 0 3579.9 4259.68 3482.3 1001.05 - OK TCONS_00004347 iPS 0 0 0 0 0 - OK TCONS_00004347 iPS 1 0 0 0 0 - OK TCONS_00004347 hESC 1 28.5437 28.2541 18.6735 5.52684 - OK TCONS_00004347 hESC 0 18.1024 18.288 12.0868 3.57736 - OK TCONS_00004347 Fibroblasts 1 89.1175 74.3596 60.7891 17.8227 - OK TCONS_00004347 Fibroblasts 0 50.4951 60.0835 49.1184 14.401 - OK TCONS_00004348 iPS 0 189.417 197.707 338.032 96.2387 - OK TCONS_00004348 iPS 1 0 0 0 0 - OK TCONS_00004348 hESC 1 2267.66 2244.64 1483.52 426.931 - OK TCONS_00004348 hESC 0 2214.16 2236.86 1478.37 425.45 - OK TCONS_00004348 Fibroblasts 1 18399.9 15352.9 12551 3578.95 - OK TCONS_00004348 Fibroblasts 0 14769.1 17573.5 14366.4 4096.6 - OK TCONS_00004349 iPS 0 45.5585 47.5525 81.3034 56.6394 - OK TCONS_00004349 iPS 1 10.4664 10.0836 17.2405 12.0104 - OK TCONS_00004349 hESC 1 6.75375 6.68521 4.41835 3.16078 - OK TCONS_00004349 hESC 0 60.9278 61.5525 40.6809 29.1022 - OK TCONS_00004349 Fibroblasts 1 571.7 477.027 389.97 272.719 - OK TCONS_00004349 Fibroblasts 0 21.0007 24.9884 20.4281 14.286 - OK TCONS_00004350 iPS 0 9.0001 9.39401 16.0615 10.5256 - OK TCONS_00004350 iPS 1 6 5.78053 9.88334 6.47687 - OK TCONS_00004350 hESC 1 3 2.96955 1.96262 1.31865 - OK TCONS_00004350 hESC 0 1.00053 1.01079 0.668048 0.44885 - OK TCONS_00004350 Fibroblasts 1 1 0.8344 0.682124 0.448641 - OK TCONS_00004350 Fibroblasts 0 1 1.18989 0.972736 0.63978 - OK TCONS_00004351 iPS 0 88.5 92.3734 157.937 118.236 - OK TCONS_00004351 iPS 1 66 63.5859 108.717 81.3883 - OK TCONS_00004351 hESC 1 128.5 127.196 84.0656 64.756 - OK TCONS_00004351 hESC 0 110.667 111.801 73.8911 56.9186 - OK TCONS_00004351 Fibroblasts 1 1191.83 994.465 812.978 611.143 - OK TCONS_00004351 Fibroblasts 0 590.667 702.827 574.563 431.919 - OK TCONS_00004352 iPS 0 5.37569 5.61097 9.59343 4.26672 - OK TCONS_00004352 iPS 1 0 0 0 0 - OK TCONS_00004352 hESC 1 106.868 105.783 69.9135 31.623 - OK TCONS_00004352 hESC 0 50.6987 51.2186 33.8511 15.3114 - OK TCONS_00004352 Fibroblasts 1 0 0 0 0 - OK TCONS_00004352 Fibroblasts 0 0.000380988 0.000453333 0.000370601 0.000165232 - OK TCONS_00004353 iPS 0 45.7051 47.7055 81.565 36.8323 - OK TCONS_00004353 iPS 1 0.0547094 0.0527083 0.0901186 0.0406948 - OK TCONS_00004353 hESC 1 454.833 450.217 297.555 136.687 - OK TCONS_00004353 hESC 0 118.157 119.368 78.8922 36.2405 - OK TCONS_00004353 Fibroblasts 1 7.9893 6.66627 5.44969 2.46707 - OK TCONS_00004353 Fibroblasts 0 3.99285 4.75104 3.88399 1.75827 - OK TCONS_00004354 iPS 0 0.000873476 0.000911705 0.0015588 0.000696568 - OK TCONS_00004354 iPS 1 67.8893 65.4061 111.829 49.9721 - OK TCONS_00004354 hESC 1 0.00921793 0.00912438 0.00603043 0.00274081 - OK TCONS_00004354 hESC 0 316.547 319.792 211.355 96.0602 - OK TCONS_00004354 Fibroblasts 1 0.0106965 0.00892518 0.00729636 0.00326853 - OK TCONS_00004354 Fibroblasts 0 0.00677162 0.00805747 0.006587 0.00295076 - OK TCONS_00004355 iPS 0 16.9183 17.6588 30.1924 12.8388 - OK TCONS_00004355 iPS 1 11.056 10.6516 18.2116 7.74421 - OK TCONS_00004355 hESC 1 79.29 78.4853 51.872 22.4161 - OK TCONS_00004355 hESC 0 80.5979 81.4243 53.8145 23.2555 - OK TCONS_00004355 Fibroblasts 1 0 0 0 0 - OK TCONS_00004355 Fibroblasts 0 0 0 0 0 - OK TCONS_00004356 iPS 0 170.841 178.318 304.882 124.231 - OK TCONS_00004356 iPS 1 168.667 162.497 277.832 113.209 - OK TCONS_00004356 hESC 1 169.348 167.629 110.789 45.8456 - OK TCONS_00004356 hESC 0 196.008 198.018 130.873 54.1566 - OK TCONS_00004356 Fibroblasts 1 203.066 169.438 138.516 56.5689 - OK TCONS_00004356 Fibroblasts 0 104.435 124.266 101.588 41.4875 - OK TCONS_00004357 iPS 0 739.314 771.672 1319.38 434.583 - OK TCONS_00004357 iPS 1 661.091 636.91 1088.96 358.689 - OK TCONS_00004357 hESC 1 2378.09 2353.95 1555.76 518.87 - OK TCONS_00004357 hESC 0 2338.16 2362.14 1561.17 520.674 - OK TCONS_00004357 Fibroblasts 1 5067.01 4227.91 3456.33 1140.54 - OK TCONS_00004357 Fibroblasts 0 2969.62 3533.51 2888.66 953.215 - OK TCONS_00004358 iPS 0 0 0 0 0 - OK TCONS_00004358 iPS 1 0 0 0 0 - OK TCONS_00004358 hESC 1 0 0 0 0 - OK TCONS_00004358 hESC 0 0 0 0 0 - OK TCONS_00004358 Fibroblasts 1 0 0 0 0 - OK TCONS_00004358 Fibroblasts 0 0 0 0 0 - OK TCONS_00004359 iPS 0 31.2662 32.6347 55.7975 19.2672 - OK TCONS_00004359 iPS 1 73.2976 70.6166 120.738 41.6914 - OK TCONS_00004359 hESC 1 26.7396 26.4683 17.4933 6.11996 - OK TCONS_00004359 hESC 0 171.746 173.506 114.673 40.118 - OK TCONS_00004359 Fibroblasts 1 237.536 198.2 162.029 56.0565 - OK TCONS_00004359 Fibroblasts 0 101.028 120.212 98.2736 33.9993 - OK TCONS_00004360 iPS 0 17.046 17.7921 30.4202 9.93668 - OK TCONS_00004360 iPS 1 17.7548 17.1053 29.2461 9.55315 - OK TCONS_00004360 hESC 1 0 0 0 0 - OK TCONS_00004360 hESC 0 11.4066 11.5235 7.61607 2.51869 - OK TCONS_00004360 Fibroblasts 1 0 0 0 0 - OK TCONS_00004360 Fibroblasts 0 0 0 0 0 - OK TCONS_00004361 iPS 0 31.7785 33.1693 56.7117 41.7489 - OK TCONS_00004361 iPS 1 32.3387 31.1558 53.2691 39.2146 - OK TCONS_00004361 hESC 1 9.13456 9.04185 5.97589 4.52441 - OK TCONS_00004361 hESC 0 9.0707 9.1637 6.05642 4.58538 - OK TCONS_00004361 Fibroblasts 1 4.25003 3.54623 2.89905 2.14287 - OK TCONS_00004361 Fibroblasts 0 1.31319 1.56255 1.27738 0.944197 - OK TCONS_00004362 iPS 0 191.466 199.846 341.688 246.785 - OK TCONS_00004362 iPS 1 153.732 148.109 253.232 182.897 - OK TCONS_00004362 hESC 1 348.771 345.231 228.168 169.394 - OK TCONS_00004362 hESC 0 379.679 383.572 253.508 188.206 - OK TCONS_00004362 Fibroblasts 1 384.916 321.174 262.56 190.394 - OK TCONS_00004362 Fibroblasts 0 273.82 325.815 266.355 193.146 - OK TCONS_00004363 iPS 0 274.288 286.293 489.493 308.627 - OK TCONS_00004363 iPS 1 336.118 323.824 553.662 349.086 - OK TCONS_00004363 hESC 1 77.9186 77.1277 50.9748 32.92 - OK TCONS_00004363 hESC 0 134.926 136.309 90.0886 58.1801 - OK TCONS_00004363 Fibroblasts 1 409.221 341.454 279.139 176.613 - OK TCONS_00004363 Fibroblasts 0 300.286 357.306 292.099 184.813 - OK TCONS_00004364 iPS 0 12.1492 12.681 21.6814 8.97156 - OK TCONS_00004364 iPS 1 12.8678 12.3971 21.1961 8.77075 - OK TCONS_00004364 hESC 1 717.199 709.92 469.197 197.217 - OK TCONS_00004364 hESC 0 630.088 636.548 420.704 176.834 - OK TCONS_00004364 Fibroblasts 1 654.973 546.509 446.773 185.294 - OK TCONS_00004364 Fibroblasts 0 1572.35 1870.91 1529.48 634.332 - OK TCONS_00004365 iPS 0 630.598 658.197 1125.36 112.744 - OK TCONS_00004365 iPS 1 540.94 521.154 891.049 89.2693 - OK TCONS_00004365 hESC 1 11491.1 11374.5 7517.56 755.99 - OK TCONS_00004365 hESC 0 10876.2 10987.7 7261.91 730.281 - OK TCONS_00004365 Fibroblasts 1 83999.1 70088.8 57297.8 5743.53 - OK TCONS_00004365 Fibroblasts 0 16575.8 19723.3 16123.9 1616.25 - OK TCONS_00004366 iPS 0 144.677 151.009 258.189 25.861 - OK TCONS_00004366 iPS 1 41.5278 40.0088 68.4055 6.85172 - OK TCONS_00004366 hESC 1 1998.76 1978.47 1307.6 131.468 - OK TCONS_00004366 hESC 0 1760.67 1778.72 1175.58 118.195 - OK TCONS_00004366 Fibroblasts 1 18146.1 15141.1 12377.9 1240.5 - OK TCONS_00004366 Fibroblasts 0 2910.38 3463.03 2831.04 283.723 - OK TCONS_00004367 iPS 0 9.83732 10.2679 17.5556 36.5985 - OK TCONS_00004367 iPS 1 8.17343 7.87446 13.4635 28.0675 - OK TCONS_00004367 hESC 1 0 0 0 0 - OK TCONS_00004367 hESC 0 0 0 0 0 - OK TCONS_00004367 Fibroblasts 1 224.404 187.243 153.071 322.826 - OK TCONS_00004367 Fibroblasts 0 0 0 0 0 - OK TCONS_00004368 iPS 0 24 25.0504 42.8302 16.2188 - OK TCONS_00004368 iPS 1 0.0359824 0.0346663 0.0592711 0.0224445 - OK TCONS_00004368 hESC 1 337 333.58 220.468 84.6913 - OK TCONS_00004368 hESC 0 249.997 252.561 166.921 64.1217 - OK TCONS_00004368 Fibroblasts 1 0.0411402 0.0343274 0.0280627 0.0101707 - OK TCONS_00004368 Fibroblasts 0 0 0 0 0 - OK TCONS_00004369 iPS 0 0 0 0 0 - OK TCONS_00004369 iPS 1 24.964 24.0509 41.1213 15.6555 - OK TCONS_00004369 hESC 1 0 0 0 0 - OK TCONS_00004369 hESC 0 0.00274652 0.00277468 0.00183383 0.0007083 - OK TCONS_00004369 Fibroblasts 1 5.95886 4.97207 4.06468 1.48074 - OK TCONS_00004369 Fibroblasts 0 0 0 0 0 - OK TCONS_00004370 iPS 0 0 0 0 0 - OK TCONS_00004370 iPS 1 1 0.963422 1.64722 6.80245 - OK TCONS_00004370 hESC 1 1 0.989851 0.654207 1.81454 - OK TCONS_00004370 hESC 0 0 0 0 0 - OK TCONS_00004370 Fibroblasts 1 0 0 0 0 - OK TCONS_00004370 Fibroblasts 0 0 0 0 0 - OK TCONS_00004371 iPS 0 846.556 883.607 1510.76 251.847 - OK TCONS_00004371 iPS 1 1539.55 1483.24 2535.99 422.755 - OK TCONS_00004371 hESC 1 1688.01 1670.87 1104.3 185.251 - OK TCONS_00004371 hESC 0 957.487 967.305 639.306 107.246 - OK TCONS_00004371 Fibroblasts 1 4202.54 3506.6 2866.65 478.317 - OK TCONS_00004371 Fibroblasts 0 1959.21 2331.24 1905.8 317.993 - OK TCONS_00004372 iPS 0 1701.35 1775.81 3036.21 510.111 - OK TCONS_00004372 iPS 1 1523.54 1467.81 2509.61 421.638 - OK TCONS_00004372 hESC 1 2033.84 2013.2 1330.55 224.966 - OK TCONS_00004372 hESC 0 3106.22 3138.07 2074 350.665 - OK TCONS_00004372 Fibroblasts 1 4956.46 4135.67 3380.92 568.553 - OK TCONS_00004372 Fibroblasts 0 2460.79 2928.06 2393.7 402.536 - OK TCONS_00004373 iPS 0 42.0979 43.9404 75.1277 28.3126 - OK TCONS_00004373 iPS 1 136.905 131.897 225.513 84.9869 - OK TCONS_00004373 hESC 1 21.153 20.9383 13.8384 5.29009 - OK TCONS_00004373 hESC 0 5.2886 5.34283 3.53115 1.34987 - OK TCONS_00004373 Fibroblasts 1 0 0 0 0 - OK TCONS_00004373 Fibroblasts 0 0 0 0 0 - OK TCONS_00004374 iPS 0 178 185.791 317.658 168.513 - OK TCONS_00004374 iPS 1 318 306.368 523.817 277.877 - OK TCONS_00004374 hESC 1 465 460.281 304.206 164.66 - OK TCONS_00004374 hESC 0 322 325.302 214.996 116.373 - OK TCONS_00004374 Fibroblasts 1 0 0 0 0 - OK TCONS_00004374 Fibroblasts 0 0 0 0 0 - OK TCONS_00004375 iPS 0 6.4626 6.74545 11.5331 11.1016 - OK TCONS_00004375 iPS 1 15.6097 15.0387 25.7126 24.7506 - OK TCONS_00004375 hESC 1 0 0 0 0 - OK TCONS_00004375 hESC 0 8.61787 8.70623 5.75407 5.74673 - OK TCONS_00004375 Fibroblasts 1 0.429547 0.358414 0.293004 0.283549 - OK TCONS_00004375 Fibroblasts 0 0 0 0 0 - OK TCONS_00004376 iPS 0 145.972 152.361 260.501 143.241 - OK TCONS_00004376 iPS 1 110.029 106.004 181.242 99.6592 - OK TCONS_00004376 hESC 1 482.769 477.869 315.831 177.331 - OK TCONS_00004376 hESC 0 596.177 602.289 398.062 223.501 - OK TCONS_00004376 Fibroblasts 1 770.29 642.73 525.433 289.799 - OK TCONS_00004376 Fibroblasts 0 710.88 845.868 691.499 381.392 - OK TCONS_00004377 iPS 0 824.992 861.099 1472.27 812.4 - OK TCONS_00004377 iPS 1 850.932 819.807 1401.68 773.443 - OK TCONS_00004377 hESC 1 3412.7 3378.06 2232.61 1258.05 - OK TCONS_00004377 hESC 0 2997 3027.73 2001.07 1127.58 - OK TCONS_00004377 Fibroblasts 1 3125.17 2607.64 2131.75 1179.9 - OK TCONS_00004377 Fibroblasts 0 2799.91 3331.58 2723.58 1507.46 - OK TCONS_00004378 iPS 0 1606.9 1677.23 2867.66 1691.94 - OK TCONS_00004378 iPS 1 1839.79 1772.49 3030.54 1788.03 - OK TCONS_00004378 hESC 1 3596.16 3559.67 2352.63 1419.55 - OK TCONS_00004378 hESC 0 3241.06 3274.29 2164.03 1305.74 - OK TCONS_00004378 Fibroblasts 1 5640.41 4706.35 3847.46 2277.44 - OK TCONS_00004378 Fibroblasts 0 5367.57 6386.8 5221.23 3090.62 - OK TCONS_00004379 iPS 0 281.914 294.252 503.102 295.722 - OK TCONS_00004379 iPS 1 176.73 170.265 291.113 171.116 - OK TCONS_00004379 hESC 1 444.711 440.197 290.933 174.874 - OK TCONS_00004379 hESC 0 576.571 582.483 384.971 231.398 - OK TCONS_00004379 Fibroblasts 1 1265.47 1055.91 863.207 509.044 - OK TCONS_00004379 Fibroblasts 0 1249.89 1487.23 1215.82 716.981 - OK TCONS_00004380 iPS 0 167.218 174.537 298.416 184.857 - OK TCONS_00004380 iPS 1 2.21883 2.13767 3.65491 2.26407 - OK TCONS_00004380 hESC 1 0 0 0 0 - OK TCONS_00004380 hESC 0 15.5389 15.6983 10.3752 6.58024 - OK TCONS_00004380 Fibroblasts 1 0 0 0 0 - OK TCONS_00004380 Fibroblasts 0 0 0 0 0 - OK TCONS_00004381 iPS 0 0.0598283 0.0624468 0.106769 0.061657 - OK TCONS_00004381 iPS 1 173.822 167.464 286.324 165.346 - OK TCONS_00004381 hESC 1 0 0 0 0 - OK TCONS_00004381 hESC 0 23.5842 23.826 15.747 9.29533 - OK TCONS_00004381 Fibroblasts 1 0 0 0 0 - OK TCONS_00004381 Fibroblasts 0 0 0 0 0 - OK TCONS_00004382 iPS 0 23.9812 25.0308 42.7968 27.263 - OK TCONS_00004382 iPS 1 61.8723 59.6091 101.917 64.9249 - OK TCONS_00004382 hESC 1 178.659 176.845 116.88 76.283 - OK TCONS_00004382 hESC 0 245.454 247.971 163.887 106.963 - OK TCONS_00004382 Fibroblasts 1 204.732 170.828 139.653 89.2775 - OK TCONS_00004382 Fibroblasts 0 169.248 201.387 164.634 105.248 - OK TCONS_00004383 iPS 0 94.5819 98.7215 168.79 57.5815 - OK TCONS_00004383 iPS 1 4.74298 4.56949 7.81274 2.66525 - OK TCONS_00004383 hESC 1 93.9997 93.0456 61.4952 21.2511 - OK TCONS_00004383 hESC 0 68.9997 69.7072 46.0705 15.9207 - OK TCONS_00004383 Fibroblasts 1 1343.15 1120.73 916.196 313.143 - OK TCONS_00004383 Fibroblasts 0 647.443 770.385 629.791 215.254 - OK TCONS_00004384 iPS 0 87.0895 90.9012 155.419 50.8378 - OK TCONS_00004384 iPS 1 19.0504 18.3536 31.3803 10.2645 - OK TCONS_00004384 hESC 1 0 0 0 0 - OK TCONS_00004384 hESC 0 0 0 0 0 - OK TCONS_00004384 Fibroblasts 1 492.698 411.107 336.081 110.131 - OK TCONS_00004384 Fibroblasts 0 413.161 491.615 401.896 131.698 - OK TCONS_00004385 iPS 0 79.1469 82.611 141.245 140.849 - OK TCONS_00004385 iPS 1 1.5436 1.48714 2.54266 2.53553 - OK TCONS_00004385 hESC 1 1.36964 1.35574 0.896026 0.92831 - OK TCONS_00004385 hESC 0 2.64117 2.66825 1.76348 1.82702 - OK TCONS_00004385 Fibroblasts 1 829.034 691.745 565.504 567.04 - OK TCONS_00004385 Fibroblasts 0 474.114 564.142 461.188 462.44 - OK TCONS_00004386 iPS 0 0 0 0 0 - OK TCONS_00004386 iPS 1 0 0 0 0 - OK TCONS_00004386 hESC 1 3.63036 3.59352 2.37501 10.5196 - OK TCONS_00004386 hESC 0 0.358831 0.362511 0.239589 1.06121 - OK TCONS_00004386 Fibroblasts 1 82.2651 68.6419 56.115 217.637 - OK TCONS_00004386 Fibroblasts 0 7.43924 8.85186 7.23642 28.0658 - OK TCONS_00004387 iPS 0 25.8531 26.9846 46.1372 114.39 - OK TCONS_00004387 iPS 1 3.64444e-05 3.51113e-05 6.0032e-05 0.00014884 - OK TCONS_00004387 hESC 1 0 0 0 0 - OK TCONS_00004387 hESC 0 0 0 0 0 - OK TCONS_00004387 Fibroblasts 1 98.3224 82.0402 67.0681 168.593 - OK TCONS_00004387 Fibroblasts 0 54.0794 64.3484 52.605 132.236 - OK TCONS_00004388 iPS 0 0 0 0 0 - OK TCONS_00004388 iPS 1 1.45636 1.40309 2.39895 7.0913 - OK TCONS_00004388 hESC 1 0 0 0 0 - OK TCONS_00004388 hESC 0 0 0 0 0 - OK TCONS_00004388 Fibroblasts 1 6.37872 5.3224 4.35108 13.0752 - OK TCONS_00004388 Fibroblasts 0 3.86739 4.60176 3.76195 11.3049 - OK TCONS_00004389 iPS 0 54.6225 57.0132 97.479 57.8266 - OK TCONS_00004389 iPS 1 55.5936 53.5602 91.5751 54.3243 - OK TCONS_00004389 hESC 1 25.7854 25.5237 16.869 10.2353 - OK TCONS_00004389 hESC 0 78.1707 78.9722 52.1938 31.6687 - OK TCONS_00004389 Fibroblasts 1 147.427 123.013 100.563 59.8523 - OK TCONS_00004389 Fibroblasts 0 229.328 272.874 223.075 132.768 - OK TCONS_00004390 iPS 0 22.8536 23.8539 40.7844 21.9901 - OK TCONS_00004390 iPS 1 48.431 46.6595 79.7767 43.014 - OK TCONS_00004390 hESC 1 304.211 301.123 199.017 109.526 - OK TCONS_00004390 hESC 0 212.429 214.608 141.837 78.0578 - OK TCONS_00004390 Fibroblasts 1 112.315 93.7159 76.613 41.4315 - OK TCONS_00004390 Fibroblasts 0 81.2724 96.705 79.0566 42.753 - OK TCONS_00004391 iPS 0 42.149 43.9937 75.2188 27.1395 - OK TCONS_00004391 iPS 1 76.267 73.4773 125.629 45.3278 - OK TCONS_00004391 hESC 1 183.048 181.19 119.751 43.8011 - OK TCONS_00004391 hESC 0 316.426 319.67 211.274 77.2774 - OK TCONS_00004391 Fibroblasts 1 370.582 309.213 252.783 91.3879 - OK TCONS_00004391 Fibroblasts 0 160.762 191.289 156.379 56.5353 - OK TCONS_00004392 iPS 0 310.375 323.959 553.893 197.78 - OK TCONS_00004392 iPS 1 269.708 259.843 444.27 158.637 - OK TCONS_00004392 hESC 1 2440.3 2415.53 1596.46 577.809 - OK TCONS_00004392 hESC 0 2250 2273.07 1502.3 543.731 - OK TCONS_00004392 Fibroblasts 1 2044.57 1705.99 1394.65 498.976 - OK TCONS_00004392 Fibroblasts 0 1884.64 2242.51 1833.26 655.899 - OK TCONS_00004393 iPS 0 0 0 0 0 - OK TCONS_00004393 iPS 1 0 0 0 0 - OK TCONS_00004393 hESC 1 0 0 0 0 - OK TCONS_00004393 hESC 0 0 0 0 0 - OK TCONS_00004393 Fibroblasts 1 0 0 0 0 - OK TCONS_00004393 Fibroblasts 0 0 0 0 0 - OK TCONS_00004394 iPS 0 0 0 0 0 - OK TCONS_00004394 iPS 1 0 0 0 0 - OK TCONS_00004394 hESC 1 103.655 102.603 67.8115 61.9915 - OK TCONS_00004394 hESC 0 0 0 0 0 - OK TCONS_00004394 Fibroblasts 1 0 0 0 0 - OK TCONS_00004394 Fibroblasts 0 0 0 0 0 - OK TCONS_00004395 iPS 0 0 0 0 0 - OK TCONS_00004395 iPS 1 0 0 0 0 - OK TCONS_00004395 hESC 1 0 0 0 0 - OK TCONS_00004395 hESC 0 6.97245 7.04394 4.65544 13.8243 - OK TCONS_00004395 Fibroblasts 1 0.105505 0.0880333 0.0719674 0.195125 - OK TCONS_00004395 Fibroblasts 0 0 0 0 0 - OK TCONS_00004396 iPS 0 11.0001 11.4815 19.6307 14.8216 - OK TCONS_00004396 iPS 1 11.0001 10.5978 18.1197 13.6807 - OK TCONS_00004396 hESC 1 3 2.96955 1.96262 1.5251 - OK TCONS_00004396 hESC 0 3.00182 3.0326 2.00429 1.55748 - OK TCONS_00004396 Fibroblasts 1 0 0 0 0 - OK TCONS_00004396 Fibroblasts 0 0 0 0 0 - OK TCONS_00004397 iPS 0 33 34.4443 58.8916 16.5798 - OK TCONS_00004397 iPS 1 39 37.5735 64.2417 18.086 - OK TCONS_00004397 hESC 1 560 554.316 366.356 104.243 - OK TCONS_00004397 hESC 0 463 467.747 309.141 87.9633 - OK TCONS_00004397 Fibroblasts 1 154 128.498 105.047 29.62 - OK TCONS_00004397 Fibroblasts 0 322 383.144 313.221 88.3184 - OK TCONS_00004398 iPS 0 1194.11 1246.37 2131 2692.57 - OK TCONS_00004398 iPS 1 826.959 796.711 1362.19 1721.15 - OK TCONS_00004398 hESC 1 3049.42 3018.47 1994.95 2646.35 - OK TCONS_00004398 hESC 0 4085.97 4127.86 2728.17 3618.98 - OK TCONS_00004398 Fibroblasts 1 1416.56 1181.97 966.267 1229.48 - OK TCONS_00004398 Fibroblasts 0 960.159 1142.48 933.981 1188.4 - OK TCONS_00004399 iPS 0 174.389 182.021 311.213 319.113 - OK TCONS_00004399 iPS 1 153.041 147.443 252.093 258.493 - OK TCONS_00004399 hESC 1 135.582 134.206 88.699 94.5968 - OK TCONS_00004399 hESC 0 239.03 241.481 159.598 170.21 - OK TCONS_00004399 Fibroblasts 1 101.444 84.6446 69.1972 71.3578 - OK TCONS_00004399 Fibroblasts 0 496.841 591.185 483.295 498.386 - OK TCONS_00004400 iPS 0 7.95208 8.30012 14.1912 22.144 - OK TCONS_00004400 iPS 1 14.7359 14.1969 24.2733 37.876 - OK TCONS_00004400 hESC 1 96.4006 95.4222 63.0659 104.54 - OK TCONS_00004400 hESC 0 52.6225 53.162 35.1355 58.2416 - OK TCONS_00004400 Fibroblasts 1 133.034 111.003 90.7456 142.83 - OK TCONS_00004400 Fibroblasts 0 50.0435 59.5461 48.6791 76.6189 - OK TCONS_00004401 iPS 0 33.942 35.4275 60.5726 59.5216 - OK TCONS_00004401 iPS 1 0 0 0 0 - OK TCONS_00004401 hESC 1 74.9549 74.1941 49.036 50.0332 - OK TCONS_00004401 hESC 0 46.336 46.8111 30.9381 31.5673 - OK TCONS_00004401 Fibroblasts 1 0 0 0 0 - OK TCONS_00004401 Fibroblasts 0 24.0612 28.6301 23.4052 23.1245 - OK TCONS_00004402 iPS 0 9.6662 10.0893 17.2502 16.6729 - OK TCONS_00004402 iPS 1 0 0 0 0 - OK TCONS_00004402 hESC 1 27.8543 27.5716 18.2224 18.2766 - OK TCONS_00004402 hESC 0 6.53072 6.59768 4.3605 4.37347 - OK TCONS_00004402 Fibroblasts 1 289.799 241.809 197.679 192.089 - OK TCONS_00004402 Fibroblasts 0 98.4852 117.186 95.8001 93.0909 - OK TCONS_00004403 iPS 0 0 0 0 0 - OK TCONS_00004403 iPS 1 15.6672 15.0941 25.8074 26.3479 - OK TCONS_00004403 hESC 1 13.4855 13.3486 8.82229 9.36654 - OK TCONS_00004403 hESC 0 35.2793 35.6411 23.5557 25.0089 - OK TCONS_00004403 Fibroblasts 1 0 0 0 0 - OK TCONS_00004403 Fibroblasts 0 60.9255 72.4945 59.2645 60.8488 - OK TCONS_00004404 iPS 0 74.1552 77.4008 132.337 133.853 - OK TCONS_00004404 iPS 1 98.9478 95.3286 162.989 164.856 - OK TCONS_00004404 hESC 1 562.838 557.125 368.212 387.15 - OK TCONS_00004404 hESC 0 584.193 590.183 390.06 410.122 - OK TCONS_00004404 Fibroblasts 1 278.555 232.426 190.009 193.265 - OK TCONS_00004404 Fibroblasts 0 507.469 603.831 493.633 502.092 - OK TCONS_00004405 iPS 0 39.3802 41.1037 70.2776 65.8995 - OK TCONS_00004405 iPS 1 36.697 35.3547 60.4481 56.6823 - OK TCONS_00004405 hESC 1 82.3328 81.4972 53.8627 52.3524 - OK TCONS_00004405 hESC 0 57.549 58.139 38.4249 37.3476 - OK TCONS_00004405 Fibroblasts 1 188.983 157.688 128.91 121.508 - OK TCONS_00004405 Fibroblasts 0 209.087 248.79 203.386 191.708 - OK TCONS_00004406 iPS 0 33.3788 34.8397 59.5676 50.8662 - OK TCONS_00004406 iPS 1 10.912 10.5128 17.9745 15.3488 - OK TCONS_00004406 hESC 1 125.264 123.992 81.9484 72.2985 - OK TCONS_00004406 hESC 0 56.7026 57.284 37.8598 33.4016 - OK TCONS_00004406 Fibroblasts 1 49.7063 41.4749 33.9059 29.0902 - OK TCONS_00004406 Fibroblasts 0 114.121 135.791 111.01 95.2429 - OK TCONS_00004407 iPS 0 0 0 0 0 - OK TCONS_00004407 iPS 1 0 0 0 0 - OK TCONS_00004407 hESC 1 0 0 0 0 - OK TCONS_00004407 hESC 0 0 0 0 0 - OK TCONS_00004407 Fibroblasts 1 0 0 0 0 - OK TCONS_00004407 Fibroblasts 0 0 0 0 0 - OK TCONS_00004408 iPS 0 4.47761 4.67359 7.99072 10.4997 - OK TCONS_00004408 iPS 1 1.31357 1.26553 2.16375 2.84314 - OK TCONS_00004408 hESC 1 16.2712 16.106 10.6447 14.7138 - OK TCONS_00004408 hESC 0 7.12591 7.19897 4.75791 6.57668 - OK TCONS_00004408 Fibroblasts 1 3.95574 3.30067 2.6983 3.57145 - OK TCONS_00004408 Fibroblasts 0 4.35154 5.17785 4.23291 5.60264 - OK TCONS_00004409 iPS 0 0 0 0 0 - OK TCONS_00004409 iPS 1 3.46242 3.33577 5.70338 10.5249 - OK TCONS_00004409 hESC 1 0 0 0 0 - OK TCONS_00004409 hESC 0 10.2837 10.3892 6.86636 13.6156 - OK TCONS_00004409 Fibroblasts 1 0 0 0 0 - OK TCONS_00004409 Fibroblasts 0 0 0 0 0 - OK TCONS_00004410 iPS 0 153.015 159.712 273.069 268.33 - OK TCONS_00004410 iPS 1 60.2297 58.0266 99.2117 97.4902 - OK TCONS_00004410 hESC 1 443.79 439.286 290.331 296.235 - OK TCONS_00004410 hESC 0 407.396 411.573 272.014 277.546 - OK TCONS_00004410 Fibroblasts 1 2365.4 1973.69 1613.5 1594.15 - OK TCONS_00004410 Fibroblasts 0 1491.85 1775.14 1451.18 1433.78 - OK TCONS_00004411 iPS 0 0 0 0 0 - OK TCONS_00004411 iPS 1 0 0 0 0 - OK TCONS_00004411 hESC 1 0 0 0 0 - OK TCONS_00004411 hESC 0 0 0 0 0 - OK TCONS_00004411 Fibroblasts 1 0 0 0 0 - OK TCONS_00004411 Fibroblasts 0 0 0 0 0 - OK TCONS_00004412 iPS 0 0 0 0 0 - OK TCONS_00004412 iPS 1 0.00517895 0.00498952 0.00853089 0.00983862 - OK TCONS_00004412 hESC 1 100.333 99.3151 65.6388 79.1313 - OK TCONS_00004412 hESC 0 32.3187 32.6501 21.5789 26.0146 - OK TCONS_00004412 Fibroblasts 1 413.395 344.937 281.987 327.298 - OK TCONS_00004412 Fibroblasts 0 46.7057 55.5746 45.4323 52.7327 - OK TCONS_00004413 iPS 0 6.18545 6.45617 11.0385 7.83655 - OK TCONS_00004413 iPS 1 6.46116 6.22482 10.643 7.55574 - OK TCONS_00004413 hESC 1 30.16 29.8539 19.7309 14.3916 - OK TCONS_00004413 hESC 0 23.0887 23.3254 15.4161 11.2444 - OK TCONS_00004413 Fibroblasts 1 0 0 0 0 - OK TCONS_00004413 Fibroblasts 0 0 0 0 0 - OK TCONS_00004414 iPS 0 5.70138 5.95091 10.1746 11.5739 - OK TCONS_00004414 iPS 1 1.31845 1.27023 2.17179 2.47047 - OK TCONS_00004414 hESC 1 16.4635 16.2964 10.7705 12.799 - OK TCONS_00004414 hESC 0 9.46843 9.56552 6.32199 7.51267 - OK TCONS_00004414 Fibroblasts 1 6.46728 5.3963 4.41149 5.04991 - OK TCONS_00004414 Fibroblasts 0 5.58469 6.64515 5.43243 6.2186 - OK TCONS_00004415 iPS 0 16.0986 16.8032 28.7295 21.5419 - OK TCONS_00004415 iPS 1 9.98552 9.62028 16.4484 12.3333 - OK TCONS_00004415 hESC 1 12.2528 12.1285 8.01588 6.18476 - OK TCONS_00004415 hESC 0 16.7284 16.8999 11.1694 8.6179 - OK TCONS_00004415 Fibroblasts 1 72.7325 60.688 49.6126 37.355 - OK TCONS_00004415 Fibroblasts 0 56.8547 67.6507 55.3047 41.6408 - OK TCONS_00004416 iPS 0 153 159.696 273.043 202.266 - OK TCONS_00004416 iPS 1 172 165.709 283.322 209.881 - OK TCONS_00004416 hESC 1 236.85 234.446 154.949 118.072 - OK TCONS_00004416 hESC 0 256.825 259.459 171.48 130.669 - OK TCONS_00004416 Fibroblasts 1 246 205.262 167.802 124.816 - OK TCONS_00004416 Fibroblasts 0 212.844 253.261 207.041 154.003 - OK TCONS_00004417 iPS 0 0 0 0 0 - OK TCONS_00004417 iPS 1 0 0 0 0 - OK TCONS_00004417 hESC 1 0 0 0 0 - OK TCONS_00004417 hESC 0 0 0 0 0 - OK TCONS_00004417 Fibroblasts 1 0 0 0 0 - OK TCONS_00004417 Fibroblasts 0 0 0 0 0 - OK TCONS_00004418 iPS 0 0 0 0 0 - OK TCONS_00004418 iPS 1 0 0 0 0 - OK TCONS_00004418 hESC 1 6.15001 6.0876 4.02338 7.77114 - OK TCONS_00004418 hESC 0 10.1746 10.279 6.79351 13.1216 - OK TCONS_00004418 Fibroblasts 1 0 0 0 0 - OK TCONS_00004418 Fibroblasts 0 2.15565 2.56498 2.09688 3.81388 - OK TCONS_00004419 iPS 0 0 0 0 0 - OK TCONS_00004419 iPS 1 1 0.963422 1.64722 1.45038 - OK TCONS_00004419 hESC 1 0 0 0 0 - OK TCONS_00004419 hESC 0 0 0 0 0 - OK TCONS_00004419 Fibroblasts 1 0 0 0 0 - OK TCONS_00004419 Fibroblasts 0 0 0 0 0 - OK TCONS_00004420 iPS 0 650.634 679.11 1161.12 792.874 - OK TCONS_00004420 iPS 1 830.157 799.792 1367.45 933.772 - OK TCONS_00004420 hESC 1 436.139 431.712 285.325 199.968 - OK TCONS_00004420 hESC 0 792.509 800.635 529.151 370.852 - OK TCONS_00004420 Fibroblasts 1 439.422 366.654 299.74 205.454 - OK TCONS_00004420 Fibroblasts 0 165.083 196.43 160.582 110.069 - OK TCONS_00004421 iPS 0 107.645 112.356 192.103 162.278 - OK TCONS_00004421 iPS 1 141.35 136.179 232.834 196.686 - OK TCONS_00004421 hESC 1 1052.76 1042.07 688.722 600.875 - OK TCONS_00004421 hESC 0 845.511 854.18 564.54 492.533 - OK TCONS_00004421 Fibroblasts 1 2219.48 1851.94 1513.96 1284.91 - OK TCONS_00004421 Fibroblasts 0 1549.93 1844.24 1507.67 1279.56 - OK TCONS_00004422 iPS 0 953.721 995.463 1702 873.409 - OK TCONS_00004422 iPS 1 1454.99 1401.77 2396.7 1229.9 - OK TCONS_00004422 hESC 1 1996.1 1975.84 1305.86 683.304 - OK TCONS_00004422 hESC 0 2478.98 2504.4 1655.19 866.093 - OK TCONS_00004422 Fibroblasts 1 2741.1 2287.17 1869.77 962.225 - OK TCONS_00004422 Fibroblasts 0 2090.99 2488.05 2033.98 1046.74 - OK TCONS_00004423 iPS 0 0 0 0 0 - OK TCONS_00004423 iPS 1 0 0 0 0 - OK TCONS_00004423 hESC 1 6.02753 5.96636 3.94325 2.26253 - OK TCONS_00004423 hESC 0 1.1269 1.13845 0.752418 0.431717 - OK TCONS_00004423 Fibroblasts 1 0 0 0 0 - OK TCONS_00004423 Fibroblasts 0 0 0 0 0 - OK TCONS_00004424 iPS 0 0 0 0 0 - OK TCONS_00004424 iPS 1 1.82042 1.75384 2.99864 0.904129 - OK TCONS_00004424 hESC 1 14.8365 14.6859 9.70615 2.96008 - OK TCONS_00004424 hESC 0 1.0683 1.07925 0.713293 0.217532 - OK TCONS_00004424 Fibroblasts 1 0 0 0 0 - OK TCONS_00004424 Fibroblasts 0 0 0 0 0 - OK TCONS_00004425 iPS 0 0 0 0 0 - OK TCONS_00004425 iPS 1 3.85805 3.71693 6.35507 1.5963 - OK TCONS_00004425 hESC 1 0 0 0 0 - OK TCONS_00004425 hESC 0 5.21741 5.27091 3.48362 0.883374 - OK TCONS_00004425 Fibroblasts 1 0 0 0 0 - OK TCONS_00004425 Fibroblasts 0 0 0 0 0 - OK TCONS_00004426 iPS 0 0 0 0 0 - OK TCONS_00004426 iPS 1 4.85378 4.67624 7.99526 2.99792 - OK TCONS_00004426 hESC 1 0 0 0 0 - OK TCONS_00004426 hESC 0 0 0 0 0 - OK TCONS_00004426 Fibroblasts 1 0 0 0 0 - OK TCONS_00004426 Fibroblasts 0 0 0 0 0 - OK TCONS_00004427 iPS 0 0 0 0 0 - OK TCONS_00004427 iPS 1 1.46775 1.41406 2.4177 0.694196 - OK TCONS_00004427 hESC 1 1.13595 1.12442 0.743146 0.215708 - OK TCONS_00004427 hESC 0 5.58739 5.64468 3.73065 1.08287 - OK TCONS_00004427 Fibroblasts 1 0 0 0 0 - OK TCONS_00004427 Fibroblasts 0 0 0 0 0 - OK TCONS_00004428 iPS 0 4.98739 5.20567 8.90046 4.9655 - OK TCONS_00004428 iPS 1 9 8.6708 14.825 8.27077 - OK TCONS_00004428 hESC 1 0 0 0 0 - OK TCONS_00004428 hESC 0 5.94333 6.00427 3.96831 2.26131 - OK TCONS_00004428 Fibroblasts 1 5.98438 4.99336 4.08209 2.28441 - OK TCONS_00004428 Fibroblasts 0 0 0 0 0 - OK TCONS_00004429 iPS 0 0 0 0 0 - OK TCONS_00004429 iPS 1 0 0 0 0 - OK TCONS_00004429 hESC 1 23 22.7666 15.0468 8.25825 - OK TCONS_00004429 hESC 0 10.0559 10.159 6.71422 3.68503 - OK TCONS_00004429 Fibroblasts 1 0 0 0 0 - OK TCONS_00004429 Fibroblasts 0 0.00103695 0.00123385 0.00100868 0.000544027 - OK TCONS_00004430 iPS 0 0 0 0 0 - OK TCONS_00004430 iPS 1 0 0 0 0 - OK TCONS_00004430 hESC 1 0 0 0 0 - OK TCONS_00004430 hESC 0 0 0 0 0 - OK TCONS_00004430 Fibroblasts 1 0 0 0 0 - OK TCONS_00004430 Fibroblasts 0 0 0 0 0 - OK TCONS_00004431 iPS 0 0.0126134 0.0131654 0.0225097 0.01245 - OK TCONS_00004431 iPS 1 0 0 0 0 - OK TCONS_00004431 hESC 1 0 0 0 0 - OK TCONS_00004431 hESC 0 0.000786593 0.000794658 0.000525201 0.000296653 - OK TCONS_00004431 Fibroblasts 1 0.0156201 0.0130334 0.0106549 0.00591119 - OK TCONS_00004431 Fibroblasts 0 8.99896 10.7078 8.75362 4.8564 - OK TCONS_00004432 iPS 0 0 0 0 0 - OK TCONS_00004432 iPS 1 0 0 0 0 - OK TCONS_00004432 hESC 1 0 0 0 0 - OK TCONS_00004432 hESC 0 0 0 0 0 - OK TCONS_00004432 Fibroblasts 1 0.00619619 0.0051701 0.00422657 0.00134022 - OK TCONS_00004432 Fibroblasts 0 0 0 0 0 - OK TCONS_00004433 iPS 0 131.333 137.081 234.376 75.6844 - OK TCONS_00004433 iPS 1 160.363 154.497 264.153 85.3001 - OK TCONS_00004433 hESC 1 226.884 224.582 148.429 48.5196 - OK TCONS_00004433 hESC 0 180.456 182.306 120.489 39.3861 - OK TCONS_00004433 Fibroblasts 1 0 0 0 0 - OK TCONS_00004433 Fibroblasts 0 0 0 0 0 - OK TCONS_00004434 iPS 0 0 0 0 0 - OK TCONS_00004434 iPS 1 18.9988 18.3039 31.2953 10.4174 - OK TCONS_00004434 hESC 1 92.6528 91.7124 60.614 20.4325 - OK TCONS_00004434 hESC 0 130.068 131.402 86.8454 29.2748 - OK TCONS_00004434 Fibroblasts 1 0.674861 0.563104 0.460339 0.147425 - OK TCONS_00004434 Fibroblasts 0 0 0 0 0 - OK TCONS_00004435 iPS 0 0.0247609 0.0258446 0.0441882 0.0146849 - OK TCONS_00004435 iPS 1 0 0 0 0 - OK TCONS_00004435 hESC 1 50.4839 49.9715 33.0269 11.1145 - OK TCONS_00004435 hESC 0 69.2202 69.9299 46.2177 15.5536 - OK TCONS_00004435 Fibroblasts 1 0.318942 0.266125 0.217558 0.0695635 - OK TCONS_00004435 Fibroblasts 0 0 0 0 0 - OK TCONS_00004436 iPS 0 1.64234 1.71422 2.93091 7.99546 - OK TCONS_00004436 iPS 1 3.6384 3.50531 5.99325 16.3495 - OK TCONS_00004436 hESC 1 63.9789 63.3296 41.8554 127.227 - OK TCONS_00004436 hESC 0 69.256 69.9661 46.2416 140.56 - OK TCONS_00004436 Fibroblasts 1 0 0 0 0 - OK TCONS_00004436 Fibroblasts 0 0 0 0 0 - OK TCONS_00004437 iPS 0 0 0 0 0 - OK TCONS_00004437 iPS 1 0 0 0 0 - OK TCONS_00004437 hESC 1 0 0 0 0 - OK TCONS_00004437 hESC 0 0 0 0 0 - OK TCONS_00004437 Fibroblasts 1 0 0 0 0 - OK TCONS_00004437 Fibroblasts 0 0 0 0 0 - OK TCONS_00004438 iPS 0 0 0 0 0 - OK TCONS_00004438 iPS 1 0 0 0 0 - OK TCONS_00004438 hESC 1 0 0 0 0 - OK TCONS_00004438 hESC 0 0 0 0 0 - OK TCONS_00004438 Fibroblasts 1 0 0 0 0 - OK TCONS_00004438 Fibroblasts 0 0 0 0 0 - OK TCONS_00004439 iPS 0 6.82145 7.12 12.1735 7.39209 - OK TCONS_00004439 iPS 1 18.7736 18.0869 30.9243 18.7781 - OK TCONS_00004439 hESC 1 19.658 19.4585 12.8604 7.99159 - OK TCONS_00004439 hESC 0 15.8749 16.0376 10.5995 6.58664 - OK TCONS_00004439 Fibroblasts 1 97.0685 80.9939 66.2127 40.3414 - OK TCONS_00004439 Fibroblasts 0 149.936 178.408 145.849 88.8612 - OK TCONS_00004440 iPS 0 0 0 0 0 - OK TCONS_00004440 iPS 1 7.32537 7.05743 12.0665 6.41796 - OK TCONS_00004440 hESC 1 39.5946 39.1927 25.903 14.0584 - OK TCONS_00004440 hESC 0 20.506 20.7163 13.6917 7.43093 - OK TCONS_00004440 Fibroblasts 1 35.2621 29.4227 24.0531 12.8311 - OK TCONS_00004440 Fibroblasts 0 24.1868 28.7796 23.5274 12.5506 - OK TCONS_00004441 iPS 0 212.727 222.038 379.632 213.478 - OK TCONS_00004441 iPS 1 68.801 66.2844 113.331 63.729 - OK TCONS_00004441 hESC 1 381.747 377.873 249.742 143.47 - OK TCONS_00004441 hESC 0 319.219 322.492 213.14 122.443 - OK TCONS_00004441 Fibroblasts 1 627.462 523.554 428.007 241.43 - OK TCONS_00004441 Fibroblasts 0 284.569 338.605 276.811 156.143 - OK TCONS_00004442 iPS 0 0 0 0 0 - OK TCONS_00004442 iPS 1 0 0 0 0 - OK TCONS_00004442 hESC 1 0 0 0 0 - OK TCONS_00004442 hESC 0 3.7548 3.7933 2.50705 1.3733 - OK TCONS_00004442 Fibroblasts 1 16.4776 13.7489 11.2398 6.05059 - OK TCONS_00004442 Fibroblasts 0 0 0 0 0 - OK TCONS_00004443 iPS 0 4.45108 4.64589 7.94337 7.56384 - OK TCONS_00004443 iPS 1 7.10004 6.84034 11.6954 11.1366 - OK TCONS_00004443 hESC 1 0 0 0 0 - OK TCONS_00004443 hESC 0 7.64494 7.72333 5.10446 5.04101 - OK TCONS_00004443 Fibroblasts 1 22.7301 18.966 15.5048 14.842 - OK TCONS_00004443 Fibroblasts 0 17.3076 20.5941 16.8357 16.116 - OK cummeRbund/inst/extdata/promoters.diff0000644000175200017520000030073414516004263021200 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 sqrt(JS) test_stat p_value q_value significant XLOC_000001 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000005 XLOC_000005 - chr1:322036-328580 iPS hESC NOTEST 0 0 0.0123586 0 0.88628 1 no XLOC_000007 XLOC_000007 - chr1:420205-421839 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000012 XLOC_000012 - chr1:763063-789740 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000014 XLOC_000014 - chr1:846814-850328 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC NOTEST 0 0 0.479212 0 0.517875 1 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC NOTEST 0 0 0.151572 0 0.444555 1 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000020 XLOC_000020 - chr1:995082-1001833 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 0 0.653809 0 0.002325 1 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.0762298 0 0.52969 1 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC NOTEST 0 0 0.301664 0 0.075735 1 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 0 0 0.17837 0 0.10647 1 no XLOC_000037 XLOC_000037 - chr1:1535818-1543166 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0.376617 0 0.118315 1 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC NOTEST 0 0 0.107902 0 0.274145 1 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.652612 0 0.04586 1 no XLOC_000041 XLOC_000041 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0.230063 0 0.00215 1 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0.072778 0 0.35025 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 0 0.252725 0 0.003545 1 no XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0.000561259 0 0.96639 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000060 XLOC_000060 - chr1:3816967-3833877 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000061 XLOC_000061 - chr1:4000676-4015322 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000062 XLOC_000062 - chr1:4472110-4484744 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 0 0 0.0398363 0 0.654595 1 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC NOTEST 0 0 0.0716766 0 0.954765 1 no XLOC_000067 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC NOTEST 0 0 0.239448 0 0.182465 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC NOTEST 0 0 0.117739 0 0.241955 1 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0.0895358 0 0.715545 1 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0.0354375 0 0.26281 1 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0.174759 0 0.305775 1 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC NOTEST 0 0 0.435222 0 0.042365 1 no XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC NOTEST 0 0 0.431793 0 0.00987 1 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC NOTEST 0 0 0.269748 0 0.194165 1 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC NOTEST 0 0 0.275205 0 0.133035 1 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0.0651242 0 0.307245 1 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 iPS hESC NOTEST 0 0 0.0662307 0 0.695455 1 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0.108433 0 0.03885 1 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000101 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 0 0.0374165 0 0.74294 1 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC NOTEST 0 0 0.43864 0 1e-05 1 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000123 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0 0.176919 0 0.02298 1 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0.531384 0 1e-05 1 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC NOTEST 0 0 0.00507089 0 0.94466 1 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC NOTEST 0 0 0.200361 0 0.09003 1 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC NOTEST 0 0 0.118196 0 0.196985 1 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 0 0 0.0743742 0 0.52475 1 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000149 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 0 0 0.156019 0 0.56623 1 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC NOTEST 0 0 0.403237 0 0.070845 1 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0.147279 0 0.01398 1 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC NOTEST 0 0 0.184785 0 0.187275 1 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0.513634 0 1e-05 1 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC NOTEST 0 0 0.316089 0 3e-05 1 no XLOC_000173 XLOC_000173 - chr1:21543739-21672034 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000174 XLOC_000174 - chr1:21761832-21762609 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0.13794 0 0.746715 1 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000179 XLOC_000179 - chr1:22351706-22357713 iPS hESC NOTEST 0 0 0.0961338 0 0.326675 1 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 0 0 0.18797 0 0.207355 1 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000191 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC NOTEST 0 0 0.0604664 0 0.1421 1 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000197 XLOC_000197 - chr1:24526729-24538180 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC NOTEST 0 0 0.0168159 0 0.87495 1 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0 0 0.136779 0 0.23346 1 no XLOC_001217 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0.477111 0 0.0347 1 no XLOC_001218 XLOC_001218 - chr1:34611-36081 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001219 XLOC_001219 - chr1:89294-237877 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 iPS hESC NOTEST 0 0 0.0717873 0 0.533545 1 no XLOC_001227 XLOC_001227 - chr1:700236-714006 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001229 XLOC_001229 FAM41C chr1:803452-812182 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001230 XLOC_001230 - chr1:852952-854817 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC NOTEST 0 0 0.000802301 0 0.975825 1 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 0 0 0.0227536 0 0.95978 1 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 0 0 0.182077 0 0.45895 1 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0.113638 0 0.359005 1 no XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC NOTEST 0 0 0.0264565 0 0.68107 1 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.23339 0 0.41193 1 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.0718313 0 0.285075 1 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS hESC NOTEST 0 0 0.0591453 0 0.517535 1 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 0 0 0.198122 0 0.01833 1 no XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC NOTEST 0 0 0.0806175 0 0.472115 1 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC NOTEST 0 0 0.151609 0 0.389575 1 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.20992 0 0.69664 1 no XLOC_001253 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.114637 0 0.60962 1 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0.222193 0 0.339 1 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC NOTEST 0 0 0.0349735 0 0.721685 1 no XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001261 XLOC_001261 - chr1:1944651-1946969 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC NOTEST 0 0 0.00760034 0 0.820605 1 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001269 XLOC_001269 - chr1:2481358-2495265 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001271 XLOC_001271 - chr1:2976182-2980350 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 0 0 0.312076 0 0.03664 1 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC NOTEST 0 0 0.0957886 0 0.06737 1 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001279 XLOC_001279 - chr1:5621768-5728315 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC NOTEST 0 0 0.0272226 0 0.673235 1 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 0 0 0 0 0 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0.369015 0 0.040475 1 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC NOTEST 0 0 0.0988218 0 0.326235 1 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC NOTEST 0 0 0.150881 0 0.113605 1 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0.447859 0 1e-05 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 0 0 0.0537259 0 0.12559 1 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001302 XLOC_001302 - chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC NOTEST 0 0 0.138245 0 0.220375 1 no XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC NOTEST 0 0 0.0130589 0 0.87721 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 0 0 0.35725 0 0.004465 1 no XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC NOTEST 0 0 0.0437797 0 0.488725 1 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 0 0 0.277737 0 0.15215 1 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 0 0 0.0661024 0 0.408995 1 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001334 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001335 XLOC_001335 - chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0.258007 0 1e-05 1 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001339 XLOC_001339 - chr1:16160709-16266950 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 0 0 0.0830669 0 0.7056 1 no XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC NOTEST 0 0 0.199294 0 0.115025 1 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 0 0 0.185656 0 0.31417 1 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 iPS hESC NOTEST 0 0 0.482934 0 0.00111 1 no XLOC_001350 XLOC_001350 - chr1:16860385-16864669 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 0 0 0.206646 0 0.21582 1 no XLOC_001353 XLOC_001353 - chr1:16944752-16971178 iPS hESC NOTEST 0 0 0.30049 0 0.26118 1 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001356 XLOC_001356 - chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC NOTEST 0 0 0.141433 0 0.130585 1 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 0 0 0.0201116 0 0.55686 1 no XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC NOTEST 0 0 0.00714474 0 0.903335 1 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0.480676 0 1e-05 1 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC NOTEST 0 0 0.146768 0 0.16474 1 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 0 0 0.374204 0 0.000125 1 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 0 0.25916 0 0.378625 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001379 XLOC_001379 - chr1:20687597-20755275 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC NOTEST 0 0 0.370019 0 0.03922 1 no XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 0 0.113535 0 0.310195 1 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 0 0 0.179053 0 0.16329 1 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0.230085 0 0.12892 1 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0.396756 0 0.010935 1 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 0 0.367366 0 2e-05 1 no XLOC_001389 XLOC_001389 - chr1:21749600-21754300 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 0 0 0.107307 0 0.61637 1 no XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0.0989523 0 0.31376 1 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0.298714 0 0.259085 1 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0.449104 0 0.051345 1 no XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 0 0.63845 0 0.051875 1 no XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0.212962 0 0.000405 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001404 XLOC_001404 - chr1:24069855-24104777 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0.0560888 0 0.929505 1 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 0 0 0.000725135 0 0.943335 1 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC LOWDATA 0 0 0 0 0 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC NOTEST 0 0 0 0 1 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0.085859 0 0.691705 1 no XLOC_000001 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000005 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts NOTEST 0 0 0.0554043 0 0.789695 1 no XLOC_000007 XLOC_000007 - chr1:420205-421839 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000012 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000014 XLOC_000014 - chr1:846814-850328 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0.537612 0 0.490145 1 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts NOTEST 0 0 0.159831 0 0.850005 1 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000020 XLOC_000020 - chr1:995082-1001833 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 0 0.48672 0 0.051095 1 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.0772756 0 0.73368 1 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts NOTEST 0 0 0.325359 0 0.120785 1 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts NOTEST 0 0 0.310328 0 0.025515 1 no XLOC_000037 XLOC_000037 - chr1:1535818-1543166 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0.393472 0 0.10823 1 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts NOTEST 0 0 0.573909 0 0.094815 1 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.790979 0 0.06578 1 no XLOC_000041 XLOC_000041 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0.832555 0 1e-05 1 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0.0560327 0 0.68209 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0.499018 0 0.05318 1 no XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0.226462 0 0.23582 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000060 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000061 XLOC_000061 - chr1:4000676-4015322 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000062 XLOC_000062 - chr1:4472110-4484744 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 0 0 0.411152 0 0.108775 1 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0.0894491 0 0.93648 1 no XLOC_000067 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 0 0 0.520825 0 0.28235 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts NOTEST 0 0 0.0214464 0 0.887365 1 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0.0415511 0 0.86942 1 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 0 0.0490202 0 0.17665 1 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0.0937917 0 0.685875 1 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts NOTEST 0 0 0.380461 0 0.10852 1 no XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts NOTEST 0 0 0.418511 0 0.012245 1 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0.0530971 0 0.955555 1 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0.260836 0 0.37664 1 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0.0884171 0 0.483395 1 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 iPS Fibroblasts NOTEST 0 0 0.175561 0 0.606135 1 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0.091655 0 0.249895 1 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000101 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0.0263154 0 0.81032 1 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 0 0.397367 0 0.009455 1 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000123 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0.274974 0 0.035065 1 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0.696998 0 0.007955 1 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts NOTEST 0 0 0.248085 0 0.160395 1 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts NOTEST 0 0 0.172354 0 0.44552 1 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts NOTEST 0 0 0.115363 0 0.31603 1 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0.21363 0 0.744825 1 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000149 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 0 0 0.263417 0 0.68259 1 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0.454351 0 0.085255 1 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0.544433 0 1e-05 1 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts NOTEST 0 0 0.146606 0 0.395215 1 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 0 0.372793 0 0.01436 1 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts NOTEST 0 0 0.324848 0 0.025445 1 no XLOC_000173 XLOC_000173 - chr1:21543739-21672034 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000174 XLOC_000174 - chr1:21761832-21762609 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0.315915 0 0.655205 1 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000179 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts NOTEST 0 0 0.0884983 0 0.55512 1 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts NOTEST 0 0 0.252651 0 0.24672 1 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000191 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts NOTEST 0 0 0.277216 0 0.074985 1 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000197 XLOC_000197 - chr1:24526729-24538180 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts NOTEST 0 0 0.263368 0 0.217415 1 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts NOTEST 0 0 0.166348 0 0.43367 1 no XLOC_001217 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0.533449 0 0.01239 1 no XLOC_001218 XLOC_001218 - chr1:34611-36081 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001219 XLOC_001219 - chr1:89294-237877 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0.0484732 0 0.95117 1 no XLOC_001227 XLOC_001227 - chr1:700236-714006 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001229 XLOC_001229 FAM41C chr1:803452-812182 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001230 XLOC_001230 - chr1:852952-854817 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0.0533063 0 0.6746 1 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 0 0.196824 0 0.69583 1 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0 0 0.492228 0 0.22171 1 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0.124762 0 0.60389 1 no XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts NOTEST 0 0 0.0470788 0 0.67422 1 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.12187 0 0.94744 1 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.0688427 0 0.596675 1 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS Fibroblasts NOTEST 0 0 0.167457 0 0.494735 1 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 0 0 0.00663235 0 0.75067 1 no XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts NOTEST 0 0 0.122911 0 0.660065 1 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts NOTEST 0 0 0.0543494 0 0.95893 1 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.209395 0 0.976985 1 no XLOC_001253 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.118982 0 0.94986 1 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0.291773 0 0.19704 1 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts NOTEST 0 0 0.629985 0 0.00494 1 no XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001261 XLOC_001261 - chr1:1944651-1946969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0.0272695 0 0.74364 1 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001269 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001271 XLOC_001271 - chr1:2976182-2980350 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 0 0 0.0181577 0 0.890195 1 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts NOTEST 0 0 0.205625 0 0.137825 1 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001279 XLOC_001279 - chr1:5621768-5728315 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 0 0 0.130879 0 0.42711 1 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 0 0 0 0 0 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0.457495 0 0.077795 1 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts NOTEST 0 0 0.0131035 0 0.95395 1 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts NOTEST 0 0 0.17676 0 0.15491 1 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts NOTEST 0 0 0.695378 0 5e-05 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 0 0 0.0619215 0 0.321555 1 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0.43374 0 0.17367 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001302 XLOC_001302 - chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0.19839 0 0.34701 1 no XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 0 0 0.203758 0 0.53769 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts NOTEST 0 0 0.189176 0 0.145055 1 no XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0.11856 0 0.3919 1 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0.30139 0 0.243795 1 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts NOTEST 0 0 0.140364 0 0.628415 1 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001334 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001335 XLOC_001335 - chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0.263171 0 0.187565 1 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001339 XLOC_001339 - chr1:16160709-16266950 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0.118977 0 0.521315 1 no XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts NOTEST 0 0 0.66256 0 0.000185 1 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts NOTEST 0 0 0.18136 0 0.32348 1 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts NOTEST 0 0 0.511323 0 0.14011 1 no XLOC_001350 XLOC_001350 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 0 0 0.246724 0 0.2059 1 no XLOC_001353 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts NOTEST 0 0 0.168522 0 0.843015 1 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001356 XLOC_001356 - chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts NOTEST 0 0 0.0796304 0 0.290065 1 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts NOTEST 0 0 0.251749 0 0.017535 1 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 0 0 0.0839394 0 0.31278 1 no XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts NOTEST 0 0 0.0642148 0 0.588745 1 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0.479597 0 0.00078 1 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts NOTEST 0 0 0.198503 0 0.137055 1 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts NOTEST 0 0 0.376864 0 0.00011 1 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0.105547 0 0.947255 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001379 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts NOTEST 0 0 0.173178 0 0.40883 1 no XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 0 0.495053 0 0.04639 1 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts NOTEST 0 0 0.244045 0 0.13319 1 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0.16017 0 0.717685 1 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0.433756 0 0.00449 1 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts NOTEST 0 0 0.251853 0 0.329895 1 no XLOC_001389 XLOC_001389 - chr1:21749600-21754300 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 0 0 0.467551 0 0.04303 1 no XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0.1481 0 0.40323 1 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0.279325 0 0.458315 1 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0.115358 0 0.457995 1 no XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts NOTEST 0 0 0.186708 0 0.23231 1 no XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0.0989342 0 1e-05 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001404 XLOC_001404 - chr1:24069855-24104777 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0.217412 0 0.63604 1 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 0 0 0.11154 0 0.227345 1 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0.136001 0 0.71662 1 no XLOC_000001 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000005 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts NOTEST 0 0 0.0677393 0 0.511975 1 no XLOC_000007 XLOC_000007 - chr1:420205-421839 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000012 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000014 XLOC_000014 - chr1:846814-850328 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000015 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0.166195 0 0.780305 1 no XLOC_000016 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts NOTEST 0 0 0.124009 0 0.490145 1 no XLOC_000017 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000018 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000019 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000020 XLOC_000020 - chr1:995082-1001833 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000021 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000025 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000027 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 0 0 0.203525 0 0.20035 1 no XLOC_000028 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.0010984 0 0.8868 1 no XLOC_000029 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000030 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000031 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000032 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000033 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000034 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000035 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts NOTEST 0 0 0.0607242 0 0.719045 1 no XLOC_000036 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 0 0 0.136264 0 0.12173 1 no XLOC_000037 XLOC_000037 - chr1:1535818-1543166 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000038 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0.459181 0 0.000235 1 no XLOC_000039 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts NOTEST 0 0 0.532254 0 0.12101 1 no XLOC_000040 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.19565 0 0.71286 1 no XLOC_000041 XLOC_000041 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000042 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000043 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000044 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000045 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0.832555 0 1e-05 1 no XLOC_000047 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000048 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000049 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000050 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000051 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0.0169606 0 0.774455 1 no XLOC_000053 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000054 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 0 0 0.33556 0 0.13673 1 no XLOC_000055 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000056 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0.225992 0 0.025715 1 no XLOC_000057 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000058 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000059 XLOC_000059 CAD,DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000060 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000061 XLOC_000061 - chr1:4000676-4015322 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000062 XLOC_000062 - chr1:4472110-4484744 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000063 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000065 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0.375737 0 0.11406 1 no XLOC_000066 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0.0683894 0 0.950135 1 no XLOC_000067 XLOC_000067 C1orf211 chr1:6297870-6299490 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000068 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000069 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts NOTEST 0 0 0.713138 0 1e-05 1 no XLOC_000070 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000071 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts NOTEST 0 0 0.0965877 0 0.29868 1 no XLOC_000072 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000073 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0.130799 0 0.60054 1 no XLOC_000074 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0.078804 0 4e-05 1 no XLOC_000075 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000076 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0.0831967 0 0.589545 1 no XLOC_000077 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000078 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts NOTEST 0 0 0.0597637 0 0.62458 1 no XLOC_000079 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000080 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000081 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts NOTEST 0 0 0.0147122 0 0.85147 1 no XLOC_000082 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000083 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000084 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0.240439 0 0.43691 1 no XLOC_000085 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000086 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000087 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts NOTEST 0 0 0.214761 0 0.29739 1 no XLOC_000088 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0.151007 0 0.12004 1 no XLOC_000089 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000090 XLOC_000090 APITD1,CORT,Cort chr1:10490158-10512208 hESC Fibroblasts NOTEST 0 0 0.209375 0 0.223475 1 no XLOC_000091 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000092 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000093 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000094 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000095 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000096 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0.0201063 0 0.7643 1 no XLOC_000097 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000098 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000100 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000101 XLOC_000101 C1orf167 chr1:11824461-11826573 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000102 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000103 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0.0111901 0 0.831555 1 no XLOC_000104 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000105 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000106 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000107 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000108 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000109 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0.113802 0 0.23937 1 no XLOC_000111 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000112 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000113 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000114 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000115 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000116 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000117 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000118 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000119 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000120 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000121 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000122 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000123 XLOC_000123 PRAMEF10 chr1:13629937-13635298 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000124 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000125 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000126 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000127 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000128 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 0 0 0.196531 0 0.1595 1 no XLOC_000129 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0.509361 0 0.059175 1 no XLOC_000130 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts NOTEST 0 0 0.243339 0 0.007875 1 no XLOC_000131 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000132 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000133 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000134 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000135 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000136 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000137 XLOC_000137 DDI2,RSC1A1 chr1:15944069-15988216 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000139 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000140 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000141 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000142 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts NOTEST 0 0 0.0292331 0 0.89311 1 no XLOC_000143 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts NOTEST 0 0 0.00285963 0 0.974165 1 no XLOC_000144 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000145 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0.140894 0 0.402895 1 no XLOC_000146 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000147 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000149 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 0 0 0.409945 0 0.1959 1 no XLOC_000150 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0.181363 0 0.43634 1 no XLOC_000151 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000152 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000153 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000154 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000155 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0.499165 0 1e-05 1 no XLOC_000156 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000157 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000159 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000160 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000161 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000162 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts NOTEST 0 0 0.0389556 0 0.62546 1 no XLOC_000163 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 0 0 0.174763 0 0.226225 1 no XLOC_000164 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000165 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000166 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000167 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000168 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000169 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000171 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000172 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts NOTEST 0 0 0.0104363 0 0.888875 1 no XLOC_000173 XLOC_000173 - chr1:21543739-21672034 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000174 XLOC_000174 - chr1:21761832-21762609 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000175 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000176 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000177 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0.443236 0 0.52472 1 no XLOC_000178 XLOC_000178 CELA3A,CELA3B chr1:22303417-22339033 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000179 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts NOTEST 0 0 0.00843083 0 0.810485 1 no XLOC_000180 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000181 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 0 0 0.0696716 0 0.532365 1 no XLOC_000182 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000183 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000184 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000185 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000186 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000188 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000189 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000191 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000192 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts NOTEST 0 0 0.333098 0 0.05103 1 no XLOC_000193 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000194 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000195 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000196 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000197 XLOC_000197 - chr1:24526729-24538180 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000198 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000199 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_000200 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts NOTEST 0 0 0.247561 0 0.126505 1 no XLOC_000201 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_000202 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts NOTEST 0 0 0.296406 0 0.109695 1 no XLOC_001217 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0.0911117 0 0.022645 1 no XLOC_001218 XLOC_001218 - chr1:34611-36081 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001219 XLOC_001219 - chr1:89294-237877 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001222 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0.056406 0 0.61975 1 no XLOC_001227 XLOC_001227 - chr1:700236-714006 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001229 XLOC_001229 FAM41C chr1:803452-812182 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001230 XLOC_001230 - chr1:852952-854817 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001231 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0.0540959 0 0.371335 1 no XLOC_001232 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001233 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001234 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 0 0.178591 0 0.40399 1 no XLOC_001235 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001236 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts NOTEST 0 0 0.338716 0 0.01216 1 no XLOC_001237 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001238 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0.195631 0 0.178315 1 no XLOC_001239 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001240 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 0 0.0209021 0 0.707125 1 no XLOC_001242 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.282119 0 0.28495 1 no XLOC_001243 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.00305798 0 0.920685 1 no XLOC_001244 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 hESC Fibroblasts NOTEST 0 0 0.219069 0 0.124295 1 no XLOC_001245 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts NOTEST 0 0 0.201633 0 0.015185 1 no XLOC_001246 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts NOTEST 0 0 0.0528814 0 0.583925 1 no XLOC_001247 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts NOTEST 0 0 0.123641 0 0.58578 1 no XLOC_001248 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001249 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001250 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001251 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001252 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.133866 0 0.87048 1 no XLOC_001253 XLOC_001253 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001254 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.113977 0 0.633615 1 no XLOC_001256 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0.448973 0 1e-05 1 no XLOC_001257 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001258 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts NOTEST 0 0 0.602025 0 1e-05 1 no XLOC_001259 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001260 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001261 XLOC_001261 - chr1:1944651-1946969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001262 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001263 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0.0347763 0 0.483045 1 no XLOC_001264 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001266 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001267 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001268 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001269 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001270 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001271 XLOC_001271 - chr1:2976182-2980350 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001272 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001273 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts NOTEST 0 0 0.294767 0 0.03039 1 no XLOC_001274 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001275 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts NOTEST 0 0 0.128821 0 0.26272 1 no XLOC_001276 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001277 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001278 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001279 XLOC_001279 - chr1:5621768-5728315 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001280 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts NOTEST 0 0 0.1042 0 0.257785 1 no XLOC_001281 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001282 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001283 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001284 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001285 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 0 0 0 0 0 1 no XLOC_001286 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001287 XLOC_001287 PLEKHG5,TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0.4099 0 0.115875 1 no XLOC_001288 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001289 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts NOTEST 0 0 0.111853 0 0.34003 1 no XLOC_001290 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001291 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001292 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001293 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts NOTEST 0 0 0.0282153 0 0.682365 1 no XLOC_001294 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0.402824 0 0.040425 1 no XLOC_001296 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 0 0 0.00922792 0 0.675705 1 no XLOC_001297 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001298 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001299 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001300 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001301 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001302 XLOC_001302 - chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001303 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0.0664311 0 0.468125 1 no XLOC_001304 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001305 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001306 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001307 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts NOTEST 0 0 0.216519 0 0.259205 1 no XLOC_001308 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001309 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001310 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 0 0 0.176795 0 0.1057 1 no XLOC_001311 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001312 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0.0753864 0 0.34972 1 no XLOC_001313 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001314 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001315 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 0 0 0.0543523 0 0.80737 1 no XLOC_001316 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001317 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001318 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001319 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts NOTEST 0 0 0.186276 0 0.341435 1 no XLOC_001320 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001321 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001322 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001323 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001324 XLOC_001324 PRAMEF5,PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001326 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001327 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001328 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001329 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001330 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001331 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001332 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001333 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001334 XLOC_001334 C1orf126 chr1:14925212-15478960 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001335 XLOC_001335 - chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001336 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts NOTEST 0 0 0.205401 0 0.28148 1 no XLOC_001337 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001339 XLOC_001339 - chr1:16160709-16266950 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001340 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001342 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0.0360903 0 0.869845 1 no XLOC_001343 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001344 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001345 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts NOTEST 0 0 0.497131 0 0.000615 1 no XLOC_001346 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001347 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts NOTEST 0 0 0.0738089 0 0.287245 1 no XLOC_001348 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001349 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts NOTEST 0 0 0.0375043 0 0.931205 1 no XLOC_001350 XLOC_001350 - chr1:16860385-16864669 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001352 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 0 0 0.0769183 0 0.589545 1 no XLOC_001353 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts NOTEST 0 0 0.251984 0 0.28754 1 no XLOC_001354 XLOC_001354 ESPN,ESPNP chr1:17017712-17046652 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001355 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001356 XLOC_001356 - chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001357 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts NOTEST 0 0 0.0796304 0 0.290065 1 no XLOC_001358 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts NOTEST 0 0 0.136982 0 0.049435 1 no XLOC_001359 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001360 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001362 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts NOTEST 0 0 0.0639282 0 0.29162 1 no XLOC_001363 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001364 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts NOTEST 0 0 0.071337 0 0.294335 1 no XLOC_001365 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001366 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0.24532 0 0.2173 1 no XLOC_001367 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts NOTEST 0 0 0.0642029 0 0.391225 1 no XLOC_001368 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001369 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001370 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001371 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0.0382553 0 0.04711 1 no XLOC_001373 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 0 0 0.183724 0 0.38696 1 no XLOC_001375 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001376 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001377 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001378 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001379 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001380 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts NOTEST 0 0 0.208449 0 0.226305 1 no XLOC_001381 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001382 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001383 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 0 0 0.48778 0 0.048035 1 no XLOC_001384 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 0 0 0.0665169 0 0.4657 1 no XLOC_001385 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0.280589 0 0.230215 1 no XLOC_001386 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0.356398 0 0.000295 1 no XLOC_001387 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 0 0 0.136925 0 0.529035 1 no XLOC_001389 XLOC_001389 - chr1:21749600-21754300 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001390 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 0 0 0.532915 0 0.000385 1 no XLOC_001391 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0.0569105 0 0.62798 1 no XLOC_001392 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0.136747 0 0.301825 1 no XLOC_001393 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001394 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001395 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001397 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001398 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0.352072 0 0.008345 1 no XLOC_001399 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts NOTEST 0 0 0.514712 0 0.12707 1 no XLOC_001400 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0.182368 0 0.00488 1 no XLOC_001402 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001403 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001404 XLOC_001404 - chr1:24069855-24104777 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001405 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0.202196 0 0.363395 1 no XLOC_001406 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts NOTEST 0 0 0.110936 0 0.017435 1 no XLOC_001407 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001408 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001409 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001410 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001411 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no XLOC_001412 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no XLOC_001414 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0.189594 0 0.25562 1 no cummeRbund/inst/extdata/read_groups.info0000644000175200017520000000062214516004263021474 0ustar00biocbuildbiocbuildfile condition replicate_num total_mass norm_mass internal_scale external_scale iPS_rep1.bam iPS 0 173431 706934 0.958068 0.584877 iPS_rep2.bam iPS 1 173007 706934 1.03797 0.584877 H1_rep1.bam hESC 0 754749 706934 0.989851 1.51306 H1_rep3.bam hESC 1 762643 706934 1.01025 1.51306 NHLF_rep1.bam Fibroblasts 0 876775 706934 0.840416 1.22324 NHLF_rep2.bam Fibroblasts 1 1.41213e+06 706934 1.19847 1.22324 cummeRbund/inst/extdata/run.info0000644000175200017520000000034214516004263017765 0ustar00biocbuildbiocbuildparam value cmd_line cuffdiff -L iPS,hESC,Fibroblasts -p 6 chr1_snippet.gtf -o iPS_hESC_fibro iPS_rep1.bam,iPS_rep2.bam H1_rep1.bam,H1_rep3.bam NHLF_rep1.bam,NHLF_rep2.bam version 1.4.0 SVN_revision 3285 boost_version 104900 cummeRbund/inst/extdata/splicing.diff0000644000175200017520000052071414516004263020760 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 sqrt(JS) test_stat p_value q_value significant TSS1 XLOC_000001 - chr1:11873-29961 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS10 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC NOTEST 0 0 0 0 1 1 no TSS100 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0.0211379 0 0.876585 1 no TSS101 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0 0 1 1 no TSS102 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0 0 1 1 no TSS103 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS104 XLOC_000074 - chr1:6845383-7829763 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS105 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC NOTEST 0 0 0 0 1 1 no TSS106 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0.268587 0 0.40572 1 no TSS107 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0.264194 0 0.210235 1 no TSS108 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC NOTEST 0 0 0.13201 0 0.211715 1 no TSS109 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC NOTEST 0 0 0 0 1 1 no TSS11 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC NOTEST 0 0 0 0 1 1 no TSS110 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC NOTEST 0 0 0 0 1 1 no TSS111 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS112 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC NOTEST 0 0 0 0 1 1 no TSS113 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC NOTEST 0 0 0 0 1 1 no TSS114 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC NOTEST 0 0 0 0 1 1 no TSS115 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC NOTEST 0 0 0.183718 0 0.18844 1 no TSS116 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC NOTEST 0 0 0.0915306 0 0.224695 1 no TSS117 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no TSS118 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no TSS119 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no TSS12 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC NOTEST 0 0 0 0 1 1 no TSS120 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC NOTEST 0 0 0 0 1 1 no TSS121 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC NOTEST 0 0 0 0 1 1 no TSS122 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC NOTEST 0 0 0.0258515 0 0.570155 1 no TSS123 XLOC_000087 - chr1:10093015-10241294 iPS hESC NOTEST 0 0 0 0 1 1 no TSS124 XLOC_000087 - chr1:10093015-10241294 iPS hESC NOTEST 0 0 0 0 1 1 no TSS125 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0.102676 0 0.039165 1 no TSS126 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS127 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 0 0 0 1 1 no TSS128 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC NOTEST 0 0 0.00553365 0 0.89069 1 no TSS129 XLOC_000090 APITD1,Cort chr1:10490158-10512208 iPS hESC NOTEST 0 0 0.172765 0 0.418265 1 no TSS13 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC NOTEST 0 0 0 0 1 1 no TSS130 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC NOTEST 0 0 0 0 1 1 no TSS131 XLOC_000090 CORT chr1:10490158-10512208 iPS hESC NOTEST 0 0 0 0 1 1 no TSS132 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0.187348 0 0.149225 1 no TSS133 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS134 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC NOTEST 0 0 0.0022836 0 0.937575 1 no TSS135 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC NOTEST 0 0 0 0 1 1 no TSS136 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC NOTEST 0 0 0 0 1 1 no TSS137 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC NOTEST 0 0 0.323068 0 0.185285 1 no TSS138 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS139 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0 0 1 1 no TSS14 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC NOTEST 0 0 0.412453 0 1e-05 1 no TSS140 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0.273673 0 0.169505 1 no TSS141 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC NOTEST 0 0 0 0 1 1 no TSS142 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC NOTEST 0 0 0 0 1 1 no TSS143 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC NOTEST 0 0 0.194019 0 0.00043 1 no TSS144 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS145 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS146 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS147 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC NOTEST 0 0 0.0819049 0 0.59011 1 no TSS148 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no TSS149 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC NOTEST 0 0 0.0630176 0 0.34135 1 no TSS15 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC NOTEST 0 0 0 0 1 1 no TSS150 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC NOTEST 0 0 0.056669 0 0.434835 1 no TSS151 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC NOTEST 0 0 0 0 1 1 no TSS152 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 0 0 0.0771635 0 0.393765 1 no TSS153 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS154 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC NOTEST 0 0 0.672685 0 1e-05 1 no TSS155 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC NOTEST 0 0 0 0 1 1 no TSS156 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC NOTEST 0 0 0 0 1 1 no TSS157 XLOC_000109 - chr1:12290112-12572096 iPS hESC NOTEST 0 0 0 0 1 1 no TSS158 XLOC_000109 - chr1:12290112-12572096 iPS hESC NOTEST 0 0 0 0 1 1 no TSS159 XLOC_000109 - chr1:12290112-12572096 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS16 XLOC_000019 AGRN chr1:955502-991492 iPS hESC NOTEST 0 0 0 0 1 1 no TSS160 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS161 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC NOTEST 0 0 0 0 1 1 no TSS162 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS163 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS164 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS165 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS166 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS167 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS168 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS169 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS17 XLOC_000020 - chr1:995082-1001833 iPS hESC NOTEST 0 0 0 0 1 1 no TSS170 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS171 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS172 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS173 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS174 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS175 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS176 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0.0387091 0 0.45367 1 no TSS177 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS178 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS179 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0 0 0 1 1 no TSS18 XLOC_000021 - chr1:1072396-1079432 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS180 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0 0.327096 0 0.097115 1 no TSS181 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS182 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 0 0.103351 0 0.255485 1 no TSS183 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0.257998 0 0.00128 1 no TSS184 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0 0 1 1 no TSS185 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0 0 1 1 no TSS186 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0 0 1 1 no TSS187 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0 0 1 1 no TSS188 XLOC_000129 - chr1:14925212-15478960 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS189 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC NOTEST 0 0 0 0 1 1 no TSS19 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 0 0 0 1 1 no TSS190 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC NOTEST 0 0 0.334193 0 0.00014 1 no TSS1906 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1907 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1908 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1909 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0.369697 0 0.021985 1 no TSS191 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1910 XLOC_001217 - chr1:11873-29961 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1911 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1912 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1913 XLOC_001218 - chr1:34611-36081 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1914 XLOC_001219 - chr1:89294-237877 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1915 XLOC_001222 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1916 XLOC_001222 - chr1:661139-679736 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1917 XLOC_001222 - chr1:661139-679736 iPS hESC NOTEST 0 0 0.0717804 0 0.475955 1 no TSS1918 XLOC_001227 - chr1:700236-714006 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1919 XLOC_001229 FAM41C chr1:803452-812182 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS192 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1920 XLOC_001230 - chr1:852952-854817 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1921 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1922 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC NOTEST 0 0 0.158672 0 0.31093 1 no TSS1923 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1924 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1925 XLOC_001233 HES4 chr1:934341-935552 iPS hESC NOTEST 0 0 0.359776 0 0.00944 1 no TSS1926 XLOC_001234 - chr1:1017197-1051736 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1927 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 0 0 0.337219 0 0.331275 1 no TSS1928 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1929 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC NOTEST 0 0 0.659302 0 1e-05 1 no TSS193 XLOC_000131 - chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1930 XLOC_001235 - chr1:1108435-1133313 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1931 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1932 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC NOTEST 0 0 0.829258 0 0.043165 1 no TSS1933 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1934 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1935 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0.081921 0 0.04295 1 no TSS1936 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1937 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1938 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1939 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC NOTEST 0 0 0.0989015 0 0.345825 1 no TSS194 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1940 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1941 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1942 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1943 XLOC_001242 - chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1944 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1945 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.157049 0 0.059335 1 no TSS1946 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS hESC NOTEST 0 0 0.00646551 0 0.87479 1 no TSS1947 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1948 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1949 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 0 0 0.270455 0 0.23418 1 no TSS195 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1950 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1951 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1952 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC NOTEST 0 0 0.114402 0 0.473025 1 no TSS1953 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1954 XLOC_001247 - chr1:1321090-1334718 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1955 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1956 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1957 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC NOTEST 0 0 0.180081 0 0.243325 1 no TSS1958 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC NOTEST 0 0 0.0308089 0 0.5316 1 no TSS1959 XLOC_001249 - chr1:1353801-1356650 iPS hESC NOTEST 0 0 0.576691 0 0.005085 1 no TSS196 XLOC_000131 - chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1960 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1961 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC NOTEST 0 0 0.114708 0 0.14322 1 no TSS1962 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1963 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.41916 0 0.255885 1 no TSS1964 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.230234 0 0.469515 1 no TSS1965 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1966 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1967 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.0643822 0 0.78355 1 no TSS1968 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.372205 0 0.6247 1 no TSS1969 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS197 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1970 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.125677 0 0.8812 1 no TSS1971 XLOC_001254 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1972 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0.251646 0 0.340145 1 no TSS1973 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1974 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1975 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1976 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1977 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1978 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1979 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC NOTEST 0 0 0 0 1 1 no TSS198 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1980 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1981 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1982 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1983 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1984 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1985 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1986 XLOC_001261 - chr1:1944651-1946969 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1987 XLOC_001262 - chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1988 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC NOTEST 0 0 0.0846533 0 0.037385 1 no TSS1989 XLOC_001263 - chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS199 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1990 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC NOTEST 0 0 0.393115 0 0.224195 1 no TSS1991 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC NOTEST 0 0 0.0845185 0 0.144455 1 no TSS1992 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1993 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1994 XLOC_001269 - chr1:2481358-2495265 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1995 XLOC_001269 - chr1:2481358-2495265 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1996 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1997 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1998 XLOC_001271 - chr1:2976182-2980350 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS1999 XLOC_001272 - chr1:2980635-2984289 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2 XLOC_000005 - chr1:322036-328580 iPS hESC NOTEST 0 0 0 0 1 1 no TSS20 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS200 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2000 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2001 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2002 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC NOTEST 0 0 0.104323 0 0.371165 1 no TSS2003 XLOC_001275 - chr1:3652549-3663886 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2004 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2005 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2006 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC NOTEST 0 0 0.140323 0 0.33852 1 no TSS2007 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC NOTEST 0 0 0.0210241 0 0.70557 1 no TSS2008 XLOC_001279 - chr1:5621768-5728315 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2009 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC NOTEST 0 0 0 0 1 1 no TSS201 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC NOTEST 0 0 0.0951446 0 0.57789 1 no TSS2010 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2011 XLOC_001280 - chr1:5922869-6052531 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2012 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2013 XLOC_001281 - chr1:6161852-6240183 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2014 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2015 XLOC_001281 - chr1:6161852-6240183 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2016 XLOC_001281 - chr1:6161852-6240183 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2017 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC NOTEST 0 0 0.116079 0 0.14422 1 no TSS2018 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC NOTEST 0 0 0.0643001 0 0.197475 1 no TSS2019 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC NOTEST 0 0 0 0 1 1 no TSS202 XLOC_000136 - chr1:15853351-15918872 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2020 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2021 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2022 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2023 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2024 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 0 0 0 0 0 1 no TSS2025 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2026 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2027 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0.250741 0 0.39611 1 no TSS2028 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2029 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS203 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC NOTEST 0 0 0.152566 0 0.20298 1 no TSS2030 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2031 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2032 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2033 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2037 XLOC_001287 - chr1:6521220-6580069 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2038 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2039 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC NOTEST 0 0 0.593289 0 1e-05 1 no TSS204 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2040 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2041 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2042 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0.0157199 0 0.937335 1 no TSS2043 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2044 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2045 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2046 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2047 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2048 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2049 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0 0 1 1 no TSS205 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2050 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0.0764871 0 0.28653 1 no TSS2051 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2052 XLOC_001294 - chr1:8412465-8877699 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2053 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2054 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC NOTEST 0 0 0.315351 0 1e-05 1 no TSS2055 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2056 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2057 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2058 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2059 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0 0 0 1 1 no TSS206 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2060 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC NOTEST 0 0 0.216256 0 0.31636 1 no TSS2061 XLOC_001300 - chr1:9208346-9242451 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2062 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2063 XLOC_001302 - chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2064 XLOC_001303 - chr1:9711789-9884550 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2065 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC NOTEST 0 0 0.0350489 0 0.000795 1 no TSS2066 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC NOTEST 0 0 0.0366221 0 0.55356 1 no TSS2067 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2068 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 0 0 0.118152 0 0.27762 1 no TSS2069 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC NOTEST 0 0 0.109049 0 0.14633 1 no TSS207 XLOC_000140 - chr1:16062808-16067885 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2070 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC NOTEST 0 0 0.39066 0 0.130145 1 no TSS2071 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2072 XLOC_001307 - chr1:10696667-10856707 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2073 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2074 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC NOTEST 0 0 0.109305 0 0.27554 1 no TSS2075 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2076 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2077 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC NOTEST 0 0 0.0206372 0 0.69018 1 no TSS2078 XLOC_001312 - chr1:11166588-11322608 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2079 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC NOTEST 0 0 0 0 1 1 no TSS208 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2080 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2081 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2082 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC NOTEST 0 0 0.0421102 0 0.38465 1 no TSS2083 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2084 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2085 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2086 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2087 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2088 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC NOTEST 0 0 0.0703995 0 0.285055 1 no TSS2089 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 0 0 0 0 1 1 no TSS209 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2090 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 0 0 0.0660654 0 0.82193 1 no TSS2091 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2092 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2093 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2094 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2095 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2096 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2097 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2098 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2099 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS21 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 0 0 0 1 1 no TSS210 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2100 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2101 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2102 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2103 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2104 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2105 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2106 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2107 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2108 XLOC_001335 - chr1:15573767-15726776 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2109 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0.510594 0 8.5e-05 1 no TSS211 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC NOTEST 0 0 0.0342957 0 0.840185 1 no TSS2110 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2111 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2112 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2113 XLOC_001339 - chr1:16160709-16266950 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2114 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC NOTEST 0 0 0.175716 0 0.51362 1 no TSS2115 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 0 0 0.250888 0 0.00996 1 no TSS2116 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2117 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2118 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2119 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC NOTEST 0 0 0 0 1 1 no TSS212 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2120 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2121 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2122 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2123 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2124 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2125 XLOC_001347 - chr1:16576559-16678948 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2126 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2127 XLOC_001349 - chr1:16793930-16819196 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2128 XLOC_001349 - chr1:16793930-16819196 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2129 XLOC_001349 - chr1:16793930-16819196 iPS hESC NOTEST 0 0 0 0 1 1 no TSS213 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2130 XLOC_001350 - chr1:16860385-16864669 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2131 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 0 0 0.0678492 0 0.62932 1 no TSS2132 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 0 0 0.658572 0 0.00028 1 no TSS2133 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2134 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2135 XLOC_001353 - chr1:16944752-16971178 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2136 XLOC_001353 - chr1:16944752-16971178 iPS hESC NOTEST 0 0 0.324269 0 0.17392 1 no TSS2137 XLOC_001353 - chr1:16944752-16971178 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2138 XLOC_001353 - chr1:16944752-16971178 iPS hESC NOTEST 0 0 0.0370902 0 0.76341 1 no TSS2139 XLOC_001353 - chr1:16944752-16971178 iPS hESC NOTEST 0 0 0 0 1 1 no TSS214 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2140 XLOC_001354 ESPN chr1:17017712-17046652 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2141 XLOC_001354 ESPNP chr1:17017712-17046652 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2142 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2143 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2144 XLOC_001356 - chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2145 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0.00707395 0 0.93333 1 no TSS2146 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2147 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2148 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC NOTEST 0 0 0.0284805 0 0.906845 1 no TSS2149 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC NOTEST 0 0 0 0 1 1 no TSS215 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2150 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2151 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2152 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2153 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2154 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2155 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2156 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2157 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC NOTEST 0 0 0.0795253 0 0.63707 1 no TSS2158 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2159 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS216 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2160 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2161 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2162 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2163 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2164 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2165 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2166 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2167 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2168 XLOC_001366 - chr1:19398603-19536746 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2169 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS217 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2170 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2171 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC NOTEST 0 0 0.157958 0 0.11819 1 no TSS2172 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2173 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2174 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2175 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2176 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2177 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC NOTEST 0 0 0.0317637 0 0.4391 1 no TSS2178 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2179 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 0 0 0 1 1 no TSS218 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2180 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 0 0.22973 0 0.33679 1 no TSS2181 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2182 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2183 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2184 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC NOTEST 0 0 0.487915 0 0.054435 1 no TSS2185 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2186 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2187 XLOC_001379 - chr1:20687597-20755275 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2188 XLOC_001379 - chr1:20687597-20755275 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2189 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC NOTEST 0 0 0 0 1 1 no TSS219 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2190 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2191 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2192 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC NOTEST 0 0 0.0143634 0 0.730015 1 no TSS2193 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2194 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2195 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 0 0.212084 0 0.172305 1 no TSS2196 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 0 0 0.202001 0 0.01605 1 no TSS2197 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2198 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2199 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0 0 1 1 no TSS22 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC NOTEST 0 0 0.491298 0 0.25092 1 no TSS220 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC NOTEST 0 0 0.141045 0 0.35279 1 no TSS2200 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0.357938 0 0.178145 1 no TSS2201 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0.0896901 0 0.84745 1 no TSS2202 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2203 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2204 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0.0583895 0 0.29773 1 no TSS2205 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2206 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0.252446 0 0.110375 1 no TSS2207 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2208 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2209 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 0 0 0 1 1 no TSS221 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC NOTEST 0 0 0.486038 0 1e-05 1 no TSS2210 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2211 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 0 0.268779 0 0.21706 1 no TSS2212 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2213 XLOC_001389 - chr1:21749600-21754300 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2214 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2215 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2216 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 0 0 0.112415 0 0.512135 1 no TSS2217 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2218 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0.267024 0 0.072605 1 no TSS2219 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC NOTEST 0 0 0 0 1 1 no TSS222 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2220 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2221 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0.00883153 0 0.827865 1 no TSS2222 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2223 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2224 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2225 XLOC_001394 - chr1:23337326-23342343 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2226 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC NOTEST 0 0 0.130208 0 0.22231 1 no TSS2227 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2228 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 0 0 0.164491 0 0.251275 1 no TSS2229 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0 0 1 1 no TSS223 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2230 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2231 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 0 0.439869 0 0.082065 1 no TSS2232 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2233 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2234 XLOC_001400 - chr1:23755055-23811057 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2235 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0.0616249 0 0.52852 1 no TSS2236 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2237 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2238 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2239 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC NOTEST 0 0 0 0 1 1 no TSS224 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC NOTEST 0 0 0.123135 0 0.3834 1 no TSS2240 XLOC_001404 - chr1:24069855-24104777 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2241 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2242 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0.386481 0 0.44012 1 no TSS2243 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0.165495 0 0.36344 1 no TSS2244 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2245 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 0 0 0.230671 0 0.00231 1 no TSS2246 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2247 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC NOTEST 0 0 0.16314 0 0.08476 1 no TSS2248 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2249 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC NOTEST 0 0 0.254092 0 0.00986 1 no TSS225 XLOC_000150 - chr1:17066767-17299474 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2250 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2251 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2252 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2253 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2254 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2255 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2256 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC NOTEST 0 0 0.454255 0 0.073705 1 no TSS2257 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2258 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2259 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0.0900007 0 0.37357 1 no TSS226 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2260 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS2261 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no TSS227 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no TSS228 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no TSS229 XLOC_000150 - chr1:17066767-17299474 iPS hESC NOTEST 0 0 0 0 1 1 no TSS23 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0.0934827 0 0.57386 1 no TSS230 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS231 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS232 XLOC_000151 - chr1:17531620-17572501 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS233 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC NOTEST 0 0 0 0 1 1 no TSS234 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS235 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS236 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0.145343 0 0.35926 1 no TSS237 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no TSS238 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS239 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no TSS24 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC NOTEST 0 0 0 0 1 1 no TSS240 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no TSS241 XLOC_000155 - chr1:17866329-18024369 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS242 XLOC_000155 - chr1:17866329-18024369 iPS hESC NOTEST 0 0 0 0 1 1 no TSS243 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC NOTEST 0 0 0 0 1 1 no TSS244 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC NOTEST 0 0 0 0 1 1 no TSS245 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS246 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS247 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS248 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC NOTEST 0 0 0 0 1 1 no TSS249 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC NOTEST 0 0 0.255357 0 0.029705 1 no TSS25 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC NOTEST 0 0 0 0 1 1 no TSS250 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC NOTEST 0 0 0 0 1 1 no TSS251 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0.278073 0 1e-05 1 no TSS252 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS253 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0 0 1 1 no TSS254 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0 0 1 1 no TSS255 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC NOTEST 0 0 0 0 1 1 no TSS256 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC NOTEST 0 0 0 0 1 1 no TSS257 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS258 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0 0 0 0 1 1 no TSS259 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS26 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS260 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC NOTEST 0 0 0 0 1 1 no TSS261 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 0 0 0 1 1 no TSS262 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS263 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC NOTEST 0 0 0 0 1 1 no TSS264 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC NOTEST 0 0 0 0 1 1 no TSS265 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC NOTEST 0 0 0 0 1 1 no TSS266 XLOC_000173 - chr1:21543739-21672034 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS267 XLOC_000174 - chr1:21761832-21762609 iPS hESC NOTEST 0 0 0 0 1 1 no TSS268 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC NOTEST 0 0 0.25968 0 0.00276 1 no TSS269 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC NOTEST 0 0 0.0544696 0 0.70103 1 no TSS27 XLOC_000031 - chr1:1334909-1342693 iPS hESC NOTEST 0 0 0.169217 0 0.474915 1 no TSS270 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS271 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0 0 1 1 no TSS272 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC NOTEST 0 0 0 0 1 1 no TSS273 XLOC_000178 CELA3B chr1:22303417-22339033 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS274 XLOC_000178 CELA3A chr1:22303417-22339033 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS275 XLOC_000179 - chr1:22351706-22357713 iPS hESC NOTEST 0 0 0 0 1 1 no TSS276 XLOC_000179 - chr1:22351706-22357713 iPS hESC NOTEST 0 0 0 0 1 1 no TSS277 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC NOTEST 0 0 0.147999 0 0.327375 1 no TSS278 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 0 0 0.28868 0 0.040735 1 no TSS279 XLOC_000181 - chr1:22778343-22857650 iPS hESC NOTEST 0 0 0 0 1 1 no TSS28 XLOC_000032 - chr1:1361507-1363166 iPS hESC NOTEST 0 0 0 0 1 1 no TSS280 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC NOTEST 0 0 0.119115 0 0.203365 1 no TSS281 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS282 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS283 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS284 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS285 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC NOTEST 0 0 0.397897 0 1e-05 1 no TSS286 XLOC_000188 - chr1:23345940-23410184 iPS hESC NOTEST 0 0 0.0114635 0 0.75691 1 no TSS287 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 0 0 0 0 1 1 no TSS288 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS289 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS29 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC NOTEST 0 0 0.124414 0 0.380655 1 no TSS290 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC NOTEST 0 0 0.0985355 0 0.348365 1 no TSS291 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC NOTEST 0 0 0.0170772 0 0.35548 1 no TSS292 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC NOTEST 0 0 0 0 1 1 no TSS293 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC NOTEST 0 0 0.0139767 0 0.81161 1 no TSS294 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC NOTEST 0 0 0.375834 0 0.01035 1 no TSS295 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC NOTEST 0 0 0 0 1 1 no TSS296 XLOC_000197 - chr1:24526729-24538180 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS297 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 0 0 0 0 1 1 no TSS298 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS299 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 0 0 0.166145 0 0.01559 1 no TSS3 XLOC_000005 - chr1:322036-328580 iPS hESC NOTEST 0 0 0.487743 0 0.127385 1 no TSS30 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC NOTEST 0 0 0 0 1 1 no TSS300 XLOC_000199 - chr1:24742244-24799472 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS301 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC NOTEST 0 0 0 0 1 1 no TSS302 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC NOTEST 0 0 0.555561 0 0.19576 1 no TSS303 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS304 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0 0 0.00289836 0 0.35277 1 no TSS305 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0 0 0 0 1 1 no TSS306 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC NOTEST 0 0 0.132067 0 0.347165 1 no TSS31 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC NOTEST 0 0 0 0 1 1 no TSS32 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC NOTEST 0 0 0.125302 0 0.33148 1 no TSS33 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC NOTEST 0 0 0 0 1 1 no TSS34 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 0 0 0.00261763 0 0.94923 1 no TSS35 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 0 0 0 0 1 1 no TSS36 XLOC_000037 - chr1:1535818-1543166 iPS hESC NOTEST 0 0 0 0 1 1 no TSS37 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0.34721 0 0.17263 1 no TSS38 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0.389322 0 0.25963 1 no TSS39 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0 0 1 1 no TSS4 XLOC_000007 - chr1:420205-421839 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS40 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0 0 1 1 no TSS41 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 0 0 0 1 1 no TSS42 XLOC_000038 - chr1:1550883-1565984 iPS hESC NOTEST 0 0 0 0 1 1 no TSS43 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC NOTEST 0 0 0.247938 0 0.24984 1 no TSS44 XLOC_000039 - chr1:1567559-1570029 iPS hESC NOTEST 0 0 0 0 1 1 no TSS45 XLOC_000039 - chr1:1567559-1570029 iPS hESC NOTEST 0 0 0 0 1 1 no TSS46 XLOC_000040 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS47 XLOC_000040 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS48 XLOC_000041 - chr1:1571099-1677431 iPS hESC NOTEST 0 0 0 0 1 1 no TSS49 XLOC_000042 - chr1:1822909-1824112 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS5 XLOC_000012 - chr1:763063-789740 iPS hESC NOTEST 0 0 0.523158 0 1e-05 1 no TSS50 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC NOTEST 0 0 0 0 1 1 no TSS51 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC NOTEST 0 0 0 0 1 1 no TSS52 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS53 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS54 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS55 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS56 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS57 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS58 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS59 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC NOTEST 0 0 0 0 1 1 no TSS6 XLOC_000014 - chr1:846814-850328 iPS hESC NOTEST 0 0 0 0 1 1 no TSS60 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC NOTEST 0 0 0.00487698 0 0.91369 1 no TSS61 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS62 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS63 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS64 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC NOTEST 0 0 0.683988 0 0.001495 1 no TSS65 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0.142906 0 0.00749 1 no TSS66 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no TSS67 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS68 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 0 0 0 1 1 no TSS69 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 0 0 0 1 1 no TSS7 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC NOTEST 0 0 0 0 1 1 no TSS70 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 0 0 0 1 1 no TSS71 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC NOTEST 0 0 0 0 1 1 no TSS72 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC NOTEST 0 0 0 0 1 1 no TSS73 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 0 0 0 0 1 1 no TSS74 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS75 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS76 XLOC_000056 - chr1:3569128-3650467 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS77 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS78 XLOC_000058 - chr1:3689351-3692545 iPS hESC NOTEST 0 0 0 0 1 1 no TSS79 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS hESC NOTEST 0 0 0.228604 0 0.002495 1 no TSS8 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC NOTEST 0 0 0 0 1 1 no TSS80 XLOC_000060 - chr1:3816967-3833877 iPS hESC NOTEST 0 0 0.50561 0 0.23392 1 no TSS81 XLOC_000061 - chr1:4000676-4015322 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS82 XLOC_000062 - chr1:4472110-4484744 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS83 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC NOTEST 0 0 0.066936 0 0.66914 1 no TSS84 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 0 0 0 0 1 1 no TSS85 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 0 0 0.0535459 0 0.60038 1 no TSS86 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS87 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS88 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC NOTEST 0 0 0.0662524 0 0.8255 1 no TSS89 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC NOTEST 0 0 0 0 1 1 no TSS9 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC NOTEST 0 0 0 0 1 1 no TSS90 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC NOTEST 0 0 0 0 1 1 no TSS91 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS hESC NOTEST 0 0 0 0 1 1 no TSS92 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC NOTEST 0 0 0 0 1 1 no TSS93 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC NOTEST 0 0 0 0 1 1 no TSS94 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC NOTEST 0 0 0 0 1 1 no TSS95 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC LOWDATA 0 0 0 0 0 1 no TSS96 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC NOTEST 0 0 0.377351 0 0.10757 1 no TSS97 XLOC_000071 - chr1:6640055-6649339 iPS hESC NOTEST 0 0 0 0 1 1 no TSS98 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC NOTEST 0 0 0 0 1 1 no TSS99 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS10 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS100 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0.0341635 0 0.844245 1 no TSS101 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS102 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS103 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS104 XLOC_000074 - chr1:6845383-7829763 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS105 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS106 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0.140384 0 0.77673 1 no TSS107 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0.217694 0 0.275755 1 no TSS108 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts NOTEST 0 0 0.204456 0 0.162415 1 no TSS109 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS11 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS110 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS111 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS112 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS113 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS114 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS115 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts NOTEST 0 0 0.104138 0 0.268225 1 no TSS116 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts NOTEST 0 0 0.16801 0 0.192375 1 no TSS117 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS118 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS119 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS12 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS120 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS121 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS122 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0.0110891 0 0.88047 1 no TSS123 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS124 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS125 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0.273049 0 0.005705 1 no TSS126 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS127 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS128 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts NOTEST 0 0 0.0311199 0 0.7749 1 no TSS129 XLOC_000090 APITD1,Cort chr1:10490158-10512208 iPS Fibroblasts NOTEST 0 0 0.114728 0 0.90814 1 no TSS13 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS130 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS131 XLOC_000090 CORT chr1:10490158-10512208 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS132 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0.243997 0 0.347985 1 no TSS133 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS134 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts NOTEST 0 0 0.07386 0 0.155265 1 no TSS135 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS136 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS137 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 0 0 0.52776 0 0.160515 1 no TSS138 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS139 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS14 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts NOTEST 0 0 0.725236 0 0.007115 1 no TSS140 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0.465848 0 0.00264 1 no TSS141 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS142 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS143 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts NOTEST 0 0 0.232859 0 0.231025 1 no TSS144 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS145 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS146 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS147 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0.0537242 0 0.75532 1 no TSS148 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS149 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts NOTEST 0 0 0.0215808 0 0.756455 1 no TSS15 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS150 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts NOTEST 0 0 0.0699725 0 0.71547 1 no TSS151 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS152 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 0 0 0.18637 0 0.327115 1 no TSS153 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS154 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts NOTEST 0 0 0.742733 0 1e-05 1 no TSS155 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS156 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS157 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS158 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS159 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS16 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS160 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS161 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS162 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS163 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS164 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS165 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS166 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS167 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS168 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS169 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS17 XLOC_000020 - chr1:995082-1001833 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS170 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS171 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS172 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS173 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS174 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS175 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS176 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0.123411 0 0.35962 1 no TSS177 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS178 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS179 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS18 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS180 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0.624504 0 0.01057 1 no TSS181 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS182 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0.199306 0 0.3682 1 no TSS183 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0.570462 0 0.23943 1 no TSS184 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS185 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS186 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS187 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS188 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS189 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS19 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS190 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts NOTEST 0 0 0.195788 0 0.2354 1 no TSS1906 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1907 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1908 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1909 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0.456758 0 0.0027 1 no TSS191 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1910 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1911 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1912 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1913 XLOC_001218 - chr1:34611-36081 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1914 XLOC_001219 - chr1:89294-237877 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1915 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1916 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1917 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 0 0 0.0197572 0 0.91831 1 no TSS1918 XLOC_001227 - chr1:700236-714006 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1919 XLOC_001229 FAM41C chr1:803452-812182 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS192 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1920 XLOC_001230 - chr1:852952-854817 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1921 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1922 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0.18587 0 0.51126 1 no TSS1923 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1924 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1925 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts NOTEST 0 0 0.211385 0 0.26558 1 no TSS1926 XLOC_001234 - chr1:1017197-1051736 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1927 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 0 0.677664 0 0.11238 1 no TSS1928 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1929 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 0 0.618663 0 0.04948 1 no TSS193 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1930 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1931 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1932 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 0 0 0.019029 0 0.776065 1 no TSS1933 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1934 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1935 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0.0495307 0 0.44951 1 no TSS1936 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1937 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1938 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1939 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts NOTEST 0 0 0.143328 0 0.41654 1 no TSS194 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1940 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1941 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1942 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1943 XLOC_001242 - chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1944 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1945 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.213948 0 0.488095 1 no TSS1946 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS Fibroblasts NOTEST 0 0 0.0528124 0 0.806575 1 no TSS1947 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1948 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1949 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 0 0 0.111785 0 0.89515 1 no TSS195 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1950 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1951 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1952 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts NOTEST 0 0 0.0818559 0 0.778525 1 no TSS1953 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1954 XLOC_001247 - chr1:1321090-1334718 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1955 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1956 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1957 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts NOTEST 0 0 0.0617983 0 0.965175 1 no TSS1958 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts NOTEST 0 0 0.0824077 0 0.362555 1 no TSS1959 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts NOTEST 0 0 0.0358006 0 0.927845 1 no TSS196 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1960 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1961 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts NOTEST 0 0 0.126255 0 0.291715 1 no TSS1962 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1963 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.470062 0 0.505525 1 no TSS1964 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.214696 0 0.97309 1 no TSS1965 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1966 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1967 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.00815719 0 0.851825 1 no TSS1968 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.531644 0 0.58094 1 no TSS1969 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS197 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1970 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.299106 0 0.782635 1 no TSS1971 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1972 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0.253597 0 0.72058 1 no TSS1973 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1974 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1975 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0.257994 0 0.166965 1 no TSS1976 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1977 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1978 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1979 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS198 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1980 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1981 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1982 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1983 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1984 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1985 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1986 XLOC_001261 - chr1:1944651-1946969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1987 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1988 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0.0976761 0 0.244325 1 no TSS1989 XLOC_001263 - chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS199 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1990 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts NOTEST 0 0 0.10219 0 0.93096 1 no TSS1991 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts NOTEST 0 0 0.0952529 0 0.352785 1 no TSS1992 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1993 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1994 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1995 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1996 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1997 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1998 XLOC_001271 - chr1:2976182-2980350 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1999 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS20 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS200 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2000 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2001 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2002 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts NOTEST 0 0 0.0901444 0 0.764615 1 no TSS2003 XLOC_001275 - chr1:3652549-3663886 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2004 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2005 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2006 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts NOTEST 0 0 0.121673 0 0.66676 1 no TSS2007 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts NOTEST 0 0 0.0815575 0 0.40338 1 no TSS2008 XLOC_001279 - chr1:5621768-5728315 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2009 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS201 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts NOTEST 0 0 0.196719 0 0.39904 1 no TSS2010 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2011 XLOC_001280 - chr1:5922869-6052531 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2012 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2013 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2014 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2015 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2016 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2017 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts NOTEST 0 0 0.149426 0 0.21832 1 no TSS2018 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0.0556887 0 0.550075 1 no TSS2019 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS202 XLOC_000136 - chr1:15853351-15918872 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2020 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2021 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2022 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2023 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2024 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 0 0 0 0 0 1 no TSS2025 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2026 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2027 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0.150318 0 0.7872 1 no TSS2028 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2029 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS203 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts NOTEST 0 0 0.167874 0 0.18994 1 no TSS2030 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2031 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2032 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2033 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2037 XLOC_001287 - chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2038 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2039 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts NOTEST 0 0 0.6715 0 0.0289 1 no TSS204 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2040 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2041 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2042 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0.0335524 0 0.921025 1 no TSS2043 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2044 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2045 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2046 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2047 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2048 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2049 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS205 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2050 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts NOTEST 0 0 0.0781322 0 0.650845 1 no TSS2051 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2052 XLOC_001294 - chr1:8412465-8877699 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2053 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2054 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts NOTEST 0 0 0.368116 0 1e-05 1 no TSS2055 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2056 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2057 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2058 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2059 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS206 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2060 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts NOTEST 0 0 0.077175 0 0.78084 1 no TSS2061 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2062 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2063 XLOC_001302 - chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2064 XLOC_001303 - chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2065 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0.565944 0 0.00142 1 no TSS2066 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts NOTEST 0 0 0.0333383 0 0.76295 1 no TSS2067 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2068 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 0 0 0.031188 0 0.827635 1 no TSS2069 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts NOTEST 0 0 0.0822105 0 0.544345 1 no TSS207 XLOC_000140 - chr1:16062808-16067885 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2070 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 0 0 0.522503 0 0.220205 1 no TSS2071 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2072 XLOC_001307 - chr1:10696667-10856707 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2073 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2074 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts NOTEST 0 0 0.179742 0 0.13161 1 no TSS2075 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2076 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2077 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts NOTEST 0 0 0.0779966 0 0.46512 1 no TSS2078 XLOC_001312 - chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2079 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS208 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2080 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2081 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2082 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts NOTEST 0 0 0.144834 0 0.346575 1 no TSS2083 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2084 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2085 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2086 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2087 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2088 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts NOTEST 0 0 0.128194 0 0.371025 1 no TSS2089 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS209 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2090 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts NOTEST 0 0 0.169148 0 0.346535 1 no TSS2091 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2092 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2093 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2094 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2095 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2096 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2097 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2098 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2099 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS21 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS210 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2100 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2101 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2102 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2103 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2104 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2105 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2106 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2107 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2108 XLOC_001335 - chr1:15573767-15726776 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2109 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0.529632 0 0.02898 1 no TSS211 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts NOTEST 0 0 0.172989 0 0.6006 1 no TSS2110 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2111 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2112 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2113 XLOC_001339 - chr1:16160709-16266950 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2114 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts NOTEST 0 0 0.245289 0 0.5482 1 no TSS2115 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0.264328 0 0.31192 1 no TSS2116 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2117 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2118 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2119 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts NOTEST 0 0 0.291307 0 0.34287 1 no TSS212 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2120 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2121 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2122 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2123 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2124 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2125 XLOC_001347 - chr1:16576559-16678948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2126 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2127 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2128 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2129 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS213 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2130 XLOC_001350 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2131 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 0 0 0.191969 0 0.424665 1 no TSS2132 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 0 0 0.587289 0 0.18715 1 no TSS2133 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2134 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2135 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2136 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts NOTEST 0 0 0.322444 0 0.373925 1 no TSS2137 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2138 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts NOTEST 0 0 0.0309086 0 0.88792 1 no TSS2139 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS214 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2140 XLOC_001354 ESPN chr1:17017712-17046652 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2141 XLOC_001354 ESPNP chr1:17017712-17046652 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2142 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2143 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2144 XLOC_001356 - chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2145 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts NOTEST 0 0 0.00735726 0 0.94924 1 no TSS2146 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2147 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2148 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts NOTEST 0 0 0.0839775 0 0.834645 1 no TSS2149 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS215 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2150 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2151 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2152 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2153 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2154 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2155 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2156 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2157 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts NOTEST 0 0 0.172185 0 0.187115 1 no TSS2158 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2159 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS216 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2160 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2161 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2162 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2163 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2164 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2165 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2166 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2167 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2168 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2169 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS217 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2170 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2171 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts NOTEST 0 0 0.125519 0 0.53941 1 no TSS2172 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2173 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2174 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts NOTEST 0 0 0.140626 0 0.277495 1 no TSS2175 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2176 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2177 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts NOTEST 0 0 0.0134493 0 0.76085 1 no TSS2178 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2179 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS218 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2180 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0.407714 0 0.408945 1 no TSS2181 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2182 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2183 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2184 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts NOTEST 0 0 0.487915 0 0.054785 1 no TSS2185 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2186 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2187 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2188 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2189 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS219 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2190 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2191 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2192 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts NOTEST 0 0 0.0346222 0 0.64207 1 no TSS2193 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2194 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2195 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts NOTEST 0 0 0.176917 0 0.233085 1 no TSS2196 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts NOTEST 0 0 0.469461 0 0.082955 1 no TSS2197 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2198 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2199 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS22 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts NOTEST 0 0 0.432215 0 0.43067 1 no TSS220 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts NOTEST 0 0 0.0205459 0 0.997415 1 no TSS2200 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0.203031 0 0.716725 1 no TSS2201 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0.218373 0 0.5134 1 no TSS2202 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2203 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2204 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0.116417 0 0.48569 1 no TSS2205 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2206 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0.17418 0 0.42327 1 no TSS2207 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2208 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2209 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS221 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts NOTEST 0 0 0.497361 0 1e-05 1 no TSS2210 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2211 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts NOTEST 0 0 0.330362 0 0.42939 1 no TSS2212 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2213 XLOC_001389 - chr1:21749600-21754300 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2214 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2215 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2216 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 0 0 0.41442 0 0.427365 1 no TSS2217 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2218 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0.230207 0 0.388955 1 no TSS2219 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS222 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2220 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2221 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0.0360278 0 0.81437 1 no TSS2222 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2223 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2224 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2225 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2226 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts NOTEST 0 0 0.154511 0 0.16353 1 no TSS2227 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2228 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 0 0 0.154605 0 0.26487 1 no TSS2229 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS223 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2230 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2231 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts NOTEST 0 0 0.199347 0 0.37311 1 no TSS2232 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2233 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2234 XLOC_001400 - chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2235 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0.064403 0 0.672925 1 no TSS2236 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2237 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2238 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2239 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS224 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 0 0 0.0241727 0 0.89358 1 no TSS2240 XLOC_001404 - chr1:24069855-24104777 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2241 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2242 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0.625489 0 0.05952 1 no TSS2243 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0.0332754 0 0.98037 1 no TSS2244 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2245 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 0 0 0.197553 0 0.17324 1 no TSS2246 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2247 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts NOTEST 0 0 0.0724176 0 0.340225 1 no TSS2248 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2249 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts NOTEST 0 0 0.403611 0 0.00373 1 no TSS225 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2250 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2251 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2252 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2253 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2254 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2255 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2256 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts NOTEST 0 0 0.783948 0 0.06304 1 no TSS2257 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2258 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2259 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0.0739539 0 0.638715 1 no TSS226 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2260 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2261 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS227 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS228 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS229 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS23 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0.0475873 0 0.85517 1 no TSS230 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS231 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS232 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS233 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS234 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS235 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS236 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0.231217 0 0.592095 1 no TSS237 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0.689575 0 0.00207 1 no TSS238 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS239 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS24 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS240 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS241 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS242 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS243 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS244 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS245 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS246 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS247 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS248 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS249 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts NOTEST 0 0 0.149811 0 0.600075 1 no TSS25 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS250 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS251 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 0 0.675324 0 0.001015 1 no TSS252 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS253 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS254 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS255 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS256 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS257 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS258 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS259 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS26 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS260 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS261 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS262 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS263 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS264 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS265 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS266 XLOC_000173 - chr1:21543739-21672034 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS267 XLOC_000174 - chr1:21761832-21762609 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS268 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts NOTEST 0 0 0.11061 0 0.44223 1 no TSS269 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 0 0 0.103742 0 0.658615 1 no TSS27 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts NOTEST 0 0 0.287618 0 0.67939 1 no TSS270 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS271 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS272 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS273 XLOC_000178 CELA3B chr1:22303417-22339033 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS274 XLOC_000178 CELA3A chr1:22303417-22339033 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS275 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS276 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS277 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts NOTEST 0 0 0.162094 0 0.286585 1 no TSS278 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts NOTEST 0 0 0.0534101 0 0.705255 1 no TSS279 XLOC_000181 - chr1:22778343-22857650 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS28 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS280 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS281 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS282 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS283 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS284 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS285 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts NOTEST 0 0 0.242277 0 0.14798 1 no TSS286 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts NOTEST 0 0 0.0347587 0 0.6618 1 no TSS287 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS288 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS289 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS29 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts NOTEST 0 0 0.0651591 0 0.64526 1 no TSS290 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts NOTEST 0 0 0.0421705 0 0.813645 1 no TSS291 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts NOTEST 0 0 0.0270389 0 0.527535 1 no TSS292 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS293 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts NOTEST 0 0 0.0613136 0 0.610055 1 no TSS294 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts NOTEST 0 0 0.428229 0 0.00241 1 no TSS295 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS296 XLOC_000197 - chr1:24526729-24538180 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS297 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS298 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS299 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 0 0 0.156533 0 0.344565 1 no TSS3 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts NOTEST 0 0 0.142714 0 0.727635 1 no TSS30 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS300 XLOC_000199 - chr1:24742244-24799472 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS301 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS302 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts NOTEST 0 0 0.319346 0 0.70155 1 no TSS303 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS304 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts NOTEST 0 0 0.417394 0 0.00193 1 no TSS305 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS306 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts NOTEST 0 0 0.0855168 0 0.783665 1 no TSS31 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS32 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts NOTEST 0 0 0.0460379 0 0.82733 1 no TSS33 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS34 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts NOTEST 0 0 0.0268122 0 0.821435 1 no TSS35 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS36 XLOC_000037 - chr1:1535818-1543166 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS37 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0.451534 0 0.08361 1 no TSS38 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0.303024 0 0.53241 1 no TSS39 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS4 XLOC_000007 - chr1:420205-421839 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS40 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS41 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS42 XLOC_000038 - chr1:1550883-1565984 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS43 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts NOTEST 0 0 0.618706 0 0.02321 1 no TSS44 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS45 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS46 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS47 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS48 XLOC_000041 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS49 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS5 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts NOTEST 0 0 0.354786 0 0.2394 1 no TSS50 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS51 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS52 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS53 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS54 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS55 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS56 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS57 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS58 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS59 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS6 XLOC_000014 - chr1:846814-850328 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS60 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts NOTEST 0 0 0.00708065 0 0.9054 1 no TSS61 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS62 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS63 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS64 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts NOTEST 0 0 0.283271 0 0.382025 1 no TSS65 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0.0957397 0 0.43412 1 no TSS66 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS67 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS68 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS69 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS7 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS70 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS71 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS72 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts NOTEST 0 0 0.0513101 0 0.303625 1 no TSS73 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS74 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS75 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS76 XLOC_000056 - chr1:3569128-3650467 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS77 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS78 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS79 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS Fibroblasts NOTEST 0 0 0.128371 0 0.23564 1 no TSS8 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS80 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 0 0 0.564249 0 0.344835 1 no TSS81 XLOC_000061 - chr1:4000676-4015322 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS82 XLOC_000062 - chr1:4472110-4484744 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS83 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts NOTEST 0 0 0.306468 0 0.392075 1 no TSS84 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS85 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 0 0 0.0450101 0 0.79281 1 no TSS86 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS87 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS88 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0.106616 0 0.801085 1 no TSS89 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS9 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS90 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS91 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS92 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS93 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS94 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS95 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS96 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts NOTEST 0 0 0.306073 0 0.339325 1 no TSS97 XLOC_000071 - chr1:6640055-6649339 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS98 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS99 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS10 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS100 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0.0130364 0 0.899655 1 no TSS101 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS102 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS103 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS104 XLOC_000074 - chr1:6845383-7829763 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS105 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS106 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0.386984 0 0.394445 1 no TSS107 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0.443201 0 1e-05 1 no TSS108 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts NOTEST 0 0 0.083242 0 0.45034 1 no TSS109 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS11 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS110 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS111 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS112 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS113 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS114 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS115 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts NOTEST 0 0 0.0942014 0 0.608715 1 no TSS116 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts NOTEST 0 0 0.257423 0 0.03628 1 no TSS117 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS118 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS119 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS12 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS120 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS121 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS122 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts NOTEST 0 0 0.0368452 0 0.4788 1 no TSS123 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS124 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS125 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0.370209 0 0.00021 1 no TSS126 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS127 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS128 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts NOTEST 0 0 0.0366217 0 0.474145 1 no TSS129 XLOC_000090 APITD1,Cort chr1:10490158-10512208 hESC Fibroblasts NOTEST 0 0 0.269218 0 0.359645 1 no TSS13 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS130 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS131 XLOC_000090 CORT chr1:10490158-10512208 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS132 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0.226807 0 0.28464 1 no TSS133 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS134 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts NOTEST 0 0 0.0719575 0 0.02387 1 no TSS135 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS136 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS137 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts NOTEST 0 0 0.251518 0 0.120265 1 no TSS138 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS139 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS14 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts NOTEST 0 0 0.523776 0 0.061745 1 no TSS140 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0.36075 0 0.00924 1 no TSS141 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS142 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS143 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts NOTEST 0 0 0.106112 0 0.57251 1 no TSS144 XLOC_000101 C1orf167 chr1:11824461-11826573 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS145 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS146 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS147 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0.0285456 0 0.7923 1 no TSS148 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS149 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts NOTEST 0 0 0.0429804 0 0.46025 1 no TSS15 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS150 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts NOTEST 0 0 0.125546 0 0.302185 1 no TSS151 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS152 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 0 0 0.121149 0 0.24614 1 no TSS153 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS154 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts NOTEST 0 0 0.0964964 0 0.37265 1 no TSS155 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS156 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS157 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS158 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS159 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS16 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS160 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS161 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS162 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS163 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS164 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS165 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS166 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS167 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS168 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS169 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS17 XLOC_000020 - chr1:995082-1001833 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS170 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS171 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS172 XLOC_000123 PRAMEF10 chr1:13629937-13635298 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS173 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS174 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS175 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS176 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0.0849071 0 0.373645 1 no TSS177 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS178 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS179 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS18 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS180 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 0 0 0.348262 0 0.141645 1 no TSS181 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS182 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 0 0 0.22758 0 0.231495 1 no TSS183 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0.364727 0 0.323135 1 no TSS184 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS185 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS186 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS187 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS188 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS189 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS19 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS190 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts NOTEST 0 0 0.208638 0 0.23012 1 no TSS1906 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1907 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1908 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1909 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0.382837 0 0.038075 1 no TSS191 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1910 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1911 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1912 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1913 XLOC_001218 - chr1:34611-36081 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1914 XLOC_001219 - chr1:89294-237877 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1915 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1916 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1917 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts NOTEST 0 0 0.0520708 0 0.586955 1 no TSS1918 XLOC_001227 - chr1:700236-714006 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1919 XLOC_001229 FAM41C chr1:803452-812182 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS192 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1920 XLOC_001230 - chr1:852952-854817 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1921 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1922 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0.0426839 0 0.78421 1 no TSS1923 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1924 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1925 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts NOTEST 0 0 0.175202 0 0.381765 1 no TSS1926 XLOC_001234 - chr1:1017197-1051736 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1927 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 0 0.411974 0 0.22297 1 no TSS1928 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1929 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 0 0.336498 0 0.280145 1 no TSS193 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1930 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1931 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1932 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts NOTEST 0 0 0.832271 0 0.00448 1 no TSS1933 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1934 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1935 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0.0959186 0 0.38139 1 no TSS1936 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1937 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1938 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1939 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts NOTEST 0 0 0.0618127 0 0.951545 1 no TSS194 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1940 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1941 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1942 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1943 XLOC_001242 - chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1944 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1945 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.156799 0 0.55813 1 no TSS1946 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 hESC Fibroblasts NOTEST 0 0 0.0592425 0 0.78434 1 no TSS1947 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1948 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1949 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts NOTEST 0 0 0.334773 0 0.075605 1 no TSS195 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1950 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1951 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1952 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts NOTEST 0 0 0.0329465 0 0.780625 1 no TSS1953 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1954 XLOC_001247 - chr1:1321090-1334718 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1955 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1956 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1957 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts NOTEST 0 0 0.204204 0 0.30902 1 no TSS1958 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts NOTEST 0 0 0.0534642 0 0.310655 1 no TSS1959 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts NOTEST 0 0 0.572682 0 0.013205 1 no TSS196 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1960 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1961 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts NOTEST 0 0 0.0236269 0 0.779525 1 no TSS1962 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1963 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.06074 0 0.74277 1 no TSS1964 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.184337 0 0.49887 1 no TSS1965 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1966 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1967 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.0725202 0 0.75634 1 no TSS1968 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.177133 0 0.775265 1 no TSS1969 XLOC_001253 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS197 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1970 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.352521 0 0.422405 1 no TSS1971 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1972 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0.094929 0 0.70221 1 no TSS1973 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1974 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1975 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0.257994 0 0.166965 1 no TSS1976 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1977 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1978 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1979 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS198 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1980 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1981 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1982 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1983 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1984 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1985 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1986 XLOC_001261 - chr1:1944651-1946969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1987 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1988 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0.0736086 0 0.31358 1 no TSS1989 XLOC_001263 - chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS199 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1990 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts NOTEST 0 0 0.319761 0 0.388975 1 no TSS1991 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts NOTEST 0 0 0.0128738 0 0.82476 1 no TSS1992 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1993 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1994 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1995 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1996 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1997 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1998 XLOC_001271 - chr1:2976182-2980350 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS1999 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS20 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS200 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2000 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2001 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2002 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts NOTEST 0 0 0.186069 0 0.186645 1 no TSS2003 XLOC_001275 - chr1:3652549-3663886 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2004 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2005 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2006 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts NOTEST 0 0 0.0209725 0 0.95846 1 no TSS2007 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts NOTEST 0 0 0.0620043 0 0.31238 1 no TSS2008 XLOC_001279 - chr1:5621768-5728315 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2009 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS201 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts NOTEST 0 0 0.122642 0 0.479875 1 no TSS2010 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2011 XLOC_001280 - chr1:5922869-6052531 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2012 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2013 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2014 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2015 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2016 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2017 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts NOTEST 0 0 0.255149 0 0.043565 1 no TSS2018 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0.00866684 0 0.85155 1 no TSS2019 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS202 XLOC_000136 - chr1:15853351-15918872 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2020 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2021 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2022 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2023 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2024 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 0 0 0 0 0 1 no TSS2025 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2026 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2027 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0.253868 0 0.42442 1 no TSS2028 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2029 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS203 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts NOTEST 0 0 0.0210319 0 0.714485 1 no TSS2030 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2031 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2032 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2033 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2037 XLOC_001287 - chr1:6521220-6580069 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2038 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2039 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts NOTEST 0 0 0.0988315 0 0.32745 1 no TSS204 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2040 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2041 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2042 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0.0263665 0 0.873175 1 no TSS2043 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2044 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2045 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2046 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2047 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2048 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2049 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS205 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2050 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0.00169239 0 0.905155 1 no TSS2051 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2052 XLOC_001294 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2053 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2054 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts NOTEST 0 0 0.0878021 0 0.17578 1 no TSS2055 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2056 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2057 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2058 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2059 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS206 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2060 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts NOTEST 0 0 0.141267 0 0.3472 1 no TSS2061 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2062 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2063 XLOC_001302 - chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2064 XLOC_001303 - chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2065 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0 0 0.574418 0 0.00123 1 no TSS2066 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts NOTEST 0 0 0.00328878 0 0.95545 1 no TSS2067 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2068 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 0 0 0.148892 0 0.15271 1 no TSS2069 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts NOTEST 0 0 0.0270079 0 0.74248 1 no TSS207 XLOC_000140 - chr1:16062808-16067885 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2070 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts NOTEST 0 0 0.147079 0 0.381795 1 no TSS2071 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2072 XLOC_001307 - chr1:10696667-10856707 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2073 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2074 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts NOTEST 0 0 0.271794 0 5.5e-05 1 no TSS2075 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2076 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2077 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts NOTEST 0 0 0.0578784 0 0.35525 1 no TSS2078 XLOC_001312 - chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2079 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS208 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2080 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2081 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2082 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts NOTEST 0 0 0.105244 0 0.31036 1 no TSS2083 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2084 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2085 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2086 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2087 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2088 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts NOTEST 0 0 0.0586784 0 0.423535 1 no TSS2089 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS209 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2090 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts NOTEST 0 0 0.189171 0 0.06044 1 no TSS2091 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2092 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2093 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2094 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2095 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2096 XLOC_001324 PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2097 XLOC_001324 PRAMEF5 chr1:12998301-13117751 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2098 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2099 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS21 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS210 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2100 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2101 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2102 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2103 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2104 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2105 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2106 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2107 XLOC_001334 C1orf126 chr1:14925212-15478960 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2108 XLOC_001335 - chr1:15573767-15726776 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2109 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts NOTEST 0 0 0.072083 0 0.79276 1 no TSS211 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts NOTEST 0 0 0.205239 0 0.456285 1 no TSS2110 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2111 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2112 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2113 XLOC_001339 - chr1:16160709-16266950 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2114 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts NOTEST 0 0 0.13745 0 0.63909 1 no TSS2115 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0.346472 0 0.19567 1 no TSS2116 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2117 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2118 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2119 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts NOTEST 0 0 0.291307 0 0.164415 1 no TSS212 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2120 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2121 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2122 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2123 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2124 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2125 XLOC_001347 - chr1:16576559-16678948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2126 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2127 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2128 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2129 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS213 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2130 XLOC_001350 - chr1:16860385-16864669 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2131 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 0 0 0.152462 0 0.324125 1 no TSS2132 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 0 0 0.0895015 0 0.61327 1 no TSS2133 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2134 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2135 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2136 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts NOTEST 0 0 0.00217467 0 0.966275 1 no TSS2137 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2138 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts NOTEST 0 0 0.0061896 0 0.930735 1 no TSS2139 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS214 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2140 XLOC_001354 ESPN chr1:17017712-17046652 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2141 XLOC_001354 ESPNP chr1:17017712-17046652 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2142 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2143 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2144 XLOC_001356 - chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2145 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts NOTEST 0 0 0.00028333 0 0.99579 1 no TSS2146 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2147 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2148 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts NOTEST 0 0 0.106172 0 0.531635 1 no TSS2149 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS215 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2150 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2151 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2152 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2153 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2154 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2155 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2156 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2157 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts NOTEST 0 0 0.105207 0 0.257235 1 no TSS2158 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2159 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS216 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2160 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2161 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2162 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2163 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2164 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2165 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2166 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2167 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2168 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2169 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS217 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2170 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2171 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts NOTEST 0 0 0.0973737 0 0.60607 1 no TSS2172 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2173 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2174 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts NOTEST 0 0 0.140626 0 0.277495 1 no TSS2175 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2176 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2177 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0.0187909 0 0.60693 1 no TSS2178 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2179 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS218 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2180 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 0 0 0.581516 0 0.078865 1 no TSS2181 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2182 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2183 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2184 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2185 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2186 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2187 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2188 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2189 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS219 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2190 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2191 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2192 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts NOTEST 0 0 0.0209844 0 0.64209 1 no TSS2193 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2194 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2195 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts NOTEST 0 0 0.357743 0 0.01365 1 no TSS2196 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 0 0 0.311235 0 0.171735 1 no TSS2197 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2198 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2199 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS22 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts NOTEST 0 0 0.0705941 0 0.59041 1 no TSS220 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0 0.127109 0 0.440345 1 no TSS2200 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0.520392 0 0.108855 1 no TSS2201 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0.217614 0 0.451045 1 no TSS2202 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2203 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2204 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0.158898 0 0.27791 1 no TSS2205 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2206 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0.0800314 0 0.385115 1 no TSS2207 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2208 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2209 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS221 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts NOTEST 0 0 0.144211 0 1e-05 1 no TSS2210 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2211 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 0 0 0.109133 0 0.80522 1 no TSS2212 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2213 XLOC_001389 - chr1:21749600-21754300 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2214 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2215 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2216 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 0 0 0.319799 0 0.251555 1 no TSS2217 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2218 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0.114474 0 0.572245 1 no TSS2219 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS222 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2220 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2221 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0.027209 0 0.580405 1 no TSS2222 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2223 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2224 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2225 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2226 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts NOTEST 0 0 0.100464 0 0.011245 1 no TSS2227 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2228 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 0 0 0.113768 0 0.102055 1 no TSS2229 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS223 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2230 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2231 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts NOTEST 0 0 0.294572 0 0.250115 1 no TSS2232 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2233 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2234 XLOC_001400 - chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2235 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0.00279996 0 0.967875 1 no TSS2236 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2237 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2238 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2239 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS224 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts NOTEST 0 0 0.146912 0 0.390335 1 no TSS2240 XLOC_001404 - chr1:24069855-24104777 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2241 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2242 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0.284904 0 0.521355 1 no TSS2243 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0.171927 0 0.36316 1 no TSS2244 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2245 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts NOTEST 0 0 0.10532 0 0.594375 1 no TSS2246 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2247 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts NOTEST 0 0 0.106203 0 0.49773 1 no TSS2248 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2249 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts NOTEST 0 0 0.161781 0 0.17407 1 no TSS225 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2250 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2251 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2252 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2253 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2254 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2255 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2256 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts NOTEST 0 0 0.663498 0 0.079455 1 no TSS2257 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2258 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2259 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0.0165942 0 0.829815 1 no TSS226 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2260 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS2261 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS227 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS228 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS229 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS23 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0.0461276 0 0.751385 1 no TSS230 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS231 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS232 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS233 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS234 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS235 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS236 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0.0873435 0 0.5539 1 no TSS237 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0.689575 0 0.00207 1 no TSS238 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS239 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS24 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS240 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS241 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS242 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS243 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS244 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS245 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS246 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS247 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS248 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS249 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts NOTEST 0 0 0.152636 0 0.451475 1 no TSS25 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS250 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS251 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 0 0 0.464093 0 0.00369 1 no TSS252 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS253 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS254 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS255 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS256 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS257 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS258 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS259 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS26 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS260 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS261 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS262 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS263 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS264 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS265 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS266 XLOC_000173 - chr1:21543739-21672034 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS267 XLOC_000174 - chr1:21761832-21762609 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS268 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts NOTEST 0 0 0.216288 0 0.24891 1 no TSS269 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts NOTEST 0 0 0.108548 0 0.236155 1 no TSS27 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts NOTEST 0 0 0.207584 0 0.43373 1 no TSS270 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS271 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS272 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS273 XLOC_000178 CELA3B chr1:22303417-22339033 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS274 XLOC_000178 CELA3A chr1:22303417-22339033 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS275 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS276 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS277 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts NOTEST 0 0 0.0552519 0 0.47217 1 no TSS278 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 0 0 0.333725 0 0.000115 1 no TSS279 XLOC_000181 - chr1:22778343-22857650 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS28 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS280 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS281 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS282 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS283 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS284 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS285 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts NOTEST 0 0 0.196149 0 0.23906 1 no TSS286 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts NOTEST 0 0 0.0233037 0 0.586485 1 no TSS287 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS288 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS289 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS29 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts NOTEST 0 0 0.0611071 0 0.629615 1 no TSS290 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts NOTEST 0 0 0.0567402 0 0.622 1 no TSS291 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts NOTEST 0 0 0.0103244 0 0.562515 1 no TSS292 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS293 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts NOTEST 0 0 0.0475124 0 0.49407 1 no TSS294 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts NOTEST 0 0 0.0640525 0 7.5e-05 1 no TSS295 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS296 XLOC_000197 - chr1:24526729-24538180 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS297 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS298 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS299 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts NOTEST 0 0 0.235704 0 0.20753 1 no TSS3 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts NOTEST 0 0 0.605562 0 0.035045 1 no TSS30 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS300 XLOC_000199 - chr1:24742244-24799472 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS301 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS302 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts NOTEST 0 0 0.448628 0 0.282905 1 no TSS303 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS304 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts NOTEST 0 0 0.417543 0 0.00192 1 no TSS305 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS306 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts NOTEST 0 0 0.214675 0 0.36433 1 no TSS31 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS32 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts NOTEST 0 0 0.170681 0 0.311525 1 no TSS33 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS34 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 0 0 0.0294213 0 0.66573 1 no TSS35 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS36 XLOC_000037 - chr1:1535818-1543166 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS37 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0.297496 0 0.08106 1 no TSS38 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0.0990022 0 0.661015 1 no TSS39 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS4 XLOC_000007 - chr1:420205-421839 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS40 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS41 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS42 XLOC_000038 - chr1:1550883-1565984 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS43 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts NOTEST 0 0 0.411554 0 0.153995 1 no TSS44 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS45 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS46 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS47 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS48 XLOC_000041 - chr1:1571099-1677431 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS49 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS5 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts NOTEST 0 0 0.222834 0 0.35282 1 no TSS50 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS51 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS52 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS53 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS54 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS55 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS56 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS57 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS58 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS59 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS6 XLOC_000014 - chr1:846814-850328 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS60 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts NOTEST 0 0 0.00220415 0 0.94103 1 no TSS61 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS62 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS63 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS64 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts NOTEST 0 0 0.681472 0 0.00016 1 no TSS65 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0.105561 0 0.45653 1 no TSS66 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS67 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS68 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS69 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS7 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS70 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS71 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS72 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts NOTEST 0 0 0.0513101 0 0.303625 1 no TSS73 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS74 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS75 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS76 XLOC_000056 - chr1:3569128-3650467 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS77 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS78 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS79 XLOC_000059 CAD,DFFB chr1:3773844-3801992 hESC Fibroblasts NOTEST 0 0 0.118496 0 0.298305 1 no TSS8 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS80 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts NOTEST 0 0 0.0699972 0 0.65481 1 no TSS81 XLOC_000061 - chr1:4000676-4015322 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS82 XLOC_000062 - chr1:4472110-4484744 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS83 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts NOTEST 0 0 0.242173 0 0.343475 1 no TSS84 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS85 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0 0 0.0979591 0 0.448595 1 no TSS86 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS87 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS88 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0.171679 0 0.689665 1 no TSS89 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS9 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS90 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS91 XLOC_000067 C1orf211 chr1:6297870-6299490 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS92 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS93 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS94 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS95 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts LOWDATA 0 0 0 0 0 1 no TSS96 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts NOTEST 0 0 0.147831 0 0.423185 1 no TSS97 XLOC_000071 - chr1:6640055-6649339 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS98 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS99 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no cummeRbund/inst/extdata/tss_group_exp.diff0000644000175200017520000070265714516004263022061 0ustar00biocbuildbiocbuildtest_id gene_id gene locus sample_1 sample_2 status value_1 value_2 log2(fold_change) test_stat p_value q_value significant TSS1 XLOC_000001 - chr1:11873-29961 iPS hESC NOTEST 20.2175 0.347386 -5.86292 0.713525 0.475521 1 no TSS10 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 63.5773 180.736 1.5073 -2.35201 0.0186723 0.0634957 no TSS100 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 34.9289 106.792 1.61231 -0.392535 0.694663 0.897878 no TSS101 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC OK 1275.04 1441.29 0.176821 -0.442029 0.658468 0.871916 no TSS102 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC OK 8.87986 26.1246 1.5568 -0.726538 0.467509 0.711118 no TSS103 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS hESC NOTEST 0 0 0 0 1 1 no TSS104 XLOC_000074 - chr1:6845383-7829763 iPS hESC NOTEST 1.762 0 -1.79769e+308 -1.79769e+308 0.464256 1 no TSS105 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS hESC NOTEST 1500.64 502.334 -1.57886 5.54278 2.9771e-08 1 no TSS106 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC OK 67.8365 7.32764 -3.21064 1.51024 0.130981 0.295904 no TSS107 XLOC_000076 PER3 chr1:7844379-7973294 iPS hESC NOTEST 223.621 110.54 -1.01649 2.30221 0.0213235 1 no TSS108 XLOC_000077 PARK7 chr1:8021713-8045341 iPS hESC OK 4677.15 8433.49 0.8505 -2.92244 0.00347301 0.0156105 yes TSS109 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 1.80448 29.7198 4.04176 -2.3049 0.0211723 0.0696275 no TSS11 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 55.6229 151.63 1.44681 -1.19456 0.23226 0.439804 no TSS110 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS hESC OK 9.62868 9.9298 0.0444265 -0.0464149 0.96298 0.999997 no TSS111 XLOC_000079 CA6 chr1:9005921-9035146 iPS hESC NOTEST 0 0 0 0 1 1 no TSS112 XLOC_000080 H6PD chr1:9294862-9331392 iPS hESC OK 137.324 93.0165 -0.562028 1.6203 0.105167 0.255349 no TSS113 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC OK 70.5381 18.3153 -1.94535 3.00918 0.00261955 0.012329 yes TSS114 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS hESC OK 17.2656 67.8157 1.97372 -1.56671 0.117183 0.275762 no TSS115 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS hESC OK 216.702 229.284 0.0814236 -0.182156 0.85546 0.984711 no TSS116 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS hESC OK 122.735 402.381 1.71301 -3.36739 0.000758831 0.00421249 yes TSS117 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 42.5258 260.118 2.61276 -2.1588 0.0308659 0.0959204 no TSS118 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 132.845 155.927 0.231123 -0.359322 0.719354 0.910761 no TSS119 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS hESC OK 17.0706 25.5368 0.581065 -0.3318 0.74004 0.927013 no TSS12 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 29.3795 229.433 2.96519 -2.42565 0.0152811 0.0539405 no TSS120 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS hESC OK 61.6068 39.4422 -0.643349 1.29478 0.195395 0.386329 no TSS121 XLOC_000086 RBP7 chr1:10057254-10076077 iPS hESC OK 115.178 229.575 0.995102 -1.81996 0.0687653 0.183799 no TSS122 XLOC_000087 UBE4B chr1:10093015-10241294 iPS hESC OK 531.227 1126.9 1.08496 -3.798 0.00014587 0.000997293 yes TSS123 XLOC_000087 - chr1:10093015-10241294 iPS hESC OK 171.613 10.087 -4.08858 0.965569 0.33426 0.566845 no TSS124 XLOC_000087 - chr1:10093015-10241294 iPS hESC OK 7.8499 10.3213 0.39488 -0.0346866 0.97233 0.999997 no TSS125 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 833.691 545.589 -0.611698 1.49076 0.136025 0.302902 no TSS126 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC NOTEST 0 1.09608 1.79769e+308 1.79769e+308 0.390853 1 no TSS127 XLOC_000088 KIF1B chr1:10270763-10441659 iPS hESC OK 76.9201 90.7558 0.238629 -0.227056 0.82038 0.967036 no TSS128 XLOC_000089 PGD chr1:10459084-10480200 iPS hESC OK 1416.9 7183.39 2.34193 -8.10241 4.44089e-16 3.20484e-14 yes TSS129 XLOC_000090 APITD1,Cort chr1:10490158-10512208 iPS hESC OK 78.5742 94.3083 0.263328 -0.223651 0.823029 0.967524 no TSS13 XLOC_000016 KLHL17 chr1:895966-901095 iPS hESC OK 34.9548 180.118 2.36538 -1.58829 0.112222 0.267479 no TSS130 XLOC_000090 APITD1 chr1:10490158-10512208 iPS hESC OK 172.607 138.152 -0.321231 0.570177 0.568558 0.795149 no TSS131 XLOC_000090 CORT chr1:10490158-10512208 iPS hESC OK 33.6985 27.3151 -0.302989 0.180451 0.856799 0.984711 no TSS132 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS hESC OK 252.617 678.266 1.4249 -2.04944 0.0404188 0.120422 no TSS133 XLOC_000091 PEX14 chr1:10535002-10690813 iPS hESC NOTEST 0 0 0 0 1 1 no TSS134 XLOC_000092 TARDBP chr1:11072678-11085548 iPS hESC NOTEST 1918.99 2401.2 0.323411 -1.5344 0.124931 1 no TSS135 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS hESC OK 25.3243 0.912846 -4.794 0.836862 0.40267 0.638977 no TSS136 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS hESC OK 358.008 307.383 -0.219953 0.645793 0.518413 0.749787 no TSS137 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC OK 37.3062 74.4396 0.996656 -0.974436 0.32984 0.563025 no TSS138 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS hESC NOTEST 12.3118 0 -1.79769e+308 -1.79769e+308 0.121771 1 no TSS139 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 0 18.7336 1.79769e+308 1.79769e+308 0.0417729 0.123606 no TSS14 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS hESC OK 6.18615 22.784 1.8809 -2.43828 0.0147571 0.0528086 no TSS140 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS hESC OK 170.98 540.251 1.6598 -1.90077 0.0573322 0.157615 no TSS141 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS hESC OK 77.8716 25.5712 -1.60658 2.97333 0.00294584 0.0137241 yes TSS142 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS hESC OK 200.894 340.257 0.760192 -1.7535 0.079517 0.206999 no TSS143 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS hESC OK 747.942 1610.7 1.10669 -2.58047 0.00986669 0.0379196 yes TSS144 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS hESC NOTEST 4.69748 3.47934 -0.433073 0.2486 0.80367 1 no TSS145 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 0 2.18711 1.79769e+308 1.79769e+308 0.240981 1 no TSS146 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS hESC NOTEST 1.75837 2.17987 0.310008 -0.0426967 0.965943 1 no TSS147 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS hESC OK 149.528 357.971 1.25943 -1.14988 0.250195 0.464955 no TSS148 XLOC_000103 - chr1:11866206-11907840 iPS hESC NOTEST 6.40643 8.28757 0.37143 -0.0794473 0.936677 1 no TSS149 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS hESC OK 865.542 956.552 0.144239 -0.492575 0.622313 0.841191 no TSS15 XLOC_000018 ISG15 chr1:948846-949915 iPS hESC OK 550.84 987.18 0.84168 -1.85219 0.0639988 0.173197 no TSS150 XLOC_000105 MFN2 chr1:12040237-12073571 iPS hESC OK 647.078 942.066 0.541888 -2.00047 0.0454496 0.130042 no TSS151 XLOC_000106 MIIP chr1:12079511-12092106 iPS hESC OK 504.143 1223.51 1.27913 -3.41913 0.000628221 0.00354808 yes TSS152 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC OK 197.882 431.964 1.12628 -2.81252 0.00491544 0.0206639 yes TSS153 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS hESC NOTEST 6.44015 9.03791 0.488895 -0.0758044 0.939575 1 no TSS154 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS hESC OK 15.3506 33.8648 1.14149 -2.08339 0.0372158 0.112689 no TSS155 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 328.032 71.9285 -2.1892 8.15805 4.44089e-16 3.20484e-14 yes TSS156 XLOC_000109 VPS13D chr1:12290112-12572096 iPS hESC OK 19.4784 66.1936 1.76482 -1.4902 0.136171 0.302902 no TSS157 XLOC_000109 - chr1:12290112-12572096 iPS hESC OK 39.9995 0 -1.79769e+308 -1.79769e+308 0.188331 0.376952 no TSS158 XLOC_000109 - chr1:12290112-12572096 iPS hESC OK 0 20.135 1.79769e+308 1.79769e+308 0.00200718 0.00962111 yes TSS159 XLOC_000109 - chr1:12290112-12572096 iPS hESC NOTEST 0 4.58204 1.79769e+308 1.79769e+308 0.140422 1 no TSS16 XLOC_000019 AGRN chr1:955502-991492 iPS hESC OK 162.844 1857.6 3.51188 -10.5984 0 0 yes TSS160 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS hESC NOTEST 0.911079 1.34969 0.566981 -0.252834 0.800396 1 no TSS161 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS hESC OK 56.4313 10.0548 -2.48861 4.5299 5.9011e-06 5.72054e-05 yes TSS162 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS hESC NOTEST 1.78177 1.29047 -0.465419 0.106597 0.915109 1 no TSS163 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS hESC NOTEST 3.60576 0.853096 -2.07952 1.38146 0.167139 1 no TSS164 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS hESC NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TSS165 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS hESC NOTEST 0 0 0 0 1 1 no TSS166 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS hESC NOTEST 0 0 0 0 1 1 no TSS167 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS hESC NOTEST 0 0 0 0 1 1 no TSS168 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS hESC NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no TSS169 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TSS17 XLOC_000020 - chr1:995082-1001833 iPS hESC OK 22.5944 32.064 0.504988 -0.666955 0.504801 0.739274 no TSS170 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS hESC NOTEST 0 0 0 0 1 1 no TSS171 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS hESC NOTEST 0 0 0 0 1 1 no TSS172 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS hESC NOTEST 0 0 0 0 1 1 no TSS173 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS hESC NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TSS174 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS hESC NOTEST 0 0.330232 1.79769e+308 1.79769e+308 0.240869 1 no TSS175 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS hESC NOTEST 0 0 0 0 1 1 no TSS176 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC OK 1297.74 1696.44 0.386516 -1.26737 0.205024 0.398096 no TSS177 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 6.91549 1.79769e+308 1.79769e+308 0.25743 1 no TSS178 XLOC_000127 PDPN chr1:13910251-13944450 iPS hESC NOTEST 0 0 0 0 1 1 no TSS179 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 0 12.8679 1.79769e+308 1.79769e+308 0.0262866 0.0828793 no TSS18 XLOC_000021 - chr1:1072396-1079432 iPS hESC NOTEST 0 1.64828 1.79769e+308 1.79769e+308 0.0567344 1 no TSS180 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 62.0992 29.8078 -1.05889 1.49259 0.135546 0.302902 no TSS181 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC NOTEST 0 1.65694 1.79769e+308 1.79769e+308 0.351997 1 no TSS182 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS hESC OK 177.84 112.101 -0.665783 1.07058 0.284357 0.51374 no TSS183 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 51.7288 54.9232 0.0864503 -0.136994 0.891036 0.990124 no TSS184 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 1.99898 19.5662 3.29103 -0.45617 0.648268 0.863692 no TSS185 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 0 0 0 0 1 1 no TSS186 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 5.70387 0 -1.79769e+308 -1.79769e+308 0.275728 1 no TSS187 XLOC_000129 - chr1:14925212-15478960 iPS hESC OK 0 79.6627 1.79769e+308 1.79769e+308 5.00434e-11 1.25012e-09 yes TSS188 XLOC_000129 - chr1:14925212-15478960 iPS hESC NOTEST 7.67766 5.19027 -0.564859 0.314148 0.753409 1 no TSS189 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 43.9133 68.8214 0.648199 -0.555983 0.578222 0.805049 no TSS19 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC OK 0 9.72413 1.79769e+308 1.79769e+308 0.000129882 0.00090223 yes TSS190 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS hESC OK 101.145 163.558 0.693377 -1.06801 0.285515 0.514403 no TSS1906 XLOC_001217 - chr1:11873-29961 iPS hESC OK 0.0436773 347.213 12.9567 -0.107346 0.914514 0.999997 no TSS1907 XLOC_001217 - chr1:11873-29961 iPS hESC OK 499.712 95.223 -2.39171 3.95618 7.61591e-05 0.000565318 yes TSS1908 XLOC_001217 - chr1:11873-29961 iPS hESC OK 108.765 0 -1.79769e+308 -1.79769e+308 0.0812742 0.209891 no TSS1909 XLOC_001217 - chr1:11873-29961 iPS hESC OK 261.042 294.38 0.173399 -0.150508 0.880364 0.987498 no TSS191 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 3.59181 6.18974 0.785167 -1.07098 0.28418 1 no TSS1910 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1911 XLOC_001217 - chr1:11873-29961 iPS hESC OK 166.699 224.306 0.428221 -0.256889 0.797265 0.961603 no TSS1912 XLOC_001217 - chr1:11873-29961 iPS hESC NOTEST 42.2462 122.62 1.5373 -0.495896 0.619968 1 no TSS1913 XLOC_001218 - chr1:34611-36081 iPS hESC OK 13.7184 16.5503 0.270741 -0.371306 0.71041 0.902118 no TSS1914 XLOC_001219 - chr1:89294-237877 iPS hESC NOTEST 12.8434 2.45836 -2.38526 1.10269 0.270162 1 no TSS1915 XLOC_001222 - chr1:661139-679736 iPS hESC OK 15.7705 18.7126 0.246788 -0.0703098 0.943947 0.999997 no TSS1916 XLOC_001222 - chr1:661139-679736 iPS hESC OK 161.143 297.645 0.885251 -1.36564 0.172053 0.353371 no TSS1917 XLOC_001222 - chr1:661139-679736 iPS hESC OK 266.451 712.204 1.41842 -1.43769 0.150522 0.325337 no TSS1918 XLOC_001227 - chr1:700236-714006 iPS hESC OK 247.682 235.71 -0.0714796 0.16032 0.872629 0.985011 no TSS1919 XLOC_001229 FAM41C chr1:803452-812182 iPS hESC NOTEST 17.3524 2.1691 -2.99997 3.22092 0.00127779 1 no TSS192 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 2.21856 1.79489 -0.305726 0.247618 0.80443 1 no TSS1920 XLOC_001230 - chr1:852952-854817 iPS hESC NOTEST 0 4.38548 1.79769e+308 1.79769e+308 0.237503 1 no TSS1921 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 36.029 100.448 1.47922 -1.10394 0.269618 0.493288 no TSS1922 XLOC_001231 NOC2L chr1:860529-894679 iPS hESC OK 628.462 1734.7 1.46479 -3.2682 0.00108234 0.00573861 yes TSS1923 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC OK 9.49353 14.7182 0.632585 -0.719442 0.471869 0.712752 no TSS1924 XLOC_001232 C1orf170 chr1:910578-917473 iPS hESC NOTEST 0 0.517867 1.79769e+308 1.79769e+308 0.291955 1 no TSS1925 XLOC_001233 HES4 chr1:934341-935552 iPS hESC OK 54.1565 37.4229 -0.533214 0.787619 0.43092 0.671181 no TSS1926 XLOC_001234 - chr1:1017197-1051736 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1927 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 26.1514 48.2129 0.88253 -0.690278 0.490019 0.726638 no TSS1928 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 50.4508 91.6026 0.860512 -1.14368 0.252756 0.467662 no TSS1929 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS hESC OK 18.8091 40.1782 1.09498 -1.02008 0.307689 0.535774 no TSS193 XLOC_000131 - chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1930 XLOC_001235 - chr1:1108435-1133313 iPS hESC NOTEST 0.346272 5.99833 4.11458 -1.36562 0.172057 1 no TSS1931 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 2.09869 10.3558 2.30287 -0.839548 0.401162 0.637833 no TSS1932 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS hESC OK 1.73875 24.8393 3.8365 -1.35602 0.175092 0.356898 no TSS1933 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS hESC NOTEST 1.29516 1.21775 -0.0889168 0.0280886 0.977591 1 no TSS1934 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 60.6719 105.623 0.799828 -0.846112 0.39749 0.633546 no TSS1935 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 868.797 1497.29 0.785266 -2.321 0.0202869 0.0675709 no TSS1936 XLOC_001238 SDF4 chr1:1152288-1167447 iPS hESC OK 32.4396 210.708 2.69942 -0.473552 0.635819 0.854115 no TSS1937 XLOC_001239 FAM132A chr1:1177832-1182102 iPS hESC OK 17.131 41.9198 1.29102 -2.02163 0.043215 0.126149 no TSS1938 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 16.9893 15.5986 -0.123217 0.0470921 0.96244 0.999997 no TSS1939 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS hESC OK 480.97 699.024 0.539395 -1.37482 0.169188 0.351247 no TSS194 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1940 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 9.37264 139.601 3.89671 -0.778285 0.436401 0.676474 no TSS1941 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 25.8307 113.499 2.13552 -1.52619 0.126964 0.289852 no TSS1942 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS hESC OK 93.257 181.357 0.959549 -1.18867 0.23457 0.442245 no TSS1943 XLOC_001242 - chr1:1227763-1260046 iPS hESC OK 26.1554 117.46 2.16699 -0.75974 0.44741 0.690244 no TSS1944 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 79.6054 94.0403 0.240413 -0.214118 0.830455 0.970814 no TSS1945 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS hESC OK 857.443 2450.2 1.51479 -3.16279 0.00156267 0.00777741 yes TSS1946 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS hESC OK 71.8385 294.553 2.0357 -1.66066 0.0967817 0.238105 no TSS1947 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 173.57 674.206 1.95767 -4.00397 6.22872e-05 0.000470413 yes TSS1948 XLOC_001244 DVL1 chr1:1270658-1284492 iPS hESC OK 30.2667 193.963 2.67998 -2.91349 0.00357416 0.0159547 yes TSS1949 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC NOTEST 1077.16 134.781 -2.99854 7.41863 1.1835e-13 1 no TSS195 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS hESC NOTEST 0 0.429055 1.79769e+308 1.79769e+308 0.297657 1 no TSS1950 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS hESC OK 2.23252 18.5375 3.0537 -0.0735157 0.941396 0.999997 no TSS1951 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 1486.29 1941.94 0.38578 -0.720816 0.471023 0.712752 no TSS1952 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 360.213 836.594 1.21568 -0.737624 0.460743 0.703296 no TSS1953 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS hESC OK 711.073 881.639 0.310189 -0.505478 0.613223 0.832786 no TSS1954 XLOC_001247 - chr1:1321090-1334718 iPS hESC OK 5.40934 15.222 1.49263 -0.137034 0.891004 0.990124 no TSS1955 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 114.444 110.19 -0.0546552 0.0718411 0.942728 0.999997 no TSS1956 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 6.6959 107.558 4.00569 -0.447929 0.654205 0.869818 no TSS1957 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS hESC OK 622.633 1006.01 0.692189 -1.9204 0.0548074 0.152779 no TSS1958 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS hESC OK 3133.93 4356.64 0.47524 -1.41917 0.15585 0.333524 no TSS1959 XLOC_001249 - chr1:1353801-1356650 iPS hESC OK 55.0852 73.1639 0.409468 -0.654196 0.512985 0.747049 no TSS196 XLOC_000131 - chr1:15573767-15726776 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1960 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS hESC OK 31.9981 83.1162 1.37714 -2.19185 0.0283903 0.0888651 no TSS1961 XLOC_001251 SSU72 chr1:1477053-1510262 iPS hESC OK 2379.43 3413.53 0.520646 -1.67432 0.0940685 0.233196 no TSS1962 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 33.8277 205.562 2.6033 -0.945911 0.344194 0.57617 no TSS1963 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 9.33823 291.78 4.96559 -0.507415 0.611863 0.832472 no TSS1964 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC OK 117.815 1203.07 3.35213 -1.38208 0.166947 0.348657 no TSS1965 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS hESC OK 76.2007 816.237 3.42111 -0.632954 0.526764 0.756095 no TSS1966 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 4.69427 110.433 4.55612 -0.181361 0.856084 0.984711 no TSS1967 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS hESC OK 44.597 244.477 2.45468 -0.745467 0.455989 0.699327 no TSS1968 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS hESC OK 35.3518 29.5615 -0.258063 0.0145324 0.988405 0.999997 no TSS1969 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS hESC OK 81.9647 251.238 1.61598 -0.407636 0.683541 0.887919 no TSS197 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS hESC OK 330.754 468.604 0.502608 -1.33415 0.182153 0.366849 no TSS1970 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 122.675 178.377 0.540082 -0.605335 0.544956 0.771972 no TSS1971 XLOC_001254 - chr1:1571099-1677431 iPS hESC OK 57.9127 222.366 1.94098 -2.0851 0.0370606 0.112481 no TSS1972 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 210.369 632.852 1.58894 -1.72338 0.0848203 0.217321 no TSS1973 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS hESC OK 48.2599 122.207 1.34043 -0.494235 0.621141 0.840481 no TSS1974 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 10.1742 13.2843 0.384809 -0.104554 0.91673 0.999997 no TSS1975 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 331.317 510.173 0.622776 -1.54768 0.1217 0.282301 no TSS1976 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 38.1873 332.932 3.12406 -1.5487 0.121454 0.282301 no TSS1977 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 46.8111 91.3616 0.964739 -0.864947 0.387068 0.622279 no TSS1978 XLOC_001256 NADK chr1:1682677-1711508 iPS hESC OK 57.4086 210.14 1.87201 -0.98712 0.323584 0.55581 no TSS1979 XLOC_001257 GNB1 chr1:1716729-1822495 iPS hESC OK 4287.86 4821.37 0.169186 -0.902592 0.366742 0.599243 no TSS198 XLOC_000133 CTRC chr1:15764937-15773153 iPS hESC NOTEST 2.23637 0 -1.79769e+308 -1.79769e+308 0.34141 1 no TSS1980 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 78.6765 212.131 1.43095 -2.30526 0.021152 0.0696275 no TSS1981 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS hESC OK 23.4913 79.5862 1.76039 -1.05879 0.289694 0.516913 no TSS1982 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC NOTEST 0 2.02001 1.79769e+308 1.79769e+308 0.0595537 1 no TSS1983 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS hESC NOTEST 0 1.04698 1.79769e+308 1.79769e+308 0.120101 1 no TSS1984 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 1.22859 0.932315 -0.398117 0.189107 0.850009 1 no TSS1985 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS hESC NOTEST 0.437707 0 -1.79769e+308 -1.79769e+308 0.332442 1 no TSS1986 XLOC_001261 - chr1:1944651-1946969 iPS hESC NOTEST 4.28982 8.18597 0.932235 -1.04285 0.297016 1 no TSS1987 XLOC_001262 - chr1:1981908-2139172 iPS hESC OK 13.1667 33.574 1.35045 -0.211947 0.832149 0.970814 no TSS1988 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS hESC OK 419.525 1848.73 2.13971 -3.03493 0.00240592 0.0114062 yes TSS1989 XLOC_001263 - chr1:1981908-2139172 iPS hESC OK 6.98486 25.7926 1.88466 -0.300022 0.76416 0.941238 no TSS199 XLOC_000134 CELA2A chr1:15783222-15798585 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1990 XLOC_001264 MORN1 chr1:2252695-2322993 iPS hESC OK 54.986 109.55 0.994453 -1.01176 0.311655 0.540111 no TSS1991 XLOC_001266 PEX10 chr1:2323213-2344010 iPS hESC OK 290.341 461.866 0.669729 -1.0578 0.290149 0.517014 no TSS1992 XLOC_001267 PANK4 chr1:2439974-2458035 iPS hESC OK 174.785 361.252 1.04742 -2.54966 0.0107829 0.0407179 yes TSS1993 XLOC_001268 HES5 chr1:2460184-2461684 iPS hESC NOTEST 6.35744 2.94754 -1.10894 0.97469 0.329714 1 no TSS1994 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 0.907232 0.475004 -0.933532 0.206521 0.836384 1 no TSS1995 XLOC_001269 - chr1:2481358-2495265 iPS hESC NOTEST 1.10294 0.649192 -0.764632 0.248778 0.803533 1 no TSS1996 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC NOTEST 0 0 0 0 1 1 no TSS1997 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS hESC OK 0.931281 12.7571 3.77594 -0.543818 0.586567 0.811449 no TSS1998 XLOC_001271 - chr1:2976182-2980350 iPS hESC NOTEST 0.620738 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TSS1999 XLOC_001272 - chr1:2980635-2984289 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2 XLOC_000005 - chr1:322036-328580 iPS hESC OK 189.247 358.383 0.921233 -1.5444 0.12249 0.283627 no TSS20 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS hESC NOTEST 0 6.97279 1.79769e+308 1.79769e+308 0.00246227 1 no TSS200 XLOC_000135 CELA2B chr1:15802595-15851384 iPS hESC NOTEST 0 1.27477 1.79769e+308 1.79769e+308 0.352721 1 no TSS2000 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC NOTEST 69.8392 41.8309 -0.739469 1.17206 0.241174 1 no TSS2001 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS hESC OK 43.7292 177.762 2.02328 -3.11751 0.00182383 0.00880726 yes TSS2002 XLOC_001274 WDR8 chr1:3547331-3566671 iPS hESC OK 264.765 597.841 1.17505 -2.43355 0.0149514 0.0533568 no TSS2003 XLOC_001275 - chr1:3652549-3663886 iPS hESC OK 0 11.3698 1.79769e+308 1.79769e+308 0.0857226 0.218496 no TSS2004 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS hESC OK 201.581 422.204 1.06658 -3.19792 0.00138423 0.00705145 yes TSS2005 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS hESC OK 867.894 1345.43 0.632479 -2.16568 0.0303353 0.0944977 no TSS2006 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS hESC OK 266.214 182.207 -0.547009 1.14487 0.252261 0.467456 no TSS2007 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS hESC OK 489.179 551.063 0.171855 -0.437761 0.66156 0.873873 no TSS2008 XLOC_001279 - chr1:5621768-5728315 iPS hESC NOTEST 0 0.669469 1.79769e+308 1.79769e+308 0.240869 1 no TSS2009 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 47.7688 153.438 1.68352 -3.11795 0.00182114 0.00880725 yes TSS201 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS hESC OK 464.958 153.207 -1.60162 4.75336 2.00064e-06 2.27968e-05 yes TSS2010 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS hESC OK 12.3891 32.7056 1.40046 -1.19183 0.233327 0.441182 no TSS2011 XLOC_001280 - chr1:5922869-6052531 iPS hESC NOTEST 1.34942 5.2451 1.95863 -0.315731 0.752207 1 no TSS2012 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC NOTEST 0 3.24653 1.79769e+308 1.79769e+308 0.0171011 1 no TSS2013 XLOC_001281 - chr1:6161852-6240183 iPS hESC NOTEST 3.69165 0.766551 -2.26781 1.09713 0.272586 1 no TSS2014 XLOC_001281 CHD5 chr1:6161852-6240183 iPS hESC OK 6.8891 13.8631 1.00887 -1.37294 0.169771 0.351726 no TSS2015 XLOC_001281 - chr1:6161852-6240183 iPS hESC NOTEST 3.73417 4.78329 0.357215 -0.144714 0.884937 1 no TSS2016 XLOC_001281 - chr1:6161852-6240183 iPS hESC NOTEST 0.120394 5.03226 5.38537 -0.374571 0.70798 1 no TSS2017 XLOC_001282 RPL22 chr1:6245080-6259679 iPS hESC OK 2431.44 4375.01 0.847474 -3.23592 0.00121251 0.00637672 yes TSS2018 XLOC_001283 ICMT chr1:6266188-6296044 iPS hESC OK 1479.52 1334.15 -0.149209 0.651214 0.514908 0.747336 no TSS2019 XLOC_001284 GPR153 chr1:6307413-6321035 iPS hESC OK 37.8293 97.14 1.36056 -1.57996 0.114116 0.271 no TSS202 XLOC_000136 - chr1:15853351-15918872 iPS hESC NOTEST 6.69281 1.81648 -1.88147 0.24849 0.803755 1 no TSS2020 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 239.832 1356.8 0 0 1 1 no TSS2021 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 0 0 0 0 1 1 no TSS2022 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 126.845 93.6803 0 0 1 1 no TSS2023 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 462.887 1047.97 0 0 1 1 no TSS2024 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS hESC FAIL 134.974 1060.75 0 0 1 1 no TSS2025 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 0 2.2157 1.79769e+308 1.79769e+308 0.0765414 1 no TSS2026 XLOC_001286 HES2 chr1:6472499-6484730 iPS hESC NOTEST 5.92301 6.44393 0.121611 -0.19958 0.841809 1 no TSS2027 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS hESC OK 50.6435 332.126 2.71328 -1.33101 0.183186 0.368357 no TSS2028 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 12.7468 35.8901 1.49345 -0.693954 0.487711 0.724042 no TSS2029 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 2.06233 38.9511 4.23932 -0.63114 0.527949 0.756597 no TSS203 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC OK 484.832 270.688 -0.840857 1.6727 0.0943855 0.233371 no TSS2030 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 14.2602 62.1096 2.12282 -1.36949 0.170845 0.352827 no TSS2031 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0 73.921 1.79769e+308 1.79769e+308 8.90841e-06 8.26573e-05 yes TSS2032 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 17.5992 43.3127 1.29928 -1.03588 0.300257 0.527577 no TSS2033 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 25.7562 4.59064 -2.48815 1.06265 0.287943 0.515429 no TSS2034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0 9.71361 1.79769e+308 1.79769e+308 0.151372 0.32555 no TSS2035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC OK 0.00544137 51.9914 13.222 -0.0944698 0.924736 0.999997 no TSS2036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS hESC NOTEST 14.4826 6.79791 -1.09116 0.659031 0.509876 1 no TSS2037 XLOC_001287 - chr1:6521220-6580069 iPS hESC OK 30.5163 77.8501 1.35112 -0.738174 0.460408 0.703296 no TSS2038 XLOC_001288 NOL9 chr1:6585209-6614581 iPS hESC OK 503.823 189.708 -1.40913 4.12461 3.71357e-05 0.000301495 yes TSS2039 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 109.476 216.693 0.985041 -1.77987 0.0750968 0.196828 no TSS204 XLOC_000137 DDI2 chr1:15944069-15988216 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2040 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS hESC OK 134.239 151.442 0.173969 -0.217709 0.827656 0.970329 no TSS2041 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2042 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS hESC OK 743.808 1372.27 0.883559 -2.94362 0.00324394 0.0147338 yes TSS2043 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2044 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 2.40953 0.950535 -1.34194 0.107691 0.914241 1 no TSS2045 XLOC_001291 UTS2 chr1:7844379-7973294 iPS hESC NOTEST 0.0400905 0 -1.79769e+308 -1.79769e+308 0.496829 1 no TSS2046 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS hESC NOTEST 0 0.267901 1.79769e+308 1.79769e+308 0.240869 1 no TSS2047 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 641.313 442.172 -0.53642 1.65281 0.098369 0.240643 no TSS2048 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS hESC OK 137.346 21.342 -2.68605 2.39853 0.0164612 0.056719 no TSS2049 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 1.40725 320.719 7.83228 -0.463892 0.642725 0.858067 no TSS205 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS hESC OK 363.264 779.207 1.10099 -3.38248 0.000718357 0.00402218 yes TSS2050 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC OK 186.982 662.61 1.82526 -5.38967 7.05863e-08 1.10472e-06 yes TSS2051 XLOC_001294 RERE chr1:8412465-8877699 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2052 XLOC_001294 - chr1:8412465-8877699 iPS hESC OK 85.8783 3.82252 -4.4897 1.16634 0.243478 0.455076 no TSS2053 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 444.441 211.161 -1.07365 0.915316 0.360026 0.592837 no TSS2054 XLOC_001296 ENO1 chr1:8921062-8938780 iPS hESC OK 21997.3 52429.9 1.25306 -8.66154 0 0 yes TSS2055 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS hESC NOTEST 0 0.358204 1.79769e+308 1.79769e+308 0.238628 1 no TSS2056 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0 0.000167835 1.79769e+308 1.79769e+308 0.499869 1 no TSS2057 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 2.34161 2.90964 0.31334 -0.148486 0.881959 1 no TSS2058 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 0.00429204 0 -1.79769e+308 -1.79769e+308 0.498401 1 no TSS2059 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS hESC NOTEST 3.56432 0 -1.79769e+308 -1.79769e+308 0.0498603 1 no TSS206 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS hESC NOTEST 6.39779 8.64356 0.434052 -0.610088 0.541804 1 no TSS2060 XLOC_001299 GPR157 chr1:9164475-9189356 iPS hESC OK 27.3747 57.8343 1.07908 -1.06541 0.286689 0.515088 no TSS2061 XLOC_001300 - chr1:9208346-9242451 iPS hESC OK 95.9263 212.722 1.14897 -2.69957 0.00694287 0.028361 yes TSS2062 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS hESC NOTEST 0 0.589835 1.79769e+308 1.79769e+308 0.430197 1 no TSS2063 XLOC_001302 - chr1:9711789-9884550 iPS hESC OK 86.8241 230.865 1.41088 -0.768268 0.442328 0.684029 no TSS2064 XLOC_001303 - chr1:9711789-9884550 iPS hESC OK 3.82816 145.676 5.24996 -0.201001 0.840698 0.976683 no TSS2065 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS hESC OK 474.526 1584.55 1.73951 -5.29999 1.15806e-07 1.76979e-06 yes TSS2066 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS hESC OK 479.396 655.696 0.45181 -1.18064 0.237746 0.446934 no TSS2067 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC NOTEST 14.1134 3.50582 -2.00924 0.588027 0.556514 1 no TSS2068 XLOC_001305 LZIC chr1:9989777-10003427 iPS hESC OK 307.377 194.222 -0.6623 1.39292 0.163644 0.345086 no TSS2069 XLOC_001306 DFFA chr1:10520604-10532613 iPS hESC OK 783.778 1126.41 0.523219 -1.52957 0.126123 0.288641 no TSS207 XLOC_000140 - chr1:16062808-16067885 iPS hESC NOTEST 2.07297 0.000570561 -11.827 0.0077785 0.993794 1 no TSS2070 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 9.93113 58.8654 2.56739 -2.40992 0.0159562 0.0554201 no TSS2071 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS hESC OK 8.95125 49.2697 2.46054 -2.10645 0.0351649 0.107734 no TSS2072 XLOC_001307 - chr1:10696667-10856707 iPS hESC NOTEST 2.07597 1.40186 -0.566439 0.097369 0.922433 1 no TSS2073 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS hESC NOTEST 1.66867 4.3281 1.37503 -0.771281 0.440541 1 no TSS2074 XLOC_001309 MASP2 chr1:11086580-11107285 iPS hESC OK 75.0649 57.5421 -0.383521 0.715264 0.474446 0.714143 no TSS2075 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC NOTEST 1171.02 432.981 -1.43539 2.34312 0.0191233 1 no TSS2076 XLOC_001310 SRM chr1:11114648-11120091 iPS hESC OK 1002.98 4481.12 2.15957 -4.75079 2.02625e-06 2.28878e-05 yes TSS2077 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS hESC OK 1430.05 1348.42 -0.0847953 0.321049 0.748173 0.9336 no TSS2078 XLOC_001312 - chr1:11166588-11322608 iPS hESC OK 59.0429 135.175 1.195 -1.06237 0.288069 0.515429 no TSS2079 XLOC_001312 MTOR chr1:11166588-11322608 iPS hESC OK 578.796 892.477 0.624761 -2.6171 0.00886801 0.0345932 yes TSS208 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS hESC OK 11.5611 31.4534 1.44394 -2.25831 0.0239262 0.0775066 no TSS2080 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC OK 302.813 1495.38 2.30402 -4.32372 1.53423e-05 0.000136505 yes TSS2081 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS hESC NOTEST 5.94962 4.06337 -0.550121 0.0348578 0.972193 1 no TSS2082 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS hESC OK 4485.74 6757.57 0.59116 -2.41689 0.0156539 0.054958 no TSS2083 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC NOTEST 12.2816 64.418 2.39096 -1.94804 0.0514098 1 no TSS2084 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC OK 98.8766 93.2442 -0.0846153 0.198665 0.842525 0.976683 no TSS2085 XLOC_001315 MTHFR chr1:11832138-11866115 iPS hESC OK 66.9034 27.4533 -1.2851 0.917236 0.359019 0.592837 no TSS2086 XLOC_001316 NPPA chr1:11866206-11907840 iPS hESC OK 3.4039 10.2838 1.59511 -0.248783 0.803529 0.964629 no TSS2087 XLOC_001317 NPPB chr1:11917521-11918992 iPS hESC NOTEST 770.486 7.22153 -6.73732 7.91417 2.44249e-15 1 no TSS2088 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS hESC OK 673.993 754.447 0.162686 -0.418068 0.675898 0.881095 no TSS2089 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 664.349 334.324 -0.990695 2.01371 0.0440397 0.127696 no TSS209 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 17.9129 28.622 0.676129 -0.286547 0.774459 0.94691 no TSS2090 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC OK 695.323 341.518 -1.02572 2.19813 0.02794 0.087667 no TSS2091 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS hESC NOTEST 17.2087 0 -1.79769e+308 -1.79769e+308 0.447612 1 no TSS2092 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2093 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2094 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS hESC NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no TSS2095 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2096 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS hESC NOTEST 0.337687 0 -1.79769e+308 -1.79769e+308 0.414194 1 no TSS2097 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS hESC NOTEST 0.334659 0 -1.79769e+308 -1.79769e+308 0.436888 1 no TSS2098 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2099 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC NOTEST 0 0 0 0 1 1 no TSS21 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 8.76366 14.5016 0.726606 -1.02369 0.30598 0.534951 no TSS210 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 565.849 821.848 0.538455 -1.58086 0.11391 0.271 no TSS2100 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2101 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS hESC NOTEST 0.200934 0 -1.79769e+308 -1.79769e+308 0.454078 1 no TSS2102 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2103 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS hESC NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TSS2104 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS hESC NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TSS2105 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2106 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS hESC NOTEST 6.96034 8.16584 0.230444 -0.308805 0.75747 1 no TSS2107 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS hESC NOTEST 8.04305 9.25388 0.202316 -0.165261 0.868738 1 no TSS2108 XLOC_001335 - chr1:15573767-15726776 iPS hESC NOTEST 0.432797 3.71564 3.10185 -1.10753 0.268064 1 no TSS2109 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 220.689 380.234 0.784877 -1.28098 0.200199 0.392105 no TSS211 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS hESC OK 311.44 109.011 -1.51449 1.96306 0.0496392 0.13957 no TSS2110 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2111 XLOC_001336 CASP9 chr1:15802595-15851384 iPS hESC OK 173.37 51.7979 -1.74289 2.23986 0.0250997 0.0797371 no TSS2112 XLOC_001337 AGMAT chr1:15853351-15918872 iPS hESC OK 122.09 115.866 -0.0754893 0.0853533 0.931981 0.999997 no TSS2113 XLOC_001339 - chr1:16160709-16266950 iPS hESC OK 68.8094 58.2932 -0.239277 0.215806 0.829139 0.970814 no TSS2114 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS hESC OK 179.279 335.879 0.905738 -1.52027 0.128444 0.292204 no TSS2115 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 121.023 3.62862 -5.05972 4.51683 6.27717e-06 6.04003e-05 yes TSS2116 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS hESC OK 71.8733 3.46957 -4.37263 3.30917 0.00093574 0.00506469 yes TSS2117 XLOC_001343 FAM131C chr1:16340522-16400127 iPS hESC OK 13.6398 25.9588 0.9284 -0.0958703 0.923624 0.999997 no TSS2118 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS hESC OK 257.159 575.636 1.16249 -2.40675 0.0160953 0.055754 no TSS2119 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 17.0126 324.019 4.2514 -2.46691 0.0136284 0.0494504 yes TSS212 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 145.636 241.251 0.72817 -2.02925 0.0424326 0.124988 no TSS2120 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS hESC OK 156.261 678.385 2.11814 -4.94328 7.68185e-07 1.01824e-05 yes TSS2121 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS hESC OK 28.2148 53.4824 0.922611 -1.70186 0.088781 0.223069 no TSS2122 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 22.2988 2.24339 -3.31321 0.94358 0.345384 1 no TSS2123 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC NOTEST 11.178 8.45144 -0.403399 0.128754 0.897552 1 no TSS2124 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS hESC OK 292.804 256.568 -0.190597 0.474516 0.635132 0.854075 no TSS2125 XLOC_001347 - chr1:16576559-16678948 iPS hESC OK 27.075 0.999115 -4.76017 1.85886 0.0630466 0.170976 no TSS2126 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS hESC NOTEST 1.25463 0 -1.79769e+308 -1.79769e+308 0.44193 1 no TSS2127 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 39.2853 48.5164 0.304485 -0.625046 0.531941 0.760166 no TSS2128 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 0 76.9358 1.79769e+308 1.79769e+308 0.00484521 0.0205014 yes TSS2129 XLOC_001349 - chr1:16793930-16819196 iPS hESC OK 7.75221 47.6242 2.61902 -0.613243 0.539716 0.766219 no TSS213 XLOC_000143 SPEN chr1:16160709-16266950 iPS hESC OK 40.228 140.357 1.80283 -2.58447 0.00975277 0.037593 yes TSS2130 XLOC_001350 - chr1:16860385-16864669 iPS hESC OK 23.1603 11.9908 -0.949728 1.38101 0.167277 0.348784 no TSS2131 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 373.983 222.328 -0.750287 1.61418 0.106488 0.256639 no TSS2132 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC OK 65.4571 148.896 1.18569 -0.71528 0.474436 0.714143 no TSS2133 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 2.67381 2.13127 -0.327187 0.010726 0.991442 1 no TSS2134 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS hESC NOTEST 8.12905 1.71985 -2.2408 0.446374 0.655327 1 no TSS2135 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 146.83 39.2466 -1.9035 1.90435 0.056864 0.157163 no TSS2136 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 24.9871 150.524 2.59074 -1.54786 0.121655 0.282301 no TSS2137 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 62.8563 148.568 1.241 -1.57081 0.116226 0.27463 no TSS2138 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 75.5926 186.65 1.30402 -1.5131 0.130255 0.294776 no TSS2139 XLOC_001353 - chr1:16944752-16971178 iPS hESC OK 93.9509 210.996 1.16724 -0.584707 0.558745 0.784659 no TSS214 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2140 XLOC_001354 ESPN chr1:17017712-17046652 iPS hESC OK 2.07327 11.1097 2.42183 -1.80538 0.0710156 0.18788 no TSS2141 XLOC_001354 ESPNP chr1:17017712-17046652 iPS hESC NOTEST 0 3.47275 1.79769e+308 1.79769e+308 0.0482484 1 no TSS2142 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC OK 14.2231 38.162 1.42391 -0.809323 0.418329 0.658678 no TSS2143 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS hESC NOTEST 1.90183 3.25841 0.776778 -0.0641904 0.948819 1 no TSS2144 XLOC_001356 - chr1:17066767-17299474 iPS hESC OK 133.893 415.352 1.63325 -0.775952 0.437778 0.677799 no TSS2145 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC OK 1947.53 4866.56 1.32126 -4.05307 5.05506e-05 0.000388552 yes TSS2146 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2147 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 66.6283 366.46 2.45945 -1.08886 0.276215 0.50323 no TSS2148 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 255.212 1022.9 2.0029 -4.92485 8.44246e-07 1.09668e-05 yes TSS2149 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 0 22.7704 1.79769e+308 1.79769e+308 0.206562 0.399949 no TSS215 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 1.3355 6.02437 2.17343 -0.0768125 0.938773 1 no TSS2150 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS hESC OK 26.0242 18.4495 -0.496273 0.192583 0.847286 0.980075 no TSS2151 XLOC_001359 SDHB chr1:17345226-17380665 iPS hESC OK 1562.94 1548.47 -0.0134229 0.0414128 0.966967 0.999997 no TSS2152 XLOC_001360 PADI2 chr1:17393256-17445948 iPS hESC OK 31.43 66.1047 1.07261 -1.6239 0.104397 0.253954 no TSS2153 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC NOTEST 2447.51 4130.7 0.75507 -3.33432 0.000855069 1 no TSS2154 XLOC_001362 RCC2 chr1:17733251-17766220 iPS hESC OK 895.394 1326.29 0.566807 -1.55253 0.120535 0.281249 no TSS2155 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS hESC NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TSS2156 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 85.8408 218.303 1.3466 -1.97734 0.0480029 0.135851 no TSS2157 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS hESC OK 178.229 434.186 1.28458 -2.62285 0.00871967 0.0342201 yes TSS2158 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS hESC OK 102.06 89.541 -0.188796 0.471554 0.637245 0.855051 no TSS2159 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 14.6135 50.0495 1.77606 -0.0664172 0.947046 0.999997 no TSS216 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS hESC OK 8.86716 23.5434 1.40878 -0.249499 0.802975 0.964629 no TSS2160 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 1.68163 92.8871 5.78754 -0.0529208 0.957795 0.999997 no TSS2161 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 0 22.9292 1.79769e+308 1.79769e+308 0.171731 0.353371 no TSS2162 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 0 167.676 1.79769e+308 1.79769e+308 0.0104565 0.0397165 yes TSS2163 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 28.2328 557.747 4.30416 -1.6445 0.100073 0.243892 no TSS2164 XLOC_001366 - chr1:19398603-19536746 iPS hESC OK 4.91166 426.519 6.44026 -0.372414 0.709584 0.902118 no TSS2165 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 623.312 765.815 0.297043 -1.44135 0.149486 0.324177 no TSS2166 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 39.3315 5.33048 -2.88335 0.667548 0.504422 0.739274 no TSS2167 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 38.8471 192.593 2.30967 -1.06958 0.284809 0.513844 no TSS2168 XLOC_001366 - chr1:19398603-19536746 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2169 XLOC_001366 UBR4 chr1:19398603-19536746 iPS hESC OK 112.418 4.71016 -4.57695 1.8239 0.0681666 0.182574 no TSS217 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS hESC NOTEST 1.5524 8.06405 2.37701 -0.243256 0.807807 1 no TSS2170 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 44.1215 13.1602 -1.7453 1.17092 0.241632 0.452871 no TSS2171 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS hESC OK 309.472 596.084 0.945708 -2.53041 0.0113928 0.0427723 yes TSS2172 XLOC_001368 AKR7L chr1:19592475-19600568 iPS hESC OK 8.4734 11.7019 0.465724 -0.687357 0.491858 0.728533 no TSS2173 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS hESC OK 16.1619 17.2325 0.0925378 -0.140051 0.88862 0.989797 no TSS2174 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS hESC OK 363.217 695.576 0.937377 -2.0313 0.0422246 0.124659 no TSS2175 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 1302.83 0 -1.79769e+308 -1.79769e+308 8.13491e-05 0.000590349 yes TSS2176 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 43.0618 69.4828 0.690248 -0.244309 0.806991 0.964629 no TSS2177 XLOC_001371 CAPZB chr1:19665273-19811992 iPS hESC OK 2378.98 5177.29 1.12186 -3.57777 0.000346543 0.00215387 yes TSS2178 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 6.20966 0 -1.79769e+308 -1.79769e+308 0.299442 1 no TSS2179 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC OK 48.488 56.5465 0.221808 -0.372847 0.709262 0.902118 no TSS218 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2180 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC OK 18.9165 10.5012 -0.849083 0.429306 0.6677 0.87699 no TSS2181 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS hESC NOTEST 6.08129 0 -1.79769e+308 -1.79769e+308 0.444566 1 no TSS2182 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2183 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2184 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS hESC OK 134.324 35.1082 -1.93584 2.65499 0.00793108 0.0316027 yes TSS2185 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2186 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2187 XLOC_001379 - chr1:20687597-20755275 iPS hESC NOTEST 0 0.74001 1.79769e+308 1.79769e+308 0.239739 1 no TSS2188 XLOC_001379 - chr1:20687597-20755275 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2189 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC OK 163.673 6.4946 -4.65543 3.51703 0.000436412 0.00262453 yes TSS219 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS hESC OK 12.6409 52.0827 2.04271 -0.708787 0.478457 0.716857 no TSS2190 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS hESC OK 171.705 124.278 -0.466364 0.783233 0.43349 0.672764 no TSS2191 XLOC_001381 MUL1 chr1:20825942-20834674 iPS hESC OK 392.307 351.837 -0.157076 0.430656 0.666719 0.876587 no TSS2192 XLOC_001382 DDOST chr1:20978259-20988037 iPS hESC OK 4463.42 4991.33 0.161274 -0.762379 0.445834 0.688631 no TSS2193 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC OK 7.59828 14.7785 0.95975 -0.28614 0.774771 0.94691 no TSS2194 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC NOTEST 0 5.90044 1.79769e+308 1.79769e+308 0.137159 1 no TSS2195 XLOC_001383 KIF17 chr1:20990508-21044317 iPS hESC OK 59.0012 151.303 1.35863 -2.6651 0.00769658 0.0307672 yes TSS2196 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC OK 17.3446 145.923 3.07264 -3.12572 0.00177367 0.00866166 yes TSS2197 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS hESC OK 56.3467 160.628 1.51132 -2.46431 0.0137277 0.049672 yes TSS2198 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 44.0552 56.1343 0.34957 -0.170091 0.864938 0.984711 no TSS2199 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 302.536 107.411 -1.49397 2.95173 0.00315996 0.0146078 yes TSS22 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS hESC OK 0.000995546 60.1613 15.883 -0.0109256 0.991283 0.999997 no TSS220 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS hESC OK 1222.98 1363.34 0.156745 -0.595518 0.551497 0.777845 no TSS2200 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 534.508 318.106 -0.748704 0.986472 0.323901 0.55581 no TSS2201 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 553.685 88.4856 -2.64555 4.97973 6.36738e-07 8.61586e-06 yes TSS2202 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS hESC OK 478.545 494.915 0.048525 -0.0769961 0.938627 0.999997 no TSS2203 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 16.2897 6.37526 -1.3534 0.281412 0.778395 1 no TSS2204 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 499.358 247.208 -1.01435 2.90293 0.00369691 0.016251 yes TSS2205 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC NOTEST 23.2845 0 -1.79769e+308 -1.79769e+308 0.220025 1 no TSS2206 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 217.515 414.51 0.93029 -2.00785 0.0446588 0.128345 no TSS2207 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 310.854 0 -1.79769e+308 -1.79769e+308 0.0196006 0.0659819 no TSS2208 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS hESC OK 99.134 39.0388 -1.34447 0.920787 0.357162 0.592837 no TSS2209 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 0 5.98009 1.79769e+308 1.79769e+308 0.100311 1 no TSS221 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS hESC OK 574.66 535.864 -0.100841 0.26818 0.788561 0.956434 no TSS2210 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC NOTEST 90.6691 28.0163 -1.69434 2.15001 0.0315541 1 no TSS2211 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 70.0685 113.914 0.701104 -0.597613 0.550098 0.776715 no TSS2212 XLOC_001387 ECE1 chr1:21543739-21672034 iPS hESC OK 67.8265 419.192 2.62769 -3.99154 6.56469e-05 0.000492921 yes TSS2213 XLOC_001389 - chr1:21749600-21754300 iPS hESC OK 100.478 59.716 -0.750686 1.55954 0.118868 0.279221 no TSS2214 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 3.1394 23.4017 2.89805 -0.879996 0.378862 0.614409 no TSS2215 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC OK 27.4868 67.9603 1.30596 -1.7024 0.0886796 0.223069 no TSS2216 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS hESC NOTEST 25.4736 87.2577 1.77628 -2.10769 0.035058 1 no TSS2217 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 119.181 49.6025 -1.26468 1.44177 0.149366 0.324177 no TSS2218 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 984.381 761.076 -0.371176 1.16066 0.24578 0.458061 no TSS2219 XLOC_001391 USP48 chr1:22004793-22109688 iPS hESC OK 40.7577 4.47726 -3.18639 1.09552 0.27329 0.498601 no TSS222 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC OK 3.60361 12.0854 1.74575 -0.913481 0.36099 0.592837 no TSS2220 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 8.87162 185.017 4.38232 -1.17013 0.24195 0.452871 no TSS2221 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 117.483 865.967 2.88186 -8.63089 0 0 yes TSS2222 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS hESC OK 32.9146 0 -1.79769e+308 -1.79769e+308 0.395674 0.631426 no TSS2223 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 15.9522 73.6692 2.2073 -4.20375 2.62532e-05 1 no TSS2224 XLOC_001393 WNT4 chr1:22443799-22470385 iPS hESC NOTEST 0.000222119 0 -1.79769e+308 -1.79769e+308 0.499864 1 no TSS2225 XLOC_001394 - chr1:23337326-23342343 iPS hESC NOTEST 3.40123 1.30651 -1.38034 0.472724 0.63641 1 no TSS2226 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS hESC OK 860.605 435.794 -0.981705 4.10013 4.12911e-05 0.000329062 yes TSS2227 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC NOTEST 18.8159 3.27082 -2.52423 0.201841 0.840041 1 no TSS2228 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS hESC OK 3123.46 3017.1 -0.0499835 0.212668 0.831586 0.970814 no TSS2229 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC OK 32.0809 18.4192 -0.8005 0.984269 0.324983 0.556197 no TSS223 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC OK 2.50115 10.5665 2.07883 -0.520855 0.602467 0.825533 no TSS2230 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS hESC OK 28.9081 0 -1.79769e+308 -1.79769e+308 0.044174 0.127739 no TSS2231 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC OK 134.779 1.36049 -6.63032 4.53999 5.62558e-06 5.53608e-05 yes TSS2232 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS hESC NOTEST 0 4.90057 1.79769e+308 1.79769e+308 0.130776 1 no TSS2233 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 57.325 22.8075 -1.32966 0.993685 0.320376 0.552681 no TSS2234 XLOC_001400 - chr1:23755055-23811057 iPS hESC OK 31.2959 92.1289 1.55768 -1.02864 0.303648 0.531589 no TSS2235 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 215.28 617.63 1.52053 -4.16521 3.11064e-05 0.000257371 yes TSS2236 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC OK 0 24.2074 1.79769e+308 1.79769e+308 0.0805175 0.208767 no TSS2237 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS hESC NOTEST 0 5.93528 1.79769e+308 1.79769e+308 0.435254 1 no TSS2238 XLOC_001402 E2F2 chr1:23832921-23857713 iPS hESC OK 17.3678 95.4288 2.45801 -4.53767 5.68796e-06 5.55538e-05 yes TSS2239 XLOC_001403 ID3 chr1:23884409-23886322 iPS hESC OK 2233.71 3052.85 0.450715 -1.53313 0.125244 0.288425 no TSS224 XLOC_000149 MST1 chr1:16972068-16976914 iPS hESC OK 9.67545 96.4681 3.31765 -3.67054 0.000242043 0.0015565 yes TSS2240 XLOC_001404 - chr1:24069855-24104777 iPS hESC OK 29.788 77.4967 1.37941 -0.241165 0.809427 0.964629 no TSS2241 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 33.6768 38.3217 0.18641 -0.095538 0.923888 0.999997 no TSS2242 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 17.4871 27.5676 0.656685 -0.229418 0.818544 0.967036 no TSS2243 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 251.387 492.642 0.970628 -1.36149 0.173357 0.354632 no TSS2244 XLOC_001405 GALE chr1:24122088-24127294 iPS hESC OK 6.56657 9.86629 0.587369 -0.0763122 0.939171 0.999997 no TSS2245 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 209.106 346.485 0.728561 -1.35249 0.17622 0.357077 no TSS2246 XLOC_001406 HMGCL chr1:24128367-24165110 iPS hESC OK 7.68224 12.5886 0.712515 -0.22441 0.822439 0.967524 no TSS2247 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS hESC OK 207.2 132.316 -0.647036 1.48317 0.138028 0.305449 no TSS2248 XLOC_001408 CNR2 chr1:24200460-24239817 iPS hESC NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TSS2249 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS hESC OK 2102.35 1582.97 -0.409363 1.38946 0.164691 0.346172 no TSS225 XLOC_000150 - chr1:17066767-17299474 iPS hESC NOTEST 2.30684 4.93427 1.09692 -0.0279067 0.977737 1 no TSS2250 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0 1.19576 1.79769e+308 1.79769e+308 0.127659 1 no TSS2251 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.452065 1.77127 1.97018 -0.674069 0.500267 1 no TSS2252 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 2.29711 0.363637 -2.65925 1.27441 0.202518 1 no TSS2253 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS hESC NOTEST 0.347098 0.607421 0.807353 -0.26392 0.791841 1 no TSS2254 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 6.64523 1.45433 -2.19197 1.68141 0.092683 1 no TSS2255 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS hESC NOTEST 0 5.55488 1.79769e+308 1.79769e+308 0.000346682 1 no TSS2256 XLOC_001412 IL28RA chr1:24480647-24513751 iPS hESC OK 99.4363 206.886 1.05699 -0.825469 0.409105 0.646506 no TSS2257 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2258 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 11.5429 7.16763 -0.687434 0.321028 0.748189 1 no TSS2259 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC OK 144.476 142.496 -0.0199167 0.0395581 0.968445 0.999997 no TSS226 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 27.4034 428.259 3.96606 -4.98435 6.21693e-07 8.59127e-06 yes TSS2260 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 0 0 0 0 1 1 no TSS2261 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS hESC NOTEST 8.9548 2.3477 -1.93141 0.435766 0.663007 1 no TSS227 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 47.5917 30.5389 -0.640063 0.42597 0.67013 0.878404 no TSS228 XLOC_000150 CROCC chr1:17066767-17299474 iPS hESC OK 65.6699 100.239 0.610141 -0.98137 0.32641 0.557904 no TSS229 XLOC_000150 - chr1:17066767-17299474 iPS hESC OK 15.9225 62.5679 1.97436 -0.950537 0.34184 0.575038 no TSS23 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 335.325 775.295 1.20918 -1.49859 0.133979 0.300585 no TSS230 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 2.7984 1.50479 -0.895036 0.422801 0.67244 1 no TSS231 XLOC_000151 PADI1 chr1:17531620-17572501 iPS hESC NOTEST 12.7402 0.286372 -5.47535 1.34414 0.178903 1 no TSS232 XLOC_000151 - chr1:17531620-17572501 iPS hESC NOTEST 0 2.33196 1.79769e+308 1.79769e+308 0.0553395 1 no TSS233 XLOC_000152 PADI3 chr1:17575592-17610725 iPS hESC NOTEST 8.59656 12.671 0.559694 -0.832934 0.404882 1 no TSS234 XLOC_000153 PADI4 chr1:17634689-17690495 iPS hESC NOTEST 4.09774 4.49965 0.134984 -0.124904 0.900599 1 no TSS235 XLOC_000154 PADI6 chr1:17698740-17728195 iPS hESC NOTEST 0 0.21117 1.79769e+308 1.79769e+308 0.240869 1 no TSS236 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 86.5635 120.034 0.471607 -0.698591 0.484808 0.723037 no TSS237 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 158.893 479.078 1.5922 -3.50027 0.000464792 0.00275691 yes TSS238 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 2.78634 1.79769e+308 1.79769e+308 0.370368 1 no TSS239 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC OK 24.8197 25.6249 0.0460618 -0.0320703 0.974416 0.999997 no TSS24 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS hESC OK 21.1644 14.7123 -0.524619 0.131747 0.895185 0.99186 no TSS240 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS hESC NOTEST 0 5.26 1.79769e+308 1.79769e+308 0.184349 1 no TSS241 XLOC_000155 - chr1:17866329-18024369 iPS hESC NOTEST 2.21468 5.36255 1.27582 -0.0636845 0.949221 1 no TSS242 XLOC_000155 - chr1:17866329-18024369 iPS hESC OK 12.7177 44.6171 1.81076 -0.557376 0.57727 0.804586 no TSS243 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS hESC OK 9.62232 17.1125 0.830595 -1.21425 0.224654 0.427885 no TSS244 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC OK 58.273 398.742 2.77455 -5.33822 9.38643e-08 1.45154e-06 yes TSS245 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS hESC NOTEST 2.74185 3.24727 0.244078 -0.0169831 0.98645 1 no TSS246 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS hESC NOTEST 0 8.37135 1.79769e+308 1.79769e+308 0.133101 1 no TSS247 XLOC_000160 PAX7 chr1:18957499-19075359 iPS hESC NOTEST 0.594028 0.969331 0.706458 -0.163503 0.870122 1 no TSS248 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS hESC OK 773.162 961.74 0.314877 -0.996481 0.319017 0.551801 no TSS249 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 105.82 262.501 1.3107 -1.83464 0.0665595 0.179533 no TSS25 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS hESC OK 140.404 187.156 0.414652 -0.925142 0.354892 0.591032 no TSS250 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS hESC OK 80.1847 62.153 -0.367503 0.445258 0.656133 0.870688 no TSS251 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS hESC OK 249.564 797.682 1.6764 -2.82278 0.00476087 0.0202465 yes TSS252 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 1.64141 1.79769e+308 1.79769e+308 0.415871 1 no TSS253 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC NOTEST 0 0 0 0 1 1 no TSS254 XLOC_000163 NBL1 chr1:19923466-19984945 iPS hESC OK 463.905 16.9244 -4.77666 4.48648 7.24109e-06 6.86583e-05 yes TSS255 XLOC_000164 HTR6 chr1:19991779-20006054 iPS hESC OK 3.39355 22.3161 2.71722 -2.91074 0.00360573 0.0159858 yes TSS256 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS hESC OK 148.118 157.667 0.0901342 -0.250748 0.802009 0.964629 no TSS257 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0.482708 0 -1.79769e+308 -1.79769e+308 0.361432 1 no TSS258 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS hESC NOTEST 0 0.847143 1.79769e+308 1.79769e+308 0.141964 1 no TSS259 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS hESC NOTEST 0 0.361045 1.79769e+308 1.79769e+308 0.159889 1 no TSS26 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS hESC NOTEST 6.25639 2.57898 -1.27853 1.50397 0.132589 1 no TSS260 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS hESC OK 12.3177 17.9074 0.539819 -0.901624 0.367257 0.59933 no TSS261 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC OK 3.13664 18.1203 2.53032 -2.59005 0.00959608 0.0370991 yes TSS262 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS hESC NOTEST 0 1.08334 1.79769e+308 1.79769e+308 0.116654 1 no TSS263 XLOC_000171 CDA chr1:20915443-20945398 iPS hESC OK 240.92 141.154 -0.771289 1.37456 0.169269 0.351247 no TSS264 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 640.208 326.979 -0.969343 2.87415 0.00405111 0.0175413 yes TSS265 XLOC_000172 PINK1 chr1:20959947-20978003 iPS hESC OK 0 114.96 1.79769e+308 1.79769e+308 4.12982e-06 4.25765e-05 yes TSS266 XLOC_000173 - chr1:21543739-21672034 iPS hESC NOTEST 2.1975 7.51557 1.77402 -0.351856 0.724946 1 no TSS267 XLOC_000174 - chr1:21761832-21762609 iPS hESC OK 0 12075.7 1.79769e+308 1.79769e+308 0.00556566 0.0231724 yes TSS268 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS hESC OK 85.2069 59.4109 -0.520244 0.987282 0.323505 0.55581 no TSS269 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC OK 953.058 5045.41 2.40434 -7.47991 7.43849e-14 3.33193e-12 yes TSS27 XLOC_000031 - chr1:1334909-1342693 iPS hESC OK 252.561 553.309 1.13145 -1.44826 0.147543 0.322115 no TSS270 XLOC_000176 ALPL chr1:21835857-21904904 iPS hESC NOTEST 0 0 0 0 1 1 no TSS271 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC OK 10.8443 22.0415 1.02328 -0.37126 0.710444 0.902118 no TSS272 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS hESC OK 11.8862 10.8865 -0.126752 0.00904423 0.992784 0.999997 no TSS273 XLOC_000178 CELA3B chr1:22303417-22339033 iPS hESC NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TSS274 XLOC_000178 CELA3A chr1:22303417-22339033 iPS hESC NOTEST 0 0 0 0 1 1 no TSS275 XLOC_000179 - chr1:22351706-22357713 iPS hESC OK 27.4246 4.05105 -2.7591 0.788301 0.430521 0.671181 no TSS276 XLOC_000179 - chr1:22351706-22357713 iPS hESC OK 470.397 427.827 -0.136852 0.300117 0.764088 0.941238 no TSS277 XLOC_000180 CDC42 chr1:22379119-22419435 iPS hESC OK 3644.56 1626.45 -1.16402 5.00502 5.58566e-07 7.80191e-06 yes TSS278 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS hESC NOTEST 88.916 198.181 1.15631 -3.02325 0.00250078 1 no TSS279 XLOC_000181 - chr1:22778343-22857650 iPS hESC OK 41.9937 23.69 -0.825896 0.593722 0.552698 0.778693 no TSS28 XLOC_000032 - chr1:1361507-1363166 iPS hESC OK 7.20193 59.0363 3.03515 -2.01569 0.0438326 0.127379 no TSS280 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS hESC OK 33.3894 86.3015 1.37 -2.23977 0.0251058 0.0797371 no TSS281 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC NOTEST 0 0 0 0 1 1 no TSS282 XLOC_000183 C1QA chr1:22963117-22966174 iPS hESC NOTEST 0 0 0 0 1 1 no TSS283 XLOC_000184 C1QC chr1:22970117-22974602 iPS hESC NOTEST 0 0 0 0 1 1 no TSS284 XLOC_000185 C1QB chr1:22979681-22988028 iPS hESC NOTEST 0 0 0 0 1 1 no TSS285 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS hESC OK 58.2137 301.66 2.37349 -5.4047 6.49186e-08 1.02841e-06 yes TSS286 XLOC_000188 - chr1:23345940-23410184 iPS hESC OK 2620.79 4034.49 0.622387 -2.50768 0.0121527 0.0451038 yes TSS287 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS hESC NOTEST 6.87752 2.53326 -1.44089 0.121829 0.903035 1 no TSS288 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC NOTEST 6.59897e-05 0 -1.79769e+308 -1.79769e+308 0.499983 1 no TSS289 XLOC_000191 MDS2 chr1:23907984-23967056 iPS hESC NOTEST 0.878658 0 -1.79769e+308 -1.79769e+308 0.300891 1 no TSS29 XLOC_000033 VWA1 chr1:1370908-1376145 iPS hESC OK 228.717 528.289 1.20777 -2.82221 0.00476939 0.0202465 yes TSS290 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 7606.61 8207.77 0.109737 -0.251342 0.801549 0.964629 no TSS291 XLOC_000192 RPL11 chr1:24018293-24022913 iPS hESC OK 37474.7 66599.3 0.829588 -4.55017 5.36016e-06 5.31515e-05 yes TSS292 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS hESC OK 755.461 523.425 -0.529375 2.00618 0.0448371 0.128573 no TSS293 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS hESC OK 1073.73 1208.06 0.170066 -0.526827 0.598314 0.822444 no TSS294 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS hESC OK 1047.53 2696.47 1.36408 -3.78556 0.000153361 0.00103221 yes TSS295 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS hESC OK 2032.12 1015.28 -1.00111 4.04417 5.25091e-05 0.000401231 yes TSS296 XLOC_000197 - chr1:24526729-24538180 iPS hESC NOTEST 0 0 0 0 1 1 no TSS297 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC OK 11.6632 24.5694 1.0749 -1.2399 0.215012 0.411735 no TSS298 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS hESC NOTEST 9.351 0.00104564 -13.1265 0.0255267 0.979635 1 no TSS299 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS hESC NOTEST 448.144 140.474 -1.67366 3.59136 0.000328956 1 no TSS3 XLOC_000005 - chr1:322036-328580 iPS hESC OK 166.576 338.321 1.02221 -1.66785 0.0953447 0.235015 no TSS30 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS hESC OK 12.4598 69.2663 2.47488 -4.24277 2.20774e-05 0.00019119 yes TSS300 XLOC_000199 - chr1:24742244-24799472 iPS hESC NOTEST 22.1357 5.64277 -1.9719 0.833904 0.404335 1 no TSS301 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC OK 326.184 113.081 -1.52832 3.43158 0.000600074 0.00343125 yes TSS302 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS hESC OK 47.0608 18.7602 -1.32685 0.53612 0.591876 0.816879 no TSS303 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS hESC NOTEST 1.31366 2.35713 0.84344 -0.758715 0.448023 1 no TSS304 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 816.972 805.739 -0.019973 0.0677286 0.946002 0.999997 no TSS305 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 41.7106 47.1916 0.178117 -0.0798044 0.936393 0.999997 no TSS306 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS hESC OK 431.882 943.452 1.12731 -1.87387 0.0609489 0.166329 no TSS31 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 117.436 409.377 1.80156 -2.4613 0.0138435 0.0499521 yes TSS32 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 280.061 249.624 -0.165989 0.322529 0.747052 0.933096 no TSS33 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS hESC OK 35.8479 321.282 3.16388 -1.35368 0.175839 0.356898 no TSS34 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 501.682 844.68 0.751631 -1.88557 0.059353 1 no TSS35 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS hESC NOTEST 100.608 542.034 2.42964 -2.70315 0.00686854 1 no TSS36 XLOC_000037 - chr1:1535818-1543166 iPS hESC OK 2.79141 10.6728 1.93487 -1.28059 0.200338 0.392105 no TSS37 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 51.1667 190.943 1.89987 -2.94405 0.00323945 0.0147338 yes TSS38 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 4.64597 63.8506 3.78065 -1.47132 0.141205 0.310673 no TSS39 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 0 3.88743 1.79769e+308 1.79769e+308 0.139724 1 no TSS4 XLOC_000007 - chr1:420205-421839 iPS hESC NOTEST 0 0 0 0 1 1 no TSS40 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC OK 0 100.348 1.79769e+308 1.79769e+308 6.18945e-08 1.00501e-06 yes TSS41 XLOC_000038 MIB2 chr1:1550883-1565984 iPS hESC NOTEST 12.0776 0 -1.79769e+308 -1.79769e+308 0.194388 1 no TSS42 XLOC_000038 - chr1:1550883-1565984 iPS hESC OK 20.1981 217.26 3.42713 -0.793207 0.427657 0.668504 no TSS43 XLOC_000039 MMP23B chr1:1567559-1570029 iPS hESC OK 12.7213 57.5318 2.17712 -2.43991 0.0146909 0.0527169 no TSS44 XLOC_000039 - chr1:1567559-1570029 iPS hESC NOTEST 0 0 0 0 1 1 no TSS45 XLOC_000039 - chr1:1567559-1570029 iPS hESC OK 0.730004 9.67624 3.72847 -0.514442 0.606943 0.830789 no TSS46 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 0 73.9259 1.79769e+308 1.79769e+308 0.128822 0.292553 no TSS47 XLOC_000040 - chr1:1571099-1677431 iPS hESC OK 19.4885 18.0861 -0.107739 0.020834 0.983378 0.999997 no TSS48 XLOC_000041 - chr1:1571099-1677431 iPS hESC OK 65.0308 78.5208 0.271951 -0.146899 0.883212 0.989045 no TSS49 XLOC_000042 - chr1:1822909-1824112 iPS hESC NOTEST 4.99201 3.15678 -0.661169 0.445901 0.655669 1 no TSS5 XLOC_000012 - chr1:763063-789740 iPS hESC OK 121.633 182.273 0.583564 -0.686162 0.492611 0.728817 no TSS50 XLOC_000043 CALML6 chr1:1846265-1848733 iPS hESC OK 5.39767 26.9908 2.32206 -2.21879 0.0265012 0.0833537 no TSS51 XLOC_000044 GABRD chr1:1950767-1962192 iPS hESC OK 12.037 41.7053 1.79275 -2.92395 0.0034562 0.0155889 yes TSS52 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 199.815 833.609 2.0607 -3.75242 0.000175133 0.00117267 yes TSS53 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS54 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS55 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 94.566 60.5588 -0.642985 0.508906 0.610818 0.832472 no TSS56 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC NOTEST 0 0 0 0 1 1 no TSS57 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 5.19072 17.7633 1.77489 -0.0935942 0.925432 0.999997 no TSS58 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS hESC OK 7.19324 17.4198 1.27601 -0.157234 0.87506 0.985011 no TSS59 XLOC_000047 SKI chr1:2160133-2241651 iPS hESC OK 246.057 740.008 1.58855 -4.88907 1.01312e-06 1.27772e-05 yes TSS6 XLOC_000014 - chr1:846814-850328 iPS hESC OK 8.69571 27.5823 1.66536 -2.60317 0.00923651 0.0359228 yes TSS60 XLOC_000048 RER1 chr1:2323213-2344010 iPS hESC OK 833.583 802.47 -0.0548773 0.173586 0.862191 0.984711 no TSS61 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 0 1.11603 1.79769e+308 1.79769e+308 0.046878 1 no TSS62 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 1.08362 1.19965 0.146754 -0.0925707 0.926245 1 no TSS63 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS hESC NOTEST 1.2132 0 -1.79769e+308 -1.79769e+308 0.274622 1 no TSS64 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS hESC OK 48.2407 3.76675 -3.67886 2.14897 0.031637 0.0978486 no TSS65 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 390.603 811.653 1.05516 -2.81366 0.00489812 0.020658 yes TSS66 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS hESC OK 48.0815 46.1049 -0.0605623 0.0438589 0.965017 0.999997 no TSS67 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS hESC NOTEST 1.00749 5.29478 2.3938 -1.73866 0.0820952 1 no TSS68 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 135.254 229.313 0.761647 -1.65559 0.0978046 0.240167 no TSS69 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 0 60.5958 1.79769e+308 1.79769e+308 0.000147716 0.00099939 yes TSS7 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 95.4282 0 -1.79769e+308 -1.79769e+308 0.357743 0.592837 no TSS70 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 23.0853 60.018 1.37842 -0.746526 0.45535 0.699172 no TSS71 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS hESC OK 8.08924 17.4666 1.11052 -0.232646 0.816037 0.967036 no TSS72 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS hESC OK 546.504 498.776 -0.131839 0.384888 0.700321 0.898884 no TSS73 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC OK 9.4337 63.3435 2.7473 -2.90135 0.00371559 0.016251 yes TSS74 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC OK 1.53994 10.2929 2.7407 -1.14287 0.253092 0.467662 no TSS75 XLOC_000056 TP73 chr1:3569128-3650467 iPS hESC NOTEST 3.71815 0.585598 -2.6666 0.662621 0.507574 1 no TSS76 XLOC_000056 - chr1:3569128-3650467 iPS hESC NOTEST 0 0.923281 1.79769e+308 1.79769e+308 0.436398 1 no TSS77 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS hESC NOTEST 0.580625 2.99279 2.36581 -1.09786 0.272267 1 no TSS78 XLOC_000058 - chr1:3689351-3692545 iPS hESC OK 29.1182 76.8718 1.40054 -1.91184 0.0558967 0.155149 no TSS79 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS hESC OK 72.973 120.109 0.718907 -1.2909 0.196737 0.387244 no TSS8 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 52.9724 1.74761 -4.92178 0.637194 0.523999 0.753819 no TSS80 XLOC_000060 - chr1:3816967-3833877 iPS hESC OK 6.8872 24.9595 1.8576 -1.68829 0.0913563 0.228215 no TSS81 XLOC_000061 - chr1:4000676-4015322 iPS hESC NOTEST 0 0 0 0 1 1 no TSS82 XLOC_000062 - chr1:4472110-4484744 iPS hESC NOTEST 0 0 0 0 1 1 no TSS83 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS hESC OK 104.444 73.9584 -0.497945 0.907909 0.363926 0.596141 no TSS84 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 7.70132 20.2988 1.39822 -0.656659 0.5114 0.746414 no TSS85 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC OK 58.0186 109.98 0.922653 -1.52205 0.127996 0.291696 no TSS86 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 3.9331 0.784025 -2.32669 0.451068 0.651941 1 no TSS87 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS hESC NOTEST 4.96806 0.706557 -2.81381 0.53939 0.589617 1 no TSS88 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 49.2513 41.1437 -0.259489 0.129226 0.897179 0.99186 no TSS89 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 15.3246 17.0218 0.151531 -0.0142087 0.988663 0.999997 no TSS9 XLOC_000015 SAMD11 chr1:860529-894679 iPS hESC OK 48.0828 4.50533 -3.41582 0.961307 0.336398 0.569728 no TSS90 XLOC_000066 RNF207 chr1:6266188-6296044 iPS hESC OK 13.014 17.9047 0.460274 -0.0359132 0.971352 0.999997 no TSS91 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS hESC OK 56.5093 132.225 1.22643 -2.33032 0.0197893 0.0664245 no TSS92 XLOC_000068 HES3 chr1:6304261-6305638 iPS hESC OK 435.49 1431.61 1.71693 -3.72325 0.000196678 0.00129032 yes TSS93 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 7.69434 20.3609 1.40393 -1.49018 0.136178 0.302902 no TSS94 XLOC_000069 ESPN chr1:6484847-6521003 iPS hESC OK 11.3056 157.325 3.79864 -3.70316 0.000212931 0.00137611 yes TSS95 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS hESC NOTEST 3.54524 1.25192 -1.50175 0.685297 0.493157 1 no TSS96 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS hESC OK 157.618 241.107 0.61324 -1.33872 0.180662 0.364976 no TSS97 XLOC_000071 - chr1:6640055-6649339 iPS hESC OK 23.546 85.1502 1.85453 -1.33781 0.18096 0.365011 no TSS98 XLOC_000072 PHF13 chr1:6673755-6684092 iPS hESC OK 277.454 660.096 1.25043 -3.53483 0.00040804 0.00247684 yes TSS99 XLOC_000073 THAP3 chr1:6684924-6761966 iPS hESC OK 69.7903 126.801 0.861471 -0.401954 0.687718 0.890673 no TSS1 XLOC_000001 - chr1:11873-29961 iPS Fibroblasts OK 20.2175 16.1506 -0.324017 0.0343416 0.972605 0.999997 no TSS10 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 63.5773 138.131 1.11946 -1.35168 0.176477 0.357077 no TSS100 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 34.9289 156.028 2.15931 -0.444045 0.65701 0.870874 no TSS101 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts OK 1275.04 3196.37 1.32589 -2.64037 0.00828147 0.032898 yes TSS102 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 8.87986 0 -1.79769e+308 -1.79769e+308 0.247765 1 no TSS103 XLOC_000074 CAMTA1 chr1:6845383-7829763 iPS Fibroblasts NOTEST 0 1.97243 1.79769e+308 1.79769e+308 0.459719 1 no TSS104 XLOC_000074 - chr1:6845383-7829763 iPS Fibroblasts NOTEST 1.762 0 -1.79769e+308 -1.79769e+308 0.464256 1 no TSS105 XLOC_000075 VAMP3 chr1:7831328-7841491 iPS Fibroblasts NOTEST 1500.64 7098.44 2.24192 -5.37272 7.75556e-08 1 no TSS106 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 67.8365 46.9633 -0.530528 0.16568 0.868409 0.985011 no TSS107 XLOC_000076 PER3 chr1:7844379-7973294 iPS Fibroblasts OK 223.621 311.575 0.478524 -0.869833 0.384392 0.618948 no TSS108 XLOC_000077 PARK7 chr1:8021713-8045341 iPS Fibroblasts OK 4677.15 21641.5 2.2101 -4.6239 3.76598e-06 3.91361e-05 yes TSS109 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 1.80448 142.738 6.30564 -3.48523 0.000491717 0.00287721 yes TSS11 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 55.6229 48.7092 -0.191482 0.0905716 0.927833 0.999997 no TSS110 XLOC_000078 SLC45A1 chr1:8384389-8404226 iPS Fibroblasts OK 9.62868 69.3396 2.84827 -2.1887 0.0286188 0.0893649 no TSS111 XLOC_000079 CA6 chr1:9005921-9035146 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS112 XLOC_000080 H6PD chr1:9294862-9331392 iPS Fibroblasts OK 137.324 1112.18 3.01773 -6.69857 2.10465e-11 5.81689e-10 yes TSS113 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts OK 70.5381 201.501 1.51431 -1.80076 0.0717407 0.189029 no TSS114 XLOC_000081 SPSB1 chr1:9352940-9429588 iPS Fibroblasts OK 17.2656 674.909 5.28872 -4.07106 4.67994e-05 0.000364027 yes TSS115 XLOC_000082 SLC25A33 chr1:9599527-9642830 iPS Fibroblasts OK 216.702 266.339 0.297552 -0.460364 0.645255 0.860561 no TSS116 XLOC_000083 TMEM201 chr1:9648976-9674935 iPS Fibroblasts OK 122.735 330.695 1.42995 -2.23236 0.025591 0.0808824 no TSS117 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 42.5258 45.2674 0.0901354 -0.0104824 0.991636 0.999997 no TSS118 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 132.845 109.373 -0.280493 0.0778734 0.937929 0.999997 no TSS119 XLOC_000084 PIK3CD chr1:9711789-9884550 iPS Fibroblasts OK 17.0706 21.2442 0.315552 -0.0174008 0.986117 0.999997 no TSS12 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 29.3795 99.7819 1.76397 -1.21385 0.224804 0.427885 no TSS120 XLOC_000085 NMNAT1 chr1:10003485-10045555 iPS Fibroblasts OK 61.6068 319.369 2.37406 -4.08642 4.38084e-05 0.000345222 yes TSS121 XLOC_000086 RBP7 chr1:10057254-10076077 iPS Fibroblasts OK 115.178 19.7819 -2.54161 2.84301 0.00446892 0.0192223 yes TSS122 XLOC_000087 UBE4B chr1:10093015-10241294 iPS Fibroblasts OK 531.227 1169.94 1.13903 -2.66732 0.00764589 0.0307492 yes TSS123 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts OK 171.613 70.0715 -1.29225 0.171361 0.86394 0.984711 no TSS124 XLOC_000087 - chr1:10093015-10241294 iPS Fibroblasts OK 7.8499 200.875 4.67748 -0.414985 0.678153 0.882686 no TSS125 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 833.691 1011.58 0.279028 -0.383355 0.701457 0.898884 no TSS126 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts NOTEST 0 5.57672 1.79769e+308 1.79769e+308 0.441638 1 no TSS127 XLOC_000088 KIF1B chr1:10270763-10441659 iPS Fibroblasts OK 76.9201 29.2168 -1.39656 0.470731 0.637833 0.855051 no TSS128 XLOC_000089 PGD chr1:10459084-10480200 iPS Fibroblasts OK 1416.9 13970.1 3.30153 -6.65003 2.93028e-11 7.61286e-10 yes TSS129 XLOC_000090 APITD1,Cort chr1:10490158-10512208 iPS Fibroblasts OK 78.5742 125.257 0.67276 -0.382475 0.702109 0.898884 no TSS13 XLOC_000016 KLHL17 chr1:895966-901095 iPS Fibroblasts OK 34.9548 60.5379 0.792348 -0.367699 0.713097 0.904603 no TSS130 XLOC_000090 APITD1 chr1:10490158-10512208 iPS Fibroblasts OK 172.607 526.06 1.60774 -2.3914 0.0167842 0.057527 no TSS131 XLOC_000090 CORT chr1:10490158-10512208 iPS Fibroblasts OK 33.6985 12.1268 -1.47448 0.209345 0.834179 0.971712 no TSS132 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 iPS Fibroblasts OK 252.617 1632.34 2.69192 -2.63313 0.00846012 0.0335052 yes TSS133 XLOC_000091 PEX14 chr1:10535002-10690813 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS134 XLOC_000092 TARDBP chr1:11072678-11085548 iPS Fibroblasts OK 1918.99 2744.34 0.516115 -1.38416 0.16631 0.348102 no TSS135 XLOC_000093 ANGPTL7 chr1:11166588-11322608 iPS Fibroblasts OK 25.3243 10.571 -1.26041 0.228828 0.819003 0.967036 no TSS136 XLOC_000094 UBIAD1 chr1:11333254-11348490 iPS Fibroblasts OK 358.008 332.294 -0.10753 0.227893 0.81973 0.967036 no TSS137 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts OK 37.3062 0.546235 -6.09375 3.88045 0.000104265 0.000748289 yes TSS138 XLOC_000095 PTCHD2 chr1:11539294-11597639 iPS Fibroblasts NOTEST 12.3118 7.55415e-05 -17.3143 0.00208675 0.998335 1 no TSS139 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts NOTEST 0 10.2274 1.79769e+308 1.79769e+308 0.339517 1 no TSS14 XLOC_000017 PLEKHN1 chr1:901876-910482 iPS Fibroblasts OK 6.18615 59.3098 3.26116 -3.26906 0.00107904 0.00573861 yes TSS140 XLOC_000096 FBXO44 chr1:11708449-11723383 iPS Fibroblasts OK 170.98 415.411 1.28071 -1.27029 0.203982 0.39726 no TSS141 XLOC_000097 FBXO6 chr1:11724149-11734407 iPS Fibroblasts OK 77.8716 363.317 2.22206 -3.49068 0.000481788 0.00283926 yes TSS142 XLOC_000098 C1orf187 chr1:11751780-11780336 iPS Fibroblasts OK 200.894 11.5677 -4.11826 4.62994 3.65767e-06 3.84618e-05 yes TSS143 XLOC_000100 AGTRAP chr1:11796141-11810827 iPS Fibroblasts OK 747.942 1911.82 1.35395 -2.52663 0.0115162 0.0431111 yes TSS144 XLOC_000101 C1orf167 chr1:11824461-11826573 iPS Fibroblasts NOTEST 4.69748 1.86471 -1.33293 0.629152 0.529249 1 no TSS145 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS146 XLOC_000102 C1orf167 chr1:11832138-11866115 iPS Fibroblasts NOTEST 1.75837 8.96806 2.35056 -0.118497 0.905674 1 no TSS147 XLOC_000103 CLCN6 chr1:11866206-11907840 iPS Fibroblasts OK 149.528 569.35 1.9289 -1.36048 0.173679 0.354732 no TSS148 XLOC_000103 - chr1:11866206-11907840 iPS Fibroblasts OK 6.40643 16.145 1.33349 -0.070307 0.943949 0.999997 no TSS149 XLOC_000104 PLOD1 chr1:11994745-12035593 iPS Fibroblasts OK 865.542 10441.6 3.5926 -6.85911 6.9289e-12 2.09317e-10 yes TSS15 XLOC_000018 ISG15 chr1:948846-949915 iPS Fibroblasts OK 550.84 3379.09 2.61693 -4.82844 1.37606e-06 1.67056e-05 yes TSS150 XLOC_000105 MFN2 chr1:12040237-12073571 iPS Fibroblasts OK 647.078 2871.51 2.1498 -5.10134 3.3726e-07 4.81429e-06 yes TSS151 XLOC_000106 MIIP chr1:12079511-12092106 iPS Fibroblasts OK 504.143 575.01 0.189755 -0.366506 0.713987 0.904848 no TSS152 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts OK 197.882 4.49636 -5.45974 4.45435 8.4148e-06 7.92088e-05 yes TSS153 XLOC_000107 TNFRSF8 chr1:12123433-12204262 iPS Fibroblasts NOTEST 6.44015 4.00161 -0.686515 0.102872 0.918064 1 no TSS154 XLOC_000108 TNFRSF1B chr1:12227059-12269276 iPS Fibroblasts OK 15.3506 1395.94 6.5068 -10.8043 0 0 yes TSS155 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 328.032 191.792 -0.774297 1.22737 0.219685 0.419663 no TSS156 XLOC_000109 VPS13D chr1:12290112-12572096 iPS Fibroblasts OK 19.4784 94.7776 2.28267 -1.3543 0.175642 0.356898 no TSS157 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts OK 39.9995 0 -1.79769e+308 -1.79769e+308 0.188331 0.376952 no TSS158 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts OK 0 65.4483 1.79769e+308 1.79769e+308 0.120597 0.281249 no TSS159 XLOC_000109 - chr1:12290112-12572096 iPS Fibroblasts NOTEST 0 2.38321 1.79769e+308 1.79769e+308 0.485245 1 no TSS16 XLOC_000019 AGRN chr1:955502-991492 iPS Fibroblasts OK 162.844 2553.38 3.97085 -8.29349 0 0 yes TSS160 XLOC_000111 AADACL4 chr1:12704565-12727096 iPS Fibroblasts NOTEST 0.911079 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TSS161 XLOC_000112 AADACL3 chr1:12776117-12788726 iPS Fibroblasts OK 56.4313 0 -1.79769e+308 -1.79769e+308 0.00123708 0.0064537 yes TSS162 XLOC_000113 C1orf158 chr1:12806162-12821101 iPS Fibroblasts NOTEST 1.78177 0 -1.79769e+308 -1.79769e+308 0.345744 1 no TSS163 XLOC_000114 PRAMEF12 chr1:12834983-12838046 iPS Fibroblasts NOTEST 3.60576 0 -1.79769e+308 -1.79769e+308 0.0603368 1 no TSS164 XLOC_000115 PRAMEF1 chr1:12851545-12856223 iPS Fibroblasts NOTEST 1.07984 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TSS165 XLOC_000116 PRAMEF2 chr1:12916940-12921764 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS166 XLOC_000117 PRAMEF8 chr1:12976449-12980566 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS167 XLOC_000118 PRAMEF22 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS168 XLOC_000119 PRAMEF6 chr1:13359818-13369057 iPS Fibroblasts NOTEST 0.310672 0 -1.79769e+308 -1.79769e+308 0.320756 1 no TSS169 XLOC_000120 PRAMEF9 chr1:13421175-13428191 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TSS17 XLOC_000020 - chr1:995082-1001833 iPS Fibroblasts OK 22.5944 70.3957 1.63952 -1.68346 0.0922859 0.229215 no TSS170 XLOC_000121 PRAMEF16 chr1:13495253-13498257 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS171 XLOC_000122 PRAMEF20 chr1:13516065-13526943 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS172 XLOC_000123 PRAMEF10 chr1:13629937-13635298 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS173 XLOC_000124 PRAMEF9 chr1:13641972-13648988 iPS Fibroblasts NOTEST 0.137425 0 -1.79769e+308 -1.79769e+308 0.378132 1 no TSS174 XLOC_000125 PRAMEF17 chr1:13716087-13719064 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS175 XLOC_000126 PRAMEF20 chr1:13736906-13747803 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS176 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts OK 1297.74 111.012 -3.54721 6.16629 6.99114e-10 1.51358e-08 yes TSS177 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS178 XLOC_000127 PDPN chr1:13910251-13944450 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS179 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 0 27.8928 1.79769e+308 1.79769e+308 0.277099 0.504134 no TSS18 XLOC_000021 - chr1:1072396-1079432 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS180 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 62.0992 14.8538 -2.06374 1.28014 0.200497 0.392105 no TSS181 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS182 XLOC_000128 PRDM2 chr1:14026734-14151572 iPS Fibroblasts OK 177.84 431.651 1.27929 -1.73525 0.0826962 0.212297 no TSS183 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 51.7288 9.90288 -2.38505 0.513512 0.607593 0.830803 no TSS184 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 1.99898 29.388 3.87789 -0.5242 0.60014 0.823212 no TSS185 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 0 13.2968 1.79769e+308 1.79769e+308 0.307255 0.535736 no TSS186 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 5.70387 205.94 5.17414 -2.0117 0.0442514 0.127739 no TSS187 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts OK 0 208.608 1.79769e+308 1.79769e+308 0.0620669 0.168671 no TSS188 XLOC_000129 - chr1:14925212-15478960 iPS Fibroblasts NOTEST 7.67766 10.0324 0.385926 -0.115068 0.908391 1 no TSS189 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 43.9133 34.1487 -0.362827 0.175295 0.860848 0.984711 no TSS19 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS190 XLOC_000130 TMEM51 chr1:15479027-15546973 iPS Fibroblasts OK 101.145 679.888 2.74888 -3.72452 0.000195685 0.00129032 yes TSS1906 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 0.0436773 560.298 13.647 -0.113064 0.909979 0.999997 no TSS1907 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 499.712 76.652 -2.7047 1.76296 0.0779065 0.203214 no TSS1908 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 108.765 0 -1.79769e+308 -1.79769e+308 0.0812742 0.209891 no TSS1909 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 261.042 313.868 0.265875 -0.178303 0.858485 0.984711 no TSS191 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 3.59181 2.29329 -0.647296 0.50928 0.610556 1 no TSS1910 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1911 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 166.699 240.082 0.526283 -0.259654 0.795131 0.960814 no TSS1912 XLOC_001217 - chr1:11873-29961 iPS Fibroblasts OK 42.2462 228.081 2.43265 -0.753697 0.451031 0.69336 no TSS1913 XLOC_001218 - chr1:34611-36081 iPS Fibroblasts NOTEST 13.7184 4.32826 -1.66426 1.37047 0.17054 1 no TSS1914 XLOC_001219 - chr1:89294-237877 iPS Fibroblasts OK 12.8434 13.5604 0.0783645 -0.0449207 0.964171 0.999997 no TSS1915 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts NOTEST 15.7705 1.6027 -3.29865 0.362728 0.716808 1 no TSS1916 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 161.143 39.9694 -2.01137 2.2363 0.0253321 0.0802595 no TSS1917 XLOC_001222 - chr1:661139-679736 iPS Fibroblasts OK 266.451 68.2817 -1.9643 1.16496 0.244037 0.455466 no TSS1918 XLOC_001227 - chr1:700236-714006 iPS Fibroblasts OK 247.682 50.5377 -2.29306 3.18069 0.00146925 0.00737546 yes TSS1919 XLOC_001229 FAM41C chr1:803452-812182 iPS Fibroblasts NOTEST 17.3524 7.41126 -1.22735 1.36605 0.171923 1 no TSS192 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 2.21856 0.862567 -1.36291 0.494457 0.620983 1 no TSS1920 XLOC_001230 - chr1:852952-854817 iPS Fibroblasts NOTEST 0 7.62477 1.79769e+308 1.79769e+308 0.121258 1 no TSS1921 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 36.029 55.7714 0.630367 -0.108681 0.913455 0.999997 no TSS1922 XLOC_001231 NOC2L chr1:860529-894679 iPS Fibroblasts OK 628.462 2164.3 1.78401 -2.74591 0.00603435 0.0248058 yes TSS1923 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts OK 9.49353 36.2061 1.93122 -1.86716 0.0618794 0.168514 no TSS1924 XLOC_001232 C1orf170 chr1:910578-917473 iPS Fibroblasts NOTEST 0 2.14049 1.79769e+308 1.79769e+308 0.233217 1 no TSS1925 XLOC_001233 HES4 chr1:934341-935552 iPS Fibroblasts OK 54.1565 33.6271 -0.68751 0.630637 0.528278 0.756597 no TSS1926 XLOC_001234 - chr1:1017197-1051736 iPS Fibroblasts NOTEST 0 6.02886 1.79769e+308 1.79769e+308 0.405618 1 no TSS1927 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 26.1514 75.8125 1.53554 -0.818049 0.413329 0.651595 no TSS1928 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 50.4508 59.219 0.231184 -0.149613 0.88107 0.987498 no TSS1929 XLOC_001234 C1orf159 chr1:1017197-1051736 iPS Fibroblasts OK 18.8091 84.2776 2.16372 -1.61722 0.105831 0.256482 no TSS193 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1930 XLOC_001235 - chr1:1108435-1133313 iPS Fibroblasts NOTEST 0.346272 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TSS1931 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts NOTEST 2.09869 0 -1.79769e+308 -1.79769e+308 0.293864 1 no TSS1932 XLOC_001236 TNFRSF18 chr1:1138888-1142089 iPS Fibroblasts OK 1.73875 14.2699 3.03685 -1.04554 0.295775 0.524571 no TSS1933 XLOC_001237 TNFRSF4 chr1:1146706-1149512 iPS Fibroblasts NOTEST 1.29516 5.89401 2.18612 -0.701912 0.482734 1 no TSS1934 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 60.6719 71.6823 0.240588 -0.0431911 0.965549 0.999997 no TSS1935 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 868.797 8958.96 3.36624 -6.90811 4.9114e-12 1.51903e-10 yes TSS1936 XLOC_001238 SDF4 chr1:1152288-1167447 iPS Fibroblasts OK 32.4396 114.07 1.81409 -0.0863577 0.931182 0.999997 no TSS1937 XLOC_001239 FAM132A chr1:1177832-1182102 iPS Fibroblasts OK 17.131 75.8216 2.146 -2.50106 0.0123824 0.0458253 yes TSS1938 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 16.9893 27.9153 0.716428 -0.129263 0.89715 0.99186 no TSS1939 XLOC_001240 UBE2J2 chr1:1189293-1209234 iPS Fibroblasts OK 480.97 1963.86 2.02967 -4.01527 5.93776e-05 0.000451061 yes TSS194 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1940 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 9.37264 101.369 3.43502 -0.620169 0.535146 0.761529 no TSS1941 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 25.8307 86.9123 1.75048 -0.820189 0.412108 0.65046 no TSS1942 XLOC_001242 ACAP3 chr1:1227763-1260046 iPS Fibroblasts OK 93.257 810.457 3.11945 -3.19403 0.00140303 0.00711926 yes TSS1943 XLOC_001242 - chr1:1227763-1260046 iPS Fibroblasts OK 26.1554 131.616 2.33116 -0.550923 0.581687 0.807183 no TSS1944 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 79.6054 120.03 0.592453 -0.238418 0.811557 0.96628 no TSS1945 XLOC_001243 CPSF3L chr1:1227763-1260046 iPS Fibroblasts OK 857.443 2988.65 1.80138 -2.24517 0.0247575 0.0796041 no TSS1946 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 iPS Fibroblasts OK 71.8385 302.198 2.07267 -1.26772 0.204896 0.398096 no TSS1947 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 173.57 1267.03 2.86786 -4.88324 1.04359e-06 1.30348e-05 yes TSS1948 XLOC_001244 DVL1 chr1:1270658-1284492 iPS Fibroblasts OK 30.2667 23.7193 -0.351671 0.119057 0.90523 0.997365 no TSS1949 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts NOTEST 1077.16 14301.4 3.73085 -6.82016 9.09384e-12 1 no TSS195 XLOC_000131 FHAD1 chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0.572031 1.79769e+308 1.79769e+308 0.365615 1 no TSS1950 XLOC_001245 MXRA8 chr1:1288071-1297157 iPS Fibroblasts OK 2.23252 18.6477 3.06225 -0.0420455 0.966462 0.999997 no TSS1951 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 1486.29 3221.31 1.11593 -1.55704 0.11946 0.279602 no TSS1952 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 360.213 1951.82 2.4379 -1.3791 0.167865 0.349449 no TSS1953 XLOC_001246 AURKAIP1 chr1:1309109-1310818 iPS Fibroblasts OK 711.073 1861.17 1.38814 -1.71255 0.0867961 0.220211 no TSS1954 XLOC_001247 - chr1:1321090-1334718 iPS Fibroblasts NOTEST 5.40934 6.77005 0.323712 -0.013806 0.988985 1 no TSS1955 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 114.444 134.515 0.233129 -0.175207 0.860917 0.984711 no TSS1956 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 6.6959 19.8352 1.56671 -0.139295 0.889217 0.989797 no TSS1957 XLOC_001247 CCNL2 chr1:1321090-1334718 iPS Fibroblasts OK 622.633 1112.52 0.837373 -1.51518 0.129727 0.294092 no TSS1958 XLOC_001248 MRPL20 chr1:1334909-1342693 iPS Fibroblasts OK 3133.93 8744.67 1.48043 -3.20965 0.00132895 0.00682334 yes TSS1959 XLOC_001249 - chr1:1353801-1356650 iPS Fibroblasts OK 55.0852 100.918 0.873453 -0.985008 0.32462 0.556197 no TSS196 XLOC_000131 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1960 XLOC_001250 C1orf70 chr1:1470158-1475740 iPS Fibroblasts OK 31.9981 233.834 2.86942 -3.74518 0.000180267 0.00120085 yes TSS1961 XLOC_001251 SSU72 chr1:1477053-1510262 iPS Fibroblasts OK 2379.43 6671.18 1.48732 -3.27366 0.00106163 0.00567515 yes TSS1962 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 33.8277 286.25 3.081 -0.800519 0.42341 0.663392 no TSS1963 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 9.33823 366.787 5.29565 -0.525029 0.599563 0.823212 no TSS1964 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 117.815 1936.1 4.03856 -1.36634 0.171831 0.353371 no TSS1965 XLOC_001252 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 76.2007 795.035 3.38314 -0.179219 0.857765 0.984711 no TSS1966 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 4.69427 19.8478 2.08001 -0.0455343 0.963681 0.999997 no TSS1967 XLOC_001252 CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 44.597 169.529 1.92651 -0.244644 0.806732 0.964629 no TSS1968 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 iPS Fibroblasts OK 35.3518 112.085 1.66473 -0.0536223 0.957236 0.999997 no TSS1969 XLOC_001253 CDC2L1 chr1:1571099-1677431 iPS Fibroblasts OK 81.9647 440.918 2.42744 -0.388777 0.697441 0.898785 no TSS197 XLOC_000132 EFHD2 chr1:15736390-15756839 iPS Fibroblasts OK 330.754 2197 2.7317 -5.82153 5.83102e-09 1.0376e-07 yes TSS1970 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 122.675 315.575 1.36314 -0.476199 0.633933 0.853346 no TSS1971 XLOC_001254 - chr1:1571099-1677431 iPS Fibroblasts OK 57.9127 276.724 2.2565 -1.53229 0.125451 0.288425 no TSS1972 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 210.369 762.008 1.85688 -1.07137 0.284005 0.51374 no TSS1973 XLOC_001254 SLC35E2 chr1:1571099-1677431 iPS Fibroblasts OK 48.2599 362.567 2.90935 -0.729277 0.465832 0.71023 no TSS1974 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts NOTEST 10.1742 1.85523 -2.45525 0.0404214 0.967757 1 no TSS1975 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 331.317 1204.38 1.86201 -3.86726 0.000110064 0.000781277 yes TSS1976 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 38.1873 0 -1.79769e+308 -1.79769e+308 0.235731 0.443789 no TSS1977 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 46.8111 2.79122 -4.06788 0.143026 0.88627 0.989719 no TSS1978 XLOC_001256 NADK chr1:1682677-1711508 iPS Fibroblasts OK 57.4086 43.7417 -0.392256 0.0819804 0.934662 0.999997 no TSS1979 XLOC_001257 GNB1 chr1:1716729-1822495 iPS Fibroblasts OK 4287.86 16708.8 1.96228 -3.94405 8.01162e-05 0.000587972 yes TSS198 XLOC_000133 CTRC chr1:15764937-15773153 iPS Fibroblasts NOTEST 2.23637 5.61806 1.32891 -0.360035 0.718821 1 no TSS1980 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 78.6765 0 -1.79769e+308 -1.79769e+308 0.00735151 0.0296654 yes TSS1981 XLOC_001258 TMEM52 chr1:1849028-1850740 iPS Fibroblasts OK 23.4913 23.4115 -0.00490924 0.00281086 0.997757 0.999997 no TSS1982 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1983 XLOC_001259 C1orf222 chr1:1853396-1859368 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1984 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 1.22859 0 -1.79769e+308 -1.79769e+308 0.233084 1 no TSS1985 XLOC_001260 KIAA1751 chr1:1884751-1935276 iPS Fibroblasts NOTEST 0.437707 0 -1.79769e+308 -1.79769e+308 0.332442 1 no TSS1986 XLOC_001261 - chr1:1944651-1946969 iPS Fibroblasts NOTEST 4.28982 0 -1.79769e+308 -1.79769e+308 0.0384012 1 no TSS1987 XLOC_001262 - chr1:1981908-2139172 iPS Fibroblasts OK 13.1667 27.1259 1.04278 -0.126228 0.899551 0.992793 no TSS1988 XLOC_001263 C1orf86 chr1:1981908-2139172 iPS Fibroblasts OK 419.525 2769.72 2.72291 -3.45353 0.000553296 0.00319436 yes TSS1989 XLOC_001263 - chr1:1981908-2139172 iPS Fibroblasts OK 6.98486 78.7015 3.49409 -0.548475 0.583366 0.80788 no TSS199 XLOC_000134 CELA2A chr1:15783222-15798585 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1990 XLOC_001264 MORN1 chr1:2252695-2322993 iPS Fibroblasts OK 54.986 102.498 0.898453 -0.711315 0.476889 0.715334 no TSS1991 XLOC_001266 PEX10 chr1:2323213-2344010 iPS Fibroblasts OK 290.341 917.336 1.6597 -1.30192 0.192945 0.383235 no TSS1992 XLOC_001267 PANK4 chr1:2439974-2458035 iPS Fibroblasts OK 174.785 500.991 1.5192 -2.92007 0.00349955 0.0156756 yes TSS1993 XLOC_001268 HES5 chr1:2460184-2461684 iPS Fibroblasts NOTEST 6.35744 0 -1.79769e+308 -1.79769e+308 0.0423949 1 no TSS1994 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts NOTEST 0.907232 6.38716 2.81563 -0.545215 0.585605 1 no TSS1995 XLOC_001269 - chr1:2481358-2495265 iPS Fibroblasts NOTEST 1.10294 9.83614 3.15674 -0.697049 0.485772 1 no TSS1996 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1997 XLOC_001270 MMEL1 chr1:2518248-2564481 iPS Fibroblasts NOTEST 0.931281 3.38316 1.86108 -0.0777597 0.938019 1 no TSS1998 XLOC_001271 - chr1:2976182-2980350 iPS Fibroblasts NOTEST 0.620738 0.336145 -0.884902 0.323409 0.746385 1 no TSS1999 XLOC_001272 - chr1:2980635-2984289 iPS Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no TSS2 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 189.247 29.2848 -2.69205 2.62731 0.00860621 0.0339801 yes TSS20 XLOC_000025 TTLL10 chr1:1108435-1133313 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS200 XLOC_000135 CELA2B chr1:15802595-15851384 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2000 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts NOTEST 69.8392 92.849 0.410849 -0.552337 0.580718 1 no TSS2001 XLOC_001273 MEGF6 chr1:3404512-3528059 iPS Fibroblasts OK 43.7292 64.5702 0.562274 -0.623806 0.532755 0.760493 no TSS2002 XLOC_001274 WDR8 chr1:3547331-3566671 iPS Fibroblasts OK 264.765 520.346 0.974758 -1.52921 0.126211 0.288641 no TSS2003 XLOC_001275 - chr1:3652549-3663886 iPS Fibroblasts OK 0 30.0855 1.79769e+308 1.79769e+308 0.199297 0.39166 no TSS2004 XLOC_001275 KIAA0495 chr1:3652549-3663886 iPS Fibroblasts OK 201.581 227.555 0.174861 -0.373366 0.708876 0.902118 no TSS2005 XLOC_001276 LRRC47 chr1:3696783-3713068 iPS Fibroblasts OK 867.894 1410.28 0.700388 -1.71311 0.0866925 0.220211 no TSS2006 XLOC_001277 KIAA0562 chr1:3728644-3773797 iPS Fibroblasts OK 266.214 568.38 1.09427 -1.74167 0.0815657 0.210178 no TSS2007 XLOC_001278 C1orf174 chr1:3805702-3816857 iPS Fibroblasts OK 489.179 1182.73 1.27368 -2.56396 0.0103486 0.0395377 yes TSS2008 XLOC_001279 - chr1:5621768-5728315 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2009 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts OK 47.7688 102.752 1.10502 -1.59553 0.110594 0.265059 no TSS201 XLOC_000136 DNAJC16 chr1:15853351-15918872 iPS Fibroblasts OK 464.958 376.455 -0.304624 0.628097 0.52994 0.758142 no TSS2010 XLOC_001280 NPHP4 chr1:5922869-6052531 iPS Fibroblasts NOTEST 12.3891 8.76607 -0.499075 0.249038 0.803332 1 no TSS2011 XLOC_001280 - chr1:5922869-6052531 iPS Fibroblasts NOTEST 1.34942 3.61882 1.42318 -0.0776635 0.938096 1 no TSS2012 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 0 2.58654 1.79769e+308 1.79769e+308 0.0700196 1 no TSS2013 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts NOTEST 3.69165 0.873718 -2.07903 0.871562 0.383447 1 no TSS2014 XLOC_001281 CHD5 chr1:6161852-6240183 iPS Fibroblasts NOTEST 6.8891 0.611774 -3.49325 1.46963 0.141662 1 no TSS2015 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts NOTEST 3.73417 0 -1.79769e+308 -1.79769e+308 0.269027 1 no TSS2016 XLOC_001281 - chr1:6161852-6240183 iPS Fibroblasts NOTEST 0.120394 0 -1.79769e+308 -1.79769e+308 0.459936 1 no TSS2017 XLOC_001282 RPL22 chr1:6245080-6259679 iPS Fibroblasts OK 2431.44 9875.13 2.02199 -4.57018 4.87316e-06 4.9455e-05 yes TSS2018 XLOC_001283 ICMT chr1:6266188-6296044 iPS Fibroblasts OK 1479.52 2608.03 0.817829 -2.06715 0.0387202 0.116161 no TSS2019 XLOC_001284 GPR153 chr1:6307413-6321035 iPS Fibroblasts OK 37.8293 268.364 2.82662 -2.76946 0.00561494 0.0233029 yes TSS202 XLOC_000136 - chr1:15853351-15918872 iPS Fibroblasts NOTEST 6.69281 2.11882 -1.65935 0.0533227 0.957475 1 no TSS2020 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 239.832 2679.84 0 0 1 1 no TSS2021 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 0 39.0287 0 0 1 1 no TSS2022 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 126.845 110.585 0 0 1 1 no TSS2023 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 462.887 732.481 0 0 1 1 no TSS2024 XLOC_001285 ACOT7 chr1:6324332-6453826 iPS Fibroblasts FAIL 134.974 1033.82 0 0 1 1 no TSS2025 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 0 0.48661 1.79769e+308 1.79769e+308 0.338266 1 no TSS2026 XLOC_001286 HES2 chr1:6472499-6484730 iPS Fibroblasts NOTEST 5.92301 1.41752 -2.06296 2.01896 0.0434917 1 no TSS2027 XLOC_001287 TNFRSF25 chr1:6521220-6580069 iPS Fibroblasts OK 50.6435 24.4669 -1.04955 0.236135 0.813328 0.966771 no TSS2028 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 12.7468 1.74109 -2.87207 0.301357 0.763142 1 no TSS2029 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 2.06233 2.5797 0.32293 -0.0411122 0.967206 1 no TSS203 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts OK 484.832 311.27 -0.639322 0.883437 0.377 0.612154 no TSS2030 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 14.2602 0 -1.79769e+308 -1.79769e+308 0.17142 1 no TSS2031 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2032 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 17.5992 34.905 0.987923 -0.737732 0.460678 0.703296 no TSS2033 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 25.7562 0.024414 -10.043 0.377839 0.70555 0.901189 no TSS2034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts OK 0.00544137 18.3016 11.7157 -0.0837056 0.93329 0.999997 no TSS2036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 iPS Fibroblasts NOTEST 14.4826 3.95345 -1.87313 0.59659 0.550781 1 no TSS2037 XLOC_001287 - chr1:6521220-6580069 iPS Fibroblasts OK 30.5163 12.5671 -1.27992 0.383901 0.701052 0.898884 no TSS2038 XLOC_001288 NOL9 chr1:6585209-6614581 iPS Fibroblasts OK 503.823 363.843 -0.469602 0.957548 0.338291 0.571443 no TSS2039 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 109.476 455.331 2.0563 -2.13231 0.0329814 0.101523 no TSS204 XLOC_000137 DDI2 chr1:15944069-15988216 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2040 XLOC_001289 KLHL21 chr1:6650778-6662929 iPS Fibroblasts OK 134.239 601.611 2.16403 -2.03687 0.0416632 0.123563 no TSS2041 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2042 XLOC_001290 DNAJC11 chr1:6684924-6761966 iPS Fibroblasts OK 743.808 1731.39 1.21893 -2.76008 0.00577868 0.0239061 yes TSS2043 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2044 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 2.40953 0 -1.79769e+308 -1.79769e+308 0.449621 1 no TSS2045 XLOC_001291 UTS2 chr1:7844379-7973294 iPS Fibroblasts NOTEST 0.0400905 0 -1.79769e+308 -1.79769e+308 0.496829 1 no TSS2046 XLOC_001292 TNFRSF9 chr1:7979907-8000887 iPS Fibroblasts NOTEST 0 1.38187 1.79769e+308 1.79769e+308 0.0774008 1 no TSS2047 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 641.313 2240.53 1.80474 -4.1258 3.69455e-05 0.000301495 yes TSS2048 XLOC_001293 ERRFI1 chr1:8071779-8086393 iPS Fibroblasts OK 137.346 71.1003 -0.949889 0.287302 0.773881 0.94691 no TSS2049 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 1.40725 1692.19 10.2318 -0.605892 0.544586 0.771972 no TSS205 XLOC_000139 PLEKHM2 chr1:16010826-16061262 iPS Fibroblasts OK 363.264 2346.33 2.69132 -6.1413 8.18468e-10 1.6876e-08 yes TSS2050 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 186.982 278.541 0.574986 -0.315866 0.752104 0.935808 no TSS2051 XLOC_001294 RERE chr1:8412465-8877699 iPS Fibroblasts OK 0 47.6257 1.79769e+308 1.79769e+308 0.43296 0.672745 no TSS2052 XLOC_001294 - chr1:8412465-8877699 iPS Fibroblasts OK 85.8783 6.13498 -3.80716 0.0566625 0.954814 0.999997 no TSS2053 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 444.441 181.074 -1.29541 0.0760813 0.939354 0.999997 no TSS2054 XLOC_001296 ENO1 chr1:8921062-8938780 iPS Fibroblasts OK 21997.3 71451.4 1.69963 -4.73115 2.23252e-06 2.50004e-05 yes TSS2055 XLOC_001297 SLC2A7 chr1:9063358-9086404 iPS Fibroblasts NOTEST 0 0.725244 1.79769e+308 1.79769e+308 0.180502 1 no TSS2056 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 0 7.16648 1.79769e+308 1.79769e+308 0.382366 1 no TSS2057 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts NOTEST 2.34161 4.17775 0.835229 -0.0307 0.975509 1 no TSS2058 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts OK 0.00429204 51.3731 13.5471 -0.0376447 0.969971 0.999997 no TSS2059 XLOC_001298 SLC2A5 chr1:9097006-9148510 iPS Fibroblasts OK 3.56432 61.3688 4.10581 -2.97039 0.00297426 0.0137984 yes TSS206 XLOC_000140 SLC25A34 chr1:16062808-16067885 iPS Fibroblasts NOTEST 6.39779 9.3373 0.545433 -0.543143 0.587032 1 no TSS2060 XLOC_001299 GPR157 chr1:9164475-9189356 iPS Fibroblasts OK 27.3747 98.5546 1.84808 -1.53473 0.12485 0.288425 no TSS2061 XLOC_001300 - chr1:9208346-9242451 iPS Fibroblasts OK 95.9263 69.3907 -0.467184 0.755747 0.449801 0.692289 no TSS2062 XLOC_001301 C1orf200 chr1:9711789-9884550 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2063 XLOC_001302 - chr1:9711789-9884550 iPS Fibroblasts OK 86.8241 61.7832 -0.490881 0.0609674 0.951385 0.999997 no TSS2064 XLOC_001303 - chr1:9711789-9884550 iPS Fibroblasts OK 3.82816 695.497 7.50525 -0.286002 0.774877 0.94691 no TSS2065 XLOC_001303 CLSTN1 chr1:9711789-9884550 iPS Fibroblasts OK 474.526 4148.55 3.12805 -6.03767 1.56358e-09 3.03148e-08 yes TSS2066 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 iPS Fibroblasts OK 479.396 509.797 0.0887044 -0.170607 0.864533 0.984711 no TSS2067 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts NOTEST 14.1134 7.08002 -0.995239 0.0690022 0.944988 1 no TSS2068 XLOC_001305 LZIC chr1:9989777-10003427 iPS Fibroblasts OK 307.377 1015.04 1.72345 -3.05124 0.00227898 0.010844 yes TSS2069 XLOC_001306 DFFA chr1:10520604-10532613 iPS Fibroblasts OK 783.778 1164.65 0.571379 -1.21263 0.22527 0.427885 no TSS207 XLOC_000140 - chr1:16062808-16067885 iPS Fibroblasts NOTEST 2.07297 4.66039 1.16876 -0.396505 0.691732 1 no TSS2070 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 9.93113 1.99903 -2.31266 1.19489 0.232132 1 no TSS2071 XLOC_001307 CASZ1 chr1:10696667-10856707 iPS Fibroblasts NOTEST 8.95125 6.07219 -0.559873 0.391727 0.69526 1 no TSS2072 XLOC_001307 - chr1:10696667-10856707 iPS Fibroblasts NOTEST 2.07597 0 -1.79769e+308 -1.79769e+308 0.393422 1 no TSS2073 XLOC_001308 C1orf127 chr1:11006532-11024258 iPS Fibroblasts NOTEST 1.66867 0.333513 -2.32288 0.608589 0.542797 1 no TSS2074 XLOC_001309 MASP2 chr1:11086580-11107285 iPS Fibroblasts OK 75.0649 15.0124 -2.32198 2.94408 0.00323915 0.0147338 yes TSS2075 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 1171.02 3003.63 1.35894 -1.46892 0.141855 0.310741 no TSS2076 XLOC_001310 SRM chr1:11114648-11120091 iPS Fibroblasts OK 1002.98 7820.85 2.96303 -5.16451 2.41072e-07 3.59946e-06 yes TSS2077 XLOC_001311 EXOSC10 chr1:11126677-11159938 iPS Fibroblasts OK 1430.05 1642.04 0.199424 -0.499119 0.617695 0.837564 no TSS2078 XLOC_001312 - chr1:11166588-11322608 iPS Fibroblasts OK 59.0429 170.948 1.53372 -1.03527 0.300544 0.527577 no TSS2079 XLOC_001312 MTOR chr1:11166588-11322608 iPS Fibroblasts OK 578.796 636.873 0.137951 -0.350853 0.725699 0.915648 no TSS208 XLOC_000141 TMEM82 chr1:16068916-16074475 iPS Fibroblasts NOTEST 11.5611 0 -1.79769e+308 -1.79769e+308 0.00828204 1 no TSS2080 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts OK 302.813 72.9584 -2.05328 1.60748 0.107949 0.259677 no TSS2081 XLOC_001313 FBXO2 chr1:11708449-11723383 iPS Fibroblasts NOTEST 5.94962 0 -1.79769e+308 -1.79769e+308 0.460599 1 no TSS2082 XLOC_001314 MAD2L2 chr1:11734537-11751678 iPS Fibroblasts OK 4485.74 2368.21 -0.921547 2.41152 0.015886 0.0554201 no TSS2083 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 12.2816 263.856 4.42518 -3.37199 0.000746263 0.0041605 yes TSS2084 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 98.8766 277.975 1.49125 -2.48281 0.0130349 0.0475628 yes TSS2085 XLOC_001315 MTHFR chr1:11832138-11866115 iPS Fibroblasts OK 66.9034 108.763 0.701034 -0.312463 0.754688 0.938125 no TSS2086 XLOC_001316 NPPA chr1:11866206-11907840 iPS Fibroblasts OK 3.4039 18.088 2.40977 -0.308338 0.757825 0.93832 no TSS2087 XLOC_001317 NPPB chr1:11917521-11918992 iPS Fibroblasts NOTEST 770.486 0 -1.79769e+308 -1.79769e+308 0.000683496 1 no TSS2088 XLOC_001318 KIAA2013 chr1:11980123-11986480 iPS Fibroblasts OK 673.993 1443.8 1.09907 -2.14667 0.0318194 0.0981791 no TSS2089 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 664.349 292.677 -1.18263 1.47016 0.141518 0.310673 no TSS209 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 17.9129 72.561 2.0182 -0.402187 0.687547 0.890673 no TSS2090 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 695.323 459.21 -0.598531 0.841218 0.400226 0.637124 no TSS2091 XLOC_001319 DHRS3 chr1:12627939-12677820 iPS Fibroblasts OK 17.2087 67.1677 1.96463 -0.0649752 0.948194 0.999997 no TSS2092 XLOC_001320 PRAMEF11 chr1:12884467-12891264 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2093 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2094 XLOC_001322 PRAMEF4 chr1:12939032-12946025 iPS Fibroblasts NOTEST 0.174144 0 -1.79769e+308 -1.79769e+308 0.364285 1 no TSS2095 XLOC_001323 PRAMEF10 chr1:12952727-12958094 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2096 XLOC_001324 PRAMEF6 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.337687 0 -1.79769e+308 -1.79769e+308 0.414194 1 no TSS2097 XLOC_001324 PRAMEF5 chr1:12998301-13117751 iPS Fibroblasts NOTEST 0.334659 0 -1.79769e+308 -1.79769e+308 0.436888 1 no TSS2098 XLOC_001326 PRAMEF22 chr1:13328195-13331692 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2099 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS21 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 8.76366 29.2958 1.74109 -1.80964 0.0703519 0.186886 no TSS210 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 565.849 2026.56 1.84054 -3.6201 0.00029449 0.001857 yes TSS2100 XLOC_001327 PRAMEF8 chr1:13386648-13390765 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2101 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 iPS Fibroblasts NOTEST 0.200934 0 -1.79769e+308 -1.79769e+308 0.454078 1 no TSS2102 XLOC_001329 PRAMEF18 chr1:13474052-13477569 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2103 XLOC_001330 PRAMEF8 chr1:13607430-13611550 iPS Fibroblasts NOTEST 0.694912 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TSS2104 XLOC_001331 PRAMEF14 chr1:13668268-13673511 iPS Fibroblasts NOTEST 0.803811 0 -1.79769e+308 -1.79769e+308 0.211443 1 no TSS2105 XLOC_001332 PRAMEF18 chr1:13694888-13698405 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2106 XLOC_001333 LRRC38 chr1:13801446-13840242 iPS Fibroblasts NOTEST 6.96034 0 -1.79769e+308 -1.79769e+308 0.0128373 1 no TSS2107 XLOC_001334 C1orf126 chr1:14925212-15478960 iPS Fibroblasts NOTEST 8.04305 0.859289 -3.22653 0.126847 0.899061 1 no TSS2108 XLOC_001335 - chr1:15573767-15726776 iPS Fibroblasts NOTEST 0.432797 2.62025 2.59795 -0.869836 0.38439 1 no TSS2109 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 220.689 207.808 -0.0867576 0.102472 0.918382 0.999997 no TSS211 XLOC_000142 FBLIM1 chr1:16083153-16114431 iPS Fibroblasts OK 311.44 344.875 0.147119 -0.0783825 0.937524 0.999997 no TSS2110 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 0 29.4638 1.79769e+308 1.79769e+308 0.209826 0.404398 no TSS2111 XLOC_001336 CASP9 chr1:15802595-15851384 iPS Fibroblasts OK 173.37 51.1746 -1.76035 1.40989 0.158573 0.336578 no TSS2112 XLOC_001337 AGMAT chr1:15853351-15918872 iPS Fibroblasts OK 122.09 43.2083 -1.49857 0.836515 0.402865 0.638977 no TSS2113 XLOC_001339 - chr1:16160709-16266950 iPS Fibroblasts OK 68.8094 39.9858 -0.783119 0.309905 0.756633 0.93832 no TSS2114 XLOC_001340 ZBTB17 chr1:16268365-16302627 iPS Fibroblasts OK 179.279 666.365 1.89411 -2.68039 0.00735355 0.0296654 yes TSS2115 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 121.023 339.016 1.48607 -1.72163 0.0851369 0.217702 no TSS2116 XLOC_001342 HSPB7 chr1:16340522-16400127 iPS Fibroblasts OK 71.8733 397.66 2.46801 -2.27742 0.0227612 0.0742885 no TSS2117 XLOC_001343 FAM131C chr1:16340522-16400127 iPS Fibroblasts OK 13.6398 46.4136 1.76672 -0.1606 0.872409 0.985011 no TSS2118 XLOC_001344 EPHA2 chr1:16450831-16482564 iPS Fibroblasts OK 257.159 923.073 1.84378 -3.23256 0.00122686 0.00642617 yes TSS2119 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 17.0126 170.844 3.328 -1.88627 0.0592585 0.162056 no TSS212 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 145.636 293.864 1.01278 -1.91218 0.0558529 0.155149 no TSS2120 XLOC_001345 ARHGEF19 chr1:16524598-16539104 iPS Fibroblasts OK 156.261 8.10745 -4.26857 2.04693 0.0406646 0.120877 no TSS2121 XLOC_001346 C1orf89 chr1:16558182-16563659 iPS Fibroblasts OK 28.2148 182.341 2.69211 -3.90462 9.4375e-05 0.000681073 yes TSS2122 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 22.2988 15.5838 -0.516918 0.12646 0.899368 0.992793 no TSS2123 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 11.178 30.8971 1.4668 -0.347568 0.728165 0.915669 no TSS2124 XLOC_001347 FBXO42 chr1:16576559-16678948 iPS Fibroblasts OK 292.804 533.075 0.864402 -1.69108 0.0908206 0.227314 no TSS2125 XLOC_001347 - chr1:16576559-16678948 iPS Fibroblasts OK 27.075 0 -1.79769e+308 -1.79769e+308 0.157924 0.33575 no TSS2126 XLOC_001348 SPATA21 chr1:16693582-16763919 iPS Fibroblasts NOTEST 1.25463 0.168084 -2.90001 0.0483682 0.961423 1 no TSS2127 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 39.2853 16.8693 -1.21959 1.57059 0.116279 0.27463 no TSS2128 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 0 33.8911 1.79769e+308 1.79769e+308 0.214876 0.411735 no TSS2129 XLOC_001349 - chr1:16793930-16819196 iPS Fibroblasts OK 7.75221 17.5001 1.17468 -0.248451 0.803786 0.964629 no TSS213 XLOC_000143 SPEN chr1:16160709-16266950 iPS Fibroblasts OK 40.228 168.12 2.06322 -2.47059 0.0134892 0.0490825 yes TSS2130 XLOC_001350 - chr1:16860385-16864669 iPS Fibroblasts NOTEST 23.1603 0.8365 -4.79115 2.95061 0.00317145 1 no TSS2131 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 373.983 890.142 1.25106 -2.02252 0.0431223 0.126149 no TSS2132 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 65.4571 783.709 3.5817 -2.07317 0.0381565 0.114734 no TSS2133 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts NOTEST 2.67381 2.38008 -0.16789 0.0019933 0.99841 1 no TSS2134 XLOC_001352 NBPF1 chr1:16890411-16939982 iPS Fibroblasts OK 8.12905 41.2295 2.34252 -0.464521 0.642275 0.858067 no TSS2135 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 146.83 151.051 0.0408874 -0.0380439 0.969653 0.999997 no TSS2136 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 24.9871 82.627 1.72543 -0.914896 0.360246 0.592837 no TSS2137 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 62.8563 44.2115 -0.507636 0.380731 0.703403 0.899331 no TSS2138 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 75.5926 89.6185 0.245552 -0.199957 0.841514 0.976683 no TSS2139 XLOC_001353 - chr1:16944752-16971178 iPS Fibroblasts OK 93.9509 217.203 1.20907 -0.536698 0.591476 0.816879 no TSS214 XLOC_000144 C1orf64 chr1:16330730-16333180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2140 XLOC_001354 ESPN chr1:17017712-17046652 iPS Fibroblasts NOTEST 2.07327 0 -1.79769e+308 -1.79769e+308 0.134129 1 no TSS2141 XLOC_001354 ESPNP chr1:17017712-17046652 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2142 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 14.2231 1.55467 -3.19355 0.207314 0.835764 1 no TSS2143 XLOC_001355 MSTP9 chr1:17066767-17299474 iPS Fibroblasts NOTEST 1.90183 1.59851 -0.250659 0.0136945 0.989074 1 no TSS2144 XLOC_001356 - chr1:17066767-17299474 iPS Fibroblasts OK 133.893 408.247 1.60836 -0.665311 0.505852 0.739979 no TSS2145 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 1947.53 2361.94 0.278325 -0.563517 0.573083 0.799608 no TSS2146 XLOC_001357 MFAP2 chr1:17300999-17308081 iPS Fibroblasts OK 0 43.7253 1.79769e+308 1.79769e+308 0.423876 0.663392 no TSS2147 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 66.6283 231.387 1.7961 -0.742034 0.458067 0.701685 no TSS2148 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 255.212 407.307 0.674418 -1.36193 0.17322 0.354632 no TSS2149 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 0 46.6117 1.79769e+308 1.79769e+308 0.321011 0.553042 no TSS215 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 1.3355 0 -1.79769e+308 -1.79769e+308 0.479662 1 no TSS2150 XLOC_001358 ATP13A2 chr1:17312452-17338423 iPS Fibroblasts OK 26.0242 0 -1.79769e+308 -1.79769e+308 0.257123 0.474181 no TSS2151 XLOC_001359 SDHB chr1:17345226-17380665 iPS Fibroblasts OK 1562.94 5372.43 1.78131 -4.16829 3.06896e-05 0.000256957 yes TSS2152 XLOC_001360 PADI2 chr1:17393256-17445948 iPS Fibroblasts OK 31.43 0.887452 -5.14633 3.80549 0.000141521 0.000977853 yes TSS2153 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts NOTEST 2447.51 869.89 -1.49241 3.66306 0.000249219 1 no TSS2154 XLOC_001362 RCC2 chr1:17733251-17766220 iPS Fibroblasts OK 895.394 178.175 -2.32923 2.83374 0.00460074 0.019724 yes TSS2155 XLOC_001363 TAS1R2 chr1:19166092-19186155 iPS Fibroblasts NOTEST 0.541163 0 -1.79769e+308 -1.79769e+308 0.23502 1 no TSS2156 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 85.8408 130.588 0.605284 -0.641601 0.521132 0.752168 no TSS2157 XLOC_001364 ALDH4A1 chr1:19197925-19229293 iPS Fibroblasts OK 178.229 406.234 1.18858 -1.98998 0.0465927 0.132728 no TSS2158 XLOC_001365 IFFO2 chr1:19230773-19282826 iPS Fibroblasts OK 102.06 303.773 1.57358 -3.15592 0.00159995 0.00790241 yes TSS2159 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 14.6135 229.039 3.97022 -0.144739 0.884917 0.989719 no TSS216 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 8.86716 0.308418 -4.84551 0.273435 0.784519 1 no TSS2160 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 1.68163 294.701 7.45324 -0.0681441 0.945671 0.999997 no TSS2161 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 0 22.1323 1.79769e+308 1.79769e+308 0.468787 0.711462 no TSS2162 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2163 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 28.2328 470.997 4.06027 -1.41628 0.156694 0.334382 no TSS2164 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts OK 4.91166 243.59 5.6321 -0.323463 0.746345 0.933096 no TSS2165 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 623.312 666.218 0.0960407 -0.218497 0.827042 0.970329 no TSS2166 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 39.3315 5.62521 -2.80571 0.0408876 0.967386 0.999997 no TSS2167 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 38.8471 171.68 2.14385 -0.711689 0.476657 0.715334 no TSS2168 XLOC_001366 - chr1:19398603-19536746 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2169 XLOC_001366 UBR4 chr1:19398603-19536746 iPS Fibroblasts OK 112.418 7.05837 -3.99339 0.139907 0.888733 0.989797 no TSS217 XLOC_000145 CLCNKA chr1:16340522-16400127 iPS Fibroblasts NOTEST 1.5524 0 -1.79769e+308 -1.79769e+308 0.44066 1 no TSS2170 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 44.1215 6.73706 -2.71129 0.0671761 0.946442 0.999997 no TSS2171 XLOC_001367 KIAA0090 chr1:19544584-19578046 iPS Fibroblasts OK 309.472 2362.61 2.9325 -6.12828 8.8834e-10 1.80305e-08 yes TSS2172 XLOC_001368 AKR7L chr1:19592475-19600568 iPS Fibroblasts NOTEST 8.4734 10.5092 0.310635 -0.34638 0.729057 1 no TSS2173 XLOC_001369 AKR7A3 chr1:19609056-19615280 iPS Fibroblasts OK 16.1619 15.2534 -0.0834673 0.0945577 0.924666 0.999997 no TSS2174 XLOC_001370 AKR7A2 chr1:19630458-19638640 iPS Fibroblasts OK 363.217 3218.59 3.14753 -5.68921 1.27629e-08 2.18144e-07 yes TSS2175 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 1302.83 0 -1.79769e+308 -1.79769e+308 8.13491e-05 0.000590349 yes TSS2176 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 43.0618 70.755 0.716423 -0.0354422 0.971727 0.999997 no TSS2177 XLOC_001371 CAPZB chr1:19665273-19811992 iPS Fibroblasts OK 2378.98 19381 3.02623 -6.15619 7.45176e-10 1.56205e-08 yes TSS2178 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 6.20966 36.9795 2.57414 -0.570371 0.568426 0.795149 no TSS2179 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 48.488 464.48 3.25992 -4.77692 1.78002e-06 2.0831e-05 yes TSS218 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2180 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 18.9165 105.748 2.48292 -1.17862 0.23855 0.447799 no TSS2181 XLOC_001373 TMCO4 chr1:20008706-20126758 iPS Fibroblasts OK 6.08129 20.9118 1.78187 -0.142277 0.886861 0.989719 no TSS2182 XLOC_001375 PLA2G2E chr1:20246799-20250110 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2183 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2184 XLOC_001376 PLA2G2A chr1:20301924-20306932 iPS Fibroblasts OK 134.324 12.952 -3.37447 3.16116 0.00157144 0.0077912 yes TSS2185 XLOC_001377 PLA2G2D chr1:20438440-20446008 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2186 XLOC_001378 PLA2G2C chr1:20490483-20501687 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2187 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2188 XLOC_001379 - chr1:20687597-20755275 iPS Fibroblasts NOTEST 0 2.56345 1.79769e+308 1.79769e+308 0.0741977 1 no TSS2189 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts OK 163.673 2654.04 4.0193 -2.24345 0.0248677 0.0797371 no TSS219 XLOC_000145 CLCNKB chr1:16340522-16400127 iPS Fibroblasts NOTEST 12.6409 1.81089 -2.80332 0.353537 0.723686 1 no TSS2190 XLOC_001380 CAMK2N1 chr1:20808884-20812728 iPS Fibroblasts OK 171.705 7835.73 5.51206 -7.85065 4.21885e-15 2.38273e-13 yes TSS2191 XLOC_001381 MUL1 chr1:20825942-20834674 iPS Fibroblasts OK 392.307 1509.04 1.94358 -4.25254 2.11358e-05 0.000184265 yes TSS2192 XLOC_001382 DDOST chr1:20978259-20988037 iPS Fibroblasts OK 4463.42 12716.5 1.51048 -3.54071 0.000399059 0.0024337 yes TSS2193 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 7.59828 87.6849 3.52858 -1.04504 0.296005 0.524571 no TSS2194 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 0 11.7825 1.79769e+308 1.79769e+308 0.246188 0.458163 no TSS2195 XLOC_001383 KIF17 chr1:20990508-21044317 iPS Fibroblasts OK 59.0012 29.9178 -0.97974 0.913569 0.360943 0.592837 no TSS2196 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 17.3446 175.668 3.34029 -3.18043 0.00147055 0.00737546 yes TSS2197 XLOC_001384 SH2D5 chr1:21046224-21059330 iPS Fibroblasts OK 56.3467 132.567 1.23432 -1.50551 0.132193 0.297607 no TSS2198 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 44.0552 89.2902 1.01919 -0.246332 0.805425 0.964629 no TSS2199 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 302.536 147.345 -1.0379 0.50504 0.613531 0.832786 no TSS22 XLOC_000027 SCNN1D chr1:1215815-1227409 iPS Fibroblasts OK 0.000995546 34.1815 15.0674 -0.0103646 0.99173 0.999997 no TSS220 XLOC_000146 C1orf144 chr1:16693582-16763919 iPS Fibroblasts OK 1222.98 5311.2 2.11864 -4.591 4.41137e-06 4.5121e-05 yes TSS2200 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 534.508 1405.24 1.39453 -1.06149 0.288467 0.515431 no TSS2201 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 553.685 1673.88 1.59606 -2.24024 0.0250756 0.0797371 no TSS2202 XLOC_001385 HP1BP3 chr1:21069170-21113799 iPS Fibroblasts OK 478.545 1140.1 1.25244 -1.19078 0.233742 0.441323 no TSS2203 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 16.2897 487.969 4.90476 -1.03572 0.300334 0.527577 no TSS2204 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 499.358 689.01 0.464451 -0.48006 0.631185 0.851411 no TSS2205 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 23.2845 233.937 3.32867 -1.41416 0.157315 0.335003 no TSS2206 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 217.515 658.192 1.59739 -2.1182 0.034158 0.104897 no TSS2207 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 310.854 0 -1.79769e+308 -1.79769e+308 0.0196006 0.0659819 no TSS2208 XLOC_001386 EIF4G3 chr1:21132975-21503340 iPS Fibroblasts OK 99.134 49.7966 -0.993333 0.110693 0.91186 0.999997 no TSS2209 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 0 127.783 1.79769e+308 1.79769e+308 0.384443 0.618948 no TSS221 XLOC_000147 NECAP2 chr1:16767166-16786582 iPS Fibroblasts OK 574.66 3729.9 2.69836 -5.62585 1.84596e-08 3.07423e-07 yes TSS2210 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 90.6691 986.479 3.4436 -2.43061 0.0150735 0.0534984 no TSS2211 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 70.0685 1498.79 4.41889 -1.92215 0.0545871 0.152492 no TSS2212 XLOC_001387 ECE1 chr1:21543739-21672034 iPS Fibroblasts OK 67.8265 3871.51 5.8349 -6.42094 1.35436e-10 3.25799e-09 yes TSS2213 XLOC_001389 - chr1:21749600-21754300 iPS Fibroblasts OK 100.478 526.991 2.3909 -4.16704 3.08585e-05 0.000256957 yes TSS2214 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts NOTEST 3.1394 0 -1.79769e+308 -1.79769e+308 0.325714 1 no TSS2215 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts OK 27.4868 2.12746 -3.69153 3.45464 0.000551018 0.00319436 yes TSS2216 XLOC_001390 RAP1GAP chr1:21922708-21995856 iPS Fibroblasts OK 25.4736 0.00165223 -13.9123 0.0432394 0.965511 0.999997 no TSS2217 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 119.181 49.025 -1.28157 0.570022 0.568663 0.795149 no TSS2218 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 984.381 1473.12 0.581581 -1.21254 0.225307 0.427885 no TSS2219 XLOC_001391 USP48 chr1:22004793-22109688 iPS Fibroblasts OK 40.7577 1.54293 -4.72333 0.0325374 0.974043 0.999997 no TSS222 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 3.60361 6.5283 0.857266 -0.428568 0.668238 1 no TSS2220 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 8.87162 262.104 4.8848 -0.257172 0.797046 0.961603 no TSS2221 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 117.483 4493.82 5.25742 -6.91117 4.8066e-12 1.51903e-10 yes TSS2222 XLOC_001392 HSPG2 chr1:22138757-22263750 iPS Fibroblasts OK 32.9146 0 -1.79769e+308 -1.79769e+308 0.395674 0.631426 no TSS2223 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 15.9522 0.00537242 -11.5359 0.13724 0.890841 1 no TSS2224 XLOC_001393 WNT4 chr1:22443799-22470385 iPS Fibroblasts NOTEST 0.000222119 0.782392 11.7823 -0.00277907 0.997783 1 no TSS2225 XLOC_001394 - chr1:23337326-23342343 iPS Fibroblasts NOTEST 3.40123 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TSS2226 XLOC_001395 LUZP1 chr1:23410515-23495517 iPS Fibroblasts OK 860.605 885.771 0.041582 -0.103965 0.917197 0.999997 no TSS2227 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts NOTEST 18.8159 0 -1.79769e+308 -1.79769e+308 0.43101 1 no TSS2228 XLOC_001397 HNRNPR chr1:23636276-23670853 iPS Fibroblasts OK 3123.46 5103.63 0.708381 -1.70932 0.0873922 0.220861 no TSS2229 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts OK 32.0809 264.956 3.04597 -3.4306 0.000602252 0.00343125 yes TSS223 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 2.50115 4.62403 0.886562 -0.205269 0.837362 1 no TSS2230 XLOC_001398 ZNF436 chr1:23685941-23698278 iPS Fibroblasts OK 28.9081 121.81 2.07509 -1.97013 0.0488238 0.137575 no TSS2231 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 134.779 699.13 2.37497 -2.41335 0.0158067 0.0553448 no TSS2232 XLOC_001399 TCEA3 chr1:23707554-23751261 iPS Fibroblasts OK 0 75.1132 1.79769e+308 1.79769e+308 0.332048 0.564568 no TSS2233 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 57.325 97.6727 0.768792 -0.486906 0.626325 0.845734 no TSS2234 XLOC_001400 - chr1:23755055-23811057 iPS Fibroblasts OK 31.2959 41.7841 0.41698 -0.182298 0.855349 0.984711 no TSS2235 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts OK 215.28 653.629 1.60226 -3.30995 0.000933136 0.00506469 yes TSS2236 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2237 XLOC_001400 ASAP3 chr1:23755055-23811057 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2238 XLOC_001402 E2F2 chr1:23832921-23857713 iPS Fibroblasts OK 17.3678 59.0676 1.76595 -2.48715 0.0128773 0.0471199 yes TSS2239 XLOC_001403 ID3 chr1:23884409-23886322 iPS Fibroblasts OK 2233.71 1179.44 -0.921339 1.94336 0.0519728 0.145501 no TSS224 XLOC_000149 MST1 chr1:16972068-16976914 iPS Fibroblasts NOTEST 9.67545 3.69539 -1.3886 0.758648 0.448063 1 no TSS2240 XLOC_001404 - chr1:24069855-24104777 iPS Fibroblasts OK 29.788 107.333 1.8493 -0.266177 0.790103 0.957262 no TSS2241 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 33.6768 12.7034 -1.40654 0.232084 0.816472 0.967036 no TSS2242 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 17.4871 167.153 3.2568 -1.1002 0.271246 0.495568 no TSS2243 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts OK 251.387 578.187 1.20162 -1.38382 0.166413 0.348102 no TSS2244 XLOC_001405 GALE chr1:24122088-24127294 iPS Fibroblasts NOTEST 6.56657 4.63048 -0.503976 0.0211657 0.983114 1 no TSS2245 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts OK 209.106 1760.73 3.07387 -4.93208 8.13602e-07 1.06754e-05 yes TSS2246 XLOC_001406 HMGCL chr1:24128367-24165110 iPS Fibroblasts NOTEST 7.68224 0 -1.79769e+308 -1.79769e+308 0.320546 1 no TSS2247 XLOC_001407 FUCA1 chr1:24171573-24194821 iPS Fibroblasts OK 207.2 142.572 -0.539327 0.599671 0.548725 0.775619 no TSS2248 XLOC_001408 CNR2 chr1:24200460-24239817 iPS Fibroblasts NOTEST 0.725191 0 -1.79769e+308 -1.79769e+308 0.243824 1 no TSS2249 XLOC_001409 SFRS13A chr1:24292938-24306821 iPS Fibroblasts OK 2102.35 2465.33 0.229784 -0.507196 0.612018 0.832472 no TSS225 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts NOTEST 2.30684 0 -1.79769e+308 -1.79769e+308 0.485306 1 no TSS2250 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2251 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.452065 0 -1.79769e+308 -1.79769e+308 0.306327 1 no TSS2252 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 2.29711 0 -1.79769e+308 -1.79769e+308 0.13721 1 no TSS2253 XLOC_001410 MYOM3 chr1:24382531-24438665 iPS Fibroblasts NOTEST 0.347098 0 -1.79769e+308 -1.79769e+308 0.308557 1 no TSS2254 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 6.64523 0 -1.79769e+308 -1.79769e+308 0.0070371 1 no TSS2255 XLOC_001411 IL22RA1 chr1:24446260-24469611 iPS Fibroblasts NOTEST 0 3.57865 1.79769e+308 1.79769e+308 0.0363411 1 no TSS2256 XLOC_001412 IL28RA chr1:24480647-24513751 iPS Fibroblasts OK 99.4363 0.114571 -9.76139 1.60037 0.109517 0.262961 no TSS2257 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2258 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 11.5429 57.9985 2.32901 -1.06707 0.285942 0.514458 no TSS2259 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 144.476 218.855 0.599143 -0.910273 0.362679 0.594848 no TSS226 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 27.4034 98.6818 1.84843 -1.99736 0.0457856 0.130715 no TSS2260 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts NOTEST 0 3.67923 1.79769e+308 1.79769e+308 0.435246 1 no TSS2261 XLOC_001414 C1orf201 chr1:24683489-24741587 iPS Fibroblasts OK 8.9548 15.7206 0.811925 -0.162795 0.87068 0.985011 no TSS227 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 47.5917 3.8214 -3.63854 0.338375 0.735081 0.923472 no TSS228 XLOC_000150 CROCC chr1:17066767-17299474 iPS Fibroblasts OK 65.6699 17.1632 -1.93591 1.03814 0.299204 0.527577 no TSS229 XLOC_000150 - chr1:17066767-17299474 iPS Fibroblasts OK 15.9225 49.7705 1.64423 -0.719566 0.471792 0.712752 no TSS23 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 335.325 855.662 1.35148 -0.826349 0.408606 0.646504 no TSS230 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 2.7984 0 -1.79769e+308 -1.79769e+308 0.230408 1 no TSS231 XLOC_000151 PADI1 chr1:17531620-17572501 iPS Fibroblasts NOTEST 12.7402 6.06956e-06 -21.0013 0.000171639 0.999863 1 no TSS232 XLOC_000151 - chr1:17531620-17572501 iPS Fibroblasts NOTEST 0 0.513935 1.79769e+308 1.79769e+308 0.202031 1 no TSS233 XLOC_000152 PADI3 chr1:17575592-17610725 iPS Fibroblasts NOTEST 8.59656 0.32407 -4.72938 2.78066 0.00542479 1 no TSS234 XLOC_000153 PADI4 chr1:17634689-17690495 iPS Fibroblasts NOTEST 4.09774 0 -1.79769e+308 -1.79769e+308 0.0386699 1 no TSS235 XLOC_000154 PADI6 chr1:17698740-17728195 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS236 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 86.5635 28.9222 -1.58158 0.683654 0.494194 0.730327 no TSS237 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 158.893 243.503 0.61588 -0.894784 0.370902 0.603762 no TSS238 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts NOTEST 0 5.30615 1.79769e+308 1.79769e+308 0.472061 1 no TSS239 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 24.8197 0 -1.79769e+308 -1.79769e+308 0.140881 0.310673 no TSS24 XLOC_000028 PUSL1 chr1:1227763-1260046 iPS Fibroblasts OK 21.1644 15.8664 -0.415662 0.0151036 0.98795 0.999997 no TSS240 XLOC_000155 ARHGEF10L chr1:17866329-18024369 iPS Fibroblasts OK 0 381.592 1.79769e+308 1.79769e+308 0.000456313 0.00273157 yes TSS241 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts NOTEST 2.21468 0 -1.79769e+308 -1.79769e+308 0.471176 1 no TSS242 XLOC_000155 - chr1:17866329-18024369 iPS Fibroblasts OK 12.7177 14.6487 0.203942 -0.0310917 0.975196 0.999997 no TSS243 XLOC_000156 ACTL8 chr1:18081807-18153556 iPS Fibroblasts NOTEST 9.62232 6.95204 -0.468948 0.497417 0.618895 1 no TSS244 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts OK 58.273 0 -1.79769e+308 -1.79769e+308 0.00185698 0.00893413 yes TSS245 XLOC_000157 IGSF21 chr1:18434239-18704976 iPS Fibroblasts NOTEST 2.74185 0 -1.79769e+308 -1.79769e+308 0.4079 1 no TSS246 XLOC_000159 KLHDC7A chr1:18807423-18812539 iPS Fibroblasts NOTEST 0 0.745204 1.79769e+308 1.79769e+308 0.105358 1 no TSS247 XLOC_000160 PAX7 chr1:18957499-19075359 iPS Fibroblasts NOTEST 0.594028 0 -1.79769e+308 -1.79769e+308 0.366238 1 no TSS248 XLOC_000161 MRTO4 chr1:19578074-19586621 iPS Fibroblasts OK 773.162 1651.61 1.09504 -2.54218 0.0110164 0.0414791 yes TSS249 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 105.82 448.712 2.08417 -2.50852 0.0121239 0.0451038 yes TSS25 XLOC_000029 GLTPD1 chr1:1260142-1264275 iPS Fibroblasts OK 140.404 781.158 2.47603 -4.62916 3.67149e-06 3.84618e-05 yes TSS250 XLOC_000162 PQLC2 chr1:19638739-19655793 iPS Fibroblasts OK 80.1847 139.07 0.794409 -0.70124 0.483153 0.722228 no TSS251 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 249.564 10711.1 5.42355 -7.07618 1.48193e-12 5.50006e-11 yes TSS252 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts NOTEST 0 3.52907 1.79769e+308 1.79769e+308 0.498836 1 no TSS253 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 0 30.6081 1.79769e+308 1.79769e+308 0.487077 0.723928 no TSS254 XLOC_000163 NBL1 chr1:19923466-19984945 iPS Fibroblasts OK 463.905 1884.11 2.02198 -1.83292 0.0668147 0.179533 no TSS255 XLOC_000164 HTR6 chr1:19991779-20006054 iPS Fibroblasts NOTEST 3.39355 0 -1.79769e+308 -1.79769e+308 0.0558829 1 no TSS256 XLOC_000165 OTUD3 chr1:20208887-20239429 iPS Fibroblasts OK 148.118 87.3998 -0.761045 1.44569 0.148264 0.322605 no TSS257 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts NOTEST 0.482708 2.12447 2.13788 -0.195883 0.844702 1 no TSS258 XLOC_000166 PLA2G5 chr1:20354671-20418393 iPS Fibroblasts OK 0 147.21 1.79769e+308 1.79769e+308 0.00318923 0.0146908 yes TSS259 XLOC_000167 PLA2G2F chr1:20465822-20476879 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS26 XLOC_000030 TAS1R3 chr1:1266725-1269843 iPS Fibroblasts NOTEST 6.25639 4.31837 -0.534842 0.552796 0.580403 1 no TSS260 XLOC_000168 UBXN10 chr1:20512577-20519941 iPS Fibroblasts NOTEST 12.3177 0.492177 -4.64542 3.23168 0.00123066 1 no TSS261 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 3.13664 0.572911 -2.45283 1.46863 0.141933 1 no TSS262 XLOC_000169 VWA5B1 chr1:20617411-20681387 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS263 XLOC_000171 CDA chr1:20915443-20945398 iPS Fibroblasts OK 240.92 232.113 -0.0537261 0.076991 0.938631 0.999997 no TSS264 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 640.208 2213.85 1.78994 -3.8392 0.000123435 0.000871425 yes TSS265 XLOC_000172 PINK1 chr1:20959947-20978003 iPS Fibroblasts OK 0 832.083 1.79769e+308 1.79769e+308 0.0365779 0.111537 no TSS266 XLOC_000173 - chr1:21543739-21672034 iPS Fibroblasts NOTEST 2.1975 3.33508 0.601856 -0.0238642 0.980961 1 no TSS267 XLOC_000174 - chr1:21761832-21762609 iPS Fibroblasts OK 0 7652.6 1.79769e+308 1.79769e+308 0.0471877 0.134129 no TSS268 XLOC_000175 NBPF3 chr1:21766630-21811392 iPS Fibroblasts OK 85.2069 528.734 2.6335 -4.2785 1.88156e-05 0.000166268 yes TSS269 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts OK 953.058 59.0365 -4.01288 4.85158 1.22484e-06 1.5153e-05 yes TSS27 XLOC_000031 - chr1:1334909-1342693 iPS Fibroblasts OK 252.561 567.727 1.16856 -1.04071 0.298009 0.526685 no TSS270 XLOC_000176 ALPL chr1:21835857-21904904 iPS Fibroblasts NOTEST 0 7.78492 1.79769e+308 1.79769e+308 0.260295 1 no TSS271 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts OK 10.8443 16.2682 0.585113 -0.00216545 0.998272 0.999997 no TSS272 XLOC_000177 LDLRAD2 chr1:22138757-22263750 iPS Fibroblasts OK 11.8862 166.982 3.81233 -0.0298855 0.976158 0.999997 no TSS273 XLOC_000178 CELA3B chr1:22303417-22339033 iPS Fibroblasts NOTEST 1.39771 0 -1.79769e+308 -1.79769e+308 0.315006 1 no TSS274 XLOC_000178 CELA3A chr1:22303417-22339033 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS275 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts OK 27.4246 6.30679 -2.12049 0.16794 0.866631 0.985011 no TSS276 XLOC_000179 - chr1:22351706-22357713 iPS Fibroblasts OK 470.397 527.288 0.164712 -0.272084 0.785557 0.954573 no TSS277 XLOC_000180 CDC42 chr1:22379119-22419435 iPS Fibroblasts OK 3644.56 9892.47 1.44059 -3.31548 0.000914851 0.00499324 yes TSS278 XLOC_000181 ZBTB40 chr1:22778343-22857650 iPS Fibroblasts OK 88.916 218.009 1.29387 -2.61908 0.00881673 0.0344968 yes TSS279 XLOC_000181 - chr1:22778343-22857650 iPS Fibroblasts OK 41.9937 12.3722 -1.76307 0.306621 0.759132 0.93832 no TSS28 XLOC_000032 - chr1:1361507-1363166 iPS Fibroblasts NOTEST 7.20193 0 -1.79769e+308 -1.79769e+308 0.163163 1 no TSS280 XLOC_000182 EPHA8 chr1:22890003-22930087 iPS Fibroblasts OK 33.3894 0 -1.79769e+308 -1.79769e+308 0.00598229 0.0246698 yes TSS281 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS282 XLOC_000183 C1QA chr1:22963117-22966174 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS283 XLOC_000184 C1QC chr1:22970117-22974602 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS284 XLOC_000185 C1QB chr1:22979681-22988028 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS285 XLOC_000186 EPHB2 chr1:23037330-23241822 iPS Fibroblasts OK 58.2137 947.084 4.02406 -6.96535 3.27582e-12 1.15008e-10 yes TSS286 XLOC_000188 - chr1:23345940-23410184 iPS Fibroblasts OK 2620.79 2352.33 -0.155907 0.384916 0.700299 0.898884 no TSS287 XLOC_000189 C1orf213 chr1:23685941-23698278 iPS Fibroblasts OK 6.87752 73.0221 3.40837 -0.284277 0.776198 0.947633 no TSS288 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts NOTEST 6.59897e-05 0 -1.79769e+308 -1.79769e+308 0.499983 1 no TSS289 XLOC_000191 MDS2 chr1:23907984-23967056 iPS Fibroblasts NOTEST 0.878658 0 -1.79769e+308 -1.79769e+308 0.300891 1 no TSS29 XLOC_000033 VWA1 chr1:1370908-1376145 iPS Fibroblasts OK 228.717 473.976 1.05125 -1.90032 0.0573916 0.157615 no TSS290 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 7606.61 65838.4 3.1136 -4.0862 4.38503e-05 0.000345222 yes TSS291 XLOC_000192 RPL11 chr1:24018293-24022913 iPS Fibroblasts OK 37474.7 56897 0.602433 -0.899442 0.368417 0.600469 no TSS292 XLOC_000193 TCEB3 chr1:24069855-24104777 iPS Fibroblasts OK 755.461 1232.52 0.706187 -1.80674 0.0708034 0.187701 no TSS293 XLOC_000194 C1orf128 chr1:24104875-24114720 iPS Fibroblasts OK 1073.73 1716.37 0.676735 -1.55782 0.119275 0.279602 no TSS294 XLOC_000195 LYPLA2 chr1:24117645-24122027 iPS Fibroblasts OK 1047.53 1186.4 0.179594 -0.354128 0.723243 0.914794 no TSS295 XLOC_000196 PNRC2 chr1:24286300-24289947 iPS Fibroblasts OK 2032.12 1795.17 -0.178866 0.476805 0.633501 0.853346 no TSS296 XLOC_000197 - chr1:24526729-24538180 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS297 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 11.6632 0 -1.79769e+308 -1.79769e+308 0.0440615 1 no TSS298 XLOC_000198 GRHL3 chr1:24645880-24681807 iPS Fibroblasts NOTEST 9.351 0.713283 -3.71257 1.8699 0.0614982 1 no TSS299 XLOC_000199 NIPAL3 chr1:24742244-24799472 iPS Fibroblasts NOTEST 448.144 1632.52 1.86507 -2.93154 0.00337283 1 no TSS3 XLOC_000005 - chr1:322036-328580 iPS Fibroblasts OK 166.576 18.7718 -3.14955 2.85815 0.00426115 0.0183895 yes TSS30 XLOC_000034 ATAD3C chr1:1385068-1405538 iPS Fibroblasts OK 12.4598 15.5201 0.316864 -0.390484 0.696179 0.898577 no TSS300 XLOC_000199 - chr1:24742244-24799472 iPS Fibroblasts NOTEST 22.1357 7.66113 -1.53075 0.0515202 0.958911 1 no TSS301 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 326.184 219.138 -0.573846 0.851455 0.394517 0.631129 no TSS302 XLOC_000200 RCAN3 chr1:24829386-24862425 iPS Fibroblasts OK 47.0608 184.423 1.97043 -0.791236 0.428806 0.669494 no TSS303 XLOC_000201 C1orf130 chr1:24882601-24935816 iPS Fibroblasts NOTEST 1.31366 0.128844 -3.34989 1.36696 0.171638 1 no TSS304 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 816.972 1363.38 0.738831 -1.65053 0.0988353 0.241329 no TSS305 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 41.7106 28.5028 -0.549309 0.090301 0.928048 0.999997 no TSS306 XLOC_000202 SRRM1 chr1:24969593-24999771 iPS Fibroblasts OK 431.882 235.095 -0.877391 0.437203 0.661964 0.873873 no TSS31 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 117.436 275.225 1.22874 -1.36979 0.170754 0.352827 no TSS32 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 280.061 197.737 -0.502161 0.619894 0.535328 0.761529 no TSS33 XLOC_000035 ATAD3B chr1:1407163-1431581 iPS Fibroblasts OK 35.8479 321.282 3.16388 -1.30931 0.190428 0.379395 no TSS34 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 501.682 859.118 0.776083 -1.24054 0.214774 0.411735 no TSS35 XLOC_000036 ATAD3A chr1:1447554-1470064 iPS Fibroblasts OK 100.608 1200.71 3.57707 -3.63335 0.000279761 0.00177273 yes TSS36 XLOC_000037 - chr1:1535818-1543166 iPS Fibroblasts NOTEST 2.79141 5.74721 1.04187 -0.592847 0.553283 1 no TSS37 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 51.1667 400.214 2.96749 -4.07318 4.63765e-05 0.00036291 yes TSS38 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 4.64597 61.0707 3.71643 -1.31215 0.189471 0.378068 no TSS39 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 0 56.0751 1.79769e+308 1.79769e+308 0.131286 0.296078 no TSS4 XLOC_000007 - chr1:420205-421839 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS40 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 0 45.3624 1.79769e+308 1.79769e+308 0.344684 0.576247 no TSS41 XLOC_000038 MIB2 chr1:1550883-1565984 iPS Fibroblasts OK 12.0776 30.3273 1.32828 -0.211428 0.832553 0.970814 no TSS42 XLOC_000038 - chr1:1550883-1565984 iPS Fibroblasts NOTEST 20.1981 0 -1.79769e+308 -1.79769e+308 0.367618 1 no TSS43 XLOC_000039 MMP23B chr1:1567559-1570029 iPS Fibroblasts NOTEST 12.7213 6.12558 -1.05432 0.596688 0.550716 1 no TSS44 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts OK 0 13.8369 1.79769e+308 1.79769e+308 0.106259 0.256563 no TSS45 XLOC_000039 - chr1:1567559-1570029 iPS Fibroblasts NOTEST 0.730004 6.24162 3.09594 -0.400296 0.688939 1 no TSS46 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts OK 0 90.7454 1.79769e+308 1.79769e+308 0.467191 0.711118 no TSS47 XLOC_000040 - chr1:1571099-1677431 iPS Fibroblasts NOTEST 19.4885 2.78903 -2.80478 0.00207132 0.998347 1 no TSS48 XLOC_000041 - chr1:1571099-1677431 iPS Fibroblasts OK 65.0308 84.1606 0.37202 -0.0435204 0.965287 0.999997 no TSS49 XLOC_000042 - chr1:1822909-1824112 iPS Fibroblasts NOTEST 4.99201 11.254 1.17274 -0.821142 0.411566 1 no TSS5 XLOC_000012 - chr1:763063-789740 iPS Fibroblasts OK 121.633 292.077 1.26381 -1.05641 0.290782 0.517433 no TSS50 XLOC_000043 CALML6 chr1:1846265-1848733 iPS Fibroblasts NOTEST 5.39767 1.08118 -2.31973 1.23799 0.215719 1 no TSS51 XLOC_000044 GABRD chr1:1950767-1962192 iPS Fibroblasts NOTEST 12.037 0.393202 -4.93606 2.5189 0.0117721 1 no TSS52 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 199.815 0 -1.79769e+308 -1.79769e+308 0.00340279 0.0154015 yes TSS53 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 0 45.4119 1.79769e+308 1.79769e+308 0.206902 0.399949 no TSS54 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS55 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 94.566 0 -1.79769e+308 -1.79769e+308 0.0668121 0.179533 no TSS56 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts OK 0 34.2875 1.79769e+308 1.79769e+308 0.311842 0.540111 no TSS57 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 5.19072 0 -1.79769e+308 -1.79769e+308 0.469481 1 no TSS58 XLOC_000045 PRKCZ chr1:1981908-2139172 iPS Fibroblasts NOTEST 7.19324 0 -1.79769e+308 -1.79769e+308 0.428534 1 no TSS59 XLOC_000047 SKI chr1:2160133-2241651 iPS Fibroblasts OK 246.057 1645.91 2.74182 -6.24327 4.28516e-10 9.61328e-09 yes TSS6 XLOC_000014 - chr1:846814-850328 iPS Fibroblasts NOTEST 8.69571 0.58031 -3.90541 2.88572 0.00390514 1 no TSS60 XLOC_000048 RER1 chr1:2323213-2344010 iPS Fibroblasts OK 833.583 3941.6 2.24138 -4.84468 1.26815e-06 1.55408e-05 yes TSS61 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 0 0.769693 1.79769e+308 1.79769e+308 0.320193 1 no TSS62 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 1.08362 1.86433 0.782804 -0.316026 0.751983 1 no TSS63 XLOC_000049 PLCH2 chr1:2407753-2436969 iPS Fibroblasts NOTEST 1.2132 0 -1.79769e+308 -1.79769e+308 0.274622 1 no TSS64 XLOC_000050 TNFRSF14 chr1:2481358-2495265 iPS Fibroblasts OK 48.2407 887.589 4.20157 -2.94606 0.00321855 0.0147338 yes TSS65 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 390.603 1204.83 1.62505 -3.16395 0.00155643 0.00777618 yes TSS66 XLOC_000051 C1orf93 chr1:2518248-2564481 iPS Fibroblasts OK 48.0815 83.8728 0.802721 -0.409495 0.682176 0.887034 no TSS67 XLOC_000053 PRDM16 chr1:2985743-3355183 iPS Fibroblasts NOTEST 1.00749 8.22698 3.0296 -2.03146 0.0422079 1 no TSS68 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts OK 135.254 2.38434 -5.82594 3.95142 7.76902e-05 0.000573407 yes TSS69 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 0 2.38281 1.79769e+308 1.79769e+308 0.214761 1 no TSS7 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 95.4282 0 -1.79769e+308 -1.79769e+308 0.357743 0.592837 no TSS70 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 23.0853 0.0183886 -10.2939 0.230903 0.81739 1 no TSS71 XLOC_000054 ARHGEF16 chr1:3371146-3397675 iPS Fibroblasts NOTEST 8.08924 0 -1.79769e+308 -1.79769e+308 0.379198 1 no TSS72 XLOC_000055 TPRG1L chr1:3541555-3546692 iPS Fibroblasts OK 546.504 2696.46 2.30276 -5.16021 2.46673e-07 3.64123e-06 yes TSS73 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 9.4337 4.37716 -1.10783 0.848408 0.396211 1 no TSS74 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 1.53994 0 -1.79769e+308 -1.79769e+308 0.263934 1 no TSS75 XLOC_000056 TP73 chr1:3569128-3650467 iPS Fibroblasts NOTEST 3.71815 0 -1.79769e+308 -1.79769e+308 0.210562 1 no TSS76 XLOC_000056 - chr1:3569128-3650467 iPS Fibroblasts NOTEST 0 0.0133356 1.79769e+308 1.79769e+308 0.492114 1 no TSS77 XLOC_000057 CCDC27 chr1:3668964-3688209 iPS Fibroblasts NOTEST 0.580625 0.344217 -0.754289 0.269747 0.787355 1 no TSS78 XLOC_000058 - chr1:3689351-3692545 iPS Fibroblasts OK 29.1182 58.9016 1.01639 -1.08029 0.280014 0.508725 no TSS79 XLOC_000059 CAD,DFFB chr1:3773844-3801992 iPS Fibroblasts OK 72.973 116.754 0.678035 -0.948977 0.342632 0.575038 no TSS8 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 52.9724 3.81714 -3.79467 0.0700385 0.944163 0.999997 no TSS80 XLOC_000060 - chr1:3816967-3833877 iPS Fibroblasts NOTEST 6.8872 4.27286 -0.688717 0.457597 0.647242 1 no TSS81 XLOC_000061 - chr1:4000676-4015322 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS82 XLOC_000062 - chr1:4472110-4484744 iPS Fibroblasts NOTEST 0 0 0 0 1 1 no TSS83 XLOC_000063 AJAP1 chr1:4715104-4843850 iPS Fibroblasts OK 104.444 1.26614 -6.36615 4.75544 1.98018e-06 2.27633e-05 yes TSS84 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 7.70132 68.4146 3.15113 -1.43097 0.152439 0.327303 no TSS85 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts OK 58.0186 34.6622 -0.743152 0.531896 0.594798 0.819345 no TSS86 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 3.9331 0 -1.79769e+308 -1.79769e+308 0.366965 1 no TSS87 XLOC_000065 KCNAB2 chr1:6052765-6160523 iPS Fibroblasts NOTEST 4.96806 0 -1.79769e+308 -1.79769e+308 0.350026 1 no TSS88 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts OK 49.2513 39.6382 -0.31327 0.0496004 0.960441 0.999997 no TSS89 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts NOTEST 15.3246 10.1307 -0.597112 0.00819778 0.993459 1 no TSS9 XLOC_000015 SAMD11 chr1:860529-894679 iPS Fibroblasts OK 48.0828 34.9169 -0.461596 0.071855 0.942717 0.999997 no TSS90 XLOC_000066 RNF207 chr1:6266188-6296044 iPS Fibroblasts OK 13.014 18.1716 0.481616 -0.0113877 0.990914 0.999997 no TSS91 XLOC_000067 C1orf211 chr1:6297870-6299490 iPS Fibroblasts OK 56.5093 4.35392 -3.6981 3.5032 0.000459696 0.0027392 yes TSS92 XLOC_000068 HES3 chr1:6304261-6305638 iPS Fibroblasts OK 435.49 0 -1.79769e+308 -1.79769e+308 0.000567569 0.00326227 yes TSS93 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 7.69434 0.205083 -5.22952 2.04494 0.0408612 1 no TSS94 XLOC_000069 ESPN chr1:6484847-6521003 iPS Fibroblasts NOTEST 11.3056 0 -1.79769e+308 -1.79769e+308 0.0762027 1 no TSS95 XLOC_000070 TAS1R1 chr1:6615433-6639816 iPS Fibroblasts NOTEST 3.54524 5.4957 0.63242 -0.359075 0.719539 1 no TSS96 XLOC_000071 ZBTB48 chr1:6640055-6649339 iPS Fibroblasts OK 157.618 214.473 0.444361 -0.646415 0.51801 0.749787 no TSS97 XLOC_000071 - chr1:6640055-6649339 iPS Fibroblasts OK 23.546 38.1578 0.696497 -0.382135 0.702361 0.898884 no TSS98 XLOC_000072 PHF13 chr1:6673755-6684092 iPS Fibroblasts OK 277.454 769.313 1.47132 -3.21767 0.00129234 0.00668827 yes TSS99 XLOC_000073 THAP3 chr1:6684924-6761966 iPS Fibroblasts OK 69.7903 402.426 2.52763 -1.06374 0.287445 0.515429 no TSS1 XLOC_000001 - chr1:11873-29961 hESC Fibroblasts OK 0.347386 16.1506 5.5389 -0.585603 0.558142 0.784659 no TSS10 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 180.736 138.131 -0.387843 0.65007 0.515647 0.747573 no TSS100 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 106.792 156.028 0.547004 -0.200367 0.841194 0.976683 no TSS101 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts OK 1441.29 3196.37 1.14907 -3.20111 0.00136897 0.00700117 yes TSS102 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts OK 26.1246 0 -1.79769e+308 -1.79769e+308 7.13423e-06 6.81424e-05 yes TSS103 XLOC_000074 CAMTA1 chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 1.97243 1.79769e+308 1.79769e+308 0.459719 1 no TSS104 XLOC_000074 - chr1:6845383-7829763 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS105 XLOC_000075 VAMP3 chr1:7831328-7841491 hESC Fibroblasts OK 502.334 7098.44 3.82078 -10.9673 0 0 yes TSS106 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts OK 7.32764 46.9633 2.68011 -0.878939 0.379435 0.61457 no TSS107 XLOC_000076 PER3 chr1:7844379-7973294 hESC Fibroblasts NOTEST 110.54 311.575 1.49502 -3.80497 0.000141822 1 no TSS108 XLOC_000077 PARK7 chr1:8021713-8045341 hESC Fibroblasts OK 8433.49 21641.5 1.3596 -3.40308 0.000666309 0.0037469 yes TSS109 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 29.7198 142.738 2.26388 -4.11985 3.79118e-05 0.000305884 yes TSS11 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 151.63 48.7092 -1.63829 0.903481 0.366271 0.599227 no TSS110 XLOC_000078 SLC45A1 chr1:8384389-8404226 hESC Fibroblasts OK 9.9298 69.3396 2.80384 -2.24691 0.0246456 0.0794408 no TSS111 XLOC_000079 CA6 chr1:9005921-9035146 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS112 XLOC_000080 H6PD chr1:9294862-9331392 hESC Fibroblasts OK 93.0165 1112.18 3.57976 -10.6305 0 0 yes TSS113 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts OK 18.3153 201.501 3.45967 -4.34856 1.37033e-05 0.000122762 yes TSS114 XLOC_000081 SPSB1 chr1:9352940-9429588 hESC Fibroblasts OK 67.8157 674.909 3.315 -7.98693 1.33227e-15 8.65308e-14 yes TSS115 XLOC_000082 SLC25A33 chr1:9599527-9642830 hESC Fibroblasts OK 229.284 266.339 0.216129 -0.423553 0.671892 0.87894 no TSS116 XLOC_000083 TMEM201 chr1:9648976-9674935 hESC Fibroblasts OK 402.381 330.695 -0.283061 0.651925 0.51445 0.747336 no TSS117 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 260.118 45.2674 -2.52262 0.296126 0.767134 0.942769 no TSS118 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 155.927 109.373 -0.511616 0.143442 0.885941 0.989719 no TSS119 XLOC_000084 PIK3CD chr1:9711789-9884550 hESC Fibroblasts OK 25.5368 21.2442 -0.265513 0.0146868 0.988282 0.999997 no TSS12 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 229.433 99.7819 -1.20123 1.4354 0.151172 0.32555 no TSS120 XLOC_000085 NMNAT1 chr1:10003485-10045555 hESC Fibroblasts OK 39.4422 319.369 3.01741 -7.86539 3.77476e-15 2.22882e-13 yes TSS121 XLOC_000086 RBP7 chr1:10057254-10076077 hESC Fibroblasts OK 229.575 19.7819 -3.53672 4.71889 2.3714e-06 2.617e-05 yes TSS122 XLOC_000087 UBE4B chr1:10093015-10241294 hESC Fibroblasts OK 1126.9 1169.94 0.0540669 -0.15898 0.873685 0.985011 no TSS123 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts OK 10.087 70.0715 2.79633 -0.330823 0.740778 0.927044 no TSS124 XLOC_000087 - chr1:10093015-10241294 hESC Fibroblasts OK 10.3213 200.875 4.2826 -1.52984 0.126057 0.288641 no TSS125 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 545.589 1011.58 0.890726 -1.42715 0.153538 0.329119 no TSS126 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts NOTEST 1.09608 5.57672 2.34706 -0.211056 0.832844 1 no TSS127 XLOC_000088 KIF1B chr1:10270763-10441659 hESC Fibroblasts OK 90.7558 29.2168 -1.63519 0.584758 0.55871 0.784659 no TSS128 XLOC_000089 PGD chr1:10459084-10480200 hESC Fibroblasts OK 7183.39 13970.1 0.959605 -2.30069 0.0214091 0.0702283 no TSS129 XLOC_000090 APITD1,Cort chr1:10490158-10512208 hESC Fibroblasts OK 94.3083 125.257 0.409432 -0.299383 0.764648 0.941238 no TSS13 XLOC_000016 KLHL17 chr1:895966-901095 hESC Fibroblasts OK 180.118 60.5379 -1.57304 0.973461 0.330324 0.563112 no TSS130 XLOC_000090 APITD1 chr1:10490158-10512208 hESC Fibroblasts OK 138.152 526.06 1.92897 -4.10601 4.02546e-05 0.000322782 yes TSS131 XLOC_000090 CORT chr1:10490158-10512208 hESC Fibroblasts OK 27.3151 12.1268 -1.17149 0.17028 0.86479 0.984711 no TSS132 XLOC_000091 PEX14,Pex14 chr1:10535002-10690813 hESC Fibroblasts OK 678.266 1632.34 1.26702 -1.57561 0.115116 0.272876 no TSS133 XLOC_000091 PEX14 chr1:10535002-10690813 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS134 XLOC_000092 TARDBP chr1:11072678-11085548 hESC Fibroblasts NOTEST 2401.2 2744.34 0.192704 -0.588326 0.556313 1 no TSS135 XLOC_000093 ANGPTL7 chr1:11166588-11322608 hESC Fibroblasts NOTEST 0.912846 10.571 3.5336 -0.48214 0.629707 1 no TSS136 XLOC_000094 UBIAD1 chr1:11333254-11348490 hESC Fibroblasts OK 307.383 332.294 0.112423 -0.306558 0.75918 0.93832 no TSS137 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts OK 74.4396 0.546235 -7.0904 5.74991 8.9292e-09 1.54654e-07 yes TSS138 XLOC_000095 PTCHD2 chr1:11539294-11597639 hESC Fibroblasts NOTEST 0 7.55415e-05 1.79769e+308 1.79769e+308 0.499931 1 no TSS139 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 18.7336 10.2274 -0.873192 0.243575 0.80756 0.964629 no TSS14 XLOC_000017 PLEKHN1 chr1:901876-910482 hESC Fibroblasts OK 22.784 59.3098 1.38025 -1.83239 0.066893 0.179533 no TSS140 XLOC_000096 FBXO44 chr1:11708449-11723383 hESC Fibroblasts OK 540.251 415.411 -0.37909 0.660823 0.508726 0.743346 no TSS141 XLOC_000097 FBXO6 chr1:11724149-11734407 hESC Fibroblasts OK 25.5712 363.317 3.82864 -8.06025 6.66134e-16 4.55425e-14 yes TSS142 XLOC_000098 C1orf187 chr1:11751780-11780336 hESC Fibroblasts OK 340.257 11.5677 -4.87845 6.10186 1.04843e-09 2.09525e-08 yes TSS143 XLOC_000100 AGTRAP chr1:11796141-11810827 hESC Fibroblasts OK 1610.7 1911.82 0.247261 -0.673622 0.500552 0.736373 no TSS144 XLOC_000101 C1orf167 chr1:11824461-11826573 hESC Fibroblasts NOTEST 3.47934 1.86471 -0.899861 0.478603 0.632221 1 no TSS145 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 2.18711 0 -1.79769e+308 -1.79769e+308 0.240981 1 no TSS146 XLOC_000102 C1orf167 chr1:11832138-11866115 hESC Fibroblasts NOTEST 2.17987 8.96806 2.04055 -0.106286 0.915355 1 no TSS147 XLOC_000103 CLCN6 chr1:11866206-11907840 hESC Fibroblasts OK 357.971 569.35 0.669474 -0.724383 0.468831 0.711462 no TSS148 XLOC_000103 - chr1:11866206-11907840 hESC Fibroblasts OK 8.28757 16.145 0.962064 -0.0517317 0.958742 0.999997 no TSS149 XLOC_000104 PLOD1 chr1:11994745-12035593 hESC Fibroblasts OK 956.552 10441.6 3.44836 -7.55593 4.15223e-14 1.92634e-12 yes TSS15 XLOC_000018 ISG15 chr1:948846-949915 hESC Fibroblasts OK 987.18 3379.09 1.77525 -5.01809 5.21889e-07 7.36884e-06 yes TSS150 XLOC_000105 MFN2 chr1:12040237-12073571 hESC Fibroblasts OK 942.066 2871.51 1.60791 -4.64298 3.43412e-06 3.6565e-05 yes TSS151 XLOC_000106 MIIP chr1:12079511-12092106 hESC Fibroblasts OK 1223.51 575.01 -1.08937 2.79975 0.00511417 0.02143 yes TSS152 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts OK 431.964 4.49636 -6.58601 5.6319 1.78233e-08 3.00682e-07 yes TSS153 XLOC_000107 TNFRSF8 chr1:12123433-12204262 hESC Fibroblasts NOTEST 9.03791 4.00161 -1.17541 0.476991 0.633369 1 no TSS154 XLOC_000108 TNFRSF1B chr1:12227059-12269276 hESC Fibroblasts OK 33.8648 1395.94 5.36531 -14.2831 0 0 yes TSS155 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 71.9285 191.792 1.41491 -2.32165 0.0202518 0.0675709 no TSS156 XLOC_000109 VPS13D chr1:12290112-12572096 hESC Fibroblasts OK 66.1936 94.7776 0.517853 -0.423606 0.671853 0.87894 no TSS157 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS158 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts OK 20.135 65.4483 1.70065 -1.27947 0.200731 0.392105 no TSS159 XLOC_000109 - chr1:12290112-12572096 hESC Fibroblasts NOTEST 4.58204 2.38321 -0.943087 0.0241683 0.980718 1 no TSS16 XLOC_000019 AGRN chr1:955502-991492 hESC Fibroblasts OK 1857.6 2553.38 0.458967 -1.27209 0.203343 0.39661 no TSS160 XLOC_000111 AADACL4 chr1:12704565-12727096 hESC Fibroblasts NOTEST 1.34969 0 -1.79769e+308 -1.79769e+308 0.0786442 1 no TSS161 XLOC_000112 AADACL3 chr1:12776117-12788726 hESC Fibroblasts OK 10.0548 0 -1.79769e+308 -1.79769e+308 6.36003e-08 1.01996e-06 yes TSS162 XLOC_000113 C1orf158 chr1:12806162-12821101 hESC Fibroblasts NOTEST 1.29047 0 -1.79769e+308 -1.79769e+308 0.275365 1 no TSS163 XLOC_000114 PRAMEF12 chr1:12834983-12838046 hESC Fibroblasts NOTEST 0.853096 0 -1.79769e+308 -1.79769e+308 0.111514 1 no TSS164 XLOC_000115 PRAMEF1 chr1:12851545-12856223 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS165 XLOC_000116 PRAMEF2 chr1:12916940-12921764 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS166 XLOC_000117 PRAMEF8 chr1:12976449-12980566 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS167 XLOC_000118 PRAMEF22 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS168 XLOC_000119 PRAMEF6 chr1:13359818-13369057 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS169 XLOC_000120 PRAMEF9 chr1:13421175-13428191 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS17 XLOC_000020 - chr1:995082-1001833 hESC Fibroblasts OK 32.064 70.3957 1.13453 -1.49743 0.13428 0.300742 no TSS170 XLOC_000121 PRAMEF16 chr1:13495253-13498257 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS171 XLOC_000122 PRAMEF20 chr1:13516065-13526943 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS172 XLOC_000123 PRAMEF10 chr1:13629937-13635298 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS173 XLOC_000124 PRAMEF9 chr1:13641972-13648988 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS174 XLOC_000125 PRAMEF17 chr1:13716087-13719064 hESC Fibroblasts NOTEST 0.330232 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TSS175 XLOC_000126 PRAMEF20 chr1:13736906-13747803 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS176 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts OK 1696.44 111.012 -3.93372 7.81367 5.55112e-15 3.00454e-13 yes TSS177 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 6.91549 0 -1.79769e+308 -1.79769e+308 0.25743 1 no TSS178 XLOC_000127 PDPN chr1:13910251-13944450 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS179 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 12.8679 27.8928 1.11612 -0.43767 0.661626 0.873873 no TSS18 XLOC_000021 - chr1:1072396-1079432 hESC Fibroblasts NOTEST 1.64828 0 -1.79769e+308 -1.79769e+308 0.0567344 1 no TSS180 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 29.8078 14.8538 -1.00486 0.667224 0.504629 0.739274 no TSS181 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts NOTEST 1.65694 0 -1.79769e+308 -1.79769e+308 0.351997 1 no TSS182 XLOC_000128 PRDM2 chr1:14026734-14151572 hESC Fibroblasts OK 112.101 431.651 1.94507 -4.26045 2.04018e-05 0.000179067 yes TSS183 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 54.9232 9.90288 -2.4715 0.535392 0.592379 0.816879 no TSS184 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 19.5662 29.388 0.586861 -0.332502 0.73951 0.927013 no TSS185 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 0 13.2968 1.79769e+308 1.79769e+308 0.307255 0.535736 no TSS186 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 0 205.94 1.79769e+308 1.79769e+308 0.0476009 0.135008 no TSS187 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts OK 79.6627 208.608 1.38882 -1.44008 0.149845 0.324414 no TSS188 XLOC_000129 - chr1:14925212-15478960 hESC Fibroblasts NOTEST 5.19027 10.0324 0.950785 -0.308976 0.75734 1 no TSS189 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 68.8214 34.1487 -1.01103 0.573613 0.56623 0.794312 no TSS19 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts OK 9.72413 0 -1.79769e+308 -1.79769e+308 0.000129882 0.00090223 yes TSS190 XLOC_000130 TMEM51 chr1:15479027-15546973 hESC Fibroblasts OK 163.558 679.888 2.0555 -4.67324 2.9649e-06 3.2095e-05 yes TSS1906 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 347.213 560.298 0.690375 -0.967644 0.333222 0.565824 no TSS1907 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 95.223 76.652 -0.312987 0.208524 0.83482 0.971712 no TSS1908 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1909 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 294.38 313.868 0.0924762 -0.0919233 0.926759 0.999997 no TSS191 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 6.18974 2.29329 -1.43246 1.29897 0.193955 1 no TSS1910 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1911 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts OK 224.306 240.082 0.0980617 -0.0766303 0.938918 0.999997 no TSS1912 XLOC_001217 - chr1:11873-29961 hESC Fibroblasts NOTEST 122.62 228.081 0.895349 -0.82671 0.408402 1 no TSS1913 XLOC_001218 - chr1:34611-36081 hESC Fibroblasts OK 16.5503 4.32826 -1.935 1.77451 0.0759782 0.198583 no TSS1914 XLOC_001219 - chr1:89294-237877 hESC Fibroblasts OK 2.45836 13.5604 2.46363 -1.44662 0.148004 0.322579 no TSS1915 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 18.7126 1.6027 -3.54544 0.420357 0.674225 0.880219 no TSS1916 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 297.645 39.9694 -2.89662 4.4069 1.04861e-05 9.59257e-05 yes TSS1917 XLOC_001222 - chr1:661139-679736 hESC Fibroblasts OK 712.204 68.2817 -3.38272 2.39972 0.0164076 0.0566846 no TSS1918 XLOC_001227 - chr1:700236-714006 hESC Fibroblasts OK 235.71 50.5377 -2.22158 3.66287 0.000249408 0.00159597 yes TSS1919 XLOC_001229 FAM41C chr1:803452-812182 hESC Fibroblasts NOTEST 2.1691 7.41126 1.77262 -1.66954 0.0950099 1 no TSS192 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 1.79489 0.862567 -1.05719 0.402707 0.687164 1 no TSS1920 XLOC_001230 - chr1:852952-854817 hESC Fibroblasts NOTEST 4.38548 7.62477 0.79796 -0.337126 0.736022 1 no TSS1921 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 100.448 55.7714 -0.848848 0.149951 0.880804 0.987498 no TSS1922 XLOC_001231 NOC2L chr1:860529-894679 hESC Fibroblasts OK 1734.7 2164.3 0.319214 -0.640593 0.521787 0.752277 no TSS1923 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts OK 14.7182 36.2061 1.29863 -1.70988 0.087289 0.220861 no TSS1924 XLOC_001232 C1orf170 chr1:910578-917473 hESC Fibroblasts NOTEST 0.517867 2.14049 2.04729 -0.62116 0.534494 1 no TSS1925 XLOC_001233 HES4 chr1:934341-935552 hESC Fibroblasts OK 37.4229 33.6271 -0.154296 0.155186 0.876675 0.985975 no TSS1926 XLOC_001234 - chr1:1017197-1051736 hESC Fibroblasts NOTEST 0 6.02886 1.79769e+308 1.79769e+308 0.405618 1 no TSS1927 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 48.2129 75.8125 0.653015 -0.445166 0.6562 0.870688 no TSS1928 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 91.6026 59.219 -0.629328 0.452454 0.650942 0.866366 no TSS1929 XLOC_001234 C1orf159 chr1:1017197-1051736 hESC Fibroblasts OK 40.1782 84.2776 1.06874 -1.12343 0.261256 0.480017 no TSS193 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1930 XLOC_001235 - chr1:1108435-1133313 hESC Fibroblasts NOTEST 5.99833 0 -1.79769e+308 -1.79769e+308 5.83424e-06 1 no TSS1931 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 10.3558 0 -1.79769e+308 -1.79769e+308 0.0150296 0.053489 no TSS1932 XLOC_001236 TNFRSF18 chr1:1138888-1142089 hESC Fibroblasts OK 24.8393 14.2699 -0.799652 0.99446 0.319999 0.552681 no TSS1933 XLOC_001237 TNFRSF4 chr1:1146706-1149512 hESC Fibroblasts NOTEST 1.21775 5.89401 2.27503 -1.70433 0.0883185 1 no TSS1934 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 105.623 71.6823 -0.55924 0.101587 0.919085 0.999997 no TSS1935 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 1497.29 8958.96 2.58097 -6.7853 1.15845e-11 3.27137e-10 yes TSS1936 XLOC_001238 SDF4 chr1:1152288-1167447 hESC Fibroblasts OK 210.708 114.07 -0.885326 0.0437604 0.965095 0.999997 no TSS1937 XLOC_001239 FAM132A chr1:1177832-1182102 hESC Fibroblasts OK 41.9198 75.8216 0.854975 -1.29359 0.195806 0.386552 no TSS1938 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 15.5986 27.9153 0.839645 -0.166774 0.867548 0.985011 no TSS1939 XLOC_001240 UBE2J2 chr1:1189293-1209234 hESC Fibroblasts OK 699.024 1963.86 1.49027 -4.18162 2.89439e-05 0.00024574 yes TSS194 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1940 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 139.601 101.369 -0.461694 0.190777 0.8487 0.980838 no TSS1941 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 113.499 86.9123 -0.385041 0.231308 0.817076 0.967036 no TSS1942 XLOC_001242 ACAP3 chr1:1227763-1260046 hESC Fibroblasts OK 181.357 810.457 2.1599 -3.18278 0.00145871 0.00737299 yes TSS1943 XLOC_001242 - chr1:1227763-1260046 hESC Fibroblasts OK 117.46 131.616 0.164166 -0.0511625 0.959196 0.999997 no TSS1944 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 94.0403 120.03 0.35204 -0.15234 0.878919 0.987498 no TSS1945 XLOC_001243 CPSF3L chr1:1227763-1260046 hESC Fibroblasts OK 2450.2 2988.65 0.286591 -0.431372 0.666198 0.876587 no TSS1946 XLOC_001244 DVL1,DVL1L1 chr1:1270658-1284492 hESC Fibroblasts OK 294.553 302.198 0.0369671 -0.0332959 0.973439 0.999997 no TSS1947 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 674.206 1267.03 0.91019 -2.44157 0.0146234 0.05262 no TSS1948 XLOC_001244 DVL1 chr1:1270658-1284492 hESC Fibroblasts OK 193.963 23.7193 -3.03165 1.07489 0.282422 0.512383 no TSS1949 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 134.781 14301.4 6.72939 -14.4747 0 0 yes TSS195 XLOC_000131 FHAD1 chr1:15573767-15726776 hESC Fibroblasts NOTEST 0.429055 0.572031 0.414929 -0.0829553 0.933887 1 no TSS1950 XLOC_001245 MXRA8 chr1:1288071-1297157 hESC Fibroblasts OK 18.5375 18.6477 0.00855196 -0.00014294 0.999886 0.999997 no TSS1951 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 1941.94 3221.31 0.730149 -1.39541 0.162892 0.344096 no TSS1952 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 836.594 1951.82 1.22222 -1.71807 0.0857836 0.218496 no TSS1953 XLOC_001246 AURKAIP1 chr1:1309109-1310818 hESC Fibroblasts OK 881.639 1861.17 1.07795 -1.80283 0.0714156 0.188555 no TSS1954 XLOC_001247 - chr1:1321090-1334718 hESC Fibroblasts OK 15.222 6.77005 -1.16892 0.0561435 0.955227 0.999997 no TSS1955 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 110.19 134.515 0.287785 -0.246328 0.805429 0.964629 no TSS1956 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 107.558 19.8352 -2.43898 0.349615 0.726628 0.915648 no TSS1957 XLOC_001247 CCNL2 chr1:1321090-1334718 hESC Fibroblasts OK 1006.01 1112.52 0.145184 -0.308378 0.757795 0.93832 no TSS1958 XLOC_001248 MRPL20 chr1:1334909-1342693 hESC Fibroblasts OK 4356.64 8744.67 1.00519 -2.83187 0.00462771 0.0197743 yes TSS1959 XLOC_001249 - chr1:1353801-1356650 hESC Fibroblasts OK 73.1639 100.918 0.463986 -0.651479 0.514737 0.747336 no TSS196 XLOC_000131 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1960 XLOC_001250 C1orf70 chr1:1470158-1475740 hESC Fibroblasts OK 83.1162 233.834 1.49228 -2.91232 0.0035875 0.0159595 yes TSS1961 XLOC_001251 SSU72 chr1:1477053-1510262 hESC Fibroblasts OK 3413.53 6671.18 0.966678 -2.68454 0.00726302 0.0295332 yes TSS1962 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 205.562 286.25 0.4777 -0.171403 0.863907 0.984711 no TSS1963 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 291.78 366.787 0.330061 -0.132413 0.894658 0.99186 no TSS1964 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 1203.07 1936.1 0.686434 -0.387205 0.698605 0.898884 no TSS1965 XLOC_001252 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 816.237 795.035 -0.0379698 0.00209118 0.998331 0.999997 no TSS1966 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 110.433 19.8478 -2.47611 0.0648849 0.948266 0.999997 no TSS1967 XLOC_001252 CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 244.477 169.529 -0.528166 0.0736087 0.941322 0.999997 no TSS1968 XLOC_001252 CDC2L1,CDC2L2 chr1:1571099-1677431 hESC Fibroblasts OK 29.5615 112.085 1.9228 -0.0741454 0.940895 0.999997 no TSS1969 XLOC_001253 CDC2L1 chr1:1571099-1677431 hESC Fibroblasts OK 251.238 440.918 0.811457 -0.158057 0.874412 0.985011 no TSS197 XLOC_000132 EFHD2 chr1:15736390-15756839 hESC Fibroblasts OK 468.604 2197 2.22909 -6.83631 8.12594e-12 2.399e-10 yes TSS1970 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 178.377 315.575 0.823057 -0.298707 0.765164 0.941238 no TSS1971 XLOC_001254 - chr1:1571099-1677431 hESC Fibroblasts OK 222.366 276.724 0.315512 -0.265379 0.790717 0.957262 no TSS1972 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 632.852 762.008 0.267939 -0.178341 0.858455 0.984711 no TSS1973 XLOC_001254 SLC35E2 chr1:1571099-1677431 hESC Fibroblasts OK 122.207 362.567 1.56892 -0.507466 0.611828 0.832472 no TSS1974 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 13.2843 1.85523 -2.84005 0.0468309 0.962648 0.999997 no TSS1975 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 510.173 1204.38 1.23923 -3.74084 0.000183405 0.00121552 yes TSS1976 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 332.932 0 -1.79769e+308 -1.79769e+308 4.29231e-10 9.61328e-09 yes TSS1977 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 91.3616 2.79122 -5.03262 0.177031 0.859484 0.984711 no TSS1978 XLOC_001256 NADK chr1:1682677-1711508 hESC Fibroblasts OK 210.14 43.7417 -2.26427 0.512149 0.608547 0.831233 no TSS1979 XLOC_001257 GNB1 chr1:1716729-1822495 hESC Fibroblasts OK 4821.37 16708.8 1.79309 -3.79657 0.000146711 0.000997786 yes TSS198 XLOC_000133 CTRC chr1:15764937-15773153 hESC Fibroblasts NOTEST 0 5.61806 1.79769e+308 1.79769e+308 0.0900461 1 no TSS1980 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 212.131 0 -1.79769e+308 -1.79769e+308 1.03345e-14 5.36982e-13 yes TSS1981 XLOC_001258 TMEM52 chr1:1849028-1850740 hESC Fibroblasts OK 79.5862 23.4115 -1.7653 2.31352 0.0206939 0.0687503 no TSS1982 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts NOTEST 2.02001 0 -1.79769e+308 -1.79769e+308 0.0595537 1 no TSS1983 XLOC_001259 C1orf222 chr1:1853396-1859368 hESC Fibroblasts NOTEST 1.04698 0 -1.79769e+308 -1.79769e+308 0.120101 1 no TSS1984 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0.932315 0 -1.79769e+308 -1.79769e+308 0.0219603 1 no TSS1985 XLOC_001260 KIAA1751 chr1:1884751-1935276 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1986 XLOC_001261 - chr1:1944651-1946969 hESC Fibroblasts NOTEST 8.18597 0 -1.79769e+308 -1.79769e+308 4.15702e-05 1 no TSS1987 XLOC_001262 - chr1:1981908-2139172 hESC Fibroblasts OK 33.574 27.1259 -0.307674 0.0564177 0.955009 0.999997 no TSS1988 XLOC_001263 C1orf86 chr1:1981908-2139172 hESC Fibroblasts OK 1848.73 2769.72 0.583205 -1.35406 0.175716 0.356898 no TSS1989 XLOC_001263 - chr1:1981908-2139172 hESC Fibroblasts OK 25.7926 78.7015 1.60943 -1.03773 0.299394 0.527577 no TSS199 XLOC_000134 CELA2A chr1:15783222-15798585 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1990 XLOC_001264 MORN1 chr1:2252695-2322993 hESC Fibroblasts OK 109.55 102.498 -0.0960002 0.099023 0.92112 0.999997 no TSS1991 XLOC_001266 PEX10 chr1:2323213-2344010 hESC Fibroblasts OK 461.866 917.336 0.989975 -0.869599 0.384519 0.618948 no TSS1992 XLOC_001267 PANK4 chr1:2439974-2458035 hESC Fibroblasts OK 361.252 500.991 0.47178 -1.29987 0.193646 0.38404 no TSS1993 XLOC_001268 HES5 chr1:2460184-2461684 hESC Fibroblasts NOTEST 2.94754 0 -1.79769e+308 -1.79769e+308 0.0305867 1 no TSS1994 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts NOTEST 0.475004 6.38716 3.74916 -0.880929 0.378356 1 no TSS1995 XLOC_001269 - chr1:2481358-2495265 hESC Fibroblasts NOTEST 0.649192 9.83614 3.92137 -1.06153 0.288449 1 no TSS1996 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS1997 XLOC_001270 MMEL1 chr1:2518248-2564481 hESC Fibroblasts OK 12.7571 3.38316 -1.91486 0.083474 0.933475 0.999997 no TSS1998 XLOC_001271 - chr1:2976182-2980350 hESC Fibroblasts NOTEST 0 0.336145 1.79769e+308 1.79769e+308 0.220257 1 no TSS1999 XLOC_001272 - chr1:2980635-2984289 hESC Fibroblasts NOTEST 0 9.74659 1.79769e+308 1.79769e+308 0.0630521 1 no TSS2 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 358.383 29.2848 -3.61328 4.06337 4.83698e-05 0.000374002 yes TSS20 XLOC_000025 TTLL10 chr1:1108435-1133313 hESC Fibroblasts NOTEST 6.97279 0 -1.79769e+308 -1.79769e+308 0.00246227 1 no TSS200 XLOC_000135 CELA2B chr1:15802595-15851384 hESC Fibroblasts NOTEST 1.27477 0 -1.79769e+308 -1.79769e+308 0.352721 1 no TSS2000 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 41.8309 92.849 1.15032 -2.02047 0.0433352 0.126216 no TSS2001 XLOC_001273 MEGF6 chr1:3404512-3528059 hESC Fibroblasts OK 177.762 64.5702 -1.461 2.2504 0.0244238 0.0789216 no TSS2002 XLOC_001274 WDR8 chr1:3547331-3566671 hESC Fibroblasts OK 597.841 520.346 -0.200289 0.431316 0.666239 0.876587 no TSS2003 XLOC_001275 - chr1:3652549-3663886 hESC Fibroblasts OK 11.3698 30.0855 1.40386 -0.69898 0.484565 0.723037 no TSS2004 XLOC_001275 KIAA0495 chr1:3652549-3663886 hESC Fibroblasts OK 422.204 227.555 -0.891723 2.49181 0.0127093 0.0466367 yes TSS2005 XLOC_001276 LRRC47 chr1:3696783-3713068 hESC Fibroblasts OK 1345.43 1410.28 0.0679088 -0.214918 0.829831 0.970814 no TSS2006 XLOC_001277 KIAA0562 chr1:3728644-3773797 hESC Fibroblasts OK 182.207 568.38 1.64128 -3.56934 0.00035788 0.00221374 yes TSS2007 XLOC_001278 C1orf174 chr1:3805702-3816857 hESC Fibroblasts OK 551.063 1182.73 1.10183 -3.13501 0.00171846 0.00842367 yes TSS2008 XLOC_001279 - chr1:5621768-5728315 hESC Fibroblasts NOTEST 0.669469 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TSS2009 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 153.438 102.752 -0.578497 1.20366 0.22872 0.433733 no TSS201 XLOC_000136 DNAJC16 chr1:15853351-15918872 hESC Fibroblasts OK 153.207 376.455 1.297 -3.22316 0.00126784 0.00658768 yes TSS2010 XLOC_001280 NPHP4 chr1:5922869-6052531 hESC Fibroblasts OK 32.7056 8.76607 -1.89953 1.12749 0.259536 0.477531 no TSS2011 XLOC_001280 - chr1:5922869-6052531 hESC Fibroblasts NOTEST 5.2451 3.61882 -0.535453 0.0305755 0.975608 1 no TSS2012 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts NOTEST 3.24653 2.58654 -0.327873 0.275149 0.783202 1 no TSS2013 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts NOTEST 0.766551 0.873718 0.188784 -0.0739284 0.941067 1 no TSS2014 XLOC_001281 CHD5 chr1:6161852-6240183 hESC Fibroblasts OK 13.8631 0.611774 -4.50211 1.97438 0.0483381 0.136503 no TSS2015 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts NOTEST 4.78329 0 -1.79769e+308 -1.79769e+308 0.0316638 1 no TSS2016 XLOC_001281 - chr1:6161852-6240183 hESC Fibroblasts NOTEST 5.03226 0 -1.79769e+308 -1.79769e+308 0.0774087 1 no TSS2017 XLOC_001282 RPL22 chr1:6245080-6259679 hESC Fibroblasts OK 4375.01 9875.13 1.17451 -3.1378 0.00170224 0.00837578 yes TSS2018 XLOC_001283 ICMT chr1:6266188-6296044 hESC Fibroblasts OK 1334.15 2608.03 0.967038 -2.79685 0.00516036 0.0215541 yes TSS2019 XLOC_001284 GPR153 chr1:6307413-6321035 hESC Fibroblasts OK 97.14 268.364 1.46605 -2.32155 0.0202573 0.0675709 no TSS202 XLOC_000136 - chr1:15853351-15918872 hESC Fibroblasts NOTEST 1.81648 2.11882 0.222122 -0.0073207 0.994159 1 no TSS2020 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1356.8 2679.84 0 0 1 1 no TSS2021 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 0 39.0287 0 0 1 1 no TSS2022 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 93.6803 110.585 0 0 1 1 no TSS2023 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1047.97 732.481 0 0 1 1 no TSS2024 XLOC_001285 ACOT7 chr1:6324332-6453826 hESC Fibroblasts FAIL 1060.75 1033.82 0 0 1 1 no TSS2025 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 2.2157 0.48661 -2.18692 0.607064 0.543809 1 no TSS2026 XLOC_001286 HES2 chr1:6472499-6484730 hESC Fibroblasts NOTEST 6.44393 1.41752 -2.18458 2.40309 0.016257 1 no TSS2027 XLOC_001287 TNFRSF25 chr1:6521220-6580069 hESC Fibroblasts OK 332.126 24.4669 -3.76283 0.949054 0.342593 0.575038 no TSS2028 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 35.8901 1.74109 -4.36552 0.469065 0.639023 0.855764 no TSS2029 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 38.9511 2.5797 -3.91639 0.954185 0.33999 0.57348 no TSS203 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts OK 270.688 311.27 0.201536 -0.348568 0.727413 0.915648 no TSS2030 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 62.1096 0 -1.79769e+308 -1.79769e+308 7.13666e-07 9.55724e-06 yes TSS2031 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 73.921 0 -1.79769e+308 -1.79769e+308 8.90841e-06 8.26573e-05 yes TSS2032 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 43.3127 34.905 -0.311353 0.350971 0.72561 0.915648 no TSS2033 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 4.59064 0.024414 -7.55484 0.283452 0.776831 1 no TSS2034 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 9.71361 0 -1.79769e+308 -1.79769e+308 0.151372 0.32555 no TSS2035 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts OK 51.9914 18.3016 -1.50631 1.47588 0.139975 0.30923 no TSS2036 XLOC_001287 PLEKHG5 chr1:6521220-6580069 hESC Fibroblasts NOTEST 6.79791 3.95345 -0.781978 0.25367 0.799751 1 no TSS2037 XLOC_001287 - chr1:6521220-6580069 hESC Fibroblasts OK 77.8501 12.5671 -2.63104 0.915797 0.359774 0.592837 no TSS2038 XLOC_001288 NOL9 chr1:6585209-6614581 hESC Fibroblasts OK 189.708 363.843 0.939533 -2.33908 0.0193314 0.0655652 no TSS2039 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 216.693 455.331 1.07126 -1.30809 0.190843 0.379639 no TSS204 XLOC_000137 DDI2 chr1:15944069-15988216 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2040 XLOC_001289 KLHL21 chr1:6650778-6662929 hESC Fibroblasts OK 151.442 601.611 1.99006 -2.62421 0.00868508 0.0341876 yes TSS2041 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2042 XLOC_001290 DNAJC11 chr1:6684924-6761966 hESC Fibroblasts OK 1372.27 1731.39 0.33537 -0.958983 0.337567 0.570964 no TSS2043 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2044 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0.950535 0 -1.79769e+308 -1.79769e+308 0.387454 1 no TSS2045 XLOC_001291 UTS2 chr1:7844379-7973294 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2046 XLOC_001292 TNFRSF9 chr1:7979907-8000887 hESC Fibroblasts NOTEST 0.267901 1.38187 2.36684 -1.03459 0.30086 1 no TSS2047 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 442.172 2240.53 2.34116 -6.97387 3.08353e-12 1.11264e-10 yes TSS2048 XLOC_001293 ERRFI1 chr1:8071779-8086393 hESC Fibroblasts OK 21.342 71.1003 1.73616 -0.530948 0.595455 0.819381 no TSS2049 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 320.719 1692.19 2.39951 -5.93358 2.96391e-09 5.66194e-08 yes TSS205 XLOC_000139 PLEKHM2 chr1:16010826-16061262 hESC Fibroblasts OK 779.207 2346.33 1.59033 -4.91682 8.79633e-07 1.13133e-05 yes TSS2050 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 662.61 278.541 -1.25027 0.69688 0.485878 0.723802 no TSS2051 XLOC_001294 RERE chr1:8412465-8877699 hESC Fibroblasts OK 0 47.6257 1.79769e+308 1.79769e+308 0.43296 0.672745 no TSS2052 XLOC_001294 - chr1:8412465-8877699 hESC Fibroblasts NOTEST 3.82252 6.13498 0.682535 -0.0101436 0.991907 1 no TSS2053 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 211.161 181.074 -0.221768 0.0130283 0.989605 0.999997 no TSS2054 XLOC_001296 ENO1 chr1:8921062-8938780 hESC Fibroblasts OK 52429.9 71451.4 0.446573 -1.32291 0.185866 0.373168 no TSS2055 XLOC_001297 SLC2A7 chr1:9063358-9086404 hESC Fibroblasts NOTEST 0.358204 0.725244 1.01768 -0.395685 0.692337 1 no TSS2056 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 0.000167835 7.16648 15.3819 -0.00350708 0.997202 1 no TSS2057 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts NOTEST 2.90964 4.17775 0.521889 -0.0192299 0.984658 1 no TSS2058 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts OK 0 51.3731 1.79769e+308 1.79769e+308 0.0696909 0.18589 no TSS2059 XLOC_001298 SLC2A5 chr1:9097006-9148510 hESC Fibroblasts OK 0 61.3688 1.79769e+308 1.79769e+308 0.0885587 0.223069 no TSS206 XLOC_000140 SLC25A34 chr1:16062808-16067885 hESC Fibroblasts NOTEST 8.64356 9.3373 0.111381 -0.136942 0.891077 1 no TSS2060 XLOC_001299 GPR157 chr1:9164475-9189356 hESC Fibroblasts OK 57.8343 98.5546 0.768999 -1.03187 0.302134 0.529652 no TSS2061 XLOC_001300 - chr1:9208346-9242451 hESC Fibroblasts OK 212.722 69.3907 -1.61616 3.35287 0.00079978 0.00442091 yes TSS2062 XLOC_001301 C1orf200 chr1:9711789-9884550 hESC Fibroblasts NOTEST 0.589835 0 -1.79769e+308 -1.79769e+308 0.430197 1 no TSS2063 XLOC_001302 - chr1:9711789-9884550 hESC Fibroblasts OK 230.865 61.7832 -1.90176 0.241221 0.809384 0.964629 no TSS2064 XLOC_001303 - chr1:9711789-9884550 hESC Fibroblasts OK 145.676 695.497 2.25528 -0.858203 0.39078 0.626696 no TSS2065 XLOC_001303 CLSTN1 chr1:9711789-9884550 hESC Fibroblasts OK 1584.55 4148.55 1.38853 -3.29458 0.000985679 0.00531285 yes TSS2066 XLOC_001304 CTNNBIP1 chr1:9908333-9970316 hESC Fibroblasts OK 655.696 509.797 -0.363105 0.953415 0.34038 0.57348 no TSS2067 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts NOTEST 3.50582 7.08002 1.014 -0.0712022 0.943237 1 no TSS2068 XLOC_001305 LZIC chr1:9989777-10003427 hESC Fibroblasts OK 194.222 1015.04 2.38575 -6.08374 1.17408e-09 2.3108e-08 yes TSS2069 XLOC_001306 DFFA chr1:10520604-10532613 hESC Fibroblasts OK 1126.41 1164.65 0.0481601 -0.135381 0.89231 0.990693 no TSS207 XLOC_000140 - chr1:16062808-16067885 hESC Fibroblasts NOTEST 0.000570561 4.66039 12.9958 -0.00854718 0.99318 1 no TSS2070 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 58.8654 1.99903 -4.88005 2.97314 0.00294767 0.0137241 yes TSS2071 XLOC_001307 CASZ1 chr1:10696667-10856707 hESC Fibroblasts OK 49.2697 6.07219 -3.02041 3.3287 0.000872536 0.00478238 yes TSS2072 XLOC_001307 - chr1:10696667-10856707 hESC Fibroblasts NOTEST 1.40186 0 -1.79769e+308 -1.79769e+308 0.26695 1 no TSS2073 XLOC_001308 C1orf127 chr1:11006532-11024258 hESC Fibroblasts NOTEST 4.3281 0.333513 -3.69792 1.07353 0.283035 1 no TSS2074 XLOC_001309 MASP2 chr1:11086580-11107285 hESC Fibroblasts OK 57.5421 15.0124 -1.93846 2.98993 0.00279038 0.0130856 yes TSS2075 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts NOTEST 432.981 3003.63 2.79433 -3.12328 0.00178846 1 no TSS2076 XLOC_001310 SRM chr1:11114648-11120091 hESC Fibroblasts OK 4481.12 7820.85 0.803466 -2.15713 0.0309952 0.0960925 no TSS2077 XLOC_001311 EXOSC10 chr1:11126677-11159938 hESC Fibroblasts OK 1348.42 1642.04 0.284219 -0.862631 0.38834 0.623553 no TSS2078 XLOC_001312 - chr1:11166588-11322608 hESC Fibroblasts OK 135.175 170.948 0.338728 -0.316107 0.751921 0.935808 no TSS2079 XLOC_001312 MTOR chr1:11166588-11322608 hESC Fibroblasts OK 892.477 636.873 -0.48681 1.45906 0.144548 0.316107 no TSS208 XLOC_000141 TMEM82 chr1:16068916-16074475 hESC Fibroblasts OK 31.4534 0 -1.79769e+308 -1.79769e+308 1.02587e-11 2.96135e-10 yes TSS2080 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts OK 1495.38 72.9584 -4.3573 3.71405 0.000203966 0.00132476 yes TSS2081 XLOC_001313 FBXO2 chr1:11708449-11723383 hESC Fibroblasts NOTEST 4.06337 0 -1.79769e+308 -1.79769e+308 0.405482 1 no TSS2082 XLOC_001314 MAD2L2 chr1:11734537-11751678 hESC Fibroblasts OK 6757.57 2368.21 -1.51271 4.77367 1.809e-06 2.09811e-05 yes TSS2083 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts NOTEST 64.418 263.856 2.03421 -3.74537 0.000180125 1 no TSS2084 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts OK 93.2442 277.975 1.57587 -3.25743 0.00112424 0.00593655 yes TSS2085 XLOC_001315 MTHFR chr1:11832138-11866115 hESC Fibroblasts OK 27.4533 108.763 1.98613 -0.970597 0.331749 0.564568 no TSS2086 XLOC_001316 NPPA chr1:11866206-11907840 hESC Fibroblasts OK 10.2838 18.088 0.814661 -0.159931 0.872936 0.985011 no TSS2087 XLOC_001317 NPPB chr1:11917521-11918992 hESC Fibroblasts NOTEST 7.22153 0 -1.79769e+308 -1.79769e+308 0.0228854 1 no TSS2088 XLOC_001318 KIAA2013 chr1:11980123-11986480 hESC Fibroblasts OK 754.447 1443.8 0.93638 -2.51973 0.0117444 0.043839 yes TSS2089 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 334.324 292.677 -0.191934 0.275888 0.782634 0.952749 no TSS209 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 28.622 72.561 1.34207 -0.293535 0.769113 0.944308 no TSS2090 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 341.518 459.21 0.42719 -0.718431 0.472491 0.712853 no TSS2091 XLOC_001319 DHRS3 chr1:12627939-12677820 hESC Fibroblasts OK 0 67.1677 1.79769e+308 1.79769e+308 0.479587 0.717722 no TSS2092 XLOC_001320 PRAMEF11 chr1:12884467-12891264 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2093 XLOC_001321 HNRNPCL1 chr1:12907235-12908578 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2094 XLOC_001322 PRAMEF4 chr1:12939032-12946025 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2095 XLOC_001323 PRAMEF10 chr1:12952727-12958094 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2096 XLOC_001324 PRAMEF6 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2097 XLOC_001324 PRAMEF5 chr1:12998301-13117751 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2098 XLOC_001326 PRAMEF22 chr1:13328195-13331692 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2099 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS21 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 14.5016 29.2958 1.01448 -1.11556 0.264609 0.485491 no TSS210 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 821.848 2026.56 1.30209 -3.21364 0.00131065 0.00675608 yes TSS2100 XLOC_001327 PRAMEF8 chr1:13386648-13390765 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2101 XLOC_001328 PRAMEF13,PRAMEF14 chr1:13447413-13452656 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2102 XLOC_001329 PRAMEF18 chr1:13474052-13477569 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2103 XLOC_001330 PRAMEF8 chr1:13607430-13611550 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2104 XLOC_001331 PRAMEF14 chr1:13668268-13673511 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2105 XLOC_001332 PRAMEF18 chr1:13694888-13698405 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2106 XLOC_001333 LRRC38 chr1:13801446-13840242 hESC Fibroblasts NOTEST 8.16584 0 -1.79769e+308 -1.79769e+308 5.37334e-05 1 no TSS2107 XLOC_001334 C1orf126 chr1:14925212-15478960 hESC Fibroblasts NOTEST 9.25388 0.859289 -3.42884 0.134917 0.892678 1 no TSS2108 XLOC_001335 - chr1:15573767-15726776 hESC Fibroblasts NOTEST 3.71564 2.62025 -0.503903 0.414142 0.67877 1 no TSS2109 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 380.234 207.808 -0.871635 1.39162 0.164038 0.345358 no TSS211 XLOC_000142 FBLIM1 chr1:16083153-16114431 hESC Fibroblasts OK 109.011 344.875 1.6616 -0.927858 0.353481 0.589438 no TSS2110 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 0 29.4638 1.79769e+308 1.79769e+308 0.209826 0.404398 no TSS2111 XLOC_001336 CASP9 chr1:15802595-15851384 hESC Fibroblasts OK 51.7979 51.1746 -0.0174654 0.0151006 0.987952 0.999997 no TSS2112 XLOC_001337 AGMAT chr1:15853351-15918872 hESC Fibroblasts OK 115.866 43.2083 -1.42308 0.890662 0.373111 0.606597 no TSS2113 XLOC_001339 - chr1:16160709-16266950 hESC Fibroblasts OK 58.2932 39.9858 -0.543842 0.228732 0.819077 0.967036 no TSS2114 XLOC_001340 ZBTB17 chr1:16268365-16302627 hESC Fibroblasts OK 335.879 666.365 0.988372 -2.2638 0.0235863 0.0765965 no TSS2115 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 3.62862 339.016 6.54579 -5.86065 4.61055e-09 8.3182e-08 yes TSS2116 XLOC_001342 HSPB7 chr1:16340522-16400127 hESC Fibroblasts OK 3.46957 397.66 6.84064 -5.90824 3.45785e-09 6.41678e-08 yes TSS2117 XLOC_001343 FAM131C chr1:16340522-16400127 hESC Fibroblasts OK 25.9588 46.4136 0.838324 -0.159162 0.873541 0.985011 no TSS2118 XLOC_001344 EPHA2 chr1:16450831-16482564 hESC Fibroblasts OK 575.636 923.073 0.681288 -2.00994 0.044437 0.12799 no TSS2119 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 324.019 170.844 -0.923397 1.89345 0.0582984 0.159767 no TSS212 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 241.251 293.864 0.284612 -0.622647 0.533517 0.760745 no TSS2120 XLOC_001345 ARHGEF19 chr1:16524598-16539104 hESC Fibroblasts OK 678.385 8.10745 -6.38671 3.11931 0.00181275 0.00880725 yes TSS2121 XLOC_001346 C1orf89 chr1:16558182-16563659 hESC Fibroblasts OK 53.4824 182.341 1.7695 -3.52638 0.000421284 0.00254534 yes TSS2122 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 2.24339 15.5838 2.7963 -0.645033 0.518906 0.749787 no TSS2123 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 8.45144 30.8971 1.8702 -0.603985 0.545854 0.772401 no TSS2124 XLOC_001347 FBXO42 chr1:16576559-16678948 hESC Fibroblasts OK 256.568 533.075 1.055 -2.88559 0.00390683 0.0169732 yes TSS2125 XLOC_001347 - chr1:16576559-16678948 hESC Fibroblasts NOTEST 0.999115 0 -1.79769e+308 -1.79769e+308 0.247955 1 no TSS2126 XLOC_001348 SPATA21 chr1:16693582-16763919 hESC Fibroblasts NOTEST 0 0.168084 1.79769e+308 1.79769e+308 0.490269 1 no TSS2127 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 48.5164 16.8693 -1.52407 2.33379 0.0196066 0.0659819 no TSS2128 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 76.9358 33.8911 -1.18275 0.619138 0.535826 0.761529 no TSS2129 XLOC_001349 - chr1:16793930-16819196 hESC Fibroblasts OK 47.6242 17.5001 -1.44433 0.677881 0.497847 0.733224 no TSS213 XLOC_000143 SPEN chr1:16160709-16266950 hESC Fibroblasts OK 140.357 168.12 0.260386 -0.417583 0.676252 0.881095 no TSS2130 XLOC_001350 - chr1:16860385-16864669 hESC Fibroblasts OK 11.9908 0.8365 -3.84142 2.49241 0.012688 0.0466367 yes TSS2131 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 222.328 890.142 2.00135 -4.24055 2.22974e-05 0.000191817 yes TSS2132 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 148.896 783.709 2.39601 -3.34092 0.000835002 0.00459605 yes TSS2133 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts NOTEST 2.13127 2.38008 0.159297 -0.00202641 0.998383 1 no TSS2134 XLOC_001352 NBPF1 chr1:16890411-16939982 hESC Fibroblasts OK 1.71985 41.2295 4.58332 -1.39535 0.162909 0.344096 no TSS2135 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 39.2466 151.051 1.94439 -1.90523 0.0567506 0.157163 no TSS2136 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 150.524 82.627 -0.865311 0.919468 0.357851 0.592837 no TSS2137 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 148.568 44.2115 -1.74863 1.56891 0.116669 0.275051 no TSS2138 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 186.65 89.6185 -1.05847 1.13268 0.25735 0.474181 no TSS2139 XLOC_001353 - chr1:16944752-16971178 hESC Fibroblasts OK 210.996 217.203 0.0418285 -0.0344889 0.972487 0.999997 no TSS214 XLOC_000144 C1orf64 chr1:16330730-16333180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2140 XLOC_001354 ESPN chr1:17017712-17046652 hESC Fibroblasts OK 11.1097 0 -1.79769e+308 -1.79769e+308 2.90933e-06 3.17582e-05 yes TSS2141 XLOC_001354 ESPNP chr1:17017712-17046652 hESC Fibroblasts NOTEST 3.47275 0 -1.79769e+308 -1.79769e+308 0.0482484 1 no TSS2142 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts OK 38.162 1.55467 -4.61745 0.301429 0.763087 0.941238 no TSS2143 XLOC_001355 MSTP9 chr1:17066767-17299474 hESC Fibroblasts NOTEST 3.25841 1.59851 -1.02744 0.0736512 0.941288 1 no TSS2144 XLOC_001356 - chr1:17066767-17299474 hESC Fibroblasts OK 415.352 408.247 -0.0248921 0.0164278 0.986893 0.999997 no TSS2145 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 4866.56 2361.94 -1.04293 2.66505 0.00769773 0.0307672 yes TSS2146 XLOC_001357 MFAP2 chr1:17300999-17308081 hESC Fibroblasts OK 0 43.7253 1.79769e+308 1.79769e+308 0.423876 0.663392 no TSS2147 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 366.46 231.387 -0.66335 0.678151 0.497676 0.733224 no TSS2148 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 1022.9 407.307 -1.32848 4.17253 3.01231e-05 0.000254091 yes TSS2149 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 22.7704 46.6117 1.03353 -0.289576 0.772141 0.94691 no TSS215 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 6.02437 0 -1.79769e+308 -1.79769e+308 0.0207184 1 no TSS2150 XLOC_001358 ATP13A2 chr1:17312452-17338423 hESC Fibroblasts OK 18.4495 0 -1.79769e+308 -1.79769e+308 0.137594 0.305449 no TSS2151 XLOC_001359 SDHB chr1:17345226-17380665 hESC Fibroblasts OK 1548.47 5372.43 1.79473 -5.61323 1.98579e-08 3.26525e-07 yes TSS2152 XLOC_001360 PADI2 chr1:17393256-17445948 hESC Fibroblasts OK 66.1047 0.887452 -6.21894 5.15106 2.59013e-07 3.78043e-06 yes TSS2153 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts NOTEST 4130.7 869.89 -2.24748 6.28248 3.33214e-10 1 no TSS2154 XLOC_001362 RCC2 chr1:17733251-17766220 hESC Fibroblasts OK 1326.29 178.175 -2.89603 3.79949 0.000144996 0.000996559 yes TSS2155 XLOC_001363 TAS1R2 chr1:19166092-19186155 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2156 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 218.303 130.588 -0.741314 1.047 0.295098 0.524394 no TSS2157 XLOC_001364 ALDH4A1 chr1:19197925-19229293 hESC Fibroblasts OK 434.186 406.234 -0.0960002 0.241311 0.809314 0.964629 no TSS2158 XLOC_001365 IFFO2 chr1:19230773-19282826 hESC Fibroblasts OK 89.541 303.773 1.76237 -4.98216 6.28781e-07 8.59775e-06 yes TSS2159 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 50.0495 229.039 2.19416 -0.336772 0.736289 0.924096 no TSS216 XLOC_000145 CLCNKA,CLCNKB chr1:16340522-16400127 hESC Fibroblasts OK 23.5434 0.308418 -6.2543 0.372202 0.709743 0.902118 no TSS2160 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 92.8871 294.701 1.6657 -0.854576 0.392786 0.629136 no TSS2161 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 22.9292 22.1323 -0.0510316 0.00276094 0.997797 0.999997 no TSS2162 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 167.676 0 -1.79769e+308 -1.79769e+308 0.0104565 0.0397165 yes TSS2163 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 557.747 470.997 -0.243893 0.19825 0.84285 0.976683 no TSS2164 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts OK 426.519 243.59 -0.808154 0.389931 0.696588 0.898577 no TSS2165 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 765.815 666.218 -0.201002 0.495133 0.620506 0.840481 no TSS2166 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 5.33048 5.62521 0.0776413 -0.00113021 0.999098 1 no TSS2167 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts OK 192.593 171.68 -0.165827 0.0762327 0.939234 0.999997 no TSS2168 XLOC_001366 - chr1:19398603-19536746 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2169 XLOC_001366 UBR4 chr1:19398603-19536746 hESC Fibroblasts NOTEST 4.71016 7.05837 0.583558 -0.0203922 0.98373 1 no TSS217 XLOC_000145 CLCNKA chr1:16340522-16400127 hESC Fibroblasts NOTEST 8.06405 0 -1.79769e+308 -1.79769e+308 0.160102 1 no TSS2170 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 13.1602 6.73706 -0.965995 0.0239382 0.980902 0.999997 no TSS2171 XLOC_001367 KIAA0090 chr1:19544584-19578046 hESC Fibroblasts OK 596.084 2362.61 1.9868 -5.91927 3.2338e-09 6.08799e-08 yes TSS2172 XLOC_001368 AKR7L chr1:19592475-19600568 hESC Fibroblasts OK 11.7019 10.5092 -0.155089 0.218303 0.827193 0.970329 no TSS2173 XLOC_001369 AKR7A3 chr1:19609056-19615280 hESC Fibroblasts OK 17.2325 15.2534 -0.176005 0.235969 0.813457 0.966771 no TSS2174 XLOC_001370 AKR7A2 chr1:19630458-19638640 hESC Fibroblasts OK 695.576 3218.59 2.21015 -6.26108 3.82316e-10 8.86836e-09 yes TSS2175 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2176 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 69.4828 70.755 0.0261749 -0.00130635 0.998958 0.999997 no TSS2177 XLOC_001371 CAPZB chr1:19665273-19811992 hESC Fibroblasts OK 5177.29 19381 1.90437 -4.80982 1.51068e-06 1.80035e-05 yes TSS2178 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 36.9795 1.79769e+308 1.79769e+308 0.343647 0.575996 no TSS2179 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 56.5465 464.48 3.03811 -7.27405 3.48832e-13 1.37313e-11 yes TSS218 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2180 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 10.5012 105.748 3.332 -2.57322 0.0100757 0.0386088 yes TSS2181 XLOC_001373 TMCO4 chr1:20008706-20126758 hESC Fibroblasts OK 0 20.9118 1.79769e+308 1.79769e+308 0.418961 0.658875 no TSS2182 XLOC_001375 PLA2G2E chr1:20246799-20250110 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2183 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2184 XLOC_001376 PLA2G2A chr1:20301924-20306932 hESC Fibroblasts OK 35.1082 12.952 -1.43863 1.65431 0.0980649 0.240352 no TSS2185 XLOC_001377 PLA2G2D chr1:20438440-20446008 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2186 XLOC_001378 PLA2G2C chr1:20490483-20501687 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2187 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts NOTEST 0.74001 0 -1.79769e+308 -1.79769e+308 0.239739 1 no TSS2188 XLOC_001379 - chr1:20687597-20755275 hESC Fibroblasts NOTEST 0 2.56345 1.79769e+308 1.79769e+308 0.0741977 1 no TSS2189 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts OK 6.4946 2654.04 8.67474 -4.40184 1.07335e-05 9.75019e-05 yes TSS219 XLOC_000145 CLCNKB chr1:16340522-16400127 hESC Fibroblasts OK 52.0827 1.81089 -4.84603 0.655272 0.512293 0.746878 no TSS2190 XLOC_001380 CAMK2N1 chr1:20808884-20812728 hESC Fibroblasts OK 124.278 7835.73 5.97843 -13.8149 0 0 yes TSS2191 XLOC_001381 MUL1 chr1:20825942-20834674 hESC Fibroblasts OK 351.837 1509.04 2.10065 -6.42614 1.30882e-10 3.20785e-09 yes TSS2192 XLOC_001382 DDOST chr1:20978259-20988037 hESC Fibroblasts OK 4991.33 12716.5 1.34921 -3.48999 0.000483045 0.00283926 yes TSS2193 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 14.7785 87.6849 2.56883 -2.42603 0.0152652 0.0539405 no TSS2194 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 5.90044 11.7825 0.997751 -0.402083 0.687623 0.890673 no TSS2195 XLOC_001383 KIF17 chr1:20990508-21044317 hESC Fibroblasts OK 151.303 29.9178 -2.33837 2.41052 0.01593 0.0554201 no TSS2196 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts OK 145.923 175.668 0.267647 -0.551906 0.581013 0.807183 no TSS2197 XLOC_001384 SH2D5 chr1:21046224-21059330 hESC Fibroblasts OK 160.628 132.567 -0.276995 0.422247 0.672845 0.879301 no TSS2198 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 56.1343 89.2902 0.66962 -0.183781 0.854185 0.984711 no TSS2199 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 107.411 147.345 0.456065 -0.225706 0.82143 0.967395 no TSS22 XLOC_000027 SCNN1D chr1:1215815-1227409 hESC Fibroblasts OK 60.1613 34.1815 -0.815621 0.87401 0.382113 0.617369 no TSS220 XLOC_000146 C1orf144 chr1:16693582-16763919 hESC Fibroblasts OK 1363.34 5311.2 1.96189 -4.89827 9.66828e-07 1.23128e-05 yes TSS2200 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 318.106 1405.24 2.14323 -1.90185 0.0571904 0.157615 no TSS2201 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 88.4856 1673.88 4.24161 -6.37005 1.88969e-10 4.46311e-09 yes TSS2202 XLOC_001385 HP1BP3 chr1:21069170-21113799 hESC Fibroblasts OK 494.915 1140.1 1.20391 -1.36518 0.172197 0.353371 no TSS2203 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 6.37526 487.969 6.25816 -3.64198 0.00027055 0.00172276 yes TSS2204 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 247.208 689.01 1.4788 -1.58927 0.112 0.267441 no TSS2205 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 0 233.937 1.79769e+308 1.79769e+308 0.156766 0.334382 no TSS2206 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 414.51 658.192 0.667101 -1.07208 0.283686 0.51374 no TSS2207 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2208 XLOC_001386 EIF4G3 chr1:21132975-21503340 hESC Fibroblasts OK 39.0388 49.7966 0.351137 -0.0394027 0.968569 0.999997 no TSS2209 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 5.98009 127.783 4.41738 -0.876867 0.380559 0.615624 no TSS221 XLOC_000147 NECAP2 chr1:16767166-16786582 hESC Fibroblasts OK 535.864 3729.9 2.7992 -8.14365 4.44089e-16 3.20484e-14 yes TSS2210 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts NOTEST 28.0163 986.479 5.13795 -3.77317 0.000161186 1 no TSS2211 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 113.914 1498.79 3.71778 -1.77951 0.0751554 0.196828 no TSS2212 XLOC_001387 ECE1 chr1:21543739-21672034 hESC Fibroblasts OK 419.192 3871.51 3.20721 -4.8217 1.42337e-06 1.71199e-05 yes TSS2213 XLOC_001389 - chr1:21749600-21754300 hESC Fibroblasts OK 59.716 526.991 3.14159 -7.90238 2.66454e-15 1.64821e-13 yes TSS2214 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 23.4017 0 -1.79769e+308 -1.79769e+308 0.0365495 0.111537 no TSS2215 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts OK 67.9603 2.12746 -4.99749 5.88103 4.07718e-09 7.45952e-08 yes TSS2216 XLOC_001390 RAP1GAP chr1:21922708-21995856 hESC Fibroblasts NOTEST 87.2577 0.00165223 -15.6886 0.0487602 0.96111 1 no TSS2217 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 49.6025 49.025 -0.0168938 0.00784538 0.99374 0.999997 no TSS2218 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts OK 761.076 1473.12 0.952757 -2.39623 0.0165647 0.0569246 no TSS2219 XLOC_001391 USP48 chr1:22004793-22109688 hESC Fibroblasts NOTEST 4.47726 1.54293 -1.53694 0.010587 0.991553 1 no TSS222 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts OK 12.0854 6.5283 -0.888487 0.712068 0.476422 0.715334 no TSS2220 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 185.017 262.104 0.502481 -0.0269747 0.97848 0.999997 no TSS2221 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts OK 865.967 4493.82 2.37556 -3.42688 0.000610566 0.00346343 yes TSS2222 XLOC_001392 HSPG2 chr1:22138757-22263750 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2223 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts OK 73.6692 0.00537242 -13.7432 0.163502 0.870123 0.985011 no TSS2224 XLOC_001393 WNT4 chr1:22443799-22470385 hESC Fibroblasts NOTEST 0 0.782392 1.79769e+308 1.79769e+308 0.106931 1 no TSS2225 XLOC_001394 - chr1:23337326-23342343 hESC Fibroblasts NOTEST 1.30651 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TSS2226 XLOC_001395 LUZP1 chr1:23410515-23495517 hESC Fibroblasts OK 435.794 885.771 1.02329 -2.90144 0.00371451 0.016251 yes TSS2227 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts NOTEST 3.27082 0 -1.79769e+308 -1.79769e+308 0.438713 1 no TSS2228 XLOC_001397 HNRNPR chr1:23636276-23670853 hESC Fibroblasts OK 3017.1 5103.63 0.758365 -2.07888 0.037628 0.113672 no TSS2229 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts OK 18.4192 264.956 3.84647 -8.51191 0 0 yes TSS223 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts OK 10.5665 4.62403 -1.19227 0.568606 0.569624 0.795636 no TSS2230 XLOC_001398 ZNF436 chr1:23685941-23698278 hESC Fibroblasts OK 0 121.81 1.79769e+308 1.79769e+308 0.0106634 0.0403842 yes TSS2231 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 1.36049 699.13 9.00529 -6.67398 2.4895e-11 6.7372e-10 yes TSS2232 XLOC_001399 TCEA3 chr1:23707554-23751261 hESC Fibroblasts OK 4.90057 75.1132 3.93805 -1.10557 0.268912 0.492689 no TSS2233 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 22.8075 97.6727 2.09845 -1.48348 0.137946 0.305449 no TSS2234 XLOC_001400 - chr1:23755055-23811057 hESC Fibroblasts OK 92.1289 41.7841 -1.1407 0.636274 0.524598 0.753819 no TSS2235 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 617.63 653.629 0.0817292 -0.233011 0.815753 0.967036 no TSS2236 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts OK 24.2074 0 -1.79769e+308 -1.79769e+308 0.0805175 0.208767 no TSS2237 XLOC_001400 ASAP3 chr1:23755055-23811057 hESC Fibroblasts NOTEST 5.93528 0 -1.79769e+308 -1.79769e+308 0.435254 1 no TSS2238 XLOC_001402 E2F2 chr1:23832921-23857713 hESC Fibroblasts OK 95.4288 59.0676 -0.692058 1.38803 0.165129 0.34653 no TSS2239 XLOC_001403 ID3 chr1:23884409-23886322 hESC Fibroblasts OK 3052.85 1179.44 -1.37205 3.45896 0.000542271 0.00315879 yes TSS224 XLOC_000149 MST1 chr1:16972068-16976914 hESC Fibroblasts OK 96.4681 3.69539 -4.70625 2.90943 0.00362092 0.0159986 yes TSS2240 XLOC_001404 - chr1:24069855-24104777 hESC Fibroblasts OK 77.4967 107.333 0.46989 -0.115729 0.907867 0.999423 no TSS2241 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 38.3217 12.7034 -1.59295 0.271023 0.786373 0.954672 no TSS2242 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 27.5676 167.153 2.60012 -1.68645 0.0917095 0.228658 no TSS2243 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 492.642 578.187 0.230997 -0.434576 0.66387 0.8755 no TSS2244 XLOC_001405 GALE chr1:24122088-24127294 hESC Fibroblasts OK 9.86629 4.63048 -1.09135 0.0482376 0.961527 0.999997 no TSS2245 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 346.485 1760.73 2.34531 -6.19247 5.92301e-10 1.30407e-08 yes TSS2246 XLOC_001406 HMGCL chr1:24128367-24165110 hESC Fibroblasts OK 12.5886 0 -1.79769e+308 -1.79769e+308 0.0210085 0.0694404 no TSS2247 XLOC_001407 FUCA1 chr1:24171573-24194821 hESC Fibroblasts OK 132.316 142.572 0.107708 -0.130272 0.896351 0.99186 no TSS2248 XLOC_001408 CNR2 chr1:24200460-24239817 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2249 XLOC_001409 SFRS13A chr1:24292938-24306821 hESC Fibroblasts OK 1582.97 2465.33 0.639147 -1.67213 0.0944981 0.233371 no TSS225 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts NOTEST 4.93427 0 -1.79769e+308 -1.79769e+308 0.334821 1 no TSS2250 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 1.19576 0 -1.79769e+308 -1.79769e+308 0.127659 1 no TSS2251 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 1.77127 0 -1.79769e+308 -1.79769e+308 0.0132666 1 no TSS2252 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0.363637 0 -1.79769e+308 -1.79769e+308 0.186004 1 no TSS2253 XLOC_001410 MYOM3 chr1:24382531-24438665 hESC Fibroblasts NOTEST 0.607421 0 -1.79769e+308 -1.79769e+308 0.0776478 1 no TSS2254 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 1.45433 0 -1.79769e+308 -1.79769e+308 0.107539 1 no TSS2255 XLOC_001411 IL22RA1 chr1:24446260-24469611 hESC Fibroblasts NOTEST 5.55488 3.57865 -0.634338 0.697543 0.485463 1 no TSS2256 XLOC_001412 IL28RA chr1:24480647-24513751 hESC Fibroblasts OK 206.886 0.114571 -10.8184 1.81069 0.0701891 0.186835 no TSS2257 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS2258 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 7.16763 57.9985 3.01645 -2.31194 0.020781 0.0688636 no TSS2259 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 142.496 218.855 0.619059 -1.29086 0.196752 0.387244 no TSS226 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 428.259 98.6818 -2.11763 4.19792 2.69379e-05 0.000230213 yes TSS2260 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts NOTEST 0 3.67923 1.79769e+308 1.79769e+308 0.435246 1 no TSS2261 XLOC_001414 C1orf201 chr1:24683489-24741587 hESC Fibroblasts OK 2.3477 15.7206 2.74334 -0.71943 0.471876 0.712752 no TSS227 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 30.5389 3.8214 -2.99847 0.278725 0.780456 0.951044 no TSS228 XLOC_000150 CROCC chr1:17066767-17299474 hESC Fibroblasts OK 100.239 17.1632 -2.54605 1.39725 0.162339 0.34401 no TSS229 XLOC_000150 - chr1:17066767-17299474 hESC Fibroblasts OK 62.5679 49.7705 -0.330131 0.274991 0.783323 0.952749 no TSS23 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 775.295 855.662 0.142295 -0.0975766 0.922268 0.999997 no TSS230 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 1.50479 0 -1.79769e+308 -1.79769e+308 0.0372925 1 no TSS231 XLOC_000151 PADI1 chr1:17531620-17572501 hESC Fibroblasts NOTEST 0.286372 6.06956e-06 -15.5259 0.00012689 0.999899 1 no TSS232 XLOC_000151 - chr1:17531620-17572501 hESC Fibroblasts NOTEST 2.33196 0.513935 -2.18188 1.11817 0.263496 1 no TSS233 XLOC_000152 PADI3 chr1:17575592-17610725 hESC Fibroblasts NOTEST 12.671 0.32407 -5.28908 3.31366 0.000920822 1 no TSS234 XLOC_000153 PADI4 chr1:17634689-17690495 hESC Fibroblasts NOTEST 4.49965 0 -1.79769e+308 -1.79769e+308 0.020742 1 no TSS235 XLOC_000154 PADI6 chr1:17698740-17728195 hESC Fibroblasts NOTEST 0.21117 0 -1.79769e+308 -1.79769e+308 0.240869 1 no TSS236 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 120.034 28.9222 -2.05319 0.913469 0.360996 0.592837 no TSS237 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 479.078 243.503 -0.97632 1.79896 0.0720247 0.189393 no TSS238 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts NOTEST 2.78634 5.30615 0.929294 -0.0441671 0.964771 1 no TSS239 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 25.6249 0 -1.79769e+308 -1.79769e+308 0.00259312 0.012249 yes TSS24 XLOC_000028 PUSL1 chr1:1227763-1260046 hESC Fibroblasts OK 14.7123 15.8664 0.108956 -0.003982 0.996823 0.999997 no TSS240 XLOC_000155 ARHGEF10L chr1:17866329-18024369 hESC Fibroblasts OK 5.26 381.592 6.18082 -3.71701 0.000201593 0.00131593 yes TSS241 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts NOTEST 5.36255 0 -1.79769e+308 -1.79769e+308 0.214661 1 no TSS242 XLOC_000155 - chr1:17866329-18024369 hESC Fibroblasts OK 44.6171 14.6487 -1.60682 0.27939 0.779946 0.951044 no TSS243 XLOC_000156 ACTL8 chr1:18081807-18153556 hESC Fibroblasts OK 17.1125 6.95204 -1.29954 1.74086 0.0817088 0.210178 no TSS244 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts OK 398.742 0 -1.79769e+308 -1.79769e+308 7.73853e-22 6.70156e-20 yes TSS245 XLOC_000157 IGSF21 chr1:18434239-18704976 hESC Fibroblasts NOTEST 3.24727 0 -1.79769e+308 -1.79769e+308 0.455712 1 no TSS246 XLOC_000159 KLHDC7A chr1:18807423-18812539 hESC Fibroblasts NOTEST 8.37135 0.745204 -3.48975 2.01068 0.0443595 1 no TSS247 XLOC_000160 PAX7 chr1:18957499-19075359 hESC Fibroblasts NOTEST 0.969331 0 -1.79769e+308 -1.79769e+308 0.0595256 1 no TSS248 XLOC_000161 MRTO4 chr1:19578074-19586621 hESC Fibroblasts OK 961.74 1651.61 0.780159 -2.37831 0.0173923 0.0593317 no TSS249 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 262.501 448.712 0.773467 -1.58974 0.111894 0.267441 no TSS25 XLOC_000029 GLTPD1 chr1:1260142-1264275 hESC Fibroblasts OK 187.156 781.158 2.06137 -5.7929 6.91832e-09 1.21445e-07 yes TSS250 XLOC_000162 PQLC2 chr1:19638739-19655793 hESC Fibroblasts OK 62.153 139.07 1.16191 -1.24407 0.213472 0.410816 no TSS251 XLOC_000163 C1orf151,NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 797.682 10711.1 3.74715 -7.27472 3.47056e-13 1.37313e-11 yes TSS252 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts NOTEST 1.64141 3.52907 1.10436 -0.00223238 0.998219 1 no TSS253 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 0 30.6081 1.79769e+308 1.79769e+308 0.487077 0.723928 no TSS254 XLOC_000163 NBL1 chr1:19923466-19984945 hESC Fibroblasts OK 16.9244 1884.11 6.79864 -4.7867 1.69545e-06 2.00217e-05 yes TSS255 XLOC_000164 HTR6 chr1:19991779-20006054 hESC Fibroblasts OK 22.3161 0 -1.79769e+308 -1.79769e+308 2.82075e-11 7.47786e-10 yes TSS256 XLOC_000165 OTUD3 chr1:20208887-20239429 hESC Fibroblasts OK 157.667 87.3998 -0.851179 2.02602 0.0427627 0.125676 no TSS257 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts NOTEST 0 2.12447 1.79769e+308 1.79769e+308 0.443361 1 no TSS258 XLOC_000166 PLA2G5 chr1:20354671-20418393 hESC Fibroblasts OK 0.847143 147.21 7.44105 -5.14402 2.68921e-07 3.88143e-06 yes TSS259 XLOC_000167 PLA2G2F chr1:20465822-20476879 hESC Fibroblasts NOTEST 0.361045 0 -1.79769e+308 -1.79769e+308 0.159889 1 no TSS26 XLOC_000030 TAS1R3 chr1:1266725-1269843 hESC Fibroblasts NOTEST 2.57898 4.31837 0.743686 -0.805548 0.420503 1 no TSS260 XLOC_000168 UBXN10 chr1:20512577-20519941 hESC Fibroblasts OK 17.9074 0.492177 -5.18523 3.87498 0.000106632 0.00076107 yes TSS261 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts OK 18.1203 0.572911 -4.98315 3.55326 0.000380487 0.00233138 yes TSS262 XLOC_000169 VWA5B1 chr1:20617411-20681387 hESC Fibroblasts NOTEST 1.08334 0 -1.79769e+308 -1.79769e+308 0.116654 1 no TSS263 XLOC_000171 CDA chr1:20915443-20945398 hESC Fibroblasts OK 141.154 232.113 0.717563 -1.23935 0.215218 0.411735 no TSS264 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 326.979 2213.85 2.75929 -7.37461 1.64757e-13 7.13398e-12 yes TSS265 XLOC_000172 PINK1 chr1:20959947-20978003 hESC Fibroblasts OK 114.96 832.083 2.8556 -3.29087 0.000998788 0.00536126 yes TSS266 XLOC_000173 - chr1:21543739-21672034 hESC Fibroblasts NOTEST 7.51557 3.33508 -1.17216 0.0473121 0.962264 1 no TSS267 XLOC_000174 - chr1:21761832-21762609 hESC Fibroblasts OK 12075.7 7652.6 -0.658091 0.637145 0.52403 0.753819 no TSS268 XLOC_000175 NBPF3 chr1:21766630-21811392 hESC Fibroblasts OK 59.4109 528.734 3.15374 -7.24865 4.20997e-13 1.60845e-11 yes TSS269 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts OK 5045.41 59.0365 -6.41722 8.33773 0 0 yes TSS27 XLOC_000031 - chr1:1334909-1342693 hESC Fibroblasts OK 553.309 567.727 0.0371112 -0.0442295 0.964721 0.999997 no TSS270 XLOC_000176 ALPL chr1:21835857-21904904 hESC Fibroblasts NOTEST 0 7.78492 1.79769e+308 1.79769e+308 0.260295 1 no TSS271 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts OK 22.0415 16.2682 -0.438171 0.00162169 0.998706 0.999997 no TSS272 XLOC_000177 LDLRAD2 chr1:22138757-22263750 hESC Fibroblasts OK 10.8865 166.982 3.93909 -0.0310011 0.975269 0.999997 no TSS273 XLOC_000178 CELA3B chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS274 XLOC_000178 CELA3A chr1:22303417-22339033 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS275 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts NOTEST 4.05105 6.30679 0.638608 -0.0500359 0.960094 1 no TSS276 XLOC_000179 - chr1:22351706-22357713 hESC Fibroblasts OK 427.827 527.288 0.301564 -0.672565 0.501224 0.736528 no TSS277 XLOC_000180 CDC42 chr1:22379119-22419435 hESC Fibroblasts OK 1626.45 9892.47 2.6046 -6.62856 3.38982e-11 8.63408e-10 yes TSS278 XLOC_000181 ZBTB40 chr1:22778343-22857650 hESC Fibroblasts NOTEST 198.181 218.009 0.137565 -0.38511 0.700156 1 no TSS279 XLOC_000181 - chr1:22778343-22857650 hESC Fibroblasts OK 23.69 12.3722 -0.937171 0.165335 0.86868 0.985011 no TSS28 XLOC_000032 - chr1:1361507-1363166 hESC Fibroblasts OK 59.0363 0 -1.79769e+308 -1.79769e+308 5.12217e-06 5.11823e-05 yes TSS280 XLOC_000182 EPHA8 chr1:22890003-22930087 hESC Fibroblasts OK 86.3015 0 -1.79769e+308 -1.79769e+308 4.21755e-12 1.36965e-10 yes TSS281 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS282 XLOC_000183 C1QA chr1:22963117-22966174 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS283 XLOC_000184 C1QC chr1:22970117-22974602 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS284 XLOC_000185 C1QB chr1:22979681-22988028 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS285 XLOC_000186 EPHB2 chr1:23037330-23241822 hESC Fibroblasts OK 301.66 947.084 1.65057 -3.98506 6.7464e-05 0.000503654 yes TSS286 XLOC_000188 - chr1:23345940-23410184 hESC Fibroblasts OK 4034.49 2352.33 -0.778295 2.28912 0.0220726 0.0722224 no TSS287 XLOC_000189 C1orf213 chr1:23685941-23698278 hESC Fibroblasts OK 2.53326 73.0221 4.84926 -1.68463 0.0920605 0.229093 no TSS288 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS289 XLOC_000191 MDS2 chr1:23907984-23967056 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS29 XLOC_000033 VWA1 chr1:1370908-1376145 hESC Fibroblasts OK 528.289 473.976 -0.156516 0.400147 0.689048 0.891508 no TSS290 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 8207.77 65838.4 3.00387 -4.3987 1.08904e-05 9.82402e-05 yes TSS291 XLOC_000192 RPL11 chr1:24018293-24022913 hESC Fibroblasts OK 66599.3 56897 -0.227155 0.348528 0.727443 0.915648 no TSS292 XLOC_000193 TCEB3 chr1:24069855-24104777 hESC Fibroblasts OK 523.425 1232.52 1.23556 -3.83604 0.000125032 0.000877925 yes TSS293 XLOC_000194 C1orf128 chr1:24104875-24114720 hESC Fibroblasts OK 1208.06 1716.37 0.506669 -1.53282 0.125321 0.288425 no TSS294 XLOC_000195 LYPLA2 chr1:24117645-24122027 hESC Fibroblasts OK 2696.47 1186.4 -1.18448 3.05149 0.00227706 0.010844 yes TSS295 XLOC_000196 PNRC2 chr1:24286300-24289947 hESC Fibroblasts OK 1015.28 1795.17 0.822244 -2.59154 0.00955471 0.0370494 yes TSS296 XLOC_000197 - chr1:24526729-24538180 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS297 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts OK 24.5694 0 -1.79769e+308 -1.79769e+308 1.33233e-14 6.59842e-13 yes TSS298 XLOC_000198 GRHL3 chr1:24645880-24681807 hESC Fibroblasts NOTEST 0.00104564 0.713283 9.41394 -0.0183069 0.985394 1 no TSS299 XLOC_000199 NIPAL3 chr1:24742244-24799472 hESC Fibroblasts OK 140.474 1632.52 3.53873 -6.93497 4.06297e-12 1.35328e-10 yes TSS3 XLOC_000005 - chr1:322036-328580 hESC Fibroblasts OK 338.321 18.7718 -4.17176 4.41315 1.01877e-05 9.38571e-05 yes TSS30 XLOC_000034 ATAD3C chr1:1385068-1405538 hESC Fibroblasts OK 69.2663 15.5201 -2.15801 3.56653 0.000361735 0.00222699 yes TSS300 XLOC_000199 - chr1:24742244-24799472 hESC Fibroblasts NOTEST 5.64277 7.66113 0.441153 -0.0148822 0.988126 1 no TSS301 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 113.081 219.138 0.954477 -1.69115 0.0908078 0.227314 no TSS302 XLOC_000200 RCAN3 chr1:24829386-24862425 hESC Fibroblasts OK 18.7602 184.423 3.29728 -2.74038 0.00613678 0.0251473 yes TSS303 XLOC_000201 C1orf130 chr1:24882601-24935816 hESC Fibroblasts NOTEST 2.35713 0.128844 -4.19333 1.83747 0.0661412 1 no TSS304 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 805.739 1363.38 0.758804 -2.02485 0.0428827 0.125744 no TSS305 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 47.1916 28.5028 -0.727426 0.120902 0.903768 0.9966 no TSS306 XLOC_000202 SRRM1 chr1:24969593-24999771 hESC Fibroblasts OK 943.452 235.095 -2.0047 1.04079 0.297974 0.526685 no TSS31 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 409.377 275.225 -0.572818 1.01836 0.308509 0.536484 no TSS32 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 249.624 197.737 -0.336172 0.467304 0.640282 0.856567 no TSS33 XLOC_000035 ATAD3B chr1:1407163-1431581 hESC Fibroblasts OK 321.282 321.282 -2.94691e-06 3.41128e-06 0.999997 0.999997 no TSS34 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 844.68 859.118 0.0244516 -0.0475858 0.962046 1 no TSS35 XLOC_000036 ATAD3A chr1:1447554-1470064 hESC Fibroblasts NOTEST 542.034 1200.71 1.14743 -2.4716 0.0134509 1 no TSS36 XLOC_000037 - chr1:1535818-1543166 hESC Fibroblasts OK 10.6728 5.74721 -0.893003 0.807327 0.419478 0.65889 no TSS37 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 190.943 400.214 1.06763 -2.42281 0.015401 0.0542164 no TSS38 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 63.8506 61.0707 -0.0642183 0.0478925 0.961802 0.999997 no TSS39 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 3.88743 56.0751 3.85047 -2.07677 0.0378229 0.113995 no TSS4 XLOC_000007 - chr1:420205-421839 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS40 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 100.348 45.3624 -1.14544 0.316453 0.751659 0.935808 no TSS41 XLOC_000038 MIB2 chr1:1550883-1565984 hESC Fibroblasts OK 0 30.3273 1.79769e+308 1.79769e+308 0.405843 0.642914 no TSS42 XLOC_000038 - chr1:1550883-1565984 hESC Fibroblasts OK 217.26 0 -1.79769e+308 -1.79769e+308 0.0174021 0.0593317 no TSS43 XLOC_000039 MMP23B chr1:1567559-1570029 hESC Fibroblasts OK 57.5318 6.12558 -3.23144 2.05082 0.0402847 0.120298 no TSS44 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 0 13.8369 1.79769e+308 1.79769e+308 0.106259 0.256563 no TSS45 XLOC_000039 - chr1:1567559-1570029 hESC Fibroblasts OK 9.67624 6.24162 -0.632526 0.19623 0.84443 0.977642 no TSS46 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 73.9259 90.7454 0.295744 -0.016833 0.98657 0.999997 no TSS47 XLOC_000040 - chr1:1571099-1677431 hESC Fibroblasts OK 18.0861 2.78903 -2.69705 0.00199175 0.998411 0.999997 no TSS48 XLOC_000041 - chr1:1571099-1677431 hESC Fibroblasts OK 78.5208 84.1606 0.10007 -0.0119073 0.9905 0.999997 no TSS49 XLOC_000042 - chr1:1822909-1824112 hESC Fibroblasts NOTEST 3.15678 11.254 1.83391 -1.49266 0.135527 1 no TSS5 XLOC_000012 - chr1:763063-789740 hESC Fibroblasts OK 182.273 292.077 0.680248 -0.756107 0.449585 0.692289 no TSS50 XLOC_000043 CALML6 chr1:1846265-1848733 hESC Fibroblasts OK 26.9908 1.08118 -4.64179 2.89373 0.003807 0.016595 yes TSS51 XLOC_000044 GABRD chr1:1950767-1962192 hESC Fibroblasts OK 41.7053 0.393202 -6.72881 3.58001 0.000343586 0.00215387 yes TSS52 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 833.609 0 -1.79769e+308 -1.79769e+308 3.60688e-28 3.34667e-26 yes TSS53 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 0 45.4119 1.79769e+308 1.79769e+308 0.206902 0.399949 no TSS54 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS55 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 60.5588 0 -1.79769e+308 -1.79769e+308 0.0391281 0.117114 no TSS56 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 0 34.2875 1.79769e+308 1.79769e+308 0.311842 0.540111 no TSS57 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 17.7633 0 -1.79769e+308 -1.79769e+308 0.251953 0.467456 no TSS58 XLOC_000045 PRKCZ chr1:1981908-2139172 hESC Fibroblasts OK 17.4198 0 -1.79769e+308 -1.79769e+308 0.133938 0.300585 no TSS59 XLOC_000047 SKI chr1:2160133-2241651 hESC Fibroblasts OK 740.008 1645.91 1.15327 -3.57845 0.000345636 0.00215387 yes TSS6 XLOC_000014 - chr1:846814-850328 hESC Fibroblasts OK 27.5823 0.58031 -5.57077 4.56368 5.0264e-06 5.06147e-05 yes TSS60 XLOC_000048 RER1 chr1:2323213-2344010 hESC Fibroblasts OK 802.47 3941.6 2.29626 -6.15611 7.45553e-10 1.56205e-08 yes TSS61 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 1.11603 0.769693 -0.536018 0.167195 0.867217 1 no TSS62 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 1.19965 1.86433 0.636049 -0.288866 0.772684 1 no TSS63 XLOC_000049 PLCH2 chr1:2407753-2436969 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS64 XLOC_000050 TNFRSF14 chr1:2481358-2495265 hESC Fibroblasts OK 3.76675 887.589 7.88043 -6.94437 3.8014e-12 1.29948e-10 yes TSS65 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 811.653 1204.83 0.569896 -1.46992 0.141584 0.310673 no TSS66 XLOC_000051 C1orf93 chr1:2518248-2564481 hESC Fibroblasts OK 46.1049 83.8728 0.863283 -0.552957 0.580293 0.807067 no TSS67 XLOC_000053 PRDM16 chr1:2985743-3355183 hESC Fibroblasts NOTEST 5.29478 8.22698 0.635791 -0.97909 0.327535 1 no TSS68 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 229.313 2.38434 -6.58758 4.64732 3.36281e-06 3.61016e-05 yes TSS69 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 60.5958 2.38281 -4.66848 2.49762 0.0125031 0.0461406 yes TSS7 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS70 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 60.018 0.0183886 -11.6724 0.262029 0.793299 0.959493 no TSS71 XLOC_000054 ARHGEF16 chr1:3371146-3397675 hESC Fibroblasts OK 17.4666 0 -1.79769e+308 -1.79769e+308 0.0518631 0.145501 no TSS72 XLOC_000055 TPRG1L chr1:3541555-3546692 hESC Fibroblasts OK 498.776 2696.46 2.4346 -7.36838 1.72751e-13 7.23881e-12 yes TSS73 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts OK 63.3435 4.37716 -3.85513 4.12793 3.66041e-05 0.000300942 yes TSS74 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts OK 10.2929 0 -1.79769e+308 -1.79769e+308 0.0235177 0.076565 no TSS75 XLOC_000056 TP73 chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.585598 0 -1.79769e+308 -1.79769e+308 0.344411 1 no TSS76 XLOC_000056 - chr1:3569128-3650467 hESC Fibroblasts NOTEST 0.923281 0.0133356 -6.11341 0.0831379 0.933742 1 no TSS77 XLOC_000057 CCDC27 chr1:3668964-3688209 hESC Fibroblasts NOTEST 2.99279 0.344217 -3.1201 1.59609 0.110469 1 no TSS78 XLOC_000058 - chr1:3689351-3692545 hESC Fibroblasts OK 76.8718 58.9016 -0.38415 0.550115 0.582241 0.807183 no TSS79 XLOC_000059 CAD,DFFB chr1:3773844-3801992 hESC Fibroblasts OK 120.109 116.754 -0.0408721 0.0771314 0.938519 0.999997 no TSS8 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts NOTEST 1.74761 3.81714 1.12711 -0.0206055 0.98356 1 no TSS80 XLOC_000060 - chr1:3816967-3833877 hESC Fibroblasts OK 24.9595 4.27286 -2.54632 2.24094 0.0250302 0.0797371 no TSS81 XLOC_000061 - chr1:4000676-4015322 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS82 XLOC_000062 - chr1:4472110-4484744 hESC Fibroblasts NOTEST 0 0 0 0 1 1 no TSS83 XLOC_000063 AJAP1 chr1:4715104-4843850 hESC Fibroblasts OK 73.9584 1.26614 -5.86821 4.71838 2.37726e-06 2.617e-05 yes TSS84 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 20.2988 68.4146 1.75291 -2.08929 0.0366819 0.111592 no TSS85 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts OK 109.98 34.6622 -1.66581 1.29825 0.194202 0.384555 no TSS86 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0.784025 0 -1.79769e+308 -1.79769e+308 0.311292 1 no TSS87 XLOC_000065 KCNAB2 chr1:6052765-6160523 hESC Fibroblasts NOTEST 0.706557 0 -1.79769e+308 -1.79769e+308 0.345594 1 no TSS88 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 41.1437 39.6382 -0.0537805 0.00881809 0.992964 0.999997 no TSS89 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 17.0218 10.1307 -0.748643 0.0103814 0.991717 0.999997 no TSS9 XLOC_000015 SAMD11 chr1:860529-894679 hESC Fibroblasts OK 4.50533 34.9169 2.95422 -0.426077 0.670052 0.878404 no TSS90 XLOC_000066 RNF207 chr1:6266188-6296044 hESC Fibroblasts OK 17.9047 18.1716 0.0213419 -0.000528226 0.999579 0.999997 no TSS91 XLOC_000067 C1orf211 chr1:6297870-6299490 hESC Fibroblasts OK 132.225 4.35392 -4.92453 5.20718 1.91728e-07 2.89599e-06 yes TSS92 XLOC_000068 HES3 chr1:6304261-6305638 hESC Fibroblasts OK 1431.61 0 -1.79769e+308 -1.79769e+308 3.8204e-30 3.81746e-28 yes TSS93 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 20.3609 0.205083 -6.63345 2.68397 0.00727531 0.0295332 yes TSS94 XLOC_000069 ESPN chr1:6484847-6521003 hESC Fibroblasts OK 157.325 0 -1.79769e+308 -1.79769e+308 1.3715e-14 6.59842e-13 yes TSS95 XLOC_000070 TAS1R1 chr1:6615433-6639816 hESC Fibroblasts NOTEST 1.25192 5.4957 2.13417 -1.03449 0.300909 1 no TSS96 XLOC_000071 ZBTB48 chr1:6640055-6649339 hESC Fibroblasts OK 241.107 214.473 -0.168879 0.307734 0.758285 0.93832 no TSS97 XLOC_000071 - chr1:6640055-6649339 hESC Fibroblasts OK 85.1502 38.1578 -1.15803 0.935662 0.349447 0.58346 no TSS98 XLOC_000072 PHF13 chr1:6673755-6684092 hESC Fibroblasts OK 660.096 769.313 0.220895 -0.682623 0.494845 0.730459 no TSS99 XLOC_000073 THAP3 chr1:6684924-6761966 hESC Fibroblasts OK 126.801 402.426 1.66615 -1.31321 0.189111 0.377931 no cummeRbund/inst/extdata/tss_groups.count_tracking0000644000175200017520000017122114516004263023455 0ustar00biocbuildbiocbuildtracking_id iPS_count iPS_count_variance iPS_count_uncertainty_var iPS_count_dispersion_var iPS_status hESC_count hESC_count_variance hESC_count_uncertainty_var hESC_count_dispersion_var hESC_status Fibroblasts_count Fibroblasts_count_variance Fibroblasts_count_uncertainty_var Fibroblasts_count_dispersion_var Fibroblasts_status TSS1 11.4409 2201 -1.11022e-15 327.045 OK 0.494996 4 0 3.78504 OK 20.0725 10516 1.77636e-15 1311.87 OK TSS10 62.5442 696 31.5484 638.109 OK 458.862 4084 380.975 3640.93 OK 282.997 12143 188.133 11055.9 OK TSS100 18.1976 3155 24.089 627.24 OK 141.016 3270.88 166.638 2613.04 OK 164.29 110661 237.126 37872.6 OK TSS101 301.021 6402.97 12.6261 5843.79 OK 886.68 7273.05 67.73 6358.72 OK 1485.36 118802 10.5158 109811 OK TSS102 19.2286 796 14.526 373.289 OK 146.203 1135 67.73 1048.48 OK 0 0 0 0 OK TSS103 0 0 0 0 OK 0 0 0 0 OK 8.45779 6993 10.5158 625.273 OK TSS104 2.76816 952 4.86346 53.7389 OK 0 0 0 0 OK 0 0 0 0 OK TSS105 1254.27 50600.6 0 50600.6 OK 1083.92 8011.86 0 8011.86 OK 12340.2 7.84133e+06 0 7.84133e+06 OK TSS106 48.4593 3047.57 68.0364 1332.54 OK 10.534 95 13.3683 55.017 OK 83.8762 17885 136.382 7664.65 OK TSS107 531.824 18042.6 68.0364 14624.2 OK 576.308 3258.57 13.3683 3009.95 OK 1636.49 168744 136.382 149543 OK TSS108 1424.81 75974.4 2.6797 58152.1 OK 6592.72 166402 5.59248 148250 OK 13694.7 1.39603e+07 2.67901 9.824e+06 OK TSS109 1.65948 4 1.98312 1.93428 OK 70.3232 123 24.968 97.2746 OK 272.319 8914 126.154 8637.4 OK TSS11 17.8183 202 8.31842 181.791 OK 124.584 1064 68.559 988.537 OK 32.1599 1563 26.9402 1256.4 OK TSS110 6.28893 10 1.98312 7.33035 OK 16.6609 52 24.968 23.0463 OK 93.694 4923.17 126.154 2971.78 OK TSS111 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS112 507.14 12966.8 0 12966.8 OK 888.348 5831.28 0 5831.28 OK 8578.29 3.46542e+06 0 3.46542e+06 OK TSS113 85.6365 867 31.9082 787.063 OK 57.3943 272 85.6327 173.32 OK 509.687 57551 744.403 49684.9 OK TSS114 19.8614 294 31.9082 182.541 OK 201.354 698 85.6327 608.05 OK 1617.23 171445 744.403 157649 OK TSS115 115.011 1135 0 1134.55 OK 314.608 1048.46 -3.55271e-14 1084.64 OK 293.84 10007 2.4869e-14 8491.61 OK TSS116 183.737 3891.94 0 2468.56 OK 1547.44 21306.6 2.84217e-14 14289.8 OK 1039.98 87942 4.26326e-14 64114.9 OK TSS117 91.98 5760.75 140.728 3696.97 OK 1453.16 48246 1161.98 46212.3 OK 204.207 1.45298e+06 299.227 244506 OK TSS118 283.269 12841 172.96 11385.5 OK 858.756 28576 1099.32 27309.6 OK 486.395 1.43681e+06 361.554 582383 OK TSS119 37.4295 1714 62.5846 1504.41 OK 144.637 5231 244.298 4599.67 OK 97.1528 1.47975e+06 155.961 116325 OK TSS12 22.1346 342 28.267 225.828 OK 445.706 3956 364.421 3536.54 OK 156.376 7741 171.34 6109.17 OK TSS120 91.6094 881.483 0 881.483 OK 151.513 311.808 0 311.808 OK 990.476 56044 0 56044 OK TSS121 22.8015 67 0 66.2587 OK 114.914 195 0 194.183 OK 7.9194 16 0 15.5536 OK TSS122 1174.79 49474.8 101.121 44418.7 OK 6427.31 148076 52.5443 142246 OK 5398.15 1.51884e+06 639.381 1.37055e+06 OK TSS123 60.8936 2985 91.2784 2302.38 OK 9.13019 651 16.0953 202.064 OK 50.9937 68955 96.3179 12947 OK TSS124 6.03788 2179 9.84271 228.291 OK 20.412 1040.13 36.449 451.748 OK 320.653 130443 543.063 81411.6 OK TSS125 3066.9 275500 428.001 182507 OK 5428.77 158684 1276.66 117972 OK 6875.45 3.10678e+06 429.805 2.28276e+06 OK TSS126 0 0 0 0 OK 12.2833 1965 24.4294 266.927 OK 50.5024 118324 97.8315 16767.6 OK TSS127 271.164 36861.2 428.001 16136.6 OK 826.294 20049.1 1261.03 17956.1 OK 214.961 172245 357.269 71370.6 OK TSS128 1028.12 39787.9 3.41061e-13 35685 OK 13394.7 475620 5.1088e-12 471885 OK 21093.2 3.62964e+07 7.22977e-13 3.04197e+07 OK TSS129 35.294 882 33.5682 392.112 OK 107.19 451.874 61.8998 370.813 OK 118.188 12762.5 109.361 5435.77 OK TSS13 13.9608 199 4.17386 142.435 OK 185.361 1532 42.9102 1470.79 OK 50.0667 3033 16.6365 1955.97 OK TSS130 89.0398 1045 28.9547 989.224 OK 183.153 694 54.0553 633.599 OK 562.635 27018 99.694 25876.9 OK TSS131 14.0019 240 4.6135 155.56 OK 29.1796 111 7.84449 100.944 OK 10.384 2438 9.66669 477.586 OK TSS132 145.602 2149 -3.55271e-15 1682.98 OK 1133.86 9031.01 0 8612.26 OK 1696.8 173800 -8.52651e-14 139112 OK TSS133 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS134 3201.71 187519 4.26326e-14 186839 OK 10323.6 324106 2.27374e-13 313514 OK 9554.82 4.42784e+06 0 4.42784e+06 OK TSS135 21.5572 1054 0 1053.69 OK 2.0001 54 0 53.428 OK 18.6975 4303 0 4302.79 OK TSS136 514.64 12989.4 0 12989.4 OK 1138.82 8677.44 0 8677.44 OK 995.51 57405.1 0 57405.1 OK TSS137 36.0274 268.57 14.755 198.662 OK 339.421 1273.79 1.66533e-16 1220.93 OK 2.3796 4 0.000329766 3.35028 OK TSS138 13.5498 135 14.755 74.7159 OK 0 0 0 0 OK 0.000173876 1 0.000329766 0.000244803 OK TSS139 0 0 0 0 OK 55.0225 1011 98.9012 842.229 OK 24.2442 3433 43.8802 1337.78 OK TSS14 5.66037 8 3.57787e-17 6.82697 OK 55.4672 124.111 0 57.2488 OK 113.654 2929.18 -2.13163e-14 1675.66 OK TSS140 167.199 4664.69 3.55271e-14 3312.52 OK 1296.24 12428.4 98.3383 19841.5 OK 851.282 63466.6 43.6514 46973.4 OK TSS141 43.9978 219.285 0 219.285 OK 37.0478 37.0478 0 37.0478 OK 425.483 14738.3 0 14738.3 OK TSS142 132.594 1435.67 0 1435.67 OK 577.571 2882.6 0 2882.6 OK 15.9475 75.9065 0 75.9065 OK TSS143 314.948 7980.53 1.56319e-13 5958.21 OK 1734.45 22849.1 -1.7053e-13 17206.5 OK 1637.76 153089 -5.68434e-14 128564 OK TSS144 1.04377 1.04377 0 1.04377 OK 2.0001 2.0001 0 2.0001 OK 0.8344 0.8344 0 0.8344 OK TSS145 0 0 0 0 OK 5.79833 68 3.82547 46.3227 OK 0 0 0 0 OK TSS146 1.13454 24 0.25802 23.0051 OK 3.60808 87 3.4876 28.8248 OK 11.9147 24191 4.80797 1799.61 OK TSS147 261.614 6246.05 0.156681 4543.81 OK 1933.14 21303.2 0.188334 20578.5 OK 2471.81 346208 1.23065 279234 OK TSS148 2.04798 36 0.156681 35.57 OK 5.6427 61 0.188334 60.0671 OK 8.90946 13038 1.23065 1006.48 OK TSS149 1010.47 37275.9 -7.10543e-14 36490.3 OK 2881.74 39305 5.32907e-14 38916.7 OK 25347.2 6.16321e+07 1.02318e-12 5.51763e+07 OK TSS15 109.513 1080.67 0 1080.67 OK 502.184 2296.71 0 2296.71 OK 1367.24 95380.1 0 95380.1 OK TSS150 1199.02 45097.9 -1.13687e-13 44749.2 OK 4499.8 76568.1 -2.27374e-13 79630.6 OK 11118.5 6.58273e+06 -1.13687e-12 6.1286e+06 OK TSS151 293.932 5326 0 5326 OK 1830.86 18761.3 0 18761.3 OK 695.807 32506.4 0 32506.4 OK TSS152 286.188 5778.57 9.24541 5171.77 OK 1614.27 15964.1 41.1473 15445.3 OK 13.6374 121 7.23359 88.0632 OK TSS153 5.25454 531 9.24541 94.9558 OK 21.005 332 41.1473 200.975 OK 6.83016 101 7.23359 44.1056 OK TSS154 21.4769 57.8239 1.23794e-15 55.8938 OK 125.813 297.332 7.10543e-15 229.173 OK 4188.31 857043 -2.27374e-13 820502 OK TSS155 2180.24 112584 244.415 111071 OK 1235.57 16665.7 1069.07 14797.2 OK 2662.85 1.18793e+06 1729.11 495496 OK TSS156 110.874 8118 198.738 5648.4 OK 973.86 12777 1059.28 11662.9 OK 1127.01 894896 1554.59 209712 OK TSS157 64.2149 5276 51.4446 3271.38 OK 0 0 0 0 OK 0 0 0 0 OK TSS158 0 0 0 0 OK 118.028 1683 206.536 1413.5 OK 309.993 69959 505.362 57682.8 OK TSS159 0 0 0 0 OK 19.7384 335 37.3804 236.387 OK 8.29527 50282 15.2946 1543.57 OK TSS16 480.802 11598.9 0 11598.9 OK 14167.9 517645 0 517645 OK 15728.2 1.48338e+07 0 1.48338e+07 OK TSS160 0.521883 0.521883 0 0.521883 OK 2.0001 2.0001 0 2.0001 OK 0 0 0 0 OK TSS161 89.4412 867.597 3.55271e-15 781.938 OK 41.0429 59.6164 0 41.0429 OK 0 0 0 0 OK TSS162 0.521883 2 -6.71528e-17 0.521883 OK 1.01025 2.85911 0 1.01025 OK 0 0 0 0 OK TSS163 2.40856 2.40856 0 2.40856 OK 1.48478 1.48478 0 1.48478 OK 0 0 0 0 OK TSS164 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK TSS165 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS166 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS167 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS168 0.21677 0.21677 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK TSS169 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK TSS17 7.06534 10.0913 0 7.67855 OK 25.981 29.9335 2.77556e-16 25.981 OK 46.5981 488.237 0 451.556 OK TSS170 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS171 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS172 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS173 0.0963422 0.0963422 0 0.0963422 OK 0 0 0 0 OK 0 0 0 0 OK TSS174 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TSS175 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS176 1412.32 81694 -1.13687e-13 58605.1 OK 4751.69 84303.5 33.0112 87115.8 OK 251.686 7474.34 2.84217e-14 6633.34 OK TSS177 0 0 0 0 OK 18.5703 813 33.0112 340.461 OK 0 0 0 0 OK TSS178 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS179 0 0 0 0 OK 34.4579 316 44.1913 243.544 OK 60.418 10434 65.2295 6095.19 OK TSS18 0 0 0 0 OK 2.50523 2.50523 0 2.50523 OK 0 0 0 0 OK TSS180 189.916 7252.27 221.843 5296.8 OK 242.769 2429.81 318.719 1715.86 OK 99.6707 10414 167.559 10055.1 OK TSS181 0 0 0 0 OK 3.44044 82 4.77588 24.3166 OK 0 0 0 0 OK TSS182 441.035 14999 221.266 12300.6 OK 725.873 5570 279.112 5130.37 OK 2007.92 231038 174.182 202567 OK TSS183 79.5916 1000 16.7965 830.263 OK 240.667 1896.53 272.965 1330.11 OK 44.0162 13906 58.806 3334.65 OK TSS184 3.02588 228 4.83958 31.5645 OK 76.4782 614.55 121.106 422.677 OK 92.6279 11940 156.346 7017.46 OK TSS185 0 0 0 0 OK 0 0 0 0 OK 39.6221 6189 73.4387 3001.75 OK TSS186 8.18816 189.013 12.9179 85.4151 OK 0 0 0 0 OK 615.45 136049 635.731 46626.3 OK TSS187 0 0 0 0 OK 273.142 1784 247.318 1509.59 OK 576.499 140567 629.137 43675.4 OK TSS188 13.8206 230 11.5951 144.17 OK 24.1109 203 33.9388 133.255 OK 37.5263 5915 31.4784 2842.98 OK TSS189 32.5428 650.115 41.2903 321.744 OK 129.219 729 164.466 543.103 OK 51.5742 3854 92.0531 3123.42 OK TSS19 0 0 0 0 OK 21.6026 35 9.72406 23.3346 OK 0 0 0 0 OK TSS190 73.6363 1008.11 41.2903 728.027 OK 309.156 1612.13 164.466 1299.37 OK 1022.85 79005.6 92.0531 61945.5 OK TSS1906 0.0119528 1 0.0237713 0.341677 OK 244.191 2029 141.77 1867.23 OK 317.7 21250 177.722 20763.8 OK TSS1907 295.87 9995.88 135.486 8457.6 OK 141.109 1266 131.171 1079 OK 92.2326 8667 86.9419 6028.01 OK TSS1908 70.4255 2543 95.9646 2013.15 OK 0 0 0 0 OK 0 0 0 0 OK TSS1909 237.336 11482 136.806 6784.37 OK 524.921 4894.16 388.915 4013.86 OK 437.968 55803.6 386.506 28624.1 OK TSS191 7.30215 12 0.700594 11.2865 OK 32.4763 35 2.12092 32.7463 OK 9.71379 52 2.57172 38.5082 OK TSS1910 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS1911 37.1139 1737 47.9138 1060.92 OK 126.532 1185 144.028 967.538 OK 110.291 8670 125.986 7208.23 OK TSS1912 14.7317 983 26.8566 421.114 OK 108.803 1040 152.951 831.972 OK 165.072 12962 187.865 10788.5 OK TSS1913 5.41934 5.76632 0 5.76632 OK 16.9193 16.9193 0 16.9193 OK 3.56966 6.52646 0 6.52646 OK TSS1914 11.6418 157 0 156.388 OK 5.74775 36 0 35.6669 OK 25.5311 198 0 197.604 OK TSS1915 26.7025 4090.81 47.0508 676.165 OK 81.7376 1216 143.304 1042.07 OK 5.64933 1085 10.4148 145.558 OK TSS1916 274.378 14416 208.955 6947.83 OK 1307.41 17773 974.82 16668.1 OK 141.699 3959 101.389 3650.95 OK TSS1917 220.954 8450.44 197.428 5595.04 OK 1222.99 18844 944.442 15592 OK 110.635 5113.56 98.574 2850.57 OK TSS1918 116.658 1146.43 0 1146.43 OK 284.696 913.288 0 913.288 OK 49.0071 397.41 0 397.41 OK TSS1919 10.9592 15.7953 0 15.7953 OK 3.50528 3.50528 0 3.50528 OK 9.64992 23.8695 0 23.8695 OK TSS192 3.05482 5 0.700594 4.72165 OK 6.37886 8 1.38817 6.43189 OK 2.46991 19 1.77188 9.79143 OK TSS1920 0 0 0 0 OK 1.01025 2 0 1.01025 OK 2.02429 3 0 2.02429 OK TSS1921 61.1304 3045 62.0216 1918.3 OK 439.671 9237 471.445 8430.88 OK 197.537 598911 213.801 49140.9 OK TSS1922 648.165 29082.3 82.2888 20339.7 OK 4660.63 128981 475.341 89369.6 OK 4788.53 1.90222e+06 239.284 1.19123e+06 OK TSS1923 4.05455 5 0 4.05455 OK 16.3542 18 1.11094 16.3542 OK 32.0095 215 3.64119 206.029 OK TSS1924 0 0 0 0 OK 1.58548 8.38045 1.11094 1.58548 OK 5.26949 52.3509 3.64119 33.917 OK TSS1925 17.4227 48 0 47.7638 OK 32.3946 66.0791 -3.55271e-15 32.3946 OK 22.3437 212.604 -8.88178e-16 127.556 OK TSS1926 0 0 0 0 OK 0 0 0 0 OK 8.74922 1342 16.0029 272.681 OK TSS1927 23.6444 335.423 30.4212 180.448 OK 95.7249 552.026 128.236 363.15 OK 101.771 10060 135.306 3171.83 OK TSS1928 37.5935 346 31.9692 286.904 OK 174.888 831 157.228 663.471 OK 91.5594 7564.45 127.029 2853.56 OK TSS1929 19.6515 189 25.8348 149.975 OK 92.9768 559.716 121.396 352.725 OK 156.495 8944.49 148.109 4877.38 OK TSS193 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS1930 0.481711 1 0 0.481711 OK 21.4756 24 0 23.1974 OK 0 0 0 0 OK TSS1931 0.766692 2 0.258727 0.766692 OK 9.70144 20 10.1912 9.70144 OK 0 0 0 0 OK TSS1932 0.718614 2 0.258727 0.718614 OK 26.7954 37 10.1912 26.7954 OK 12.2618 39 -1.89519e-16 37.7139 OK TSS1933 0.481711 1 0 0.481711 OK 1.9899 2 0 1.9899 OK 4.46577 7 0 6.06008 OK TSS1934 84.2784 2758 39.6271 2570.44 OK 378.524 5879 168.939 5693.71 OK 207.578 625615 108.281 163878 OK TSS1935 663.197 22011.3 42.1192 20227.1 OK 2937.32 45025.1 210.72 44182.8 OK 14245.2 1.32112e+07 143.651 1.12463e+07 OK TSS1936 7.91371 970 2.49209 241.364 OK 132.463 2164 41.7812 1992.5 OK 56.8912 636081 35.37 44914.5 OK TSS1937 6.06174 6.24262 0 6.24262 OK 38.3949 38.3949 0 38.3949 OK 55.9469 575.399 0 575.399 OK TSS1938 14.6397 629 21.6114 342.756 OK 34.5496 423 52.9287 341.378 OK 50.0534 29623 81.1062 8374.85 OK TSS1939 416.705 11884.6 21.6114 9756.23 OK 1554.62 14859.8 52.9287 15361 OK 3529.14 691563 81.1062 590490 OK TSS194 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS1940 11.7405 1652 19.7426 426.472 OK 451.343 12037 554.072 11302.4 OK 264.838 193219 429.901 115841 OK TSS1941 54.9376 2713 58.686 1995.6 OK 623.646 16250 571.23 15617.2 OK 385.917 192054 457.546 168801 OK TSS1942 137.959 5235 77.4115 5011.34 OK 692.77 18254 757.473 17348.2 OK 2501.42 1.14647e+06 917.832 1.09413e+06 OK TSS1943 19.0877 1378 13.6472 693.358 OK 220.966 6180 121.707 5533.39 OK 199.748 192319 150.343 87370.2 OK TSS1944 88.9312 3981 68.884 3230.41 OK 270.968 7514 235.285 6785.53 OK 279.235 192075 243.771 122138 OK TSS1945 658.867 37497.7 68.884 23933.2 OK 4667.49 126818 235.419 116882 OK 4670.93 4.1306e+06 248.672 2.04308e+06 OK TSS1946 59.4968 2505.01 78.6064 1125.37 OK 628.85 5934.03 779.735 9505.64 OK 521.633 157406 747.515 87161.9 OK TSS1947 196.855 4142.49 98.0686 3723.47 OK 1973.02 30972 1087.45 29824 OK 2996.98 528250 799.358 500778 OK TSS1948 52.8372 1084 48.5841 999.405 OK 874.448 13948 705.844 13218.1 OK 86.4379 28419 89.9626 14443.3 OK TSS1949 895.532 45390.2 3.63881 37146.2 OK 282.894 1517.28 70.7722 1007.24 OK 24510.6 5.01754e+07 63.6372 4.01056e+07 OK TSS195 0 0 0 0 OK 0.53115 1 0.0493654 0.535565 OK 0.594944 3 0 2.35852 OK TSS1950 2.34525 4559 3.63881 97.2799 OK 50.394 261 70.7722 179.428 OK 40.9182 2.87926e+06 63.6372 66952.7 OK TSS1951 369.932 17302.2 309.081 10950.1 OK 1234.87 17061 1150.43 15744.2 OK 1651.92 328431 1783.32 315371 OK TSS1952 107.234 14762.7 153.683 3174.16 OK 627.397 9131.09 824.361 7999.1 OK 1187.26 299919 1444 226662 OK TSS1953 238.398 9230.58 255.062 7056.65 OK 757.432 10620 854.458 9657 OK 1291.16 255495 1402.42 246499 OK TSS1954 6.12172 2115 8.08546 237.409 OK 44.3574 1114 67.0169 826.469 OK 15.9153 52610 23.2487 3362.36 OK TSS1955 198.039 9274 315.045 7680.22 OK 491.8 10065 829.329 9163.23 OK 484.65 144259 834.442 102390 OK TSS1956 7.44983 2104 11.7985 288.915 OK 308.091 48678.2 504.536 5740.37 OK 45.8367 48049 85.9717 9683.75 OK TSS1957 1092.29 54602 328.85 42360.7 OK 4048.6 150866 1287.28 75433.7 OK 4125.94 1.35736e+06 920.63 871671 OK TSS1958 734.586 26672.8 2.11396 24016.5 OK 2565.8 40646.7 9.30668 38759.9 OK 4112.43 946098 14.4719 874245 OK TSS1959 30.6297 166.727 7.10543e-15 109.842 OK 104.077 311.13 2.84217e-14 163.929 OK 118.678 3260.27 -1.06581e-14 2096.82 OK TSS196 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS1960 12.3243 26.2426 0 26.2426 OK 83.2646 117.1 0 117.1 OK 186.689 3807.84 0 3807.84 OK TSS1961 1387.41 81880.6 2.13163e-14 55181.9 OK 4489.52 104679 2.55795e-13 79309 OK 7024.54 3.05593e+06 -2.27374e-13 2.21318e+06 OK TSS1962 20.2909 1446 21.9975 744.157 OK 317.277 12789.2 426.539 9395.05 OK 357.455 460600 470.435 241887 OK TSS1963 6.55916 1977 10.589 240.554 OK 551.185 17830.3 575.286 16321.4 OK 564.617 924388 630.977 382073 OK TSS1964 103.472 14468.4 60.7908 3794.76 OK 2862.82 160746 1097.14 84772.4 OK 3667.98 6.83456e+06 943.638 2.4821e+06 OK TSS1965 2.75655 102 0 101.095 OK 64.5415 2551 3.55058 1911.17 OK 53.8828 458101 2.74575 36462.1 OK TSS1966 3.10043 2913 4.97466 113.706 OK 187.651 6241 237.981 5556.62 OK 27.188 517069 48.2347 18397.9 OK TSS1967 24.9152 3183 26.3847 913.751 OK 352.257 9445.21 498.563 10430.9 OK 196.129 947721 326.77 132719 OK TSS1968 8.02509 7660 9.8769 294.316 OK 20.1472 2132 27.0645 596.588 OK 64.6687 1.06476e+06 102.362 43760.9 OK TSS1969 5.39263 198 0 197.772 OK 39.9337 1183 0 1182.5 OK 56.7623 38411 0 38410.7 OK TSS197 306.218 5761.87 0 5761.87 OK 1118.9 8437.14 0 8437.14 OK 4236.07 795691 0 795691 OK TSS1970 238.535 10356 174.408 8748.13 OK 934.872 29719.9 1193.58 27683 OK 1496.68 2.36235e+06 1697.78 1.01279e+06 OK TSS1971 118.874 5505 150.445 4359.64 OK 1177.49 37111 1431.5 34867.2 OK 1185.88 917421 1512.47 802478 OK TSS1972 175.765 10081.9 106.557 6446.1 OK 2046.67 68567 1747.53 60605 OK 1727.61 1.91468e+06 1753.73 1.16906e+06 OK TSS1973 21.0024 1453 24.8328 770.252 OK 136.028 4441 153.586 4027.99 OK 325.103 460013 321.259 219995 OK TSS1974 11.9599 867 20.3772 316.702 OK 40.2219 723 72.4004 597.746 OK 4.5397 36407 8.23207 633.513 OK TSS1975 417.808 11909.6 187.622 11063.7 OK 1657.61 26296 1552.03 24634.1 OK 3144.25 424579 90.4185 438778 OK TSS1976 46.9582 4252.41 82.9559 1243.47 OK 1054.66 29565.1 1385.95 15673.6 OK 0 0 0 0 OK TSS1977 67.1219 2187 93.7061 1777.41 OK 337.684 12804.2 485.18 5018.39 OK 8.33846 26989 13.4197 1163.63 OK TSS1978 29.7458 1476 28.5239 787.679 OK 279.266 4663 295.189 4150.23 OK 46.9284 20550 69.6007 6548.82 OK TSS1979 5224.53 390283 -1.74083e-13 383983 OK 15162.3 588633 4.61853e-14 580074 OK 42400 1.8633e+08 9.9476e-13 1.59686e+08 OK TSS198 0.521883 2 6.68478e-17 0.521883 OK 0 0 0 0 OK 2.68094 4 0 3.30449 OK TSS1980 30.5683 157 10.8489 131.643 OK 211.212 763 89.6659 665.284 OK 0 0 0 0 OK TSS1981 7.56834 72 10.8489 32.5932 OK 65.6798 307 89.6659 206.88 OK 15.4833 50 0 49.766 OK TSS1982 0 0 0 0 OK 4.12349 7 2.47122 4.12349 OK 0 0 0 0 OK TSS1983 0 0 0 0 OK 2.87688 6 2.47122 2.87688 OK 0 0 0 0 OK TSS1984 1.61418 4.12607 0.492327 1.61418 OK 4.50533 5 0 4.50533 OK 0 0 0 0 OK TSS1985 0.43318 1 0.492327 0.43318 OK 0 0 0 0 OK 0 0 0 0 OK TSS1986 3.1313 3.1313 0 3.1313 OK 15.4855 15.4855 0 15.4855 OK 0 0 0 0 OK TSS1987 5.87104 655 4.41275 137.103 OK 38.4374 743 29.1573 602.843 OK 24.8876 8539 10.5313 2274.36 OK TSS1988 122.828 2549.25 11.1121 2868.33 OK 1197.92 20758.5 102.919 18787.8 OK 1534.24 166272 165.325 140208 OK TSS1989 6.02928 678 5.44401 140.799 OK 57.3085 1011 67.6298 898.812 OK 141.074 16873 143.152 12892.1 OK TSS199 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS1990 28.0605 317.147 2.88658e-15 201.367 OK 159.485 1899.34 8.9706e-14 1819.82 OK 110.277 4664.13 -7.10543e-15 3928.98 OK TSS1991 219.978 8486 53.0116 8352.6 OK 901.76 14023.3 239.268 13440.8 OK 1445.96 1.28514e+06 358.097 810896 OK TSS1992 177.998 2342 0 2341.89 OK 948.601 6446 0 6445.66 OK 1062.64 63378 0 63377.8 OK TSS1993 2.97061 2.97061 0 2.97061 OK 3.50528 3.50528 0 3.50528 OK 0 0 0 0 OK TSS1994 0.757876 4 0.258585 3.91972 OK 1.01025 3 -1.45283e-17 1.01025 OK 11.1023 721 0.965892 720.186 OK TSS1995 1.42892 8 0.45301 7.39037 OK 2.19856 3 0.373206 2.19856 OK 26.5655 4189 3.95285 1723.26 OK TSS1996 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS1997 1.04769 25 0.087877 24.5211 OK 37.0717 532 8.09863 440.517 OK 7.93134 15880 1.43979 981.461 OK TSS1998 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0.594944 0.594944 0 0.594944 OK TSS1999 0 0 0 0 OK 0 0 0 0 OK 3.51534 5.28145 0 5.28145 OK TSS2 201.334 5988.24 170.21 4905.63 OK 982.546 22416.6 791.543 12154.5 OK 64.8609 1500.58 45.491 1065.72 OK TSS20 0 0 0 0 OK 14.3381 26 9.72406 15.4876 OK 0 0 0 0 OK TSS200 0 0 0 0 OK 1.00006 7 0 6.30426 OK 0 0 0 0 OK TSS2000 181.51 4964 123.339 4279.95 OK 281.228 3209 427.023 2713.72 OK 503.729 29221 387.873 28742.4 OK TSS2001 131.016 3349 123.339 3089.32 OK 1377.62 13788 427.023 13293.3 OK 403.94 31856.7 387.873 23048.5 OK TSS2002 213.324 4754.26 -1.06581e-14 3168.71 OK 1360.33 18284.8 -4.83169e-13 11595.6 OK 773.354 57030.2 -1.06581e-13 38124 OK TSS2003 0 0 0 0 OK 38.1453 778 56.6726 508.458 OK 81.4316 9306 135.806 5434.41 OK TSS2004 514.963 12901 0 12900.1 OK 2785 37200 56.6726 37122.7 OK 1213.21 83504 135.806 80964.7 OK TSS2005 886.334 28798.7 0 28798.7 OK 3538.15 54073.2 0 54073.2 OK 2996.18 391842 0 391842 OK TSS2006 462.278 14649.4 1.56319e-13 11060.6 OK 923.086 6795.73 1.98952e-13 6167.03 OK 2276.69 310817 -5.11591e-13 232457 OK TSS2007 305.253 6367.48 1.42109e-14 5660.97 OK 879.265 5710.28 -1.42109e-14 5694.68 OK 1502.93 120875 -7.99361e-14 111512 OK TSS2008 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TSS2009 89.8073 982.274 7.45419 896.229 OK 767.774 5699.91 58.5009 5125.76 OK 422.789 16897 21.0021 15303.1 OK TSS201 950.259 34428.2 6.16659 33483.2 OK 861.801 5544.39 4.57734 6480.93 OK 1825.88 185213 4.52184 163817 OK TSS2010 21.4962 284 7.11415 214.521 OK 146.3 1044 54.791 976.717 OK 31.6717 1319 17.9299 1146.38 OK TSS2011 0.65654 7 0.340037 6.55193 OK 6.46378 94 3.70994 43.153 OK 3.61292 1894 3.07225 130.772 OK TSS2012 0 0 0 0 OK 21.3875 102 34.008 53.7744 OK 13.7639 87 10.0446 65.2525 OK TSS2013 11.5342 110 15.244 55.4897 OK 6.19164 47 10.9549 15.5676 OK 5.70189 62 8.17015 27.0317 OK TSS2014 26.967 173 17.7061 129.735 OK 140.322 424 68.3923 352.81 OK 5.0034 62 6.39921 23.7203 OK TSS2015 5.11488 69 7.54567 24.6071 OK 16.917 83 26.7809 42.5343 OK 0 0 0 0 OK TSS2016 0.100595 1 0.199073 0.483951 OK 10.8351 58 16.697 27.2426 OK 0 0 0 0 OK TSS2017 1914.7 109209 -5.68434e-14 88285.8 OK 8864.52 244515 6.82121e-13 239547 OK 16108.2 1.66466e+07 1.81899e-12 1.45579e+07 OK TSS2018 2846.15 174278 0 159535 OK 6613.34 163311 0.00133521 151075 OK 10447.7 5.86922e+06 0.421541 5.38142e+06 OK TSS2019 38.3444 489 6.87781 393.777 OK 254.26 1532 37.9765 1469.52 OK 567.742 54120 88.3439 50151.1 OK TSS202 7.60925 1462 6.16659 268.119 OK 5.3232 65 4.59245 40.0316 OK 4.9999 11000 4.66992 448.589 OK TSS2020 122.501 3799 178.211 3027.76 OK 1775.09 35935 2121.13 33515.2 FAIL 2848.54 868233 2232.54 839507 FAIL TSS2021 0 0 0 0 OK 0 0 0 0 FAIL 42.0223 94296 78.9541 12384.6 FAIL TSS2022 75.8548 2563 110.94 1874.85 OK 143.701 3372 238.468 2713.19 FAIL 137.715 88566 220.161 40586.6 FAIL TSS2023 213.669 6162 221.2 5281.1 OK 1238.18 25425 1728.77 23377.9 FAIL 703.138 601575 1176.53 207225 FAIL TSS2024 90.7557 2557.34 117.69 2243.14 OK 1830.68 36559.7 1951.42 34564.8 FAIL 1446.89 932697 1642.67 426420 FAIL TSS2025 0 0 0 0 OK 2.47463 3 0 2.47463 OK 0.4172 1 0 0.747942 OK TSS2026 9.99577 14.1364 0 13.1442 OK 28.0321 29 0 28.0321 OK 4.99901 9 0 8.96205 OK TSS2027 23.2033 1065.17 1.77636e-15 332.134 OK 413.726 3932.37 0.137611 4626.21 OK 19.8803 2767 -8.88178e-16 544.212 OK TSS2028 18.5213 728.776 25.8876 265.116 OK 134.736 1829 194.986 1506.6 OK 5.27916 1157 7.95901 144.514 OK TSS2029 4.14314 371 7.1487 59.3054 OK 202.253 2602 304.541 2261.56 OK 10.8193 940 17.6709 296.172 OK TSS203 311.382 10149.4 31.1146 9006.95 OK 454.069 3110 38.8947 3018.42 OK 420.453 25704 38.7227 23993.1 OK TSS2030 26.8022 798.366 43.9187 383.65 OK 301.698 3916 471.372 3373.53 OK 0 0 0 0 OK TSS2031 0 0 0 0 OK 356.933 6920.4 534.032 3991.16 OK 0 0 0 0 OK TSS2032 33.0046 675 51.6809 472.432 OK 209.928 6001.5 352.138 2347.37 OK 136.657 4518 118.614 3740.91 OK TSS2033 47.5352 868 66.6221 680.426 OK 21.8964 1078.74 42.195 244.842 OK 0.0940643 3 0.187631 2.57496 OK TSS2034 0 0 0 0 OK 47.7861 2150.06 91.2102 534.336 OK 0 0 0 0 OK TSS2035 0.0103079 1 0.0204769 0.147549 OK 254.545 3647.25 413.636 2846.28 OK 72.3805 2327 100.272 1981.38 OK TSS2036 30.1906 678 44.4761 432.152 OK 31.5888 572 54.5716 353.221 OK 14.838 879 24.2073 406.183 OK TSS2037 17.2687 445 17.3417 247.186 OK 113.729 1518 120.516 1271.7 OK 14.7919 842 18.5048 404.921 OK TSS2038 553.019 14392 0 14391.8 OK 535.65 2587.66 0 2564.78 OK 830.74 47365 2.4869e-14 42210.4 OK TSS2039 277.99 10499.7 155.917 6591.53 OK 1117.54 14048.2 622.867 10747.2 OK 1813.21 930834 1468.49 275792 OK TSS204 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2040 183.059 9597.53 155.917 4340.6 OK 532.232 5776 622.867 5118.4 OK 1707.87 746455 1468.49 259769 OK TSS2041 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2042 957.313 35668 6.2669 32996.9 OK 4549.94 86241.1 44.197 84310.5 OK 4640.31 1.16961e+06 43.5825 1.0697e+06 OK TSS2043 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2044 0.473762 14 0.0155155 13.0276 OK 0.495301 3 0 2.58687 OK 0 0 0 0 OK TSS2045 0.00794891 1 0.0155155 0.21858 OK 0 0 0 0 OK 0 0 0 0 OK TSS2046 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 2.02429 2.02429 0 2.02429 OK TSS2047 782.952 27093 137.209 26096.7 OK 1388.68 12363 48.3751 12298 OK 5682.94 1.54164e+06 101.978 1.50715e+06 OK TSS2048 112.488 4538 137.209 3749.34 OK 44.8931 491.57 48.3751 397.569 OK 120.499 71051 101.978 31957.2 OK TSS2049 3.56552 1741 6.04179 104.39 OK 2098.11 54999 2820.95 51830.3 OK 8941.35 5.28271e+06 2614.9 5.14078e+06 OK TSS205 591.643 16261 0 16261 OK 3276.8 47768.8 0 47768.8 OK 7970.37 2.91049e+06 0 2.91049e+06 OK TSS2050 606.526 18524.7 106.186 17757.6 OK 5545.24 146548 2832.46 136986 OK 1883.11 5.47392e+06 2586.61 1.08268e+06 OK TSS2051 0 0 0 0 OK 0 0 0 0 OK 98.6868 341626 171.982 56739.4 OK TSS2052 89.9347 3510 100.145 2633.07 OK 10.3127 711 11.5072 254.758 OK 13.3577 386938 15.3184 7679.96 OK TSS2053 383.82 54349 549.072 44524 OK 469.299 64337 678.332 59303.5 OK 325.524 1.47206e+07 470.43 1.24361e+06 OK TSS2054 14453.4 1.75301e+06 549.072 1.67662e+06 OK 85821.3 1.00747e+07 678.332 1.08449e+07 OK 92561.3 4.39201e+08 470.43 3.53615e+08 OK TSS2055 0 0 0 0 OK 0.505127 0.505127 0 0.505127 OK 0.8344 0.8344 0 0.8344 OK TSS2056 0 0 0 0 OK 0.000328935 1 0.000632743 0.000328935 OK 11.1897 1398 19.4752 370.732 OK TSS2057 0.71795 1 0.232527 0.71795 OK 5.48466 6 0.000632743 5.48466 OK 2.57164 2339 3.3547 85.2022 OK TSS2058 0.00400899 1 0.00792014 0.00400899 OK 0 0 0 0 OK 99.0435 4490 109.829 3281.45 OK TSS2059 3.29242 4 0.239887 3.29242 OK 0 0 0 0 OK 116.988 7513.13 111.848 3875.99 OK TSS206 7.65209 12 2.02641 9.29398 OK 26.5667 27 0.00185466 26.5667 OK 23.2402 151 8.32475 123.616 OK TSS2060 10.8116 50.4652 1.99213 26.4613 OK 52.4664 90.2692 1.72442 59.3463 OK 72.0636 1234.02 0.304223 783.006 OK TSS2061 148.894 1762.49 0 1762.49 OK 851.217 5456.86 0 5456.86 OK 224.353 5239.76 0 5239.76 OK TSS2062 0 0 0 0 OK 1.01031 33 0 32.1292 OK 0 0 0 0 OK TSS2063 27.6993 1114 0 1113.33 OK 188.867 6007 0 6006.23 OK 40.3228 48281 0 48280.3 OK TSS2064 3.2571 3476 5.4269 130.914 OK 318.968 11487 577.788 10143.6 OK 1228.48 4.83701e+06 2091.13 1.47092e+06 OK TSS2065 976.288 45429.7 5.4269 39240.2 OK 8413.86 287956 577.817 267572 OK 17888.7 2.5985e+07 2091.84 2.14189e+07 OK TSS2066 552.878 20004 2.84217e-14 14418.4 OK 1949.6 19306.5 1.13687e-13 20761.6 OK 1223.31 96823.6 1.13687e-13 78394.8 OK TSS2067 6.80602 188 5.49225 87.6525 OK 4.3242 29 2.66159 13.5434 OK 7.02481 4732 6.741 431.498 OK TSS2068 165.652 2576.17 5.49225 2133.38 OK 270.246 1059.64 2.66159 846.412 OK 1128.75 74663.7 6.741 69333.3 OK TSS2069 769.075 28671.2 -2.84217e-14 23478 OK 2617.8 31164.5 1.13687e-13 33357.1 OK 2228.87 227430 2.27374e-13 223848 OK TSS207 1.34009 4.07874 2.02641 1.62764 OK 0.000948845 1 0.00185466 0.000948845 OK 6.23544 74 8.32475 33.1666 OK TSS2070 30.0486 275.1 9.64816 153.803 OK 345.078 2211.09 142.472 1598.39 OK 8.35844 88.5885 6.74953 38.3779 OK TSS2071 11.3528 80 9.57204 58.1088 OK 161.328 907 142.276 747.263 OK 16.0564 93 6.74953 73.7233 OK TSS2072 1.79371 44 1.42394 9.18105 OK 3.11032 25 2.21196 14.4069 OK 0 0 0 0 OK TSS2073 1.44513 3 -4.33681e-18 1.44513 OK 9.93931 11.2157 -1.76942e-16 9.93931 OK 0.594944 2 5.46438e-17 0.594944 OK TSS2074 69.649 561.276 1.38778e-17 484.076 OK 133.966 331.387 -2.498e-16 252.311 OK 29.2361 155 0 154.83 OK TSS2075 314.827 10255 292.992 9610.53 OK 295.597 6714 537.386 5924.17 OK 1660.33 848345 2407.94 763799 OK TSS2076 454.286 19685.3 292.992 13867.7 OK 5187.24 104723 537.386 103959 OK 7339.82 3.38122e+06 2407.94 3.37652e+06 OK TSS2077 1548.41 69383.3 4.26326e-14 64885.1 OK 3762.25 63337.6 2.27374e-13 59803.6 OK 3708.59 652555 8.52651e-14 597919 OK TSS2078 93.8168 4888 132.071 4585.64 OK 553.953 16125 929.174 14797.5 OK 566.052 159929 886.862 130264 OK TSS2079 2045.4 100768 132.071 99976.3 OK 8147.42 218665 929.174 217639 OK 4699.1 1.10827e+06 886.862 1.08139e+06 OK TSS208 6.42293 7.18464 0 7.18464 OK 44.9207 44.9207 0 44.9207 OK 0 0 0 0 OK TSS2080 169.704 3730 1.93775 3362.14 OK 2160.75 32272.9 5.27331 33074.6 OK 84.3335 4654 0.228805 4653.49 OK TSS2081 2.47313 625 1.93775 48.9973 OK 4.35154 331 4.71043 66.609 OK 0 0 0 0 OK TSS2082 1836.93 95192.3 -4.26326e-14 83365.3 OK 7192.85 176466 -2.27374e-13 170626 OK 2148.03 210899 0 215444 OK TSS2083 35.5968 893 62.4951 721.798 OK 482.051 4421 558.965 3851.09 OK 1595.64 312406 1617.62 241006 OK TSS2084 283.187 5936 64.5155 5742.2 OK 689.493 6245.71 560.335 5508.34 OK 1661.08 274007 1618.22 250891 OK TSS2085 34.1494 787 2.33551 692.451 OK 35.862 345 5.69532 286.5 OK 114.168 22726 18.3016 17244 OK TSS2086 0.963422 17 0 16.7331 OK 7.46469 80 0 79.4624 OK 10.246 1158 0 1157.46 OK TSS2087 167.837 2748.29 0 2748.29 OK 3.99001 3.99001 0 3.99001 OK 0 0 0 0 OK TSS2088 612.757 25268.3 0 16873.4 OK 1756.8 20480.9 5.68434e-14 17552 OK 2708.47 450850 -5.68434e-14 376136 OK TSS2089 326.702 10388 309.42 10039.5 OK 421.253 3365 395.279 2937.76 OK 298.47 19026 353.381 16732.2 OK TSS209 24.5385 1424 44.9178 876.804 OK 101.2 3175.38 184.561 1441.45 OK 206.746 416040 377.378 70332.3 OK TSS2090 452.653 16502 309.424 13909.9 OK 566.258 4725.79 395.279 3949 OK 641.333 48131 354.288 35953 OK TSS2091 0.55874 18 0.152663 17.17 OK 0 0 0 0 OK 3.65544 5099 4.09438 204.923 OK TSS2092 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2093 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2094 0.120428 0.120428 0 0.120428 OK 0 0 0 0 OK 0 0 0 0 OK TSS2095 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2096 0.21677 1 0 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK TSS2097 0.21677 2 1.37423e-17 0.21677 OK 0 0 0 0 OK 0 0 0 0 OK TSS2098 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2099 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS21 10.0751 14.6915 0.00194097 13.5351 OK 43.3312 183.253 58.6748 109.029 OK 70.8666 1514.75 65.3573 1188.77 OK TSS210 741.443 27778 427.452 26493.1 OK 2779.16 40240 622.121 39585.2 OK 5521.91 2.24615e+06 1582.79 1.87849e+06 OK TSS2100 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2101 0.16057 2 -1.19262e-17 0.16057 OK 0 0 0 0 OK 0 0 0 0 OK TSS2102 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2103 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TSS2104 0.642282 0.642282 0 0.642282 OK 0 0 0 0 OK 0 0 0 0 OK TSS2105 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2106 4.9778 4.9778 0 4.9778 OK 15.0008 15.0008 0 15.0008 OK 0 0 0 0 OK TSS2107 22.6294 321 11.5951 236.059 OK 67.2598 422 41.9354 371.729 OK 5.03478 7864 4.81586 381.433 OK TSS2108 0.521884 1 0 0.806644 OK 11.5755 13 0.705696 11.6717 OK 6.62983 27 0.799834 26.2825 OK TSS2109 210.875 5683.79 105.043 4119 OK 751.363 6743.53 152.452 4736.53 OK 353.43 21975.5 151.697 12959.2 OK TSS211 307.347 15211.5 407.549 10982.1 OK 271.738 4434.14 469.137 3870.53 OK 760.837 488296 1294.94 258827 OK TSS2110 0 0 0 0 OK 0 0 0 0 OK 43.6456 2924.87 71.4123 1600.36 OK TSS2111 116.255 2684 105.043 2270.79 OK 89.2316 735 152.452 562.508 OK 71.1201 2784 110.939 2607.77 OK TSS2112 101.965 3593 0 3592.82 OK 248.768 1871 0.0151021 1870.79 OK 74.9987 6729 0.148077 6728.85 OK TSS2113 72.6602 2488 0 2487.37 OK 158.544 3001 0 3000.9 OK 87.8318 20032 0 20031.4 OK TSS2114 167.481 3401.66 3.90243e-14 2222.68 OK 857.006 6797.05 4.38982e-13 5461.57 OK 1417.12 126654 -1.68254e-13 100551 OK TSS2115 135.291 3309.64 79.1616 2676.73 OK 10.5517 47 4.4677 32.5732 OK 793.225 111768 700.066 62996.1 OK TSS2116 66.1961 1663.05 79.1616 1309.69 OK 8.34645 32 4.4677 25.7655 OK 765.483 108233 700.066 60792.8 OK TSS2117 6.04182 1066 0 119.538 OK 38.39 136.233 -4.44089e-16 118.51 OK 55.362 15397 -8.88178e-16 4396.71 OK TSS2118 379.438 8340.73 0 8035.25 OK 2305.96 27664 2.66454e-14 27379 OK 3001.55 447835 0 447834 OK TSS2119 12.8817 233 23.2341 180.792 OK 631.131 9088 854.031 8177.03 OK 267.436 6504.2 27.5182 7202.03 OK TSS212 725.589 25339 292.217 24839 OK 3106.71 132571 2203.67 58803.4 OK 3057.18 809868 2140.79 697239 OK TSS2120 184.224 2773 23.2341 2585.54 OK 2062.08 27664 854.031 26716.7 OK 19.887 794 27.5182 535.555 OK TSS2121 16.0977 32.2129 0 32.2129 OK 78.8205 104.945 0 104.945 OK 215.616 4838.83 0 4838.83 OK TSS2122 21.1607 1102 29.0307 466.224 OK 5.48041 104 6.90222 33.4002 OK 30.7307 5257 40.3374 2154.86 OK TSS2123 13.2914 765.527 21.8627 292.844 OK 25.9048 257 41.4174 157.876 OK 76.4537 24687.5 125.275 5360.98 OK TSS2124 338.451 7951 61.8464 7456.93 OK 764.698 4738 48.7684 4660.44 OK 1282.23 92267 161.192 89910.5 OK TSS2125 31.1584 965 13.7187 686.499 OK 2.96814 19 0.922302 18.0893 OK 0 0 0 0 OK TSS2126 0.957894 43 0 42.0774 OK 0 0 0 0 OK 0.502332 424 0.170259 423.709 OK TSS2127 84.2729 706 1.63121 688.727 OK 268.776 1055 64.4508 981.75 OK 75.4399 1083 18.0909 1041.33 OK TSS2128 0 0 0 0 OK 31.0402 144 23.5483 113.38 OK 11.0828 197 7.44316 152.981 OK TSS2129 3.02014 79 1.63121 24.6823 OK 47.7827 233 40.9025 174.534 OK 14.0086 408 10.6477 193.368 OK TSS213 194.986 7262.63 292.217 6674.92 OK 1758.36 132209 2203.67 33282.1 OK 1701.49 417033 2140.79 388052 OK TSS2130 22.0823 86 2.54338 78.6562 OK 29.4125 44 11.898 31.2848 OK 1.65868 3 0.281855 2.38724 OK TSS2131 487.06 19927.8 68.2527 12745.9 OK 777.527 7546.75 199.211 5464.32 OK 2729.48 606355 953.483 444459 OK TSS2132 36.0288 1627.21 50.5291 942.842 OK 210.01 2938.87 188.962 1475.91 OK 892.891 143884 810.566 145395 OK TSS2133 2.25002 2244 4.09386 58.8812 OK 4.60949 81 8.44737 32.3946 OK 4.1616 51354 7.35208 677.66 OK TSS2134 9.56692 876 15.0207 250.358 OK 5.21555 69 8.18384 36.654 OK 101.135 27076 141.1 16468.5 OK TSS2135 74.3615 1478 52.9057 1169.74 OK 51.1689 557 87.8509 405.419 OK 158.281 7207 142.473 6706.45 OK TSS2136 20.6022 558 30.1577 324.082 OK 310.783 2998.35 281.748 2462.38 OK 137.555 7423.63 161.363 5828.27 OK TSS2137 66.7164 1240 54.9385 1049.48 OK 406.819 3524 279.474 3223.29 OK 97.6583 5489 106.726 4137.84 OK TSS2138 54.9669 1003.36 20.9284 864.655 OK 348.573 3155.65 157.301 2761.8 OK 134.916 7219.35 69.2556 5716.47 OK TSS2139 16.1072 473 1.78959 253.374 OK 93.2586 796 23.3592 738.901 OK 75.7614 3531 13.9094 3210.05 OK TSS214 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2140 1.56565 2 0 1.56565 OK 21.7389 23 0.366626 21.7389 OK 0 0 0 0 OK TSS2141 0 0 0 0 OK 3.71652 5 0.366626 3.71652 OK 0 0 0 0 OK TSS2142 23.4616 758 4.99532 462.752 OK 162.545 2910 20.552 2714.55 OK 5.35099 3225 4.10921 270.343 OK TSS2143 3.3144 757 4.99532 65.3725 OK 14.6653 311 20.552 244.914 OK 5.81345 3111 4.10921 293.707 OK TSS2144 10.3168 204 0 203.486 OK 78.8307 1317 0 1316.49 OK 56.7096 2866 0 2865.09 OK TSS2145 741.576 26025.8 -5.68434e-14 22268.5 OK 4750.62 83886 -2.27374e-13 86977.2 OK 1872.38 244879 51.7749 208827 OK TSS2146 0 0 0 0 OK 0 0 0 0 OK 33.9235 31163 51.7749 3783.49 OK TSS2147 28.854 2000.8 45.1316 673.072 OK 406.175 7920 586.656 7292.8 OK 206.565 17567 259.451 15724 OK TSS2148 401.714 11882.8 60.1671 9370.7 OK 4154.24 89146 625.084 74588.7 OK 1331.02 76670.1 282.241 101319 OK TSS2149 0 0 0 0 OK 21.7148 704 25.4767 389.886 OK 35.7681 5920 22.7894 2722.71 OK TSS215 1.59257 975 1.58485 31.5091 OK 18.5774 83 20.6585 57.3483 OK 0 0 0 0 OK TSS2150 15.7486 583 15.0355 367.364 OK 28.6217 688 37.1587 513.898 OK 0 0 0 0 OK TSS2151 622.652 17272.2 0 17272.2 OK 1579.1 14771.3 0 14771.3 OK 4419.26 843537 0 843537 OK TSS2152 47.4502 296.728 0 247.85 OK 284.923 974.398 0 914.64 OK 2.9204 6 1.65585e-16 4.68651 OK TSS2153 3820.8 313161 2041.54 288924 OK 16630.2 881307 8093.68 823877 OK 2829.68 466812 961.216 440467 OK TSS2154 1449.99 115123 2041.54 109646 OK 5539.63 284839 8093.68 274439 OK 601.309 97570 961.216 93599.6 OK TSS2155 0.521883 0.521883 0 0.521883 OK 0 0 0 0 OK 0 0 0 0 OK TSS2156 108.685 2419 144.323 2153.44 OK 712.623 9161 943.822 8127.52 OK 344.324 26417 521.12 24881 OK TSS2157 229.768 5265.44 144.323 4552.54 OK 1467.45 18461.8 943.822 16736.4 OK 1120.35 82963 521.12 80956.7 OK TSS2158 238.616 3881.51 0 3881.51 OK 540.696 2585.27 0 2585.27 OK 1481.34 112518 0 112518 OK TSS2159 4.61433 7289 6.12483 313.014 OK 40.113 1974 77.3318 1723.61 OK 148.362 421908 253.044 95354.1 OK TSS216 8.49768 1074 7.75969 168.127 OK 57.9596 171.697 35.8136 178.921 OK 0.594944 48 0 47.249 OK TSS2160 1.63902 15436 2.22861 111.183 OK 232.877 14180.9 442.688 10006.4 OK 597.004 557377 989.844 383702 OK TSS2161 0 0 0 0 OK 66.8244 4975.69 128.14 2871.37 OK 52.132 443062 100.905 33505.9 OK TSS2162 0 0 0 0 OK 483.67 43857.4 887.524 20782.7 OK 0 0 0 0 OK TSS2163 38.5603 4842 51.0804 2615.75 OK 1962.5 134043 2735.12 84326.1 OK 1339.59 1.24242e+06 1853.21 860974 OK TSS2164 6.7 6448 9.23039 454.495 OK 1499 95947.3 2317.83 64410.2 OK 691.965 967722 1167.81 444735 OK TSS2165 4046.88 278853 584.9 274520 OK 12850.8 557979 4314.03 552185 OK 9036.84 6.19015e+06 2968.96 5.8081e+06 OK TSS2166 48.5237 4621 22.869 3291.61 OK 16.9441 2010 16.6999 728.069 OK 14.4389 471244 14.8141 9280.09 OK TSS2167 47.3242 4845 77.7555 3210.24 OK 604.06 28119 922.113 25955.7 OK 434.84 415301 657.371 279477 OK TSS2168 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2169 259.091 33730.2 415.914 17575.4 OK 28.0066 1979 38.7843 1203.41 OK 33.8979 449202 51.1857 21786.6 OK TSS217 0.472119 10 0.679166 9.34089 OK 6.84872 50.534 4.75754 21.142 OK 0 0 0 0 OK TSS2170 45.5788 1398 38.0356 1197.3 OK 34.9917 483 25.3796 445.453 OK 14.463 163574 13.4044 5513.88 OK TSS2171 518.963 16542.4 38.0356 13632.5 OK 2580.14 37346.6 25.3796 32845.8 OK 8263 3.30795e+06 13.4044 3.1502e+06 OK TSS2172 7.48679 10 3.41524e-17 8.0333 OK 26.5422 27 0 26.5422 OK 19.2924 75.9899 0 73.4272 OK TSS2173 7.08542 7.95273 0 7.95273 OK 19.4755 19.4755 0 19.4755 OK 13.8725 41.5589 0 41.5589 OK TSS2174 174.426 2712.6 -2.66454e-15 2316.3 OK 872.826 5698 1.42109e-14 5626.23 OK 3243.82 500823 -6.56364e-13 460572 OK TSS2175 752.195 39791 977.815 37360.6 OK 0 0 0 0 OK 0 0 0 0 OK TSS2176 33.9246 4178.25 49.2081 1684.99 OK 141.005 4069 203.471 3622.72 OK 115.713 2.57991e+06 172.241 183572 OK TSS2177 1429.64 90704.1 992.22 71008.2 OK 7987.52 206153 203.471 205217 OK 24105.5 4.28079e+07 172.241 3.82422e+07 OK TSS2178 5.26007 100 9.45756 42.5737 OK 0 0 0 0 OK 65.2273 26257.9 121.909 4509.66 OK TSS2179 55.9397 485 21.6649 452.762 OK 168.647 428 20.1406 406.317 OK 1117.17 85822 354.778 77238.7 OK TSS218 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2180 12.6247 305 12.6181 102.181 OK 18.1387 109.854 20.1406 43.7012 OK 175.2 14887.2 244.994 12113 OK TSS2181 2.1686 242 4.00141 17.5521 OK 0 0 0 0 OK 15.4135 5678 24.382 1065.65 OK TSS2182 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2183 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2184 41.1079 371.868 0 236.164 OK 29.4556 31 -3.4792e-16 29.4556 OK 8.80812 25.4984 2.16515e-16 23.3156 OK TSS2185 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2186 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2187 0 0 0 0 OK 1.00005 2 0 1.00005 OK 0 0 0 0 OK TSS2188 0 0 0 0 OK 0 0 0 0 OK 5.0064 12 0 11.5431 OK TSS2189 96.1199 2393 95.2454 2091.76 OK 9.88948 57 10.2311 32.8114 OK 3235.79 1.34347e+07 4774.3 3.66488e+06 OK TSS219 10.2113 413 5.92521 202.032 OK 108.494 350 13.786 334.921 OK 3.03643 242 0 241.146 OK TSS2190 153.58 3741 95.2454 3342.21 OK 287.8 972 10.2311 954.864 OK 14595.1 1.66668e+07 4774.3 1.65305e+07 OK TSS2191 369.343 7702.97 0 7702.97 OK 853.157 5421.54 0 5421.54 OK 2956.3 383602 0 383602 OK TSS2192 3591.63 238811 6.39488e-14 221253 OK 10342.6 313444 -2.13163e-13 308238 OK 21264.4 3.0893e+07 4.61853e-13 2.77297e+07 OK TSS2193 4.69485 114 7.77231 40.1155 OK 24.1278 143.009 43.0086 128.518 OK 112.073 3947 70.1989 2770.61 OK TSS2194 0 0 0 0 OK 11.3606 108 19.9478 60.5129 OK 18.1121 696 31.0094 447.756 OK TSS2195 87.7557 867.764 7.77231 749.835 OK 581.539 4128.13 59.4764 3097.61 OK 92.4814 3762.53 61.5126 2286.27 OK TSS2196 26.2233 303 31.6345 221.271 OK 567.312 7614.25 468.464 4159.41 OK 544.257 26274.4 374.517 30532.2 OK TSS2197 67.2312 671 31.6345 567.292 OK 494.448 7885.6 468.464 3625.19 OK 329.84 18985 374.517 18503.6 OK TSS2198 53.8813 5626 95.7464 2754.98 OK 177.068 2868 260.565 2400.12 OK 227.367 325004 405.684 128730 OK TSS2199 574.7 31475 602.878 29384.7 OK 526.714 7707 544.622 7139.49 OK 583.66 658783 775.847 330454 OK TSS22 0.000992404 1 0.00194097 0.00133321 OK 153.353 716.2 58.6748 385.863 OK 70.7471 1900.26 65.3573 1186.76 OK TSS220 1692.31 71791.9 3.06954e-12 74338.1 OK 4960.3 98928 2.27374e-12 93235 OK 15400 1.36383e+07 0.170259 1.29896e+07 OK TSS2200 591.987 40570.8 756.989 30268.5 OK 1000.6 13819.2 985.899 13562.9 OK 3821.53 3.95563e+06 4685.4 2.16366e+06 OK TSS2201 745.219 43804.9 824.953 38103.4 OK 298.9 4644.71 404.921 4051.52 OK 4945 3.37092e+06 4942.66 2.79974e+06 OK TSS2202 332.236 19243.9 446.493 16987.4 OK 883.628 12874 765.838 11977.4 OK 1642.25 963248 2306.75 929801 OK TSS2203 33.5527 11521.7 64.705 1613.02 OK 33.8932 1009 65.136 580.529 OK 2095.47 2.37239e+06 3199.15 1.0328e+06 OK TSS2204 1156.09 60720 889.89 55578.1 OK 1479.8 27291 1845.3 25346.3 OK 3296.4 4.38474e+06 4326.23 1.62471e+06 OK TSS2205 54.6019 5001 106.004 2624.94 OK 0 0 0 0 OK 1144.18 1.28886e+06 2009.28 563935 OK TSS2206 546.224 28380.2 735.229 26259.3 OK 2671.04 56844.2 1915.13 45750.1 OK 3433.19 2.10044e+06 4276.63 1.69213e+06 OK TSS2207 223.19 11715 298.836 10729.7 OK 0 0 0 0 OK 0 0 0 0 OK TSS2208 78.2751 4778 115.654 3763.01 OK 79.3135 1538 125.083 1358.5 OK 81.5019 251823 128.853 40170.1 OK TSS2209 0 0 0 0 OK 32.3255 638 59.0002 444.452 OK 557.862 3.6046e+06 1015.43 1.05599e+06 OK TSS221 441.064 11848.7 0 10595.3 OK 1082.12 8280.39 2.13163e-14 7981.85 OK 5936.67 1.7084e+06 -2.27374e-12 1.55849e+06 OK TSS2210 184.007 6295.73 203.857 4228.61 OK 146.827 2424 271.355 2018.76 OK 4175.3 1.35706e+07 6917.7 7.90349e+06 OK TSS2211 105.646 5162.11 149.666 2427.82 OK 552.943 35968.8 863.007 7602.55 OK 6135.24 6.18469e+07 9263.41 1.16135e+07 OK TSS2212 139.022 3792 182.287 3194.82 OK 2218.96 59174.8 1058.48 30509 OK 16550.5 5.49355e+07 12746.3 3.13287e+07 OK TSS2213 77.9796 588.486 0 588.486 OK 119.499 207.666 0 207.666 OK 848.646 44213.8 0 44213.8 OK TSS2214 4.11591 83 6.78307 29.2564 OK 79.1442 1950.11 128.242 405.529 OK 0 0 0 0 OK TSS2215 35.4863 305 35.1739 252.241 OK 226.332 2076.43 277.154 1159.71 OK 5.71289 10 0.00886678 9.18201 OK TSS2216 33.941 383.429 34.8667 241.257 OK 297.673 1200.5 293.139 1525.26 OK 0.0044839 1 0.00886678 0.00720673 OK TSS2217 170.517 8293 139.161 6934.85 OK 183.055 2830 192.902 2596.77 OK 146.024 45703 190.277 31016.6 OK TSS2218 1252.27 63346.4 149.359 50929.2 OK 2934.69 42881.3 196.974 41630.6 OK 4713.65 1.28893e+06 191.603 1.00121e+06 OK TSS2219 32.1819 1646 10.5259 1308.82 OK 9.1006 205 4.16628 129.098 OK 2.52668 64627 1.35831 536.687 OK TSS222 1.80058 5 0.364327 3.60628 OK 18.9284 103.788 18.8301 56.8458 OK 13.7851 87 8.23904 66.5462 OK TSS2220 12.4948 1043 15.8386 374.545 OK 672.68 26311 1003.49 24202.6 OK 767.614 9.82001e+07 1369.32 7.58952e+06 OK TSS2221 685.279 23649.2 41.37 20542 OK 13060.3 547066 1049.87 469902 OK 54740.4 6.82225e+08 1526.7 5.41227e+08 OK TSS2222 9.06478 1174 14.2878 271.727 OK 0 0 0 0 OK 0 0 0 0 OK TSS2223 24.5676 73 0.000655155 72.1102 OK 293.072 989.27 0 966.596 OK 0.0171637 1 0.0339104 0.0249525 OK TSS2224 0.000340285 1 0.000655155 0.000998795 OK 0 0 0 0 OK 2.48604 4 0.0339104 3.61419 OK TSS2225 0.481711 0.481711 0 0.481711 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TSS2226 2893.15 177035 5.28644e-12 161466 OK 3907.87 79224.6 -1.79767e-12 63489.5 OK 6450.78 2.26973e+06 0 1.93158e+06 OK TSS2227 11.3478 4263 18.6492 657.529 OK 5.07327 1082 9.12638 127.922 OK 0 0 0 0 OK TSS2228 3140.72 222355 18.6492 181983 OK 7902.74 248766 9.12638 199267 OK 10718.3 6.87992e+06 1.45519e-11 5.77034e+06 OK TSS2229 54.7521 897 47.9431 730.475 OK 81.3763 123 0 122.182 OK 944.062 70888 566.671 69882.7 OK TSS223 1.61867 19 1.76115 3.24193 OK 15.1629 95.4987 17.5606 45.5373 OK 5.31383 55.2806 2.1394 25.6521 OK TSS2230 51.465 912 50.7955 686.62 OK 0 0 0 0 OK 452.786 38683 579.459 33516.8 OK TSS2231 56.2429 743.79 1.77636e-15 517.342 OK 2.04538 3 0.845403 2.04538 OK 722.657 46230.5 37.1586 34803 OK TSS2232 0 0 0 0 OK 1.94462 3 0.845403 1.94462 OK 22.1901 2611 37.1586 1068.67 OK TSS2233 56.2661 1736 91.0179 1312.63 OK 57.687 1038 111.781 791.561 OK 199.517 25852 349.682 22492.6 OK TSS2234 33.8123 1184 53.4556 788.808 OK 256.544 4351.64 401.926 3520.2 OK 93.9806 13055 161.875 10594.9 OK TSS2235 351.101 7246.14 122.401 8190.85 OK 2601.24 35698.7 554.733 35693.4 OK 2224.2 266368 470.766 250746 OK TSS2236 0 0 0 0 OK 40.9593 854 79.1193 562.029 OK 0 0 0 0 OK TSS2237 0 0 0 0 OK 3.23573 394 5.40835 44.3996 OK 0 0 0 0 OK TSS2238 36.0089 171 0 170.375 OK 511.032 2376.24 0 2372.72 OK 255.821 7221 0 7220.07 OK TSS2239 1022.18 38616 167.319 38389 OK 3571.31 58226.3 189.661 57350.1 OK 1118.32 88834 369.363 83683.8 OK TSS224 8.62406 27.3151 1.97598 17.2726 OK 216.376 912.212 16.2109 649.82 OK 6.8922 60 7.09642 33.2715 OK TSS2240 11.0532 1893 8.82559 455.4 OK 73.577 1212 69.0652 962.843 OK 81.7724 51466 95.2926 18334 OK TSS2241 19.8826 568.923 32.2927 266.536 OK 58.2393 1322.59 97.8645 370.386 OK 15.5936 3941 28.306 889.347 OK TSS2242 9.93607 345.764 15.8915 133.198 OK 41.1567 723.338 66.1595 261.745 OK 205.952 30296.1 285.534 11746.1 OK TSS2243 149.507 3625.66 45.6033 2004.21 OK 742.433 4798.6 160.188 4721.67 OK 718.541 66795.6 303.311 40980.6 OK TSS2244 2.88735 229 1.57808 38.7062 OK 11.2106 125 7.82228 71.2965 OK 4.21282 4347 3.14322 240.27 OK TSS2245 125.754 2053.69 8.21784 1484.29 OK 518.857 2902.97 34.669 2504.09 OK 2144.86 261899 3.12639e-13 210269 OK TSS2246 6.28075 181.523 8.21784 74.1328 OK 26.5895 171 34.669 128.325 OK 0 0 0 0 OK TSS2247 162.703 2007 0 2006.23 OK 255.136 826.119 5.32907e-15 761.18 OK 230.544 7636 -8.88178e-16 5421.28 OK TSS2248 0.481711 0.481711 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TSS2249 2062.34 145389 1.13687e-13 98998.8 OK 3804.42 91806 9.09495e-13 60998.1 OK 4517.24 1.27459e+06 -3.41061e-13 882248 OK TSS225 1.42205 1490 1.82542 28.0482 OK 7.79711 334 8.47253 130.214 OK 0 0 0 0 OK TSS2250 0 0 0 0 OK 3.21741 8 4.12139 3.21741 OK 0 0 0 0 OK TSS2251 0.876918 3 1.33493 1.29662 OK 8.87328 16 6.49258 8.87328 OK 0 0 0 0 OK TSS2252 4.19659 13.7525 1.63792 6.20514 OK 2.18671 6 3.62681 2.18671 OK 0 0 0 0 OK TSS2253 0.70703 2 0.397675 1.04542 OK 3.17762 5 1.342 3.17762 OK 0 0 0 0 OK TSS2254 6.94482 8 0 7.70653 OK 3.92034 10 5.41364 3.92034 OK 0 0 0 0 OK TSS2255 0 0 0 0 OK 15.545 21 5.41364 15.545 OK 7.85769 19.2218 4.34115e-16 16.5967 OK TSS2256 157.564 2558.35 7.99361e-15 1916.98 OK 441.599 2356.17 1.06581e-13 1864.58 OK 0.4172 3 -2.86229e-17 0.4172 OK TSS2257 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS2258 11.048 224.22 17.7267 150.495 OK 17.7244 115 31.8512 71.0903 OK 115.577 6035.44 161.771 4966.29 OK TSS2259 149.537 2490 20.9885 2036.99 OK 382.257 1773.61 32.9687 1533.18 OK 472.802 22063.1 175.741 20316.1 OK TSS226 73.3883 1598 92.2149 1447.49 OK 2962.13 65723.8 1088.33 49468.3 OK 551.431 34898.4 231.975 27859.4 OK TSS2260 0 0 0 0 OK 0 0 0 0 OK 8.30351 2594 14.7139 356.798 OK TSS2261 5.45122 214 3.70378 74.256 OK 3.66226 30 1.22778 14.6888 OK 19.8535 1872 7.60156 853.097 OK TSS227 47.9224 1188 43.5204 945.211 OK 79.2235 3561.68 130.3 1323.05 OK 7.99399 3517 12.673 403.873 OK TSS228 161.762 3417 76.8116 3190.56 OK 637.685 22418.4 835.27 10649.5 OK 88.2041 11982.3 135.617 4456.25 OK TSS229 14.7839 425 16.8329 291.595 OK 149.569 2871 204.325 2497.84 OK 95.9739 5196 119.715 4848.8 OK TSS23 145.007 6088.23 9.95861 5267.36 OK 865.318 18639.8 20.3053 21669.1 OK 768.516 577721 29.6504 336151 OK TSS230 4.23664 33 4.45887 12.6453 OK 5.91357 11 4.17494 5.91357 OK 0 0 0 0 OK TSS231 12.2628 81.3392 4.45887 36.6011 OK 0.745477 4 1.35856 0.745477 OK 1.17908e-05 1 1.97244e-05 1.17908e-05 OK TSS232 0 0 0 0 OK 4.78545 9 4.14697 4.78545 OK 0.834388 1 1.97244e-05 0.834388 OK TSS233 10.7182 21.9841 0 21.9841 OK 40.8185 42.6001 0 42.6001 OK 0.8344 0.8344 0 0.8344 OK TSS234 3.53267 4 0 3.53267 OK 8.98007 16.8091 -8.88178e-16 8.98007 OK 0 0 0 0 OK TSS235 0 0 0 0 OK 0.494925 0.494925 0 0.494925 OK 0 0 0 0 OK TSS236 134.647 3295.84 160.245 3179.15 OK 503.391 9367.5 694.55 6735.98 OK 100.359 21667 171.29 10082.3 OK TSS237 267.146 6620 190.95 6307.61 OK 2079.15 28762 922.097 27821.5 OK 855.46 98653.8 923.309 85941.3 OK TSS238 0 0 0 0 OK 5.43689 270 8.83299 72.7521 OK 8.33178 14131 13.995 837.028 OK TSS239 45.361 1776 58.1454 1071.02 OK 120.908 1871 184.862 1617.89 OK 0 0 0 0 OK TSS24 15.3384 1388 9.82185 557.164 OK 27.4502 1295 19.5185 687.404 OK 23.8915 204343 20.14 10450.2 OK TSS240 0 0 0 0 OK 18.5316 425 33.8043 247.975 OK 1153.45 120984 928.304 115878 OK TSS241 2.6521 1345 4.22222 62.6189 OK 16.5597 439 30.8508 221.589 OK 0 0 0 0 OK TSS242 10.9447 590 6.49151 258.416 OK 98.9274 1423 86.3128 1323.77 OK 26.1736 10787 27.4182 2629.45 OK TSS243 6.66397 8.52878 0 8.52878 OK 30.5271 30.5271 0 30.5271 OK 10.0054 23.5232 0 23.5232 OK TSS244 42.5442 215 2.69788 208.919 OK 748.514 6166.83 6.72838 4465.76 OK 0 0 0 0 OK TSS245 1.93503 69 2.69788 9.50224 OK 5.88741 2801 6.72838 35.1253 OK 0 0 0 0 OK TSS246 0 0 0 0 OK 34.9264 986.769 66.977 265.842 OK 2.5032 4 0 3.63915 OK TSS247 1.44513 4 -4.22297e-17 1.44513 OK 6.05132 8 3.91831e-16 6.05132 OK 0 0 0 0 OK TSS248 669.417 19138.8 0 19138.8 OK 2143.61 24185.8 0 24185.8 OK 2976.89 411506 0 411506 OK TSS249 78.2233 1334.42 53.7021 836.152 OK 482.995 3182.5 153.709 2427.61 OK 669.938 43862 266.873 34812.1 OK TSS25 116.779 1180.53 0 1180.53 OK 400.73 1597.85 0 1597.85 OK 1352.09 93029.7 0 93029.7 OK TSS250 51.7224 702 53.7021 552.876 OK 103.265 692 153.709 519.029 OK 186.38 12303.8 266.873 9684.85 OK TSS251 248.351 9497 1.77636e-15 7002.11 OK 1944.81 26564.6 56.4934 20932.4 OK 17872.7 4.01949e+07 4726.29 2.68289e+07 OK TSS252 0 0 0 0 OK 3.27781 238 5.51527 35.2799 OK 5.7005 3.82011e+06 10.5607 8557.06 OK TSS253 0 0 0 0 OK 0 0 0 0 OK 50.341 2.4143e+06 91.3682 75567.3 OK TSS254 352.266 9932 0 9931.95 OK 33.1976 512 52.0189 357.313 OK 2989.71 4.51069e+06 4659.94 4.48788e+06 OK TSS255 2.52907 2.52907 0 2.52907 OK 42.941 42.941 0 42.941 OK 0 0 0 0 OK TSS256 387.508 8290.68 0 8290.68 OK 1065.12 7793.15 0 7793.15 OK 477.077 17737.6 0 17737.6 OK TSS257 0.481711 2 8.74951e-17 0.481711 OK 0 0 0 0 OK 4.79918 1135 4.76989 137.966 OK TSS258 0 0 0 0 OK 1.51538 2 0 1.51538 OK 218.008 6388 4.76989 6267.29 OK TSS259 0 0 0 0 OK 0.989851 0.989851 0 0.989851 OK 0 0 0 0 OK TSS26 6.14209 7.30868 0 7.30868 OK 6.51564 6.51564 0 6.51564 OK 8.81552 19.8959 0 19.8959 OK TSS260 14.2508 30.939 0 30.939 OK 53.4059 56.7037 0 56.7037 OK 1.18989 1.18989 0 1.18989 OK TSS261 5.01797 11.0044 7.61652e-18 5.01797 OK 73.8302 175.142 2.88194 93.8523 OK 2.086 4 -4.30211e-16 2.70955 OK TSS262 0 0 0 0 OK 3.15343 7 2.88194 4.00861 OK 0 0 0 0 OK TSS263 76.3134 628.847 -2.66454e-15 557.958 OK 116.226 620.832 -4.44089e-16 203.975 OK 152.599 2838 0 2837.72 OK TSS264 655.455 19724.7 0 19642.6 OK 864.816 6535 267.022 6254.33 OK 4717.66 1.30252e+06 1530.6 1.23673e+06 OK TSS265 0 0 0 0 OK 180.989 1648 267.022 1308.91 OK 1052.67 345126 1530.6 275956 OK TSS266 2.04741 48 0 47.0509 OK 18.0315 248 0 247.92 OK 6.43574 12183 0 12182.3 OK TSS267 0 0 0 0 OK 6.44423 6.44423 0 6.44423 OK 5.89881 12.4355 0 12.4355 OK TSS268 140.975 2138.9 7.10543e-15 1595.59 OK 244.431 1214.31 8.52651e-14 707.707 OK 1820.06 224531 -4.54747e-13 172349 OK TSS269 947.571 41095.4 -2.16716e-13 31745.1 OK 12929.7 463082 -1.79057e-12 445172 OK 121.648 4041 27.2263 2782.07 OK TSS27 157.491 7033.69 2.11396 5149 OK 905.692 10440.6 9.30668 13681.7 OK 752.532 177670 14.4719 159978 OK TSS270 0 0 0 0 OK 0 0 0 0 OK 15.8279 607 27.2263 361.982 OK TSS271 17.1811 936 11.663 515.022 OK 90.1891 3897 66.8818 3244.94 OK 53.6278 1.00873e+08 46.0022 530227 OK TSS272 3.95144 1216 3.06353 118.449 OK 9.4136 1461 7.20227 338.695 OK 113.553 9.98063e+07 135.897 1.12271e+06 OK TSS273 0.481711 1 0 0.481711 OK 0 0 0 0 OK 0 0 0 0 OK TSS274 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS275 10.417 229 16.7251 143.293 OK 3.95315 59 6.84927 15.5263 OK 4.93896 1817 8.10924 163.227 OK TSS276 166.217 2478 16.7251 2286.42 OK 388.006 1537 6.84927 1523.92 OK 383.719 12719 8.10924 12681.4 OK TSS277 2921.04 178404 -2.98428e-13 165730 OK 3327.08 52459.9 1.49214e-13 48988.6 OK 16373 1.80178e+07 -2.33058e-11 1.5005e+07 OK TSS278 312.828 6198.84 23.6678 6302.09 OK 1776.86 22596.6 40.7835 19436.8 OK 1604.11 139061 23.0907 125862 OK TSS279 34.4161 816 23.6678 693.331 OK 49.6281 593 40.7835 542.875 OK 21.0118 6709 23.0907 1648.63 OK TSS28 0.963422 0.963422 0 0.963422 OK 19.4653 19.4653 0 19.4653 OK 0 0 0 0 OK TSS280 26.535 124.832 8.88178e-16 83.5016 OK 210.843 926.54 7.10543e-15 577.718 OK 0 0 0 0 OK TSS281 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS282 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS283 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS284 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS285 112.804 1085 -1.06165e-15 1083.41 OK 1438.42 15095.1 6.82121e-13 12729 OK 3783.18 1.04988e+06 -1.25056e-12 903678 OK TSS286 3113.5 257703 1.13687e-13 179886 OK 12355.4 482960 -1.36424e-12 414072 OK 5819.29 1.77727e+06 -4.54747e-13 1.48864e+06 OK TSS287 1.99401 263 1.13364 26.603 OK 1.94154 4 1.84071 2.91511 OK 43.4993 5525 21.1656 3219.96 OK TSS288 4.33935e-05 1 7.8269e-05 4.33935e-05 OK 0 0 0 0 OK 0 0 0 0 OK TSS289 0.52184 1 7.8269e-05 0.52184 OK 0 0 0 0 OK 0 0 0 0 OK TSS29 222.274 3843 -2.4869e-14 3470.84 OK 1301.74 10895.9 -2.84217e-14 10782.4 OK 948.748 59102.9 0 53957.4 OK TSS290 1345.01 132445 2167.35 117516 OK 3683.51 248854 6364.78 238795 OK 23543.9 1.14179e+08 21187.2 9.28283e+07 OK TSS291 6558.97 598479 2167.35 573070 OK 29287.5 1.9542e+06 6364.78 1.89865e+06 OK 19827.9 9.33404e+07 21187.2 7.81772e+07 OK TSS292 1488.11 63123.9 8.82559 61311.6 OK 2660.48 35024 69.0652 34815.6 OK 5063.6 1.15113e+06 95.2926 1.1353e+06 OK TSS293 639.529 18049.3 1.42109e-14 17886.4 OK 1844.28 20190.8 2.84217e-14 19026.7 OK 2116.77 208542 -5.68434e-14 204736 OK TSS294 629.695 22633.4 -1.42109e-13 17474.2 OK 4118.98 96229.4 -4.09273e-12 69057.9 OK 1463.91 143960 -7.95808e-13 116447 OK TSS295 1876.88 85755.8 0 85755.8 OK 2408.87 29578 0 29578 OK 3447.05 514118 0 514118 OK TSS296 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS297 12.6475 55 10.8264 34.8156 OK 68.5467 81.0564 0.00553655 80.9083 OK 0 0 0 0 OK TSS298 9.75264 47 10.8264 26.8468 OK 0.00280556 1 0.00553655 0.00331151 OK 1.42934 3 2.68665e-16 1.42934 OK TSS299 806.048 33492.2 4.13499 28906.2 OK 566.645 3537.3 3.3618 2848.22 OK 6798.98 2.60043e+06 5.88657 2.3035e+06 OK TSS3 285.123 13664.5 170.21 6947.2 OK 1513.01 30206.6 791.543 18716.6 OK 66.7142 1860.62 45.491 1096.17 OK TSS30 18.9347 54.4857 0 54.4857 OK 271.704 849.392 0 849.392 OK 49.2598 398.908 0 398.908 OK TSS300 23.3778 1269 4.13499 838.364 OK 15.3595 86 3.3618 77.2042 OK 16.8108 119205 5.88657 5695.52 OK TSS301 204.779 3365 36.6038 3151.38 OK 182.052 499 31.6392 465.881 OK 284.362 11158 199.193 10649.8 OK TSS302 21.7121 1068 36.6038 334.131 OK 21.1622 140.883 31.6392 54.1552 OK 179.322 10470.3 199.193 6715.89 OK TSS303 2.04736 2.04736 0 2.04736 OK 9.49539 9.49539 0 9.49539 OK 0.4172 0.4172 0 0.4172 OK TSS304 1268.72 56805.8 468.926 55344.7 OK 3227.94 67640 1971.74 65441.1 OK 4429.99 1.19672e+06 740.841 946024 OK TSS305 38.2085 2029 67.5398 1666.75 OK 111.353 12443.1 205.555 2257.49 OK 54.2757 48279 94.0161 11590.6 OK TSS306 380.99 19494.8 449.179 16619.7 OK 2272.02 55432.8 1985.35 46061.4 OK 409.356 290143 673.302 87418.1 OK TSS31 109.341 2941 100.681 2410.56 OK 982.411 11011 697.399 10281.7 OK 535.021 40248 488.747 37932.5 OK TSS32 264.585 6468.77 105.551 5833.13 OK 575.167 10937.3 503.244 6019.57 OK 396.993 34885.8 404.062 28146.5 OK TSS33 14.6749 546.077 18.2542 323.527 OK 338.226 10162.9 392.665 3539.8 OK 273.779 20216 300.766 19410.7 OK TSS34 476.479 15662.3 148.211 12757 OK 2066.95 32392.3 1521.63 30678.7 OK 1698.58 346272 1838.85 315279 OK TSS35 89.441 3001 144.119 2394.65 OK 1241.17 20035 1514.97 18422.1 OK 2223.83 447776 1841.34 412772 OK TSS36 1.00359 1.00359 0 1.00359 OK 9.95972 9.95972 0 9.95972 OK 4.172 8.48407 0 8.48407 OK TSS37 62.0412 702.159 25.3916 484.951 OK 596.387 6881.4 520.221 4563.46 OK 1031.02 78451.9 585.086 76290.5 OK TSS38 5.28331 86 7.78209 41.2975 OK 186.016 3160.18 258.251 1423.37 OK 143.856 15967.6 233.295 10644.6 OK TSS39 0 0 0 0 OK 12.9787 144 24.6344 99.311 OK 151.119 18194.7 256.419 11182 OK TSS4 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS40 0 0 0 0 OK 257.642 2374 372.798 1971.43 OK 93.9564 55252.7 170.146 6952.3 OK TSS41 10.6255 152 16.7051 83.0551 OK 0 0 0 0 OK 55.4155 54098.8 101.643 4100.47 OK TSS42 3.3817 100 4.47215 26.4334 OK 92.4544 1918.81 100.519 707.446 OK 0 0 0 0 OK TSS43 5.83959 11.5577 0.382732 5.83959 OK 66.5345 167.317 8.80003 82.5456 OK 5.58246 36 5.78888 22.1967 OK TSS44 0 0 0 0 OK 0 0 0 0 OK 8.63718 48 7.78236 34.3427 OK TSS45 0.202063 1 0.382732 0.202063 OK 6.88776 35.3414 8.80003 8.54526 OK 3.59862 55 5.16655 14.3086 OK TSS46 0 0 0 0 OK 57.5863 2588 15.5853 1705.22 OK 55.7194 458013 2.63772 37704.9 OK TSS47 5.35927 197 0 196.548 OK 12.9405 1003 15.5853 383.188 OK 1.56786 2.16556e+06 2.63772 1060.96 OK TSS48 43.7732 2702 21.2785 1605.36 OK 135.959 4371 101.205 4025.95 OK 117.065 461793 68.3686 79217.1 OK TSS49 1.52548 1.52548 0 1.52548 OK 2.49503 2.49503 0 2.49503 OK 7.20104 16.8246 0 16.8246 OK TSS5 51.2037 380.022 -4.44089e-16 286.841 OK 190.335 652.866 0 466.513 OK 282.187 10990.7 -2.13163e-14 7508.98 OK TSS50 2.04736 2.04736 0 2.04736 OK 26.4657 26.4657 0 26.4657 OK 0.8344 0.8344 0 0.8344 OK TSS51 8.67116 12.3414 0 12.3414 OK 77.4887 98.9312 0 98.9312 OK 0.594944 0.594944 0 0.594944 OK TSS52 177.355 4295 103.393 4141.68 OK 1904.57 30294 351.049 29870.8 OK 0 0 0 0 OK TSS53 0 0 0 0 OK 0 0 0 0 OK 75.1929 8466 70.9148 6871.54 OK TSS54 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS55 71.6222 2280 98.1028 1672.56 OK 117.97 4488.22 220.649 1850.21 OK 0 0 0 0 OK TSS56 0 0 0 0 OK 0 0 0 0 OK 45.8921 8749 62.8905 4193.87 OK TSS57 2.22725 846 1.45778 52.0118 OK 29.4847 1688.44 47.1713 462.43 OK 0 0 0 0 OK TSS58 4.99777 770 5.76468 116.71 OK 31.1416 790 36.5946 488.417 OK 0 0 0 0 OK TSS59 562.295 14778.4 0 14778.4 OK 4366.32 75900.2 0 75900.2 OK 7849.78 2.82964e+06 0 2.82964e+06 OK TSS6 10.277 19.049 0 19.049 OK 84.3667 115.845 0 115.845 OK 1.42934 1.42934 0 1.42934 OK TSS60 1005.52 42617.3 53.0116 38179.7 OK 2497.29 37501.1 239.268 37222.1 OK 9899.37 5.96779e+06 358.097 5.55159e+06 OK TSS61 0 0 0 0 OK 5.55836 11 4.73147 5.55836 OK 3.09879 44 3.54435 11.5284 OK TSS62 2.41501 5 0.98055 2.41501 OK 6.90658 13 4.73147 6.90658 OK 7.84965 98.0546 3.54435 29.2031 OK TSS63 1.03732 3 0.98055 1.03732 OK 0 0 0 0 OK 0 0 0 0 OK TSS64 23.827 293.897 0.194424 123.233 OK 7.25602 16.7031 0.373206 7.25602 OK 1161.88 109666 2.98695 75369.2 OK TSS65 405.816 10058.3 84.4534 9498.12 OK 2178.4 30985.6 219.462 25885.5 OK 2607.15 446809 314.43 322621 OK TSS66 47.5642 1800 84.3848 1113.24 OK 117.53 1664 212.234 1396.58 OK 172.684 31328 313.178 21368.7 OK TSS67 3.53267 11.1273 -6.85216e-17 3.53267 OK 47.9821 51.555 0 47.9821 OK 60.6274 662.527 3.55271e-15 565.222 OK TSS68 152.408 2099 31.5328 1997.17 OK 665.608 5015.23 344.755 4529.15 OK 5.60754 30 4.19539 15.676 OK TSS69 0 0 0 0 OK 130.995 1309.99 214.619 891.361 OK 4.18034 28 4.19541 11.6863 OK TSS7 11.9119 1068 8.69793 373.8 OK 0 0 0 0 OK 0 0 0 0 OK TSS70 19.4773 595.934 30.7617 255.232 OK 130.263 1140 209.06 886.38 OK 0.0323877 1 0.0642745 0.0905408 OK TSS71 4.10372 178 1.08715 53.7754 OK 25.3848 250.719 22.1601 172.732 OK 0 0 0 0 OK TSS72 507.179 12810 0 12809.8 OK 1193.68 9366 0 9365.61 OK 5205.43 1.2345e+06 -1.27898e-13 1.18067e+06 OK TSS73 8.79359 27.1402 1.07221 12.7511 OK 180.111 497 32.2617 459.587 OK 9.73879 37 0.0392145 32.6434 OK TSS74 0.892741 2 0.649688 1.29452 OK 21.5134 104.211 30.1584 54.8954 OK 0 0 0 0 OK TSS75 1.39339 3 0.585492 2.02048 OK 0.566327 2 0.141665 1.44509 OK 0 0 0 0 OK TSS76 0 0 0 0 OK 1.68685 111 2.42212 4.30432 OK 0.0197686 1 0.0392145 0.0662621 OK TSS77 0.481711 0.481711 0 0.481711 OK 6.44423 6.44423 0 6.44423 OK 0.594944 0.594944 0 0.594944 OK TSS78 4.45592 4.45592 0 4.45592 OK 29.9302 29.9302 0 29.9302 OK 17.9248 64.5406 0 64.5406 OK TSS79 86.2292 978.969 2.66454e-15 696.539 OK 357.733 1853.21 2.0961e-13 1331.51 OK 287.346 9668.46 -7.10543e-15 7737.75 OK TSS8 51.9052 2019 54.2737 1628.81 OK 4.42255 546 5.30023 84.8043 OK 7.81277 86041 11.7699 1943.57 OK TSS80 4.45592 7.90642 -5.55112e-17 4.45592 OK 27.0626 42.1913 2.22045e-16 27.0626 OK 4.88297 13.4574 0 6.98968 OK TSS81 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS82 0 0 0 0 OK 0 0 0 0 OK 0 0 0 0 OK TSS83 109.591 1416.74 0 1168.4 OK 193.908 444.954 -7.10543e-15 477.122 OK 2.37978 4.33669 0 3.35053 OK TSS84 9.3942 184 15.7115 77.9143 OK 63.8882 381 100.067 256.351 OK 173.571 7376.75 108.342 4424.07 OK TSS85 69.4503 742.542 28.8185 576.012 OK 334.459 1608.24 105.614 1342.01 OK 86.7402 5270.38 108.342 2210.88 OK TSS86 5.49561 261.41 8.53379 45.5799 OK 2.82742 33 4.63406 11.345 OK 0 0 0 0 OK TSS87 6.54508 297.719 10.3037 54.2841 OK 2.44878 38 3.88294 9.82571 OK 0 0 0 0 OK TSS88 64.5046 6487 3.31361 3615.67 OK 129.419 3541.3 18.8626 2956.43 OK 118.359 267854 19.0053 60965 OK TSS89 7.81288 3207 1.21321 437.935 OK 22.275 1045 8.0543 508.849 OK 10.6386 282551 3.79686 5479.79 OK TSS9 38.5161 2074 44.5253 1208.65 OK 9.31442 405 7.24329 178.608 OK 58.3927 62838 33.3498 14526.2 OK TSS90 6.64588 3401 2.2788 372.521 OK 23.6989 1076 15.2209 541.377 OK 19.2162 288899 16.8003 9897.93 OK TSS91 25.0095 74.6717 0 74.6717 OK 150.34 309.521 0 309.521 OK 3.93254 6.43363 0 6.43363 OK TSS92 92.1693 801.958 0 801.958 OK 762.203 4511.79 0 4511.79 OK 0 0 0 0 OK TSS93 10.6588 36 6.05186 24.504 OK 72.8803 582.005 62.7498 273.548 OK 0.594944 1 0 0.594944 OK TSS94 7.96795 31 6.05186 18.3179 OK 285.988 1412.33 62.7498 1073.42 OK 0 0 0 0 OK TSS95 3.05096 7.97535 2.22045e-16 3.05096 OK 2.48483 6.47165 0 2.48483 OK 6.37403 25.9886 -2.22045e-16 12.0397 OK TSS96 137.533 1730.1 13.0602 1676.81 OK 541.901 2703.27 149.742 3176.16 OK 387.213 20307.3 60.7863 14088.3 OK TSS97 22.4395 449 13.0602 273.584 OK 208.975 1379 149.742 1224.83 OK 75.5738 4023 60.7863 2749.66 OK TSS98 400.713 8852.95 0 8852.95 OK 2457.98 30132.5 0 30132.5 OK 2311.86 242240 0 242240 OK TSS99 34.1028 2411 17.8221 1175.46 OK 159.672 3411 122.441 2958.72 OK 407.454 106189 193.543 93927.3 OK cummeRbund/inst/extdata/tss_groups.fpkm_tracking0000644000175200017520000024341214516004263023264 0ustar00biocbuildbiocbuildtracking_id class_code nearest_ref_id gene_id gene_short_name tss_id locus length coverage iPS_FPKM iPS_conf_lo iPS_conf_hi iPS_status hESC_FPKM hESC_conf_lo hESC_conf_hi hESC_status Fibroblasts_FPKM Fibroblasts_conf_lo Fibroblasts_conf_hi Fibroblasts_status TSS1 - - XLOC_000001 - TSS1 chr1:11873-29961 - - 20.2175 0 182.529 OK 0.347386 0 3.15457 OK 16.1506 0 182.924 OK TSS10 - - XLOC_000016 KLHL17 TSS10 chr1:895966-901095 - - 63.5773 9.94217 117.212 OK 180.736 130.393 231.079 OK 138.131 30.5583 245.704 OK TSS100 - - XLOC_000073 THAP3 TSS100 chr1:6684924-6761966 - - 34.9289 0 231.813 OK 106.792 20.664 192.92 OK 156.028 0 732.971 OK TSS101 - - XLOC_000074 CAMTA1 TSS101 chr1:6845383-7829763 - - 1275.04 609.748 1940.33 OK 1441.29 1170.62 1711.96 OK 3196.37 1723.39 4669.34 OK TSS102 - - XLOC_000074 CAMTA1 TSS102 chr1:6845383-7829763 - - 8.87986 0 34.9381 OK 26.1246 14.0847 38.1644 OK 0 0 0 OK TSS103 - - XLOC_000074 CAMTA1 TSS103 chr1:6845383-7829763 - - 0 0 0 OK 0 0 0 OK 1.97243 0 40.9763 OK TSS104 - - XLOC_000074 - TSS104 chr1:6845383-7829763 - - 1.762 0 41.0413 OK 0 0 0 OK 0 0 0 OK TSS105 - - XLOC_000075 VAMP3 TSS105 chr1:7831328-7841491 - - 1500.64 962.379 2038.91 OK 502.334 419.37 585.299 OK 7098.44 3876.89 10320 OK TSS106 - - XLOC_000076 PER3 TSS106 chr1:7844379-7973294 - - 67.8365 0 223.434 OK 7.32764 0 20.8878 OK 46.9633 0 225.452 OK TSS107 - - XLOC_000076 PER3 TSS107 chr1:7844379-7973294 - - 223.621 95.1999 352.042 OK 110.54 87.1283 133.951 OK 311.575 155.217 467.932 OK TSS108 - - XLOC_000077 PARK7 TSS108 chr1:8021713-8045341 - - 4677.15 2880.65 6473.66 OK 8433.49 7392.61 9474.37 OK 21641.5 9956.7 33326.3 OK TSS109 - - XLOC_000078 SLC45A1 TSS109 chr1:8384389-8404226 - - 1.80448 0 6.154 OK 29.7198 20.3457 39.0939 OK 142.738 43.7625 241.713 OK TSS11 - - XLOC_000016 KLHL17 TSS11 chr1:895966-901095 - - 55.6229 0 144.357 OK 151.63 72.2295 231.031 OK 48.7092 0 168.468 OK TSS110 - - XLOC_000078 SLC45A1 TSS110 chr1:8384389-8404226 - - 9.62868 0 19.3119 OK 9.9298 1.33427 18.5253 OK 69.3396 0 173.193 OK TSS111 - - XLOC_000079 CA6 TSS111 chr1:9005921-9035146 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS112 - - XLOC_000080 H6PD TSS112 chr1:9294862-9331392 - - 137.324 75.6555 198.993 OK 93.0165 77.025 109.008 OK 1112.18 629.474 1594.88 OK TSS113 - - XLOC_000081 SPSB1 TSS113 chr1:9352940-9429588 - - 70.5381 22.0311 119.045 OK 18.3153 7.78939 28.8412 OK 201.501 11.8174 391.185 OK TSS114 - - XLOC_000081 SPSB1 TSS114 chr1:9352940-9429588 - - 17.2656 0 47.0766 OK 67.8157 50.0195 85.6119 OK 674.909 329.316 1020.5 OK TSS115 - - XLOC_000082 SLC25A33 TSS115 chr1:9599527-9642830 - - 216.702 89.7467 343.656 OK 229.284 182.986 275.581 OK 266.339 85.7716 446.906 OK TSS116 - - XLOC_000083 TMEM201 TSS116 chr1:9648976-9674935 - - 122.735 39.3309 206.14 OK 402.381 326.516 478.246 OK 330.695 141.661 519.73 OK TSS117 - - XLOC_000084 PIK3CD TSS117 chr1:9711789-9884550 - - 42.5258 0 112.708 OK 260.118 181.483 338.754 OK 45.2674 0 579.677 OK TSS118 - - XLOC_000084 PIK3CD TSS118 chr1:9711789-9884550 - - 132.845 26.5593 239.131 OK 155.927 94.5391 217.315 OK 109.373 0 648.449 OK TSS119 - - XLOC_000084 PIK3CD TSS119 chr1:9711789-9884550 - - 17.0706 0 54.8339 OK 25.5368 0 51.0761 OK 21.2442 0 553.241 OK TSS12 - - XLOC_000016 KLHL17 TSS12 chr1:895966-901095 - - 29.3795 0 78.4723 OK 229.433 164.679 294.188 OK 99.7819 0 212.064 OK TSS120 - - XLOC_000085 NMNAT1 TSS120 chr1:10003485-10045555 - - 61.6068 21.6744 101.539 OK 39.4422 30.2486 48.6358 OK 319.369 166.702 472.035 OK TSS121 - - XLOC_000086 RBP7 TSS121 chr1:10057254-10076077 - - 115.178 32.484 197.872 OK 229.575 173.78 285.371 OK 19.7819 0 39.7651 OK TSS122 - - XLOC_000087 UBE4B TSS122 chr1:10093015-10241294 - - 531.227 330.689 731.764 OK 1126.9 992.025 1261.78 OK 1169.94 636.429 1703.44 OK TSS123 - - XLOC_000087 - TSS123 chr1:10093015-10241294 - - 171.613 0 479.562 OK 10.087 0 66.4644 OK 70.0715 0 791.741 OK TSS124 - - XLOC_000087 - TSS124 chr1:10093015-10241294 - - 7.8499 0 129.227 OK 10.3213 0 42.9367 OK 200.875 0 653.389 OK TSS125 - - XLOC_000088 KIF1B TSS125 chr1:10270763-10441659 - - 833.691 379.7 1287.68 OK 545.589 455.888 635.291 OK 1011.58 152.279 1870.88 OK TSS126 - - XLOC_000088 KIF1B TSS126 chr1:10270763-10441659 - - 0 0 0 OK 1.09608 0 9.00725 OK 5.57672 0 81.5452 OK TSS127 - - XLOC_000088 KIF1B TSS127 chr1:10270763-10441659 - - 76.9201 0 185.844 OK 90.7558 59.649 121.863 OK 29.2168 0 142.034 OK TSS128 - - XLOC_000089 PGD TSS128 chr1:10459084-10480200 - - 1416.9 868.215 1965.58 OK 7183.39 6443.81 7922.96 OK 13970.1 6021.45 21918.7 OK TSS129 - - XLOC_000090 APITD1,Cort TSS129 chr1:10490158-10512208 - - 78.5742 0 203.008 OK 94.3083 57.0289 131.588 OK 125.257 0 357.509 OK TSS13 - - XLOC_000016 KLHL17 TSS13 chr1:895966-901095 - - 34.9548 0 105.595 OK 180.118 104.051 256.186 OK 60.5379 0 193.719 OK TSS130 - - XLOC_000090 APITD1 TSS130 chr1:10490158-10512208 - - 172.607 47.2749 297.939 OK 138.152 98.4097 177.895 OK 526.06 218.688 833.433 OK TSS131 - - XLOC_000090 CORT TSS131 chr1:10490158-10512208 - - 33.6985 0 108.268 OK 27.3151 7.59018 47.0399 OK 12.1268 0 127.453 OK TSS132 - - XLOC_000091 PEX14,Pex14 TSS132 chr1:10535002-10690813 - - 252.617 20.0714 485.164 OK 678.266 484.546 871.986 OK 1632.34 0 3391.32 OK TSS133 - - XLOC_000091 PEX14 TSS133 chr1:10535002-10690813 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS134 - - XLOC_000092 TARDBP TSS134 chr1:11072678-11085548 - - 1918.99 1399.81 2438.16 OK 2401.2 2136.18 2666.23 OK 2744.34 1535.58 3953.11 OK TSS135 - - XLOC_000093 ANGPTL7 TSS135 chr1:11166588-11322608 - - 25.3243 0 101.602 OK 0.912846 0 7.62052 OK 10.571 0 84.7445 OK TSS136 - - XLOC_000094 UBIAD1 TSS136 chr1:11333254-11348490 - - 358.008 199.441 516.575 OK 307.383 257.097 357.67 OK 332.294 172.345 492.244 OK TSS137 - - XLOC_000095 PTCHD2 TSS137 chr1:11539294-11597639 - - 37.3062 0 88.9145 OK 74.4396 51.287 97.5922 OK 0.546235 0 1.46443 OK TSS138 - - XLOC_000095 PTCHD2 TSS138 chr1:11539294-11597639 - - 12.3118 0 33.4266 OK 0 0 0 OK 7.55415e-05 0 0.868989 OK TSS139 - - XLOC_000096 FBXO44 TSS139 chr1:11708449-11723383 - - 0 0 0 OK 18.7336 0 40.385 OK 10.2274 0 59.6611 OK TSS14 - - XLOC_000017 PLEKHN1 TSS14 chr1:901876-910482 - - 6.18615 0.0532496 12.3191 OK 22.784 13.6492 31.9187 OK 59.3098 2.1237 116.496 OK TSS140 - - XLOC_000096 FBXO44 TSS140 chr1:11708449-11723383 - - 170.98 0 372.797 OK 540.251 395.085 685.417 OK 415.411 104.477 726.345 OK TSS141 - - XLOC_000097 FBXO6 TSS141 chr1:11724149-11734407 - - 77.8716 25.4534 130.29 OK 25.5712 17.1689 33.9736 OK 363.317 155.989 570.645 OK TSS142 - - XLOC_000098 C1orf187 TSS142 chr1:11751780-11780336 - - 200.894 86.0788 315.709 OK 340.257 276.998 403.517 OK 11.5677 0 24.207 OK TSS143 - - XLOC_000100 AGTRAP TSS143 chr1:11796141-11810827 - - 747.942 322.73 1173.15 OK 1610.7 1330.44 1890.96 OK 1911.82 997.619 2826.02 OK TSS144 - - XLOC_000101 C1orf167 TSS144 chr1:11824461-11826573 - - 4.69748 0 13.8934 OK 3.47934 0 8.39975 OK 1.86471 0 5.94749 OK TSS145 - - XLOC_000102 C1orf167 TSS145 chr1:11832138-11866115 - - 0 0 0 OK 2.18711 0 8.40798 OK 0 0 0 OK TSS146 - - XLOC_000102 C1orf167 TSS146 chr1:11832138-11866115 - - 1.75837 0 16.9438 OK 2.17987 0 13.4504 OK 8.96806 0 243.105 OK TSS147 - - XLOC_000103 CLCN6 TSS147 chr1:11866206-11907840 - - 149.528 0 374.495 OK 357.971 284.725 431.216 OK 569.35 0 1289.45 OK TSS148 - - XLOC_000103 - TSS148 chr1:11866206-11907840 - - 6.40643 0 43.9495 OK 8.28757 0 31.2298 OK 16.145 0 429.975 OK TSS149 - - XLOC_000104 PLOD1 TSS149 chr1:11994745-12035593 - - 865.542 534.969 1196.12 OK 956.552 824.968 1088.14 OK 10441.6 3993.52 16889.8 OK TSS15 - - XLOC_000018 ISG15 TSS15 chr1:948846-949915 - - 550.84 220.139 881.541 OK 987.18 798.765 1175.6 OK 3379.09 1852.53 4905.64 OK TSS150 - - XLOC_000105 MFN2 TSS150 chr1:12040237-12073571 - - 647.078 417.464 876.692 OK 942.066 826.307 1057.82 OK 2871.51 1538.86 4204.17 OK TSS151 - - XLOC_000106 MIIP TSS151 chr1:12079511-12092106 - - 504.143 253.799 754.486 OK 1223.51 1040.45 1406.58 OK 575.01 277.02 872.999 OK TSS152 - - XLOC_000107 TNFRSF8 TSS152 chr1:12123433-12204262 - - 197.882 92.4906 303.273 OK 431.964 364.319 499.61 OK 4.49636 0 11.7515 OK TSS153 - - XLOC_000107 TNFRSF8 TSS153 chr1:12123433-12204262 - - 6.44015 0 62.9259 OK 9.03791 0 24.7179 OK 4.00161 0 15.7775 OK TSS154 - - XLOC_000108 TNFRSF1B TSS154 chr1:12227059-12269276 - - 15.3506 4.48109 26.2201 OK 33.8648 24.5574 43.1722 OK 1395.94 778.496 2013.39 OK TSS155 - - XLOC_000109 VPS13D TSS155 chr1:12290112-12572096 - - 328.032 227.072 428.992 OK 71.9285 56.898 86.959 OK 191.792 34.7885 348.795 OK TSS156 - - XLOC_000109 VPS13D TSS156 chr1:12290112-12572096 - - 19.4784 0 51.136 OK 66.1936 50.8275 81.5597 OK 94.7776 0 253.886 OK TSS157 - - XLOC_000109 - TSS157 chr1:12290112-12572096 - - 39.9995 0 130.49 OK 0 0 0 OK 0 0 0 OK TSS158 - - XLOC_000109 - TSS158 chr1:12290112-12572096 - - 0 0 0 OK 20.135 6.13794 34.1321 OK 65.4483 0 177.134 OK TSS159 - - XLOC_000109 - TSS159 chr1:12290112-12572096 - - 0 0 0 OK 4.58204 0 13.0797 OK 2.38321 0 131.228 OK TSS16 - - XLOC_000019 AGRN TSS16 chr1:955502-991492 - - 162.844 89.8907 235.797 OK 1857.6 1668.93 2046.27 OK 2553.38 1302.85 3803.9 OK TSS160 - - XLOC_000111 AADACL4 TSS160 chr1:12704565-12727096 - - 0.911079 0 3.43339 OK 1.34969 0 3.25839 OK 0 0 0 OK TSS161 - - XLOC_000112 AADACL3 TSS161 chr1:12776117-12788726 - - 56.4313 19.1396 93.7229 OK 10.0548 6.24819 13.8614 OK 0 0 0 OK TSS162 - - XLOC_000113 C1orf158 TSS162 chr1:12806162-12821101 - - 1.78177 0 10.7617 OK 1.29047 0 5.61605 OK 0 0 0 OK TSS163 - - XLOC_000114 PRAMEF12 TSS163 chr1:12834983-12838046 - - 3.60576 0 8.25249 OK 0.853096 0 2.25332 OK 0 0 0 OK TSS164 - - XLOC_000115 PRAMEF1 TSS164 chr1:12851545-12856223 - - 1.07984 0 3.77465 OK 0 0 0 OK 0 0 0 OK TSS165 - - XLOC_000116 PRAMEF2 TSS165 chr1:12916940-12921764 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS166 - - XLOC_000117 PRAMEF8 TSS166 chr1:12976449-12980566 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS167 - - XLOC_000118 PRAMEF22 TSS167 chr1:12998301-13117751 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS168 - - XLOC_000119 PRAMEF6 TSS168 chr1:13359818-13369057 - - 0.310672 0 1.64522 OK 0 0 0 OK 0 0 0 OK TSS169 - - XLOC_000120 PRAMEF9 TSS169 chr1:13421175-13428191 - - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK TSS17 - - XLOC_000020 - TSS17 chr1:995082-1001833 - - 22.5944 1.03271 44.1561 OK 32.064 18.0485 46.0795 OK 70.3957 3.16407 137.627 OK TSS170 - - XLOC_000121 PRAMEF16 TSS170 chr1:13495253-13498257 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS171 - - XLOC_000122 PRAMEF20 TSS171 chr1:13516065-13526943 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS172 - - XLOC_000123 PRAMEF10 TSS172 chr1:13629937-13635298 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS173 - - XLOC_000124 PRAMEF9 TSS173 chr1:13641972-13648988 - - 0.137425 0 1.02292 OK 0 0 0 OK 0 0 0 OK TSS174 - - XLOC_000125 PRAMEF17 TSS174 chr1:13716087-13719064 - - 0 0 0 OK 0.330232 0 1.26905 OK 0 0 0 OK TSS175 - - XLOC_000126 PRAMEF20 TSS175 chr1:13736906-13747803 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS176 - - XLOC_000127 PDPN TSS176 chr1:13910251-13944450 - - 1297.74 772.49 1822.98 OK 1696.44 1489.13 1903.75 OK 111.012 34.7319 187.293 OK TSS177 - - XLOC_000127 PDPN TSS177 chr1:13910251-13944450 - - 0 0 0 OK 6.91549 0 28.1518 OK 0 0 0 OK TSS178 - - XLOC_000127 PDPN TSS178 chr1:13910251-13944450 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS179 - - XLOC_000128 PRDM2 TSS179 chr1:14026734-14151572 - - 0 0 0 OK 12.8679 0 26.1446 OK 27.8928 0 122.208 OK TSS18 - - XLOC_000021 - TSS18 chr1:1072396-1079432 - - 0 0 0 OK 1.64828 0 3.73103 OK 0 0 0 OK TSS180 - - XLOC_000128 PRDM2 TSS180 chr1:14026734-14151572 - - 62.0992 6.50308 117.695 OK 29.8078 17.6738 41.9417 OK 14.8538 0 45.2703 OK TSS181 - - XLOC_000128 PRDM2 TSS181 chr1:14026734-14151572 - - 0 0 0 OK 1.65694 0 10.3792 OK 0 0 0 OK TSS182 - - XLOC_000128 PRDM2 TSS182 chr1:14026734-14151572 - - 177.84 29.7289 325.95 OK 112.101 87.1248 137.076 OK 431.651 175.946 687.356 OK TSS183 - - XLOC_000129 - TSS183 chr1:14925212-15478960 - - 51.7288 10.5132 92.9443 OK 54.9232 35.0832 74.7633 OK 9.90288 0 73.175 OK TSS184 - - XLOC_000129 - TSS184 chr1:14925212-15478960 - - 1.99898 0 21.9495 OK 19.5662 6.88158 32.2509 OK 29.388 0 98.7243 OK TSS185 - - XLOC_000129 - TSS185 chr1:14925212-15478960 - - 0 0 0 OK 0 0 0 OK 13.2968 0 66.0987 OK TSS186 - - XLOC_000129 - TSS186 chr1:14925212-15478960 - - 5.70387 0 24.8579 OK 0 0 0 OK 205.94 0 452.786 OK TSS187 - - XLOC_000129 - TSS187 chr1:14925212-15478960 - - 0 0 0 OK 79.6627 55.0254 104.3 OK 208.608 0 479.942 OK TSS188 - - XLOC_000129 - TSS188 chr1:14925212-15478960 - - 7.67766 0 24.5275 OK 5.19027 0 11.3244 OK 10.0324 0 51.1545 OK TSS189 - - XLOC_000130 TMEM51 TSS189 chr1:15479027-15546973 - - 43.9133 0 112.474 OK 68.8214 40.0624 97.5803 OK 34.1487 0 116.359 OK TSS19 - - XLOC_000025 TTLL10 TSS19 chr1:1108435-1133313 - - 0 0 0 OK 9.72413 4.39939 15.0489 OK 0 0 0 OK TSS190 - - XLOC_000130 TMEM51 TSS190 chr1:15479027-15546973 - - 101.145 13.988 188.301 OK 163.558 121.066 206.049 OK 679.888 304.834 1054.94 OK TSS1906 - - XLOC_001217 - TSS1906 chr1:11873-29961 - - 0.0436773 0 7.35198 OK 347.213 219.116 475.309 OK 560.298 46.1225 1074.47 OK TSS1907 - - XLOC_001217 - TSS1907 chr1:11873-29961 - - 499.712 165.216 834.208 OK 95.223 47.2016 143.244 OK 76.652 0 231.392 OK TSS1908 - - XLOC_001217 - TSS1908 chr1:11873-29961 - - 108.765 0 264.527 OK 0 0 0 OK 0 0 0 OK TSS1909 - - XLOC_001217 - TSS1909 chr1:11873-29961 - - 261.042 0 668.761 OK 294.38 196.144 392.616 OK 313.868 0 738.883 OK TSS191 - - XLOC_000131 FHAD1 TSS191 chr1:15573767-15726776 - - 3.59181 0.183939 6.99968 OK 6.18974 3.93462 8.44486 OK 2.29329 0 5.69816 OK TSS1910 - - XLOC_001217 - TSS1910 chr1:11873-29961 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS1911 - - XLOC_001217 - TSS1911 chr1:11873-29961 - - 166.699 0 541.09 OK 224.306 102.258 346.353 OK 240.082 0 645.46 OK TSS1912 - - XLOC_001217 - TSS1912 chr1:11873-29961 - - 42.2462 0 222.067 OK 122.62 49.9311 195.309 OK 228.081 0 542.697 OK TSS1913 - - XLOC_001218 - TSS1913 chr1:34611-36081 - - 13.7184 1.56112 25.8757 OK 16.5503 8.50309 24.5975 OK 4.32826 0 10.5235 OK TSS1914 - - XLOC_001219 - TSS1914 chr1:89294-237877 - - 12.8434 0 40.4901 OK 2.45836 0 7.59087 OK 13.5604 0 28.5077 OK TSS1915 - - XLOC_001222 - TSS1915 chr1:661139-679736 - - 15.7705 0 91.3192 OK 18.7126 2.74613 34.6791 OK 1.6027 0 20.2923 OK TSS1916 - - XLOC_001222 - TSS1916 chr1:661139-679736 - - 161.143 20.1116 302.174 OK 297.645 236.943 358.346 OK 39.9694 4.47313 75.4657 OK TSS1917 - - XLOC_001222 - TSS1917 chr1:661139-679736 - - 266.451 0 619.729 OK 712.204 473.087 951.322 OK 68.2817 0 199.731 OK TSS1918 - - XLOC_001227 - TSS1918 chr1:700236-714006 - - 247.682 103.907 391.458 OK 235.71 185.668 285.751 OK 50.5377 9.42215 91.6533 OK TSS1919 - - XLOC_001229 FAM41C TSS1919 chr1:803452-812182 - - 17.3524 4.7668 29.9381 OK 2.1691 0 4.48622 OK 7.41126 0 14.9157 OK TSS192 - - XLOC_000131 FHAD1 TSS192 chr1:15573767-15726776 - - 2.21856 0 5.46644 OK 1.79489 0.20316 3.38662 OK 0.862567 0 3.90708 OK TSS1920 - - XLOC_001230 - TSS1920 chr1:852952-854817 - - 0 0 0 OK 4.38548 0 16.6636 OK 7.62477 0 20.6728 OK TSS1921 - - XLOC_001231 NOC2L TSS1921 chr1:860529-894679 - - 36.029 0 101.075 OK 100.448 56.5333 144.362 OK 55.7714 0 492.764 OK TSS1922 - - XLOC_001231 NOC2L TSS1922 chr1:860529-894679 - - 628.462 251.373 1005.55 OK 1734.7 1454.84 2014.57 OK 2164.3 710.538 3618.07 OK TSS1923 - - XLOC_001232 C1orf170 TSS1923 chr1:910578-917473 - - 9.49353 0 19.9648 OK 14.7182 7.08177 22.3546 OK 36.2061 3.03557 69.3766 OK TSS1924 - - XLOC_001232 C1orf170 TSS1924 chr1:910578-917473 - - 0 0 0 OK 0.517867 0 2.40899 OK 2.14049 0 8.01859 OK TSS1925 - - XLOC_001233 HES4 TSS1925 chr1:934341-935552 - - 54.1565 11.0853 97.2278 OK 37.4229 18.7755 56.0703 OK 33.6271 0 76.8424 OK TSS1926 - - XLOC_001234 - TSS1926 chr1:1017197-1051736 - - 0 0 0 OK 0 0 0 OK 6.02886 0 56.515 OK TSS1927 - - XLOC_001234 C1orf159 TSS1927 chr1:1017197-1051736 - - 26.1514 0 70.5989 OK 48.2129 23.9776 72.4482 OK 75.8125 0 225.197 OK TSS1928 - - XLOC_001234 C1orf159 TSS1928 chr1:1017197-1051736 - - 50.4508 0.525248 100.376 OK 91.6026 61.4046 121.8 OK 59.219 0 171.725 OK TSS1929 - - XLOC_001234 C1orf159 TSS1929 chr1:1017197-1051736 - - 18.8091 0 45.1259 OK 40.1782 19.8195 60.5369 OK 84.2776 0 186.892 OK TSS193 - - XLOC_000131 - TSS193 chr1:15573767-15726776 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS1930 - - XLOC_001235 - TSS1930 chr1:1108435-1133313 - - 0.346272 0 1.78395 OK 5.99833 3.26167 8.73498 OK 0 0 0 OK TSS1931 - - XLOC_001236 TNFRSF18 TSS1931 chr1:1138888-1142089 - - 2.09869 0 9.84106 OK 10.3558 0.808242 19.9033 OK 0 0 0 OK TSS1932 - - XLOC_001236 TNFRSF18 TSS1932 chr1:1138888-1142089 - - 1.73875 0 8.51254 OK 24.8393 13.5618 36.1167 OK 14.2699 0 28.7977 OK TSS1933 - - XLOC_001237 TNFRSF4 TSS1933 chr1:1146706-1149512 - - 1.29516 0 6.6725 OK 1.21775 0 2.94864 OK 5.89401 0 12.8778 OK TSS1934 - - XLOC_001238 SDF4 TSS1934 chr1:1152288-1167447 - - 60.6719 0 136.285 OK 105.623 62.8327 148.414 OK 71.6823 0 617.962 OK TSS1935 - - XLOC_001238 SDF4 TSS1935 chr1:1152288-1167447 - - 868.797 481.106 1256.49 OK 1497.29 1281.06 1713.53 OK 8958.96 4415.39 13502.5 OK TSS1936 - - XLOC_001238 SDF4 TSS1936 chr1:1152288-1167447 - - 32.4396 0 287.775 OK 210.708 62.714 358.702 OK 114.07 0 3312.32 OK TSS1937 - - XLOC_001239 FAM132A TSS1937 chr1:1177832-1182102 - - 17.131 3.00892 31.2531 OK 41.9198 28.3894 55.4503 OK 75.8216 10.8039 140.839 OK TSS1938 - - XLOC_001240 UBE2J2 TSS1938 chr1:1189293-1209234 - - 16.9893 0 75.1996 OK 15.5986 0 34.1698 OK 27.9153 0 219.894 OK TSS1939 - - XLOC_001240 UBE2J2 TSS1939 chr1:1189293-1209234 - - 480.97 230.406 731.534 OK 699.024 589.765 808.283 OK 1963.86 1043.43 2884.28 OK TSS194 - - XLOC_000131 FHAD1 TSS194 chr1:15573767-15726776 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS1940 - - XLOC_001242 ACAP3 TSS1940 chr1:1227763-1260046 - - 9.37264 0 74.2674 OK 139.601 71.7322 207.47 OK 101.369 0 437.866 OK TSS1941 - - XLOC_001242 ACAP3 TSS1941 chr1:1227763-1260046 - - 25.8307 0 74.8109 OK 113.499 67.0995 159.898 OK 86.9123 0 284.304 OK TSS1942 - - XLOC_001242 ACAP3 TSS1942 chr1:1227763-1260046 - - 93.257 0 191.075 OK 181.357 110.619 252.095 OK 810.457 116.624 1504.29 OK TSS1943 - - XLOC_001242 - TSS1943 chr1:1227763-1260046 - - 26.1554 0 127.888 OK 117.46 33.8827 201.038 OK 131.616 0 709.538 OK TSS1944 - - XLOC_001243 CPSF3L TSS1944 chr1:1227763-1260046 - - 79.6054 0 192.563 OK 94.0403 33.8728 154.208 OK 120.03 0 496.806 OK TSS1945 - - XLOC_001243 CPSF3L TSS1945 chr1:1227763-1260046 - - 857.443 305.167 1409.72 OK 2450.2 2055.32 2845.08 OK 2988.65 278.525 5698.77 OK TSS1946 - - XLOC_001244 DVL1,DVL1L1 TSS1946 chr1:1270658-1284492 - - 71.8385 0 192.647 OK 294.553 222.49 366.616 OK 302.198 0 761.412 OK TSS1947 - - XLOC_001244 DVL1 TSS1947 chr1:1270658-1284492 - - 173.57 60.0717 287.069 OK 674.206 553.931 794.481 OK 1267.03 652.486 1881.58 OK TSS1948 - - XLOC_001244 DVL1 TSS1948 chr1:1270658-1284492 - - 30.2667 0 67.9866 OK 193.963 141.571 246.356 OK 23.7193 0 116.238 OK TSS1949 - - XLOC_001245 MXRA8 TSS1949 chr1:1288071-1297157 - - 1077.16 552.946 1601.38 OK 134.781 97.3504 172.212 OK 14301.4 5983.8 22618.9 OK TSS195 - - XLOC_000131 FHAD1 TSS195 chr1:15573767-15726776 - - 0 0 0 OK 0.429055 0 2.04463 OK 0.572031 0 3.90272 OK TSS1950 - - XLOC_001245 MXRA8 TSS1950 chr1:1288071-1297157 - - 2.23252 0 130.782 OK 18.5375 6.65185 30.4231 OK 18.6477 0 1565.25 OK TSS1951 - - XLOC_001246 AURKAIP1 TSS1951 chr1:1309109-1310818 - - 1486.29 429.321 2543.26 OK 1941.94 1531.12 2352.75 OK 3221.31 986.215 5456.4 OK TSS1952 - - XLOC_001246 AURKAIP1 TSS1952 chr1:1309109-1310818 - - 360.213 0 1175.8 OK 836.594 580.702 1092.49 OK 1951.82 121.862 3781.78 OK TSS1953 - - XLOC_001246 AURKAIP1 TSS1953 chr1:1309109-1310818 - - 711.073 137.94 1284.21 OK 881.639 641.734 1121.54 OK 1861.17 403.947 3318.4 OK TSS1954 - - XLOC_001247 - TSS1954 chr1:1321090-1334718 - - 5.40934 0 86.6842 OK 15.222 0 38.1295 OK 6.77005 0 201.908 OK TSS1955 - - XLOC_001247 CCNL2 TSS1955 chr1:1321090-1334718 - - 114.444 3.14115 225.747 OK 110.19 65.2334 155.146 OK 134.515 0 345.352 OK TSS1956 - - XLOC_001247 CCNL2 TSS1956 chr1:1321090-1334718 - - 6.6959 0 89.1507 OK 107.558 0 261.608 OK 19.8352 0 209.547 OK TSS1957 - - XLOC_001247 CCNL2 TSS1957 chr1:1321090-1334718 - - 622.633 340.49 904.775 OK 1006.01 794.182 1217.83 OK 1112.52 425.241 1799.79 OK TSS1958 - - XLOC_001248 MRPL20 TSS1958 chr1:1334909-1342693 - - 3133.93 1763.88 4503.98 OK 4356.64 3676.16 5037.11 OK 8744.67 4664.17 12825.2 OK TSS1959 - - XLOC_001249 - TSS1959 chr1:1353801-1356650 - - 55.0852 10.8581 99.3122 OK 73.1639 49.0898 97.2379 OK 100.918 6.9754 194.861 OK TSS196 - - XLOC_000131 - TSS196 chr1:15573767-15726776 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS1960 - - XLOC_001250 C1orf70 TSS1960 chr1:1470158-1475740 - - 31.9981 5.39734 58.5989 OK 83.1162 61.5122 104.72 OK 233.834 79.2517 388.416 OK TSS1961 - - XLOC_001251 SSU72 TSS1961 chr1:1477053-1510262 - - 2379.43 1408.04 3350.83 OK 3413.53 2940.95 3886.1 OK 6671.18 3471.61 9870.75 OK TSS1962 - - XLOC_001252 CDC2L1 TSS1962 chr1:1571099-1677431 - - 33.8277 0 160.618 OK 205.562 59.0219 352.102 OK 286.25 0 1373.22 OK TSS1963 - - XLOC_001252 CDC2L1 TSS1963 chr1:1571099-1677431 - - 9.33823 0 135.943 OK 291.78 150.271 433.289 OK 366.787 0 1621.7 OK TSS1964 - - XLOC_001252 CDC2L1,CDC2L2 TSS1964 chr1:1571099-1677431 - - 117.815 0 509.053 OK 1203.07 569.027 1837.12 OK 1936.1 0 6583.6 OK TSS1965 - - XLOC_001252 CDC2L1 TSS1965 chr1:1571099-1677431 - - 76.2007 0 634.572 OK 816.237 0 2093.74 OK 795.035 0 20768.2 OK TSS1966 - - XLOC_001252 CDC2L2 TSS1966 chr1:1571099-1677431 - - 4.69427 0 168.13 OK 110.433 17.4495 203.416 OK 19.8478 0 1069.73 OK TSS1967 - - XLOC_001252 CDC2L2 TSS1967 chr1:1571099-1677431 - - 44.597 0 246.684 OK 244.477 109.73 379.223 OK 169.529 0 1853.26 OK TSS1968 - - XLOC_001252 CDC2L1,CDC2L2 TSS1968 chr1:1571099-1677431 - - 35.3518 0 888.891 OK 29.5615 0 171.59 OK 112.085 0 4105.43 OK TSS1969 - - XLOC_001253 CDC2L1 TSS1969 chr1:1571099-1677431 - - 81.9647 0 509.713 OK 251.238 0 684.019 OK 440.918 0 3485.7 OK TSS197 - - XLOC_000132 EFHD2 TSS197 chr1:15736390-15756839 - - 330.754 166.776 494.733 OK 468.604 391.665 545.542 OK 2197 1271.73 3122.27 OK TSS1970 - - XLOC_001254 SLC35E2 TSS1970 chr1:1571099-1677431 - - 122.675 0 264.856 OK 178.377 101.339 255.415 OK 315.575 0 1513.28 OK TSS1971 - - XLOC_001254 - TSS1971 chr1:1571099-1677431 - - 57.9127 0 130.206 OK 222.366 149.606 295.126 OK 276.724 0 723.736 OK TSS1972 - - XLOC_001254 SLC35E2 TSS1972 chr1:1571099-1677431 - - 210.369 0 470.956 OK 632.852 433.456 832.247 OK 762.008 0 2330.83 OK TSS1973 - - XLOC_001254 SLC35E2 TSS1973 chr1:1571099-1677431 - - 48.2599 0 223.438 OK 122.207 2.4671 241.946 OK 362.567 0 1875.37 OK TSS1974 - - XLOC_001256 NADK TSS1974 chr1:1682677-1711508 - - 10.1742 0 60.2712 OK 13.2843 0 31.0456 OK 1.85523 0 157.807 OK TSS1975 - - XLOC_001256 NADK TSS1975 chr1:1682677-1711508 - - 331.317 158.238 504.397 OK 510.173 410.355 609.992 OK 1204.38 703.991 1704.77 OK TSS1976 - - XLOC_001256 NADK TSS1976 chr1:1682677-1711508 - - 38.1873 0 144.248 OK 332.932 224.374 441.49 OK 0 0 0 OK TSS1977 - - XLOC_001256 NADK TSS1977 chr1:1682677-1711508 - - 46.8111 0 112.04 OK 91.3616 30.1322 152.591 OK 2.79122 0 112.776 OK TSS1978 - - XLOC_001256 NADK TSS1978 chr1:1682677-1711508 - - 57.4086 0 205.703 OK 210.14 107.373 312.907 OK 43.7417 0 310.979 OK TSS1979 - - XLOC_001257 GNB1 TSS1979 chr1:1716729-1822495 - - 4287.86 3261.64 5314.08 OK 4821.37 4333.38 5309.36 OK 16708.8 5900.45 27517.1 OK TSS198 - - XLOC_000133 CTRC TSS198 chr1:15764937-15773153 - - 2.23637 0 13.1824 OK 0 0 0 OK 5.61806 0 14.0003 OK TSS1980 - - XLOC_001258 TMEM52 TSS1980 chr1:1849028-1850740 - - 78.6765 14.1773 143.176 OK 212.131 156.646 267.616 OK 0 0 0 OK TSS1981 - - XLOC_001258 TMEM52 TSS1981 chr1:1849028-1850740 - - 23.4913 0 76.1659 OK 79.5862 37.1237 122.049 OK 23.4115 2.02793 44.795 OK TSS1982 - - XLOC_001259 C1orf222 TSS1982 chr1:1853396-1859368 - - 0 0 0 OK 2.02001 0 4.61222 OK 0 0 0 OK TSS1983 - - XLOC_001259 C1orf222 TSS1983 chr1:1853396-1859368 - - 0 0 0 OK 1.04698 0 2.82985 OK 0 0 0 OK TSS1984 - - XLOC_001260 KIAA1751 TSS1984 chr1:1884751-1935276 - - 1.22859 0 4.60047 OK 0.932315 0.00687002 1.85776 OK 0 0 0 OK TSS1985 - - XLOC_001260 KIAA1751 TSS1985 chr1:1884751-1935276 - - 0.437707 0 2.45861 OK 0 0 0 OK 0 0 0 OK TSS1986 - - XLOC_001261 - TSS1986 chr1:1944651-1946969 - - 4.28982 0 9.13831 OK 8.18597 4.02555 12.3464 OK 0 0 0 OK TSS1987 - - XLOC_001262 - TSS1987 chr1:1981908-2139172 - - 13.1667 0 127.959 OK 33.574 0 81.1922 OK 27.1259 0 228.561 OK TSS1988 - - XLOC_001263 C1orf86 TSS1988 chr1:1981908-2139172 - - 419.525 22.256 816.794 OK 1848.73 1401.4 2296.06 OK 2769.72 1257.84 4281.61 OK TSS1989 - - XLOC_001263 - TSS1989 chr1:1981908-2139172 - - 6.98486 0 67.3153 OK 25.7926 0 54.4134 OK 78.7015 0 223.633 OK TSS199 - - XLOC_000134 CELA2A TSS199 chr1:15783222-15798585 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS1990 - - XLOC_001264 MORN1 TSS1990 chr1:2252695-2322993 - - 54.986 0 123.624 OK 109.55 49.7037 169.396 OK 102.498 0 228.358 OK TSS1991 - - XLOC_001266 PEX10 TSS1991 chr1:2323213-2344010 - - 290.341 47.1703 533.511 OK 461.866 340.617 583.116 OK 917.336 0 2344.9 OK TSS1992 - - XLOC_001267 PANK4 TSS1992 chr1:2439974-2458035 - - 174.785 79.7438 269.827 OK 361.252 300.101 422.403 OK 500.991 263.612 738.37 OK TSS1993 - - XLOC_001268 HES5 TSS1993 chr1:2460184-2461684 - - 6.35744 0 13.7346 OK 2.94754 0 6.09621 OK 0 0 0 OK TSS1994 - - XLOC_001269 - TSS1994 chr1:2481358-2495265 - - 0.907232 0 5.69552 OK 0.475004 0 2.07964 OK 6.38716 0 37.2825 OK TSS1995 - - XLOC_001269 - TSS1995 chr1:2481358-2495265 - - 1.10294 0 5.46926 OK 0.649192 0 1.67207 OK 9.83614 0 57.7644 OK TSS1996 - - XLOC_001270 MMEL1 TSS1996 chr1:2518248-2564481 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS1997 - - XLOC_001270 MMEL1 TSS1997 chr1:2518248-2564481 - - 0.931281 0 9.82019 OK 12.7571 0 28.6315 OK 3.38316 0 110.889 OK TSS1998 - - XLOC_001271 - TSS1998 chr1:2976182-2980350 - - 0.620738 0 2.33924 OK 0 0 0 OK 0.336145 0 1.20775 OK TSS1999 - - XLOC_001272 - TSS1999 chr1:2980635-2984289 - - 0 0 0 OK 0 0 0 OK 9.74659 0 22.4902 OK TSS2 - - XLOC_000005 - TSS2 chr1:322036-328580 - - 189.247 43.7707 334.723 OK 358.383 249.161 467.605 OK 29.2848 0 64.2647 OK TSS20 - - XLOC_000025 TTLL10 TSS20 chr1:1108435-1133313 - - 0 0 0 OK 6.97279 2.01336 11.9322 OK 0 0 0 OK TSS200 - - XLOC_000135 CELA2B TSS200 chr1:15802595-15851384 - - 0 0 0 OK 1.27477 0 8.01985 OK 0 0 0 OK TSS2000 - - XLOC_001273 MEGF6 TSS2000 chr1:3404512-3528059 - - 69.8392 15.621 124.058 OK 41.8309 24.9788 58.6829 OK 92.849 29.832 155.866 OK TSS2001 - - XLOC_001273 MEGF6 TSS2001 chr1:3404512-3528059 - - 43.7292 5.09832 82.36 OK 177.762 147.458 208.065 OK 64.5702 7.50835 121.632 OK TSS2002 - - XLOC_001274 WDR8 TSS2002 chr1:3547331-3566671 - - 264.765 95.8022 433.729 OK 597.841 477.064 718.617 OK 520.346 202.296 838.397 OK TSS2003 - - XLOC_001275 - TSS2003 chr1:3652549-3663886 - - 0 0 0 OK 11.3698 0 27.9975 OK 30.0855 0 101.367 OK TSS2004 - - XLOC_001275 KIAA0495 TSS2004 chr1:3652549-3663886 - - 201.581 112.658 290.504 OK 422.204 363.725 480.683 OK 227.555 119.154 335.957 OK TSS2005 - - XLOC_001276 LRRC47 TSS2005 chr1:3696783-3713068 - - 867.894 535.552 1200.24 OK 1345.43 1168.58 1522.28 OK 1410.28 820.996 1999.56 OK TSS2006 - - XLOC_001277 KIAA0562 TSS2006 chr1:3728644-3773797 - - 266.214 98.7958 433.631 OK 182.207 144.327 220.086 OK 568.38 225.872 910.888 OK TSS2007 - - XLOC_001278 C1orf174 TSS2007 chr1:3805702-3816857 - - 489.179 236.635 741.722 OK 551.063 456.161 645.964 OK 1182.73 643.67 1721.78 OK TSS2008 - - XLOC_001279 - TSS2008 chr1:5621768-5728315 - - 0 0 0 OK 0.669469 0 2.5727 OK 0 0 0 OK TSS2009 - - XLOC_001280 NPHP4 TSS2009 chr1:5922869-6052531 - - 47.7688 13.3524 82.1852 OK 153.438 122.296 184.581 OK 102.752 37.5449 167.958 OK TSS201 - - XLOC_000136 DNAJC16 TSS201 chr1:15853351-15918872 - - 464.958 267.954 661.962 OK 153.207 123.082 183.332 OK 376.455 179.931 572.979 OK TSS2010 - - XLOC_001280 NPHP4 TSS2010 chr1:5922869-6052531 - - 12.3891 0 31.8145 OK 32.7056 18.2592 47.1519 OK 8.76607 0 28.8702 OK TSS2011 - - XLOC_001280 - TSS2011 chr1:5922869-6052531 - - 1.34942 0 12.2253 OK 5.2451 0 20.9799 OK 3.61882 0 90.8012 OK TSS2012 - - XLOC_001281 CHD5 TSS2012 chr1:6161852-6240183 - - 0 0 0 OK 3.24653 0.180409 6.31265 OK 2.58654 0 6.09219 OK TSS2013 - - XLOC_001281 - TSS2013 chr1:6161852-6240183 - - 3.69165 0 10.4053 OK 0.766551 0 2.46407 OK 0.873718 0 3.28683 OK TSS2014 - - XLOC_001281 CHD5 TSS2014 chr1:6161852-6240183 - - 6.8891 0.168879 13.6093 OK 13.8631 9.7945 17.9318 OK 0.611774 0 2.53731 OK TSS2015 - - XLOC_001281 - TSS2015 chr1:6161852-6240183 - - 3.73417 0 15.8629 OK 4.78329 0 9.93525 OK 0 0 0 OK TSS2016 - - XLOC_001281 - TSS2016 chr1:6161852-6240183 - - 0.120394 0 2.51404 OK 5.03226 0 12.1064 OK 0 0 0 OK TSS2017 - - XLOC_001282 RPL22 TSS2017 chr1:6245080-6259679 - - 2431.44 1591.39 3271.5 OK 4375.01 3886.91 4863.12 OK 9875.13 4870.71 14879.6 OK TSS2018 - - XLOC_001283 ICMT TSS2018 chr1:6266188-6296044 - - 1479.52 1045.7 1913.34 OK 1334.15 1171.21 1497.09 OK 2608.03 1399.2 3816.86 OK TSS2019 - - XLOC_001284 GPR153 TSS2019 chr1:6307413-6321035 - - 37.8293 0 81.4618 OK 97.14 67.2326 127.047 OK 268.364 48.4351 488.292 OK TSS202 - - XLOC_000136 - TSS202 chr1:15853351-15918872 - - 6.69281 0 73.9549 OK 1.81648 0 7.31877 OK 2.11882 0 91.0102 OK TSS2020 - - XLOC_001285 ACOT7 TSS2020 chr1:6324332-6453826 - - 239.832 0 481.175 OK 1356.8 1067.01 1646.59 FAIL 2679.84 926.627 4433.06 FAIL TSS2021 - - XLOC_001285 ACOT7 TSS2021 chr1:6324332-6453826 - - 0 0 0 OK 0 0 0 FAIL 39.0287 0 609.432 FAIL TSS2022 - - XLOC_001285 ACOT7 TSS2022 chr1:6324332-6453826 - - 126.845 0 296.16 OK 93.6803 17.9687 169.392 FAIL 110.585 0 588.532 FAIL TSS2023 - - XLOC_001285 ACOT7 TSS2023 chr1:6324332-6453826 - - 462.887 122.773 803 OK 1047.97 778.058 1317.89 FAIL 732.481 0 2348.44 FAIL TSS2024 - - XLOC_001285 ACOT7 TSS2024 chr1:6324332-6453826 - - 134.974 0 285.391 OK 1060.75 839.25 1282.25 FAIL 1033.82 0 2413.86 FAIL TSS2025 - - XLOC_001286 HES2 TSS2025 chr1:6472499-6484730 - - 0 0 0 OK 2.2157 0 5.31734 OK 0.48661 0 2.81936 OK TSS2026 - - XLOC_001286 HES2 TSS2026 chr1:6472499-6484730 - - 5.92301 1.46722 10.3788 OK 6.44393 3.96808 8.91978 OK 1.41752 0 3.11887 OK TSS2027 - - XLOC_001287 TNFRSF25 TSS2027 chr1:6521220-6580069 - - 50.6435 0 192.723 OK 332.126 219.276 444.976 OK 24.4669 0 158.69 OK TSS2028 - - XLOC_001287 PLEKHG5 TSS2028 chr1:6521220-6580069 - - 12.7468 0 49.9051 OK 35.8901 13.1062 58.674 OK 1.74109 0 24.1775 OK TSS2029 - - XLOC_001287 PLEKHG5 TSS2029 chr1:6521220-6580069 - - 2.06233 0 21.2378 OK 38.9511 19.3035 58.5986 OK 2.5797 0 17.2003 OK TSS203 - - XLOC_000137 DDI2 TSS203 chr1:15944069-15988216 - - 484.832 168.824 800.841 OK 270.688 203.935 337.441 OK 311.27 73.8798 548.659 OK TSS2030 - - XLOC_001287 PLEKHG5 TSS2030 chr1:6521220-6580069 - - 14.2602 0 44.3271 OK 62.1096 36.3441 87.8751 OK 0 0 0 OK TSS2031 - - XLOC_001287 PLEKHG5 TSS2031 chr1:6521220-6580069 - - 0 0 0 OK 73.921 39.464 108.378 OK 0 0 0 OK TSS2032 - - XLOC_001287 PLEKHG5 TSS2032 chr1:6521220-6580069 - - 17.5992 0 45.307 OK 43.3127 11.3454 75.2799 OK 34.905 0.568263 69.2418 OK TSS2033 - - XLOC_001287 PLEKHG5 TSS2033 chr1:6521220-6580069 - - 25.7562 0 57.6831 OK 4.59064 0 18.3624 OK 0.024414 0 0.923507 OK TSS2034 - - XLOC_001287 PLEKHG5 TSS2034 chr1:6521220-6580069 - - 0 0 0 OK 9.71361 0 28.5646 OK 0 0 0 OK TSS2035 - - XLOC_001287 PLEKHG5 TSS2035 chr1:6521220-6580069 - - 0.00544137 0 1.06121 OK 51.9914 27.3208 76.662 OK 18.3016 0 42.6962 OK TSS2036 - - XLOC_001287 PLEKHG5 TSS2036 chr1:6521220-6580069 - - 14.4826 0 39.4641 OK 6.79791 0 17.0916 OK 3.95345 0 19.7523 OK TSS2037 - - XLOC_001287 - TSS2037 chr1:6521220-6580069 - - 30.5163 0 105.072 OK 77.8501 24.5101 131.19 OK 12.5671 0 61.8728 OK TSS2038 - - XLOC_001288 NOL9 TSS2038 chr1:6585209-6614581 - - 503.823 285.234 722.412 OK 189.708 153.676 225.74 OK 363.843 173.395 554.291 OK TSS2039 - - XLOC_001289 KLHL21 TSS2039 chr1:6650778-6662929 - - 109.476 28.7693 190.182 OK 216.693 170.648 262.738 OK 455.331 0 963.137 OK TSS204 - - XLOC_000137 DDI2 TSS204 chr1:15944069-15988216 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2040 - - XLOC_001289 KLHL21 TSS2040 chr1:6650778-6662929 - - 134.239 0 277.918 OK 151.442 108.192 194.693 OK 601.611 0 1210.3 OK TSS2041 - - XLOC_001290 DNAJC11 TSS2041 chr1:6684924-6761966 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2042 - - XLOC_001290 DNAJC11 TSS2042 chr1:6684924-6761966 - - 743.808 449.589 1038.03 OK 1372.27 1195.02 1549.51 OK 1731.39 922.337 2540.44 OK TSS2043 - - XLOC_001291 UTS2 TSS2043 chr1:7844379-7973294 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2044 - - XLOC_001291 UTS2 TSS2044 chr1:7844379-7973294 - - 2.40953 0 40.4693 OK 0.950535 0 7.59851 OK 0 0 0 OK TSS2045 - - XLOC_001291 UTS2 TSS2045 chr1:7844379-7973294 - - 0.0400905 0 10.1271 OK 0 0 0 OK 0 0 0 OK TSS2046 - - XLOC_001292 TNFRSF9 TSS2046 chr1:7979907-8000887 - - 0 0 0 OK 0.267901 0 1.02951 OK 1.38187 0 3.32436 OK TSS2047 - - XLOC_001293 ERRFI1 TSS2047 chr1:8071779-8086393 - - 641.313 371.667 910.958 OK 442.172 371.365 512.98 OK 2240.53 1261.49 3219.56 OK TSS2048 - - XLOC_001293 ERRFI1 TSS2048 chr1:8071779-8086393 - - 137.346 0 301.849 OK 21.342 0.261651 42.4224 OK 71.1003 0 385.659 OK TSS2049 - - XLOC_001294 RERE TSS2049 chr1:8412465-8877699 - - 1.40725 0 34.3439 OK 320.719 249.022 392.416 OK 1692.19 822.22 2562.16 OK TSS205 - - XLOC_000139 PLEKHM2 TSS205 chr1:16010826-16061262 - - 363.264 206.673 519.855 OK 779.207 675.262 883.152 OK 2346.33 1341.89 3350.77 OK TSS2050 - - XLOC_001294 RERE TSS2050 chr1:8412465-8877699 - - 186.982 103.076 270.889 OK 662.61 571.167 754.054 OK 278.541 0 970.246 OK TSS2051 - - XLOC_001294 RERE TSS2051 chr1:8412465-8877699 - - 0 0 0 OK 0 0 0 OK 47.6257 0 611.766 OK TSS2052 - - XLOC_001294 - TSS2052 chr1:8412465-8877699 - - 85.8783 0 199.024 OK 3.82252 0 23.5895 OK 6.13498 0 577.522 OK TSS2053 - - XLOC_001296 ENO1 TSS2053 chr1:8921062-8938780 - - 444.441 0 984.339 OK 211.161 0 439.419 OK 181.074 0 4449.48 OK TSS2054 - - XLOC_001296 ENO1 TSS2054 chr1:8921062-8938780 - - 21997.3 17904.2 26090.4 OK 52429.9 48506.8 56352.9 OK 71451.4 38444.4 104458 OK TSS2055 - - XLOC_001297 SLC2A7 TSS2055 chr1:9063358-9086404 - - 0 0 0 OK 0.358204 0 1.3662 OK 0.725244 0 2.31316 OK TSS2056 - - XLOC_001298 SLC2A5 TSS2056 chr1:9097006-9148510 - - 0 0 0 OK 0.000167835 0 1.02064 OK 7.16648 0 55.0592 OK TSS2057 - - XLOC_001298 SLC2A5 TSS2057 chr1:9097006-9148510 - - 2.34161 0 8.86464 OK 2.90964 0.310704 5.50857 OK 4.17775 0 161.314 OK TSS2058 - - XLOC_001298 SLC2A5 TSS2058 chr1:9097006-9148510 - - 0.00429204 0 2.1455 OK 0 0 0 OK 51.3731 0 120.886 OK TSS2059 - - XLOC_001298 SLC2A5 TSS2059 chr1:9097006-9148510 - - 3.56432 0 7.89466 OK 0 0 0 OK 61.3688 0 152.307 OK TSS206 - - XLOC_000140 SLC25A34 TSS206 chr1:16062808-16067885 - - 6.39779 0.605227 12.1903 OK 8.64356 5.26239 12.0247 OK 9.3373 0 19.2115 OK TSS2060 - - XLOC_001299 GPR157 TSS2060 chr1:9164475-9189356 - - 27.3747 0 64.5617 OK 57.8343 37.3002 78.3683 OK 98.5546 2.9359 194.173 OK TSS2061 - - XLOC_001300 - TSS2061 chr1:9208346-9242451 - - 95.9263 41.8317 150.021 OK 212.722 175.801 249.643 OK 69.3907 24.6136 114.168 OK TSS2062 - - XLOC_001301 C1orf200 TSS2062 chr1:9711789-9884550 - - 0 0 0 OK 0.589835 0 7.29737 OK 0 0 0 OK TSS2063 - - XLOC_001302 - TSS2063 chr1:9711789-9884550 - - 86.8241 0 296.064 OK 230.865 41.3861 420.343 OK 61.7832 0 735.129 OK TSS2064 - - XLOC_001303 - TSS2064 chr1:9711789-9884550 - - 3.82816 0 142.417 OK 145.676 47.7779 243.573 OK 695.497 0 3185.75 OK TSS2065 - - XLOC_001303 CLSTN1 TSS2065 chr1:9711789-9884550 - - 474.526 267.278 681.774 OK 1584.55 1382.42 1786.68 OK 4148.55 1783.16 6513.93 OK TSS2066 - - XLOC_001304 CTNNBIP1 TSS2066 chr1:9908333-9970316 - - 479.396 234.429 724.362 OK 655.696 562.205 749.188 OK 509.797 250.642 768.951 OK TSS2067 - - XLOC_001305 LZIC TSS2067 chr1:9989777-10003427 - - 14.1134 0 70.9786 OK 3.50582 0 12.2378 OK 7.08002 0 145.74 OK TSS2068 - - XLOC_001305 LZIC TSS2068 chr1:9989777-10003427 - - 307.377 118.888 495.866 OK 194.222 147.269 241.175 OK 1015.04 520.786 1509.29 OK TSS2069 - - XLOC_001306 DFFA TSS2069 chr1:10520604-10532613 - - 783.778 429.622 1137.93 OK 1126.41 964.355 1288.47 OK 1164.65 615.282 1714.02 OK TSS207 - - XLOC_000140 - TSS207 chr1:16062808-16067885 - - 2.07297 0 8.32109 OK 0.000570561 0 1.20321 OK 4.66039 0 17.5192 OK TSS2070 - - XLOC_001307 CASZ1 TSS2070 chr1:10696667-10856707 - - 9.93113 0 24.3274 OK 58.8654 42.2362 75.4945 OK 1.99903 0 6.51248 OK TSS2071 - - XLOC_001307 CASZ1 TSS2071 chr1:10696667-10856707 - - 8.95125 0 23.0557 OK 49.2697 30.8745 67.6649 OK 6.07219 0 13.3662 OK TSS2072 - - XLOC_001307 - TSS2072 chr1:10696667-10856707 - - 2.07597 0 17.4301 OK 1.40186 0 5.909 OK 0 0 0 OK TSS2073 - - XLOC_001308 C1orf127 TSS2073 chr1:11006532-11024258 - - 1.66867 0 5.63544 OK 4.3281 1.40188 7.25432 OK 0.333513 0 1.91009 OK TSS2074 - - XLOC_001309 MASP2 TSS2074 chr1:11086580-11107285 - - 75.0649 23.5982 126.532 OK 57.5421 41.0203 74.064 OK 15.0124 2.22666 27.7982 OK TSS2075 - - XLOC_001310 SRM TSS2075 chr1:11114648-11120091 - - 1171.02 417.682 1924.36 OK 432.981 192.938 673.023 OK 3003.63 0 6336.11 OK TSS2076 - - XLOC_001310 SRM TSS2076 chr1:11114648-11120091 - - 1002.98 383.446 1622.51 OK 4481.12 3922.01 5040.24 OK 7820.85 3902.21 11739.5 OK TSS2077 - - XLOC_001311 EXOSC10 TSS2077 chr1:11126677-11159938 - - 1430.05 942.742 1917.36 OK 1348.42 1167.79 1529.05 OK 1642.04 925.011 2359.07 OK TSS2078 - - XLOC_001312 - TSS2078 chr1:11166588-11322608 - - 59.0429 0 147.043 OK 135.175 73.202 197.149 OK 170.948 0 412.495 OK TSS2079 - - XLOC_001312 MTOR TSS2079 chr1:11166588-11322608 - - 578.796 399.141 758.451 OK 892.477 790.031 994.924 OK 636.873 351.515 922.231 OK TSS208 - - XLOC_000141 TMEM82 TSS208 chr1:16068916-16074475 - - 11.5611 1.91174 21.2104 OK 31.4534 22.0675 40.8392 OK 0 0 0 OK TSS2080 - - XLOC_001313 FBXO2 TSS2080 chr1:11708449-11723383 - - 302.813 84.8574 520.768 OK 1495.38 1246.72 1744.05 OK 72.9584 0 190.995 OK TSS2081 - - XLOC_001313 FBXO2 TSS2081 chr1:11708449-11723383 - - 5.94962 0 126.235 OK 4.06337 0 38.0406 OK 0 0 0 OK TSS2082 - - XLOC_001314 MAD2L2 TSS2082 chr1:11734537-11751678 - - 4485.74 3057.88 5913.6 OK 6757.57 5967.93 7547.22 OK 2368.21 1365.35 3371.08 OK TSS2083 - - XLOC_001315 MTHFR TSS2083 chr1:11832138-11866115 - - 12.2816 0 32.9022 OK 64.418 46.6473 82.1887 OK 263.856 79.0046 448.707 OK TSS2084 - - XLOC_001315 MTHFR TSS2084 chr1:11832138-11866115 - - 98.8766 45.0748 152.678 OK 93.2442 71.8689 114.62 OK 277.975 102.778 453.172 OK TSS2085 - - XLOC_001315 MTHFR TSS2085 chr1:11832138-11866115 - - 66.9034 0 176.825 OK 27.4533 0 55.8914 OK 108.763 0 395.992 OK TSS2086 - - XLOC_001316 NPPA TSS2086 chr1:11866206-11907840 - - 3.4039 0 32.5388 OK 10.2838 0 34.928 OK 18.088 0 138.237 OK TSS2087 - - XLOC_001317 NPPB TSS2087 chr1:11917521-11918992 - - 770.486 289.163 1251.81 OK 7.22153 0 14.4521 OK 0 0 0 OK TSS2088 - - XLOC_001318 KIAA2013 TSS2088 chr1:11980123-11986480 - - 673.993 327.238 1020.75 OK 754.447 632.031 876.864 OK 1443.8 737.85 2149.75 OK TSS2089 - - XLOC_001319 DHRS3 TSS2089 chr1:12627939-12677820 - - 664.349 249.834 1078.86 OK 334.324 242.248 426.4 OK 292.677 22.1621 563.193 OK TSS209 - - XLOC_000142 FBLIM1 TSS209 chr1:16083153-16114431 - - 17.9129 0 73.0066 OK 28.622 0 60.497 OK 72.561 0 525.317 OK TSS2090 - - XLOC_001319 DHRS3 TSS2090 chr1:12627939-12677820 - - 695.323 280.489 1110.16 OK 341.518 256.118 426.919 OK 459.21 98.5156 819.904 OK TSS2091 - - XLOC_001319 DHRS3 TSS2091 chr1:12627939-12677820 - - 17.2087 0 278.548 OK 0 0 0 OK 67.1677 0 2691.35 OK TSS2092 - - XLOC_001320 PRAMEF11 TSS2092 chr1:12884467-12891264 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2093 - - XLOC_001321 HNRNPCL1 TSS2093 chr1:12907235-12908578 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2094 - - XLOC_001322 PRAMEF4 TSS2094 chr1:12939032-12946025 - - 0.174144 0 1.17777 OK 0 0 0 OK 0 0 0 OK TSS2095 - - XLOC_001323 PRAMEF10 TSS2095 chr1:12952727-12958094 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2096 - - XLOC_001324 PRAMEF6 TSS2096 chr1:12998301-13117751 - - 0.337687 0 3.45331 OK 0 0 0 OK 0 0 0 OK TSS2097 - - XLOC_001324 PRAMEF5 TSS2097 chr1:12998301-13117751 - - 0.334659 0 4.54779 OK 0 0 0 OK 0 0 0 OK TSS2098 - - XLOC_001326 PRAMEF22 TSS2098 chr1:13328195-13331692 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2099 - - XLOC_001327 PRAMEF8 TSS2099 chr1:13386648-13390765 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS21 - - XLOC_000027 SCNN1D TSS21 chr1:1215815-1227409 - - 8.76366 2.09562 15.4317 OK 14.5016 5.45372 23.5494 OK 29.2958 0 61.3882 OK TSS210 - - XLOC_000142 FBLIM1 TSS210 chr1:16083153-16114431 - - 565.849 311.457 820.241 OK 821.848 703.206 940.49 OK 2026.56 926.491 3126.63 OK TSS2100 - - XLOC_001327 PRAMEF8 TSS2100 chr1:13386648-13390765 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2101 - - XLOC_001328 PRAMEF13,PRAMEF14 TSS2101 chr1:13447413-13452656 - - 0.200934 0 3.68442 OK 0 0 0 OK 0 0 0 OK TSS2102 - - XLOC_001329 PRAMEF18 TSS2102 chr1:13474052-13477569 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2103 - - XLOC_001330 PRAMEF8 TSS2103 chr1:13607430-13611550 - - 0.694912 0 2.69739 OK 0 0 0 OK 0 0 0 OK TSS2104 - - XLOC_001331 PRAMEF14 TSS2104 chr1:13668268-13673511 - - 0.803811 0 2.80977 OK 0 0 0 OK 0 0 0 OK TSS2105 - - XLOC_001332 PRAMEF18 TSS2105 chr1:13694888-13698405 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2106 - - XLOC_001333 LRRC38 TSS2106 chr1:13801446-13840242 - - 6.96034 0.720957 13.1997 OK 8.16584 3.94913 12.3826 OK 0 0 0 OK TSS2107 - - XLOC_001334 C1orf126 TSS2107 chr1:14925212-15478960 - - 8.04305 0 20.7783 OK 9.25388 3.6012 14.9066 OK 0.859289 0 31.1292 OK TSS2108 - - XLOC_001335 - TSS2108 chr1:15573767-15726776 - - 0.432797 0 2.09139 OK 3.71564 1.40094 6.03034 OK 2.62025 0 6.72752 OK TSS2109 - - XLOC_001336 CASP9 TSS2109 chr1:15802595-15851384 - - 220.689 39.7029 401.674 OK 380.234 296.128 464.34 OK 207.808 33.3212 382.296 OK TSS211 - - XLOC_000142 FBLIM1 TSS211 chr1:16083153-16114431 - - 311.44 20.0304 602.849 OK 109.011 52.5396 165.482 OK 344.875 0 1182.2 OK TSS2110 - - XLOC_001336 CASP9 TSS2110 chr1:15802595-15851384 - - 0 0 0 OK 0 0 0 OK 29.4638 0 102.482 OK TSS2111 - - XLOC_001336 CASP9 TSS2111 chr1:15802595-15851384 - - 173.37 18.8501 327.89 OK 51.7979 20.3228 83.2729 OK 51.1746 0 127.107 OK TSS2112 - - XLOC_001337 AGMAT TSS2112 chr1:15853351-15918872 - - 122.09 0 265.635 OK 115.866 75.573 156.159 OK 43.2083 0 137.727 OK TSS2113 - - XLOC_001339 - TSS2113 chr1:16160709-16266950 - - 68.8094 0 163.282 OK 58.2932 18.0093 98.5771 OK 39.9858 0 168.854 OK TSS2114 - - XLOC_001340 ZBTB17 TSS2114 chr1:16268365-16302627 - - 179.279 36.1088 322.448 OK 335.879 265.104 406.653 OK 666.365 288.276 1044.45 OK TSS2115 - - XLOC_001342 HSPB7 TSS2115 chr1:16340522-16400127 - - 121.023 18.117 223.929 OK 3.62862 0 8.34379 OK 339.016 53.5817 624.45 OK TSS2116 - - XLOC_001342 HSPB7 TSS2116 chr1:16340522-16400127 - - 71.8733 0 160.429 OK 3.46957 0 8.17261 OK 397.66 55.8486 739.472 OK TSS2117 - - XLOC_001343 FAM131C TSS2117 chr1:16340522-16400127 - - 13.6398 0 196.505 OK 25.9588 7.90771 44.0099 OK 46.4136 0 383.774 OK TSS2118 - - XLOC_001344 EPHA2 TSS2118 chr1:16450831-16482564 - - 257.159 89.2372 425.081 OK 575.636 490.312 660.96 OK 923.073 511.47 1334.68 OK TSS2119 - - XLOC_001345 ARHGEF19 TSS2119 chr1:16524598-16539104 - - 17.0126 0 57.3312 OK 324.019 226.134 421.903 OK 170.844 67.5142 274.174 OK TSS212 - - XLOC_000143 SPEN TSS212 chr1:16160709-16266950 - - 145.636 81.7357 209.536 OK 241.251 184.702 297.8 OK 293.864 120.858 466.87 OK TSS2120 - - XLOC_001345 ARHGEF19 TSS2120 chr1:16524598-16539104 - - 156.261 66.9287 245.594 OK 678.385 568.95 787.821 OK 8.10745 0 31.0825 OK TSS2121 - - XLOC_001346 C1orf89 TSS2121 chr1:16558182-16563659 - - 28.2148 8.31912 48.1105 OK 53.4824 39.5802 67.3846 OK 182.341 64.6878 299.993 OK TSS2122 - - XLOC_001347 FBXO42 TSS2122 chr1:16576559-16678948 - - 22.2988 0 92.2622 OK 2.24339 0 10.5925 OK 15.5838 0 89.1198 OK TSS2123 - - XLOC_001347 FBXO42 TSS2123 chr1:16576559-16678948 - - 11.178 0 57.7157 OK 8.45144 0 18.9118 OK 30.8971 0 157.892 OK TSS2124 - - XLOC_001347 FBXO42 TSS2124 chr1:16576559-16678948 - - 292.804 138.52 447.089 OK 256.568 210.379 302.757 OK 533.075 280.508 785.642 OK TSS2125 - - XLOC_001347 - TSS2125 chr1:16576559-16678948 - - 27.075 0 81.0616 OK 0.999115 0 3.93364 OK 0 0 0 OK TSS2126 - - XLOC_001348 SPATA21 TSS2126 chr1:16693582-16763919 - - 1.25463 0 18.4322 OK 0 0 0 OK 0.168084 0 13.948 OK TSS2127 - - XLOC_001349 - TSS2127 chr1:16793930-16819196 - - 39.2853 14.5125 64.058 OK 48.5164 36.7903 60.2425 OK 16.8693 2.15158 31.587 OK TSS2128 - - XLOC_001349 - TSS2128 chr1:16793930-16819196 - - 0 0 0 OK 76.9358 17.4498 136.422 OK 33.8911 0 119.733 OK TSS2129 - - XLOC_001349 - TSS2129 chr1:16793930-16819196 - - 7.75221 0 53.3814 OK 47.6242 17.1968 78.0516 OK 17.5001 0 67.9667 OK TSS213 - - XLOC_000143 SPEN TSS213 chr1:16160709-16266950 - - 40.228 5.06363 75.3923 OK 140.357 82.3092 198.405 OK 168.12 40.5038 295.735 OK TSS2130 - - XLOC_001350 - TSS2130 chr1:16860385-16864669 - - 23.1603 3.70763 42.613 OK 11.9908 6.58234 17.3992 OK 0.8365 0 2.58351 OK TSS2131 - - XLOC_001352 NBPF1 TSS2131 chr1:16890411-16939982 - - 373.983 149.21 598.757 OK 222.328 170.677 273.978 OK 890.142 345.701 1434.58 OK TSS2132 - - XLOC_001352 NBPF1 TSS2132 chr1:16890411-16939982 - - 65.4571 0 212.032 OK 148.896 72.0228 225.77 OK 783.709 117.835 1449.58 OK TSS2133 - - XLOC_001352 NBPF1 TSS2133 chr1:16890411-16939982 - - 2.67381 0 115.26 OK 2.13127 0 10.4539 OK 2.38008 0 261.588 OK TSS2134 - - XLOC_001352 NBPF1 TSS2134 chr1:16890411-16939982 - - 8.12905 0 58.4269 OK 1.71985 0 7.19816 OK 41.2295 0 175.391 OK TSS2135 - - XLOC_001353 - TSS2135 chr1:16944752-16971178 - - 146.83 0 298.651 OK 39.2466 3.04286 75.4504 OK 151.051 0 313.083 OK TSS2136 - - XLOC_001353 - TSS2136 chr1:16944752-16971178 - - 24.9871 0 82.2865 OK 150.524 97.2448 203.804 OK 82.627 0 186.382 OK TSS2137 - - XLOC_001353 - TSS2137 chr1:16944752-16971178 - - 62.8563 0 129.209 OK 148.568 105.21 191.927 OK 44.2115 0 111.293 OK TSS2138 - - XLOC_001353 - TSS2138 chr1:16944752-16971178 - - 75.5926 0 162.563 OK 186.65 126.535 246.766 OK 89.6185 0 202.071 OK TSS2139 - - XLOC_001353 - TSS2139 chr1:16944752-16971178 - - 93.9509 0 347.663 OK 210.996 83.331 338.661 OK 217.203 0 557.922 OK TSS214 - - XLOC_000144 C1orf64 TSS214 chr1:16330730-16333180 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2140 - - XLOC_001354 ESPN TSS2140 chr1:17017712-17046652 - - 2.07327 0 5.81874 OK 11.1097 6.20784 16.0115 OK 0 0 0 OK TSS2141 - - XLOC_001354 ESPNP TSS2141 chr1:17017712-17046652 - - 0 0 0 OK 3.47275 0 7.65156 OK 0 0 0 OK TSS2142 - - XLOC_001355 MSTP9 TSS2142 chr1:17066767-17299474 - - 14.2231 0 47.6041 OK 38.162 12.8322 63.4919 OK 1.55467 0 34.5536 OK TSS2143 - - XLOC_001355 MSTP9 TSS2143 chr1:17066767-17299474 - - 1.90183 0 33.477 OK 3.25841 0 11.095 OK 1.59851 0 32.2719 OK TSS2144 - - XLOC_001356 - TSS2144 chr1:17066767-17299474 - - 133.893 0 504.624 OK 415.352 32.9291 797.775 OK 408.247 0 1179.03 OK TSS2145 - - XLOC_001357 MFAP2 TSS2145 chr1:17300999-17308081 - - 1947.53 1100.04 2795.02 OK 4866.56 4273.21 5459.92 OK 2361.94 1113.34 3610.53 OK TSS2146 - - XLOC_001357 MFAP2 TSS2146 chr1:17300999-17308081 - - 0 0 0 OK 0 0 0 OK 43.7253 0 499.228 OK TSS2147 - - XLOC_001358 ATP13A2 TSS2147 chr1:17312452-17338423 - - 66.6283 0 273.207 OK 366.46 205.875 527.046 OK 231.387 0 528.322 OK TSS2148 - - XLOC_001358 ATP13A2 TSS2148 chr1:17312452-17338423 - - 255.212 116.091 394.333 OK 1022.9 875.696 1170.11 OK 407.307 237.355 577.259 OK TSS2149 - - XLOC_001358 ATP13A2 TSS2149 chr1:17312452-17338423 - - 0 0 0 OK 22.7704 0 78.4159 OK 46.6117 0 247.147 OK TSS215 - - XLOC_000145 CLCNKA TSS215 chr1:16340522-16400127 - - 1.3355 0 53.7048 OK 6.02437 0.115613 11.9331 OK 0 0 0 OK TSS2150 - - XLOC_001358 ATP13A2 TSS2150 chr1:17312452-17338423 - - 26.0242 0 105.824 OK 18.4495 0 52.2647 OK 0 0 0 OK TSS2151 - - XLOC_001359 SDHB TSS2151 chr1:17345226-17380665 - - 1562.94 903.16 2222.73 OK 1548.47 1310.11 1786.83 OK 5372.43 3139.35 7605.51 OK TSS2152 - - XLOC_001360 PADI2 TSS2152 chr1:17393256-17445948 - - 31.43 3.74415 59.1159 OK 66.1047 49.5775 82.632 OK 0.887452 0 2.35611 OK TSS2153 - - XLOC_001362 RCC2 TSS2153 chr1:17733251-17766220 - - 2447.51 1730.57 3164.45 OK 4130.7 3664.34 4597.05 OK 869.89 449.813 1289.97 OK TSS2154 - - XLOC_001362 RCC2 TSS2154 chr1:17733251-17766220 - - 895.394 476.348 1314.44 OK 1326.29 1070.74 1581.85 OK 178.175 0 363.289 OK TSS2155 - - XLOC_001363 TAS1R2 TSS2155 chr1:19166092-19186155 - - 0.541163 0 2.03937 OK 0 0 0 OK 0 0 0 OK TSS2156 - - XLOC_001364 ALDH4A1 TSS2156 chr1:19197925-19229293 - - 85.8408 8.14943 163.532 OK 218.303 159.662 276.944 OK 130.588 7.30382 253.872 OK TSS2157 - - XLOC_001364 ALDH4A1 TSS2157 chr1:19197925-19229293 - - 178.229 62.5565 293.901 OK 434.186 347.596 520.776 OK 406.234 197.354 615.114 OK TSS2158 - - XLOC_001365 IFFO2 TSS2158 chr1:19230773-19282826 - - 102.06 48.7649 155.355 OK 89.541 72.7006 106.381 OK 303.773 166.199 441.347 OK TSS2159 - - XLOC_001366 - TSS2159 chr1:19398603-19536746 - - 14.6135 0 555.378 OK 50.0495 0 160.92 OK 229.039 0 2234.55 OK TSS216 - - XLOC_000145 CLCNKA,CLCNKB TSS216 chr1:16340522-16400127 - - 8.86716 0 78.1613 OK 23.5434 12.9503 34.1366 OK 0.308418 0 7.49156 OK TSS2160 - - XLOC_001366 - TSS2160 chr1:19398603-19536746 - - 1.68163 0 256.626 OK 92.8871 0 187.884 OK 294.701 0 1031.77 OK TSS2161 - - XLOC_001366 UBR4 TSS2161 chr1:19398603-19536746 - - 0 0 0 OK 22.9292 0 71.3365 OK 22.1323 0 587.311 OK TSS2162 - - XLOC_001366 - TSS2162 chr1:19398603-19536746 - - 0 0 0 OK 167.676 22.4737 312.879 OK 0 0 0 OK TSS2163 - - XLOC_001366 - TSS2163 chr1:19398603-19536746 - - 28.2328 0 130.129 OK 557.747 349.643 765.85 OK 470.997 0 1254.8 OK TSS2164 - - XLOC_001366 - TSS2164 chr1:19398603-19536746 - - 4.91166 0 122.644 OK 426.519 250.247 602.791 OK 243.59 0 936.189 OK TSS2165 - - XLOC_001366 UBR4 TSS2165 chr1:19398603-19536746 - - 623.312 460.643 785.98 OK 765.815 676.786 854.844 OK 666.218 299.375 1033.06 OK TSS2166 - - XLOC_001366 UBR4 TSS2166 chr1:19398603-19536746 - - 39.3315 0 149.532 OK 5.33048 0 33.5387 OK 5.62521 0 540.505 OK TSS2167 - - XLOC_001366 UBR4 TSS2167 chr1:19398603-19536746 - - 38.8471 0 153.122 OK 192.593 85.6652 299.52 OK 171.68 0 680.545 OK TSS2168 - - XLOC_001366 - TSS2168 chr1:19398603-19536746 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2169 - - XLOC_001366 UBR4 TSS2169 chr1:19398603-19536746 - - 112.418 0 271.794 OK 4.71016 0 19.6735 OK 7.05837 0 286.173 OK TSS217 - - XLOC_000145 CLCNKA TSS217 chr1:16340522-16400127 - - 1.5524 0 22.3485 OK 8.06405 0 24.2889 OK 0 0 0 OK TSS2170 - - XLOC_001367 KIAA0090 TSS2170 chr1:19544584-19578046 - - 44.1215 0 116.51 OK 13.1602 0 29.6914 OK 6.73706 0 383.528 OK TSS2171 - - XLOC_001367 KIAA0090 TSS2171 chr1:19544584-19578046 - - 309.472 155.981 462.963 OK 596.084 506.782 685.387 OK 2362.61 1321.81 3403.42 OK TSS2172 - - XLOC_001368 AKR7L TSS2172 chr1:19592475-19600568 - - 8.4734 1.23882 15.708 OK 11.7019 7.12012 16.2836 OK 10.5092 1.01211 20.0062 OK TSS2173 - - XLOC_001369 AKR7A3 TSS2173 chr1:19609056-19615280 - - 16.1619 3.29675 29.0271 OK 17.2325 9.42284 25.0423 OK 15.2534 1.07679 29.43 OK TSS2174 - - XLOC_001370 AKR7A2 TSS2174 chr1:19630458-19638640 - - 363.217 139.609 586.825 OK 695.576 574.601 816.551 OK 3218.59 1746.38 4690.81 OK TSS2175 - - XLOC_001371 CAPZB TSS2175 chr1:19665273-19811992 - - 1302.83 611.827 1993.83 OK 0 0 0 OK 0 0 0 OK TSS2176 - - XLOC_001371 CAPZB TSS2176 chr1:19665273-19811992 - - 43.0618 0 207.16 OK 69.4828 6.61671 132.349 OK 70.755 0 2035.05 OK TSS2177 - - XLOC_001371 CAPZB TSS2177 chr1:19665273-19811992 - - 2378.98 1380.82 3377.13 OK 5177.29 4588.94 5765.65 OK 19381 8973.62 29788.3 OK TSS2178 - - XLOC_001373 TMCO4 TSS2178 chr1:20008706-20126758 - - 6.20966 0 29.8202 OK 0 0 0 OK 36.9795 0 220.714 OK TSS2179 - - XLOC_001373 TMCO4 TSS2179 chr1:20008706-20126758 - - 48.488 10.3098 86.6662 OK 56.5465 42.6732 70.4197 OK 464.48 220.881 708.08 OK TSS218 - - XLOC_000145 CLCNKB TSS218 chr1:16340522-16400127 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2180 - - XLOC_001373 TMCO4 TSS2180 chr1:20008706-20126758 - - 18.9165 0 66.8168 OK 10.5012 0 21.5426 OK 105.748 0 259.604 OK TSS2181 - - XLOC_001373 TMCO4 TSS2181 chr1:20008706-20126758 - - 6.08129 0 93.3291 OK 0 0 0 OK 20.9118 0 225.377 OK TSS2182 - - XLOC_001375 PLA2G2E TSS2182 chr1:20246799-20250110 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2183 - - XLOC_001376 PLA2G2A TSS2183 chr1:20301924-20306932 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2184 - - XLOC_001376 PLA2G2A TSS2184 chr1:20301924-20306932 - - 134.324 8.37934 260.269 OK 35.1082 21.8517 48.3647 OK 12.952 0 27.7808 OK TSS2185 - - XLOC_001377 PLA2G2D TSS2185 chr1:20438440-20446008 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2186 - - XLOC_001378 PLA2G2C TSS2186 chr1:20490483-20501687 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2187 - - XLOC_001379 - TSS2187 chr1:20687597-20755275 - - 0 0 0 OK 0.74001 0 2.83297 OK 0 0 0 OK TSS2188 - - XLOC_001379 - TSS2188 chr1:20687597-20755275 - - 0 0 0 OK 0 0 0 OK 2.56345 0 6.11092 OK TSS2189 - - XLOC_001380 CAMK2N1 TSS2189 chr1:20808884-20812728 - - 163.673 0 330.269 OK 6.4946 0 16.4108 OK 2654.04 0 8666.76 OK TSS219 - - XLOC_000145 CLCNKB TSS219 chr1:16340522-16400127 - - 12.6409 0 62.956 OK 52.0827 34.1208 70.0445 OK 1.81089 0 20.3662 OK TSS2190 - - XLOC_001380 CAMK2N1 TSS2190 chr1:20808884-20812728 - - 171.705 34.941 308.47 OK 124.278 97.3523 151.204 OK 7835.73 3452.15 12219.3 OK TSS2191 - - XLOC_001381 MUL1 TSS2191 chr1:20825942-20834674 - - 392.307 205.86 578.753 OK 351.837 291.107 412.567 OK 1509.04 876.74 2141.34 OK TSS2192 - - XLOC_001382 DDOST TSS2192 chr1:20978259-20988037 - - 4463.42 3247.07 5679.77 OK 4991.33 4450.62 5532.04 OK 12716.5 6041.99 19391.1 OK TSS2193 - - XLOC_001383 KIF17 TSS2193 chr1:20990508-21044317 - - 7.59828 0 42.1585 OK 14.7785 0.506407 29.0505 OK 87.6849 0 184.619 OK TSS2194 - - XLOC_001383 KIF17 TSS2194 chr1:20990508-21044317 - - 0 0 0 OK 5.90044 0 16.6955 OK 11.7825 0 46.107 OK TSS2195 - - XLOC_001383 KIF17 TSS2195 chr1:20990508-21044317 - - 59.0012 19.3947 98.6076 OK 151.303 117.871 184.735 OK 29.9178 0 69.6045 OK TSS2196 - - XLOC_001384 SH2D5 TSS2196 chr1:21046224-21059330 - - 17.3446 0 40.3711 OK 145.923 101.041 190.804 OK 175.668 70.6534 280.682 OK TSS2197 - - XLOC_001384 SH2D5 TSS2197 chr1:21046224-21059330 - - 56.3467 12.9268 99.7667 OK 160.628 102.931 218.324 OK 132.567 21.811 243.324 OK TSS2198 - - XLOC_001385 HP1BP3 TSS2198 chr1:21069170-21113799 - - 44.0552 0 166.711 OK 56.1343 22.179 90.0896 OK 89.2902 0 537.056 OK TSS2199 - - XLOC_001385 HP1BP3 TSS2199 chr1:21069170-21113799 - - 302.536 115.748 489.323 OK 107.411 71.6054 143.216 OK 147.345 0 557.151 OK TSS22 - - XLOC_000027 SCNN1D TSS22 chr1:1215815-1227409 - - 0.000995546 0 2.00733 OK 60.1613 39.1507 81.1719 OK 34.1815 0 76.7597 OK TSS220 - - XLOC_000146 C1orf144 TSS220 chr1:16693582-16763919 - - 1222.98 804.558 1641.4 OK 1363.34 1190.43 1536.25 OK 5311.2 2440.13 8182.27 OK TSS2200 - - XLOC_001385 HP1BP3 TSS2200 chr1:21069170-21113799 - - 534.508 2.22972 1066.79 OK 318.106 210.062 426.15 OK 1405.24 0 3548.05 OK TSS2201 - - XLOC_001385 HP1BP3 TSS2201 chr1:21069170-21113799 - - 553.685 234.221 873.149 OK 88.4856 47.9835 128.988 OK 1673.88 332.079 3015.68 OK TSS2202 - - XLOC_001385 HP1BP3 TSS2202 chr1:21069170-21113799 - - 478.545 78.9201 878.17 OK 494.915 367.814 622.015 OK 1140.1 0 2502.82 OK TSS2203 - - XLOC_001386 EIF4G3 TSS2203 chr1:21132975-21503340 - - 16.2897 0 120.515 OK 6.37526 0 18.3251 OK 487.969 0 1205.32 OK TSS2204 - - XLOC_001386 EIF4G3 TSS2204 chr1:21132975-21503340 - - 499.358 284.696 714.02 OK 247.208 192.013 302.403 OK 689.01 0 1564.37 OK TSS2205 - - XLOC_001386 EIF4G3 TSS2205 chr1:21132975-21503340 - - 23.2845 0 83.5985 OK 0 0 0 OK 233.937 0 698.17 OK TSS2206 - - XLOC_001386 EIF4G3 TSS2206 chr1:21132975-21503340 - - 217.515 83.3081 351.723 OK 414.51 340.517 488.504 OK 658.192 102.71 1213.67 OK TSS2207 - - XLOC_001386 EIF4G3 TSS2207 chr1:21132975-21503340 - - 310.854 9.35684 612.35 OK 0 0 0 OK 0 0 0 OK TSS2208 - - XLOC_001386 EIF4G3 TSS2208 chr1:21132975-21503340 - - 99.134 0 274.22 OK 39.0388 0.43254 77.6451 OK 49.7966 0 663.007 OK TSS2209 - - XLOC_001387 ECE1 TSS2209 chr1:21543739-21672034 - - 0 0 0 OK 5.98009 0 15.3256 OK 127.783 0 997.551 OK TSS221 - - XLOC_000147 NECAP2 TSS221 chr1:16767166-16786582 - - 574.66 291.154 858.166 OK 535.864 445.659 626.07 OK 3729.9 2067.17 5392.62 OK TSS2210 - - XLOC_001387 ECE1 TSS2210 chr1:21543739-21672034 - - 90.6691 12.4744 168.864 OK 28.0163 9.22743 46.8052 OK 986.479 0 2727.2 OK TSS2211 - - XLOC_001387 ECE1 TSS2211 chr1:21543739-21672034 - - 70.0685 0 174.158 OK 113.914 38.504 189.324 OK 1498.79 0 5724.77 OK TSS2212 - - XLOC_001387 ECE1 TSS2212 chr1:21543739-21672034 - - 67.8265 7.73965 127.913 OK 419.192 327.282 511.102 OK 3871.51 403.938 7339.09 OK TSS2213 - - XLOC_001389 - TSS2213 chr1:21749600-21754300 - - 100.478 37.9623 162.993 OK 59.716 45.3134 74.1186 OK 526.991 265.844 788.138 OK TSS2214 - - XLOC_001390 RAP1GAP TSS2214 chr1:21922708-21995856 - - 3.1394 0 17.0373 OK 23.4017 0 49.5166 OK 0 0 0 OK TSS2215 - - XLOC_001390 RAP1GAP TSS2215 chr1:21922708-21995856 - - 27.4868 0.432069 54.5415 OK 67.9603 40.5951 95.3256 OK 2.12746 0 4.48271 OK TSS2216 - - XLOC_001390 RAP1GAP TSS2216 chr1:21922708-21995856 - - 25.4736 0 54.6318 OK 87.2577 66.8396 107.676 OK 0.00165223 0 0.738614 OK TSS2217 - - XLOC_001391 USP48 TSS2217 chr1:22004793-22109688 - - 119.181 0 246.481 OK 49.6025 20.7725 78.4325 OK 49.025 0 192.573 OK TSS2218 - - XLOC_001391 USP48 TSS2218 chr1:22004793-22109688 - - 984.381 581.6 1387.16 OK 761.076 631.197 890.956 OK 1473.12 701.03 2245.2 OK TSS2219 - - XLOC_001391 USP48 TSS2219 chr1:22004793-22109688 - - 40.7577 0 143.522 OK 4.47726 0 18.5653 OK 1.54293 0 312.022 OK TSS222 - - XLOC_000149 MST1 TSS222 chr1:16972068-16976914 - - 3.60361 0 12.3257 OK 12.0854 0 25.106 OK 6.5283 0 15.3628 OK TSS2220 - - XLOC_001392 HSPG2 TSS2220 chr1:22138757-22263750 - - 8.87162 0 54.733 OK 185.017 95.7889 274.245 OK 262.104 0 7029.42 OK TSS2221 - - XLOC_001392 HSPG2 TSS2221 chr1:22138757-22263750 - - 117.483 64.7549 170.211 OK 865.967 767.885 964.05 OK 4493.82 205.366 8782.28 OK TSS2222 - - XLOC_001392 HSPG2 TSS2222 chr1:22138757-22263750 - - 32.9146 0 281.74 OK 0 0 0 OK 0 0 0 OK TSS2223 - - XLOC_001393 WNT4 TSS2223 chr1:22443799-22470385 - - 15.9522 4.85667 27.0478 OK 73.6692 57.8567 89.4816 OK 0.00537242 0 0.631395 OK TSS2224 - - XLOC_001393 WNT4 TSS2224 chr1:22443799-22470385 - - 0.000222119 0 1.30571 OK 0 0 0 OK 0.782392 0 2.04125 OK TSS2225 - - XLOC_001394 - TSS2225 chr1:23337326-23342343 - - 3.40123 0 13.2023 OK 1.30651 0 5.02077 OK 0 0 0 OK TSS2226 - - XLOC_001395 LUZP1 TSS2226 chr1:23410515-23495517 - - 860.605 603.459 1117.75 OK 435.794 372.802 498.787 OK 885.771 472.058 1299.48 OK TSS2227 - - XLOC_001397 HNRNPR TSS2227 chr1:23636276-23670853 - - 18.8159 0 235.337 OK 3.27082 0 45.6852 OK 0 0 0 OK TSS2228 - - XLOC_001397 HNRNPR TSS2228 chr1:23636276-23670853 - - 3123.46 2185.17 4061.74 OK 3017.1 2636.42 3397.77 OK 5103.63 2604.29 7602.98 OK TSS2229 - - XLOC_001398 ZNF436 TSS2229 chr1:23685941-23698278 - - 32.0809 0 67.178 OK 18.4192 13.3986 23.4398 OK 264.956 115.508 414.403 OK TSS223 - - XLOC_000149 MST1 TSS223 chr1:16972068-16976914 - - 2.50115 0 15.9718 OK 10.5665 0 23.9613 OK 4.62403 0 16.7198 OK TSS2230 - - XLOC_001398 ZNF436 TSS2230 chr1:23685941-23698278 - - 28.9081 0 62.8343 OK 0 0 0 OK 121.81 15.9871 227.633 OK TSS2231 - - XLOC_001399 TCEA3 TSS2231 chr1:23707554-23751261 - - 134.779 0 284.291 OK 1.36049 0 3.66464 OK 699.13 143.953 1254.31 OK TSS2232 - - XLOC_001399 TCEA3 TSS2232 chr1:23707554-23751261 - - 0 0 0 OK 4.90057 0 13.6303 OK 75.1132 0 421.044 OK TSS2233 - - XLOC_001400 ASAP3 TSS2233 chr1:23755055-23811057 - - 57.325 0 142.224 OK 22.8075 0 48.2833 OK 97.6727 0 255.097 OK TSS2234 - - XLOC_001400 - TSS2234 chr1:23755055-23811057 - - 31.2959 0 94.9927 OK 92.1289 44.7493 139.508 OK 41.7841 0 143.383 OK TSS2235 - - XLOC_001400 ASAP3 TSS2235 chr1:23755055-23811057 - - 215.28 110.918 319.642 OK 617.63 527.9 707.36 OK 653.629 350.322 956.936 OK TSS2236 - - XLOC_001400 ASAP3 TSS2236 chr1:23755055-23811057 - - 0 0 0 OK 24.2074 0 58.75 OK 0 0 0 OK TSS2237 - - XLOC_001400 ASAP3 TSS2237 chr1:23755055-23811057 - - 0 0 0 OK 5.93528 0 78.7546 OK 0 0 0 OK TSS2238 - - XLOC_001402 E2F2 TSS2238 chr1:23832921-23857713 - - 17.3678 4.7535 29.9821 OK 95.4288 77.2231 113.634 OK 59.0676 19.8264 98.3088 OK TSS2239 - - XLOC_001403 ID3 TSS2239 chr1:23884409-23886322 - - 2233.71 1374.86 3092.55 OK 3052.85 2640.31 3465.39 OK 1179.44 550.757 1808.12 OK TSS224 - - XLOC_000149 MST1 TSS224 chr1:16972068-16976914 - - 9.67545 0 21.4858 OK 96.4681 69.1707 123.766 OK 3.69539 0 11.9159 OK TSS2240 - - XLOC_001404 - TSS2240 chr1:24069855-24104777 - - 29.788 0 264.297 OK 77.4967 4.15983 150.834 OK 107.333 0 702.882 OK TSS2241 - - XLOC_001405 GALE TSS2241 chr1:24122088-24127294 - - 33.6768 0 114.477 OK 38.3217 0 86.1816 OK 12.7034 0 114.987 OK TSS2242 - - XLOC_001405 GALE TSS2242 chr1:24122088-24127294 - - 17.4871 0 82.9391 OK 27.5676 0 63.8999 OK 167.153 0 448.413 OK TSS2243 - - XLOC_001405 GALE TSS2243 chr1:24122088-24127294 - - 251.387 7.47472 495.3 OK 492.642 400.036 585.248 OK 578.187 166.23 990.144 OK TSS2244 - - XLOC_001405 GALE TSS2244 chr1:24122088-24127294 - - 6.56657 0 75.3981 OK 9.86629 0 29.5456 OK 4.63048 0 149.567 OK TSS2245 - - XLOC_001406 HMGCL TSS2245 chr1:24128367-24165110 - - 209.106 59.1541 359.058 OK 346.485 274.283 418.688 OK 1760.73 912.21 2609.26 OK TSS2246 - - XLOC_001406 HMGCL TSS2246 chr1:24128367-24165110 - - 7.68224 0 40.6411 OK 12.5886 0.206477 24.9707 OK 0 0 0 OK TSS2247 - - XLOC_001407 FUCA1 TSS2247 chr1:24171573-24194821 - - 207.2 93.0962 321.303 OK 132.316 99.2404 165.391 OK 142.572 0 302.051 OK TSS2248 - - XLOC_001408 CNR2 TSS2248 chr1:24200460-24239817 - - 0.725191 0 2.81492 OK 0 0 0 OK 0 0 0 OK TSS2249 - - XLOC_001409 SFRS13A TSS2249 chr1:24292938-24306821 - - 2102.35 1315.04 2889.66 OK 1582.97 1324.94 1841.01 OK 2465.33 1222.33 3708.34 OK TSS225 - - XLOC_000150 - TSS225 chr1:17066767-17299474 - - 2.30684 0 127.542 OK 4.93427 0 28.0652 OK 0 0 0 OK TSS2250 - - XLOC_001410 MYOM3 TSS2250 chr1:24382531-24438665 - - 0 0 0 OK 1.19576 0 3.29814 OK 0 0 0 OK TSS2251 - - XLOC_001410 MYOM3 TSS2251 chr1:24382531-24438665 - - 0.452065 0 2.23786 OK 1.77127 0.174322 3.36822 OK 0 0 0 OK TSS2252 - - XLOC_001410 MYOM3 TSS2252 chr1:24382531-24438665 - - 2.29711 0 6.50065 OK 0.363637 0 1.17831 OK 0 0 0 OK TSS2253 - - XLOC_001410 MYOM3 TSS2253 chr1:24382531-24438665 - - 0.347098 0 1.73564 OK 0.607421 0 1.4623 OK 0 0 0 OK TSS2254 - - XLOC_001411 IL22RA1 TSS2254 chr1:24446260-24469611 - - 6.64523 1.2324 12.0581 OK 1.45433 0 3.80055 OK 0 0 0 OK TSS2255 - - XLOC_001411 IL22RA1 TSS2255 chr1:24446260-24469611 - - 0 0 0 OK 5.55488 2.27978 8.82997 OK 3.57865 0 7.56641 OK TSS2256 - - XLOC_001412 IL28RA TSS2256 chr1:24480647-24513751 - - 99.4363 0 272.313 OK 206.886 132.751 281.02 OK 0.114571 0 1.06264 OK TSS2257 - - XLOC_001414 C1orf201 TSS2257 chr1:24683489-24741587 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS2258 - - XLOC_001414 C1orf201 TSS2258 chr1:24683489-24741587 - - 11.5429 0 42.8324 OK 7.16763 0 15.8409 OK 57.9985 0 135.969 OK TSS2259 - - XLOC_001414 C1orf201 TSS2259 chr1:24683489-24741587 - - 144.476 48.7641 240.189 OK 142.496 111.183 173.808 OK 218.855 81.5319 356.178 OK TSS226 - - XLOC_000150 CROCC TSS226 chr1:17066767-17299474 - - 27.4034 0 57.257 OK 428.259 354.129 502.389 OK 98.6818 31.8198 165.544 OK TSS2260 - - XLOC_001414 C1orf201 TSS2260 chr1:24683489-24741587 - - 0 0 0 OK 0 0 0 OK 3.67923 0 48.8139 OK TSS2261 - - XLOC_001414 C1orf201 TSS2261 chr1:24683489-24741587 - - 8.9548 0 57.0165 OK 2.3477 0 9.37006 OK 15.7206 0 84.2402 OK TSS227 - - XLOC_000150 CROCC TSS227 chr1:17066767-17299474 - - 47.5917 0 116.051 OK 30.5389 0 76.5493 OK 3.8214 0 60.5204 OK TSS228 - - XLOC_000150 CROCC TSS228 chr1:17066767-17299474 - - 65.6699 18.2084 113.131 OK 100.239 53.167 147.311 OK 17.1632 0 59.7634 OK TSS229 - - XLOC_000150 - TSS229 chr1:17066767-17299474 - - 15.9225 0 60.3287 OK 62.5679 17.7392 107.397 OK 49.7705 0 124.533 OK TSS23 - - XLOC_000028 PUSL1 TSS23 chr1:1227763-1260046 - - 335.325 0 695.291 OK 775.295 531.553 1019.04 OK 855.662 0 2564.44 OK TSS230 - - XLOC_000151 PADI1 TSS230 chr1:17531620-17572501 - - 2.7984 0 10.3872 OK 1.50479 0 3.19272 OK 0 0 0 OK TSS231 - - XLOC_000151 PADI1 TSS231 chr1:17531620-17572501 - - 12.7402 0 31.4404 OK 0.286372 0 1.84795 OK 6.06956e-06 0 1.02954 OK TSS232 - - XLOC_000151 - TSS232 chr1:17531620-17572501 - - 0 0 0 OK 2.33196 0 5.25577 OK 0.513935 0 1.74582 OK TSS233 - - XLOC_000152 PADI3 TSS233 chr1:17575592-17610725 - - 8.59656 1.07534 16.1178 OK 12.671 8.61879 16.7231 OK 0.32407 0 1.03362 OK TSS234 - - XLOC_000153 PADI4 TSS234 chr1:17634689-17690495 - - 4.09774 0 8.73756 OK 4.49965 0.0853275 8.91396 OK 0 0 0 OK TSS235 - - XLOC_000154 PADI6 TSS235 chr1:17698740-17728195 - - 0 0 0 OK 0.21117 0 0.811504 OK 0 0 0 OK TSS236 - - XLOC_000155 ARHGEF10L TSS236 chr1:17866329-18024369 - - 86.5635 12.8043 160.323 OK 120.034 73.5761 166.491 OK 28.9222 0 118.344 OK TSS237 - - XLOC_000155 ARHGEF10L TSS237 chr1:17866329-18024369 - - 158.893 62.1068 255.68 OK 479.078 400.922 557.233 OK 243.503 64.6597 422.346 OK TSS238 - - XLOC_000155 ARHGEF10L TSS238 chr1:17866329-18024369 - - 0 0 0 OK 2.78634 0 19.6284 OK 5.30615 0 156.718 OK TSS239 - - XLOC_000155 ARHGEF10L TSS239 chr1:17866329-18024369 - - 24.8197 0 70.9372 OK 25.6249 7.29019 43.9596 OK 0 0 0 OK TSS24 - - XLOC_000028 PUSL1 TSS24 chr1:1227763-1260046 - - 21.1644 0 123.978 OK 14.7123 0 53.2867 OK 15.8664 0 616.273 OK TSS240 - - XLOC_000155 ARHGEF10L TSS240 chr1:17866329-18024369 - - 0 0 0 OK 5.26 0 16.963 OK 381.592 151.451 611.732 OK TSS241 - - XLOC_000155 - TSS241 chr1:17866329-18024369 - - 2.21468 0 63.4655 OK 5.36255 0 18.9326 OK 0 0 0 OK TSS242 - - XLOC_000155 - TSS242 chr1:17866329-18024369 - - 12.7177 0 69.1669 OK 44.6171 10.5906 78.6436 OK 14.6487 0 130.905 OK TSS243 - - XLOC_000156 ACTL8 TSS243 chr1:18081807-18153556 - - 9.62232 1.18858 18.0561 OK 17.1125 10.9181 23.3069 OK 6.95204 0.2121 13.692 OK TSS244 - - XLOC_000157 IGSF21 TSS244 chr1:18434239-18704976 - - 58.273 18.1053 98.4407 OK 398.742 315.075 482.408 OK 0 0 0 OK TSS245 - - XLOC_000157 IGSF21 TSS245 chr1:18434239-18704976 - - 2.74185 0 26.2821 OK 3.24727 0 61.6295 OK 0 0 0 OK TSS246 - - XLOC_000159 KLHDC7A TSS246 chr1:18807423-18812539 - - 0 0 0 OK 8.37135 0 23.4298 OK 0.745204 0 1.93601 OK TSS247 - - XLOC_000160 PAX7 TSS247 chr1:18957499-19075359 - - 0.594028 0 4.06958 OK 0.969331 0 2.21305 OK 0 0 0 OK TSS248 - - XLOC_000161 MRTO4 TSS248 chr1:19578074-19586621 - - 773.162 453.595 1092.73 OK 961.74 822.192 1101.29 OK 1651.61 939.806 2363.42 OK TSS249 - - XLOC_000162 PQLC2 TSS249 chr1:19638739-19655793 - - 105.82 3.97485 207.666 OK 262.501 201.161 323.841 OK 448.712 164.806 732.618 OK TSS25 - - XLOC_000029 GLTPD1 TSS25 chr1:1260142-1264275 - - 140.404 57.7844 223.024 OK 187.156 149.818 224.494 OK 781.158 428.727 1133.59 OK TSS250 - - XLOC_000162 PQLC2 TSS250 chr1:19638739-19655793 - - 80.1847 0 162.335 OK 62.153 30.4872 93.8188 OK 139.07 0 304.602 OK TSS251 - - XLOC_000163 C1orf151,NBL1 TSS251 chr1:19923466-19984945 - - 249.564 48.6001 450.529 OK 797.682 660.972 934.392 OK 10711.1 3286.2 18136 OK TSS252 - - XLOC_000163 NBL1 TSS252 chr1:19923466-19984945 - - 0 0 0 OK 1.64141 0 17.0922 OK 3.52907 0 2423.53 OK TSS253 - - XLOC_000163 NBL1 TSS253 chr1:19923466-19984945 - - 0 0 0 OK 0 0 0 OK 30.6081 0 1920.08 OK TSS254 - - XLOC_000163 NBL1 TSS254 chr1:19923466-19984945 - - 463.905 201.419 726.392 OK 16.9244 0 39.9956 OK 1884.11 0 4561 OK TSS255 - - XLOC_000164 HTR6 TSS255 chr1:19991779-20006054 - - 3.39355 0 7.66135 OK 22.3161 15.5051 29.1271 OK 0 0 0 OK TSS256 - - XLOC_000165 OTUD3 TSS256 chr1:20208887-20239429 - - 148.118 78.5111 217.725 OK 157.667 131.532 183.802 OK 87.3998 38.6021 136.198 OK TSS257 - - XLOC_000166 PLA2G5 TSS257 chr1:20354671-20418393 - - 0.482708 0 3.205 OK 0 0 0 OK 2.12447 0 31.9517 OK TSS258 - - XLOC_000166 PLA2G5 TSS258 chr1:20354671-20418393 - - 0 0 0 OK 0.847143 0 2.42832 OK 147.21 39.2714 255.148 OK TSS259 - - XLOC_000167 PLA2G2F TSS259 chr1:20465822-20476879 - - 0 0 0 OK 0.361045 0 1.08683 OK 0 0 0 OK TSS26 - - XLOC_000030 TAS1R3 TSS26 chr1:1266725-1269843 - - 6.25639 0.748851 11.7639 OK 2.57898 0.558292 4.59967 OK 4.31837 0 8.68841 OK TSS260 - - XLOC_000168 UBXN10 TSS260 chr1:20512577-20519941 - - 12.3177 2.70219 21.9333 OK 17.9074 12.8575 22.9573 OK 0.492177 0 1.39458 OK TSS261 - - XLOC_000169 VWA5B1 TSS261 chr1:20617411-20681387 - - 3.13664 0 7.23539 OK 18.1203 11.6723 24.5683 OK 0.572911 0 1.66793 OK TSS262 - - XLOC_000169 VWA5B1 TSS262 chr1:20617411-20681387 - - 0 0 0 OK 1.08334 0 2.90121 OK 0 0 0 OK TSS263 - - XLOC_000171 CDA TSS263 chr1:20915443-20945398 - - 240.92 79.6033 402.237 OK 141.154 85.2695 197.038 OK 232.113 70.0502 394.177 OK TSS264 - - XLOC_000172 PINK1 TSS264 chr1:20959947-20978003 - - 640.208 365.853 914.562 OK 326.979 265.85 388.108 OK 2213.85 1142.71 3284.98 OK TSS265 - - XLOC_000172 PINK1 TSS265 chr1:20959947-20978003 - - 0 0 0 OK 114.96 63.3891 166.53 OK 832.083 0 1760.82 OK TSS266 - - XLOC_000173 - TSS266 chr1:21543739-21672034 - - 2.1975 0 17.0697 OK 7.51557 0 20.6432 OK 3.33508 0 117.732 OK TSS267 - - XLOC_000174 - TSS267 chr1:21761832-21762609 - - 0 0 0 OK 12075.7 2561.85 21589.6 OK 7652.6 0 16802.3 OK TSS268 - - XLOC_000175 NBPF3 TSS268 chr1:21766630-21811392 - - 85.2069 28.1135 142.3 OK 59.4109 42.1246 76.6971 OK 528.734 249.389 808.079 OK TSS269 - - XLOC_000176 ALPL TSS269 chr1:21835857-21904904 - - 953.058 540.412 1365.7 OK 5045.41 4513.74 5577.07 OK 59.0365 0 121.719 OK TSS27 - - XLOC_000031 - TSS27 chr1:1334909-1342693 - - 252.561 0 520.025 OK 553.309 427.762 678.856 OK 567.727 0 1215.41 OK TSS270 - - XLOC_000176 ALPL TSS270 chr1:21835857-21904904 - - 0 0 0 OK 0 0 0 OK 7.78492 0 32.0206 OK TSS271 - - XLOC_000177 LDLRAD2 TSS271 chr1:22138757-22263750 - - 10.8443 0 49.4651 OK 22.0415 0 52.5544 OK 16.2682 0 6109.78 OK TSS272 - - XLOC_000177 LDLRAD2 TSS272 chr1:22138757-22263750 - - 11.8862 0 221.676 OK 10.8865 0 99.2934 OK 166.982 0 29549 OK TSS273 - - XLOC_000178 CELA3B TSS273 chr1:22303417-22339033 - - 1.39771 0 7.20083 OK 0 0 0 OK 0 0 0 OK TSS274 - - XLOC_000178 CELA3A TSS274 chr1:22303417-22339033 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS275 - - XLOC_000179 - TSS275 chr1:22351706-22357713 - - 27.4246 0 107.103 OK 4.05105 0 19.7938 OK 6.30679 0 115.17 OK TSS276 - - XLOC_000179 - TSS276 chr1:22351706-22357713 - - 470.397 188.643 752.15 OK 427.827 341.371 514.283 OK 527.288 217.338 837.237 OK TSS277 - - XLOC_000180 CDC42 TSS277 chr1:22379119-22419435 - - 3644.56 2581.85 4707.27 OK 1626.45 1402.71 1850.2 OK 9892.47 4678.47 15106.5 OK TSS278 - - XLOC_000181 ZBTB40 TSS278 chr1:22778343-22857650 - - 88.916 44.2392 133.593 OK 198.181 164.628 231.734 OK 218.009 116.557 319.461 OK TSS279 - - XLOC_000181 - TSS279 chr1:22778343-22857650 - - 41.9937 0 111.704 OK 23.69 0.441524 46.9385 OK 12.3722 0 108.831 OK TSS28 - - XLOC_000032 - TSS28 chr1:1361507-1363166 - - 7.20193 0 21.8767 OK 59.0363 32.2743 85.7983 OK 0 0 0 OK TSS280 - - XLOC_000182 EPHA8 TSS280 chr1:22890003-22930087 - - 33.3894 6.81803 59.9607 OK 86.3015 61.0337 111.569 OK 0 0 0 OK TSS281 - - XLOC_000183 C1QA TSS281 chr1:22963117-22966174 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS282 - - XLOC_000183 C1QA TSS282 chr1:22963117-22966174 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS283 - - XLOC_000184 C1QC TSS283 chr1:22970117-22974602 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS284 - - XLOC_000185 C1QB TSS284 chr1:22979681-22988028 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS285 - - XLOC_000186 EPHB2 TSS285 chr1:23037330-23241822 - - 58.2137 24.2103 92.2171 OK 301.66 249.897 353.423 OK 947.084 428.131 1466.04 OK TSS286 - - XLOC_000188 - TSS286 chr1:23345940-23410184 - - 2620.79 1768.5 3473.08 OK 4034.49 3581.17 4487.82 OK 2352.33 1275.56 3429.11 OK TSS287 - - XLOC_000189 C1orf213 TSS287 chr1:23685941-23698278 - - 6.87752 0 118.747 OK 2.53326 0 7.75234 OK 73.0221 0 322.578 OK TSS288 - - XLOC_000191 MDS2 TSS288 chr1:23907984-23967056 - - 6.59897e-05 0 3.04152 OK 0 0 0 OK 0 0 0 OK TSS289 - - XLOC_000191 MDS2 TSS289 chr1:23907984-23967056 - - 0.878658 0 4.24619 OK 0 0 0 OK 0 0 0 OK TSS29 - - XLOC_000033 VWA1 TSS29 chr1:1370908-1376145 - - 228.717 98.7236 358.71 OK 528.289 438.43 618.149 OK 473.976 229.937 718.014 OK TSS290 - - XLOC_000192 RPL11 TSS290 chr1:24018293-24022913 - - 7606.61 3489.42 11723.8 OK 8207.77 5984.48 10431.1 OK 65838.4 6115.1 125562 OK TSS291 - - XLOC_000192 RPL11 TSS291 chr1:24018293-24022913 - - 37474.7 28699 46250.5 OK 66599.3 60266.1 72932.4 OK 56897 5774.82 108019 OK TSS292 - - XLOC_000193 TCEB3 TSS292 chr1:24069855-24104777 - - 755.461 500.365 1010.56 OK 523.425 449.786 597.064 OK 1232.52 710.214 1754.83 OK TSS293 - - XLOC_000194 C1orf128 TSS293 chr1:24104875-24114720 - - 1073.73 622.661 1524.79 OK 1208.06 1021.73 1394.38 OK 1716.37 975.756 2456.98 OK TSS294 - - XLOC_000195 LYPLA2 TSS294 chr1:24117645-24122027 - - 1047.53 548.302 1546.76 OK 2696.47 2292.83 3100.1 OK 1186.4 573.182 1799.61 OK TSS295 - - XLOC_000196 PNRC2 TSS295 chr1:24286300-24289947 - - 2032.12 1397.99 2666.24 OK 1015.28 870.304 1160.25 OK 1795.17 1048.34 2541.99 OK TSS296 - - XLOC_000197 - TSS296 chr1:24526729-24538180 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS297 - - XLOC_000198 GRHL3 TSS297 chr1:24645880-24681807 - - 11.6632 0 25.3412 OK 24.5694 18.1154 31.0234 OK 0 0 0 OK TSS298 - - XLOC_000198 GRHL3 TSS298 chr1:24645880-24681807 - - 9.351 0 22.5208 OK 0.00104564 0 0.746452 OK 0.713283 0 2.40005 OK TSS299 - - XLOC_000199 NIPAL3 TSS299 chr1:24742244-24799472 - - 448.144 183.996 712.292 OK 140.474 103.322 177.627 OK 1632.52 561.449 2703.6 OK TSS3 - - XLOC_000005 - TSS3 chr1:322036-328580 - - 166.576 30.3179 302.835 OK 338.321 260.595 416.047 OK 18.7718 0 42.9906 OK TSS30 - - XLOC_000034 ATAD3C TSS30 chr1:1385068-1405538 - - 12.4598 2.74524 22.1743 OK 69.2663 54.4066 84.1261 OK 15.5201 2.93467 28.1056 OK TSS300 - - XLOC_000199 - TSS300 chr1:24742244-24799472 - - 22.1357 0 89.5964 OK 5.64277 0 12.4566 OK 7.66113 0 322.35 OK TSS301 - - XLOC_000200 RCAN3 TSS301 chr1:24829386-24862425 - - 326.184 141.385 510.982 OK 113.081 85.3306 140.832 OK 219.138 56.3326 381.943 OK TSS302 - - XLOC_000200 RCAN3 TSS302 chr1:24829386-24862425 - - 47.0608 0 199.219 OK 18.7602 0 40.2951 OK 184.423 0 407.613 OK TSS303 - - XLOC_000201 C1orf130 TSS303 chr1:24882601-24935816 - - 1.31366 0 3.14984 OK 2.35713 0.82725 3.88701 OK 0.128844 0 0.527799 OK TSS304 - - XLOC_000202 SRRM1 TSS304 chr1:24969593-24999771 - - 816.972 510.022 1123.92 OK 805.739 675.901 935.577 OK 1363.38 690.029 2036.73 OK TSS305 - - XLOC_000202 SRRM1 TSS305 chr1:24969593-24999771 - - 41.7106 0 140.057 OK 47.1916 0 141.741 OK 28.5028 0 259.28 OK TSS306 - - XLOC_000202 SRRM1 TSS306 chr1:24969593-24999771 - - 431.882 82.9638 780.799 OK 943.452 748.185 1138.72 OK 235.095 0 860.957 OK TSS31 - - XLOC_000035 ATAD3B TSS31 chr1:1407163-1431581 - - 117.436 0.943989 233.928 OK 409.377 321.924 496.83 OK 275.225 68.8205 481.63 OK TSS32 - - XLOC_000035 ATAD3B TSS32 chr1:1407163-1431581 - - 280.061 105.659 454.464 OK 249.624 162.712 336.535 OK 197.737 12.9458 382.528 OK TSS33 - - XLOC_000035 ATAD3B TSS33 chr1:1407163-1431581 - - 35.8479 0 150.016 OK 321.282 129.76 512.804 OK 321.282 0 654.988 OK TSS34 - - XLOC_000036 ATAD3A TSS34 chr1:1447554-1470064 - - 501.682 238.574 764.79 OK 844.68 697.583 991.777 OK 859.118 265.707 1452.53 OK TSS35 - - XLOC_000036 ATAD3A TSS35 chr1:1447554-1470064 - - 100.608 0 223.85 OK 542.034 418.405 665.662 OK 1200.71 478.111 1923.3 OK TSS36 - - XLOC_000037 - TSS36 chr1:1535818-1543166 - - 2.79141 0 8.36422 OK 10.6728 3.90909 17.4365 OK 5.74721 0 13.7722 OK TSS37 - - XLOC_000038 MIB2 TSS37 chr1:1550883-1565984 - - 51.1667 7.64182 94.6916 OK 190.943 138.055 243.831 OK 400.214 182.307 618.121 OK TSS38 - - XLOC_000038 MIB2 TSS38 chr1:1550883-1565984 - - 4.64597 0 20.9568 OK 63.8506 25.341 102.36 OK 61.0707 0 168.451 OK TSS39 - - XLOC_000038 MIB2 TSS39 chr1:1550883-1565984 - - 0 0 0 OK 3.88743 0 11.076 OK 56.0751 0 156.18 OK TSS4 - - XLOC_000007 - TSS4 chr1:420205-421839 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS40 - - XLOC_000038 MIB2 TSS40 chr1:1550883-1565984 - - 0 0 0 OK 100.348 62.3934 138.302 OK 45.3624 0 272.337 OK TSS41 - - XLOC_000038 MIB2 TSS41 chr1:1550883-1565984 - - 12.0776 0 40.1051 OK 0 0 0 OK 30.3273 0 284.908 OK TSS42 - - XLOC_000038 - TSS42 chr1:1550883-1565984 - - 20.1981 0 139.654 OK 217.26 11.3877 423.133 OK 0 0 0 OK TSS43 - - XLOC_000039 MMP23B TSS43 chr1:1567559-1570029 - - 12.7213 0 27.6623 OK 57.5318 35.1983 79.8653 OK 6.12558 0 19.2931 OK TSS44 - - XLOC_000039 - TSS44 chr1:1567559-1570029 - - 0 0 0 OK 0 0 0 OK 13.8369 0 36.035 OK TSS45 - - XLOC_000039 - TSS45 chr1:1567559-1570029 - - 0.730004 0 7.95551 OK 9.67624 0 26.3795 OK 6.24162 0 31.9677 OK TSS46 - - XLOC_000040 - TSS46 chr1:1571099-1677431 - - 0 0 0 OK 73.9259 0 204.54 OK 90.7454 0 2295.13 OK TSS47 - - XLOC_000040 - TSS47 chr1:1571099-1677431 - - 19.4885 0 121.567 OK 18.0861 0 106.613 OK 2.78903 0 5238.31 OK TSS48 - - XLOC_000041 - TSS48 chr1:1571099-1677431 - - 65.0308 0 219.479 OK 78.5208 2.15522 154.886 OK 84.1606 0 1061.25 OK TSS49 - - XLOC_000042 - TSS49 chr1:1822909-1824112 - - 4.99201 0 13.0756 OK 3.15678 0 7.15379 OK 11.254 0 24.0748 OK TSS5 - - XLOC_000012 - TSS5 chr1:763063-789740 - - 121.633 0 259.917 OK 182.273 125.346 239.2 OK 292.077 0 644.751 OK TSS50 - - XLOC_000043 CALML6 TSS50 chr1:1846265-1848733 - - 5.39767 0 12.9423 OK 26.9908 16.4977 37.4839 OK 1.08118 0 3.44841 OK TSS51 - - XLOC_000044 GABRD TSS51 chr1:1950767-1962192 - - 12.037 2.28368 21.7903 OK 41.7053 30.9987 52.4118 OK 0.393202 0 1.41275 OK TSS52 - - XLOC_000045 PRKCZ TSS52 chr1:1981908-2139172 - - 199.815 52.1436 347.487 OK 833.609 681.248 985.97 OK 0 0 0 OK TSS53 - - XLOC_000045 PRKCZ TSS53 chr1:1981908-2139172 - - 0 0 0 OK 0 0 0 OK 45.4119 0 156.55 OK TSS54 - - XLOC_000045 PRKCZ TSS54 chr1:1981908-2139172 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS55 - - XLOC_000045 PRKCZ TSS55 chr1:1981908-2139172 - - 94.566 0 220.657 OK 60.5588 0 129.341 OK 0 0 0 OK TSS56 - - XLOC_000045 PRKCZ TSS56 chr1:1981908-2139172 - - 0 0 0 OK 0 0 0 OK 34.2875 0 174.055 OK TSS57 - - XLOC_000045 PRKCZ TSS57 chr1:1981908-2139172 - - 5.19072 0 140.764 OK 17.7633 0 70.9185 OK 0 0 0 OK TSS58 - - XLOC_000045 PRKCZ TSS58 chr1:1981908-2139172 - - 7.19324 0 87.0707 OK 17.4198 0 48.8643 OK 0 0 0 OK TSS59 - - XLOC_000047 SKI TSS59 chr1:2160133-2241651 - - 246.057 139.664 352.451 OK 740.008 646.624 833.392 OK 1645.91 940.496 2351.32 OK TSS6 - - XLOC_000014 - TSS6 chr1:846814-850328 - - 8.69571 1.30977 16.0817 OK 27.5823 20.5446 34.6199 OK 0.58031 0 1.55109 OK TSS60 - - XLOC_000048 RER1 TSS60 chr1:2323213-2344010 - - 833.583 491.897 1175.27 OK 802.47 678.01 926.93 OK 3941.6 1997.26 5885.94 OK TSS61 - - XLOC_000049 PLCH2 TSS61 chr1:2407753-2436969 - - 0 0 0 OK 1.11603 0 2.44788 OK 0.769693 0 4.06489 OK TSS62 - - XLOC_000049 PLCH2 TSS62 chr1:2407753-2436969 - - 1.08362 0 3.15444 OK 1.19965 0 2.50167 OK 1.86433 0 7.18326 OK TSS63 - - XLOC_000049 PLCH2 TSS63 chr1:2407753-2436969 - - 1.2132 0 5.26466 OK 0 0 0 OK 0 0 0 OK TSS64 - - XLOC_000050 TNFRSF14 TSS64 chr1:2481358-2495265 - - 48.2407 0 138.917 OK 3.76675 0 9.22407 OK 887.589 343.505 1431.67 OK TSS65 - - XLOC_000051 C1orf93 TSS65 chr1:2518248-2564481 - - 390.603 197.586 583.62 OK 811.653 680.555 942.751 OK 1204.83 587.197 1822.46 OK TSS66 - - XLOC_000051 C1orf93 TSS66 chr1:2518248-2564481 - - 48.0815 0 133.857 OK 46.1049 14.1008 78.109 OK 83.8728 0 255.808 OK TSS67 - - XLOC_000053 PRDM16 TSS67 chr1:2985743-3355183 - - 1.00749 0 2.90667 OK 5.29478 3.71016 6.87941 OK 8.22698 1.24217 15.2118 OK TSS68 - - XLOC_000054 ARHGEF16 TSS68 chr1:3371146-3397675 - - 135.254 53.9378 216.57 OK 229.313 180.517 278.109 OK 2.38434 0 7.0422 OK TSS69 - - XLOC_000054 ARHGEF16 TSS69 chr1:3371146-3397675 - - 0 0 0 OK 60.5958 27.1107 94.0808 OK 2.38281 0 8.41518 OK TSS7 - - XLOC_000015 SAMD11 TSS7 chr1:860529-894679 - - 95.4282 0 619.043 OK 0 0 0 OK 0 0 0 OK TSS70 - - XLOC_000054 ARHGEF16 TSS70 chr1:3371146-3397675 - - 23.0853 0 80.9527 OK 60.018 28.905 91.1311 OK 0.0183886 0 1.15392 OK TSS71 - - XLOC_000054 ARHGEF16 TSS71 chr1:3371146-3397675 - - 8.08924 0 60.6874 OK 17.4666 0 38.9368 OK 0 0 0 OK TSS72 - - XLOC_000055 TPRG1L TSS72 chr1:3541555-3546692 - - 546.504 302.59 790.417 OK 498.776 417.899 579.653 OK 2696.46 1541.33 3851.58 OK TSS73 - - XLOC_000056 TP73 TSS73 chr1:3569128-3650467 - - 9.4337 0 21.595 OK 63.3435 47.6627 79.0243 OK 4.37716 0 9.93961 OK TSS74 - - XLOC_000056 TP73 TSS74 chr1:3569128-3650467 - - 1.53994 0 6.41886 OK 10.2929 0 20.6585 OK 0 0 0 OK TSS75 - - XLOC_000056 TP73 TSS75 chr1:3569128-3650467 - - 3.71815 0 12.9619 OK 0.585598 0 3.51027 OK 0 0 0 OK TSS76 - - XLOC_000056 - TSS76 chr1:3569128-3650467 - - 0 0 0 OK 0.923281 0 12.4564 OK 0.0133356 0 1.36251 OK TSS77 - - XLOC_000057 CCDC27 TSS77 chr1:3668964-3688209 - - 0.580625 0 2.25377 OK 2.99279 0.634917 5.35067 OK 0.344217 0 1.23675 OK TSS78 - - XLOC_000058 - TSS78 chr1:3689351-3692545 - - 29.1182 1.52983 56.7065 OK 76.8718 48.7695 104.974 OK 58.9016 6.1034 111.7 OK TSS79 - - XLOC_000059 CAD,DFFB TSS79 chr1:3773844-3801992 - - 72.973 20.4154 125.531 OK 120.109 86.7161 153.501 OK 116.754 37.3661 196.141 OK TSS8 - - XLOC_000015 SAMD11 TSS8 chr1:860529-894679 - - 52.9724 0 144.687 OK 1.74761 0 20.2147 OK 3.81714 0 290.443 OK TSS80 - - XLOC_000060 - TSS80 chr1:3816967-3833877 - - 6.8872 0 16.8662 OK 24.9595 13.0609 36.8581 OK 4.27286 0 10.6879 OK TSS81 - - XLOC_000061 - TSS81 chr1:4000676-4015322 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS82 - - XLOC_000062 - TSS82 chr1:4472110-4484744 - - 0 0 0 OK 0 0 0 OK 0 0 0 OK TSS83 - - XLOC_000063 AJAP1 TSS83 chr1:4715104-4843850 - - 104.444 28.7796 180.108 OK 73.9584 56.8913 91.0255 OK 1.26614 0 3.42947 OK TSS84 - - XLOC_000065 KCNAB2 TSS84 chr1:6052765-6160523 - - 7.70132 0 29.9418 OK 20.2988 7.89535 32.7022 OK 68.4146 0.707363 136.122 OK TSS85 - - XLOC_000065 KCNAB2 TSS85 chr1:6052765-6160523 - - 58.0186 11.3557 104.682 OK 109.98 83.1883 136.772 OK 34.6622 0 95.7377 OK TSS86 - - XLOC_000065 KCNAB2 TSS86 chr1:6052765-6160523 - - 3.9331 0 27.0755 OK 0.784025 0 3.96989 OK 0 0 0 OK TSS87 - - XLOC_000065 KCNAB2 TSS87 chr1:6052765-6160523 - - 4.96806 0 30.7594 OK 0.706557 0 4.26385 OK 0 0 0 OK TSS88 - - XLOC_000066 RNF207 TSS88 chr1:6266188-6296044 - - 49.2513 0 174.461 OK 41.1437 0 87.8003 OK 39.6382 0 371.745 OK TSS89 - - XLOC_000066 RNF207 TSS89 chr1:6266188-6296044 - - 15.3246 0 237.481 OK 17.0218 0 66.4273 OK 10.1307 0 1022.49 OK TSS9 - - XLOC_000015 SAMD11 TSS9 chr1:860529-894679 - - 48.0828 0 161.788 OK 4.50533 0 23.9737 OK 34.9169 0 334.708 OK TSS90 - - XLOC_000066 RNF207 TSS90 chr1:6266188-6296044 - - 13.014 0 241.412 OK 17.9047 0 67.4698 OK 18.1716 0 1034.72 OK TSS91 - - XLOC_000067 C1orf211 TSS91 chr1:6297870-6299490 - - 56.5093 17.4592 95.5594 OK 132.225 101.278 163.171 OK 4.35392 0 9.9704 OK TSS92 - - XLOC_000068 HES3 TSS92 chr1:6304261-6305638 - - 435.49 167.883 703.097 OK 1431.61 1179.29 1683.94 OK 0 0 0 OK TSS93 - - XLOC_000069 ESPN TSS93 chr1:6484847-6521003 - - 7.69434 0 16.3569 OK 20.3609 6.88119 33.8405 OK 0.205083 0 0.894501 OK TSS94 - - XLOC_000069 ESPN TSS94 chr1:6484847-6521003 - - 11.3056 0 27.1057 OK 157.325 115.978 198.673 OK 0 0 0 OK TSS95 - - XLOC_000070 TAS1R1 TSS95 chr1:6615433-6639816 - - 3.54524 0 10.1829 OK 1.25192 0 4.24694 OK 5.4957 0 14.1083 OK TSS96 - - XLOC_000071 ZBTB48 TSS96 chr1:6640055-6649339 - - 157.618 62.2204 253.016 OK 241.107 194.764 287.45 OK 214.473 56.6009 372.345 OK TSS97 - - XLOC_000071 - TSS97 chr1:6640055-6649339 - - 23.546 0 68.0149 OK 85.1502 54.8878 115.413 OK 38.1578 0 102.208 OK TSS98 - - XLOC_000072 PHF13 TSS98 chr1:6673755-6684092 - - 277.454 147.158 407.75 OK 660.096 566.862 753.331 OK 769.313 441.751 1096.88 OK TSS99 - - XLOC_000073 THAP3 TSS99 chr1:6684924-6761966 - - 69.7903 0 270.762 OK 126.801 34.04 219.563 OK 402.426 0 1046.12 OK cummeRbund/inst/extdata/tss_groups.read_group_tracking0000644000175200017520000055400514516004263024461 0ustar00biocbuildbiocbuildtracking_id condition replicate raw_frags internal_scaled_frags external_scaled_frags FPKM effective_length status TSS1 iPS 0 9 9.3939 16.0613 17.2049 - OK TSS1 iPS 1 14 13.4879 23.0611 22.9288 - OK TSS1 hESC 1 1 0.989851 0.654207 0.621918 - OK TSS1 hESC 0 0 0 0 0 - OK TSS1 Fibroblasts 1 31 25.8664 21.1458 20.6009 - OK TSS1 Fibroblasts 0 12.0001 14.2788 11.6729 11.1815 - OK TSS10 iPS 0 75.4676 78.7706 134.679 79.6273 - OK TSS10 iPS 1 47.8616 46.1109 78.8387 46.6124 - OK TSS10 hESC 1 507.821 502.667 332.22 200.885 - OK TSS10 hESC 0 413.996 418.241 276.421 167.146 - OK TSS10 Fibroblasts 1 324.047 270.385 221.04 131.115 - OK TSS10 Fibroblasts 0 250.618 298.207 243.785 144.607 - OK TSS100 iPS 0 16.0838 16.7877 28.703 31.8026 - OK TSS100 iPS 1 22.1812 21.3698 36.5374 41.1406 - OK TSS100 hESC 1 144.346 142.881 94.4323 109.096 - OK TSS100 hESC 0 137.255 138.663 91.6442 110.195 - OK TSS100 Fibroblasts 1 165.769 138.318 113.075 139.083 - OK TSS100 Fibroblasts 0 159.152 189.373 154.813 167.196 - OK TSS101 iPS 0 334.884 349.541 597.631 1449 - OK TSS101 iPS 1 262.222 252.63 431.938 1044.8 - OK TSS101 hESC 1 831.42 822.982 543.92 1384.08 - OK TSS101 hESC 0 941.032 950.68 628.318 1666.12 - OK TSS101 Fibroblasts 1 1970.66 1644.32 1344.23 3404.41 - OK TSS101 Fibroblasts 0 1113.26 1324.65 1082.91 2774.08 - OK TSS102 iPS 0 25.043 26.1391 44.6916 12.0427 - OK TSS102 iPS 1 12.6184 12.1568 20.7853 5.60088 - OK TSS102 hESC 1 160.58 158.95 105.053 28.5975 - OK TSS102 hESC 0 131.802 133.153 88.0028 23.9562 - OK TSS102 Fibroblasts 1 0 0 0 0 - OK TSS102 Fibroblasts 0 0.0113055 0.0134523 0.0109973 0.00296778 - OK TSS103 iPS 0 0 0 0 0 - OK TSS103 iPS 1 0 0 0 0 - OK TSS103 hESC 1 0 0 0 0 - OK TSS103 hESC 0 0 0 0 0 - OK TSS103 Fibroblasts 1 15.8422 13.2187 10.8063 3.06783 - OK TSS103 Fibroblasts 0 0 0 0 0 - OK TSS104 iPS 0 0.573278 0.598369 1.02307 0.379687 - OK TSS104 iPS 1 5.15981 4.97108 8.49937 3.15433 - OK TSS104 hESC 1 0 0 0 0 - OK TSS104 hESC 0 0 0 0 0 - OK TSS104 Fibroblasts 1 0 0 0 0 - OK TSS104 Fibroblasts 0 4.56349 5.43004 4.43907 1.65084 - OK TSS105 iPS 0 1712 1786.93 3055.22 2122.13 - OK TSS105 iPS 1 749 721.603 1233.77 856.964 - OK TSS105 hESC 1 1147 1135.36 750.375 535.176 - OK TSS105 hESC 0 1022 1032.48 682.38 486.681 - OK TSS105 Fibroblasts 1 16345 13638.3 11149.3 7774.02 - OK TSS105 Fibroblasts 0 9280 11042.2 9026.99 6294.2 - OK TSS106 iPS 0 39.339 41.0608 70.2042 73.2609 - OK TSS106 iPS 1 46.3608 44.665 76.3665 54.2864 - OK TSS106 hESC 1 14.2138 14.0696 9.29878 10.0998 - OK TSS106 hESC 0 30.8078 31.1237 20.5701 11.7307 - OK TSS106 Fibroblasts 1 136.437 113.843 93.0667 75.2121 - OK TSS106 Fibroblasts 0 53.8208 64.0407 52.3534 25.6525 - OK TSS107 iPS 0 699.661 730.283 1248.61 318.762 - OK TSS107 iPS 1 357.639 344.558 589.112 136.598 - OK TSS107 hESC 1 739.786 732.278 483.973 143.401 - OK TSS107 hESC 0 392.192 396.213 261.863 73.0511 - OK TSS107 Fibroblasts 1 2716.56 2266.7 1853.03 429.805 - OK TSS107 Fibroblasts 0 837.179 996.149 814.354 189.014 - OK TSS108 iPS 0 1565.19 1633.7 2793.23 5299.48 - OK TSS108 iPS 1 1262.08 1215.91 2078.92 3899.41 - OK TSS108 hESC 1 6476.51 6410.78 4236.97 8569.68 - OK TSS108 hESC 0 6706 6774.76 4477.54 9063.75 - OK TSS108 Fibroblasts 1 15721.9 13118.3 10724.3 20192.3 - OK TSS108 Fibroblasts 0 11993.5 14270.9 11666.5 22128.9 - OK TSS109 iPS 0 0 0 0 0 - OK TSS109 iPS 1 3.43456 3.30893 5.65749 3.58464 - OK TSS109 hESC 1 69.4714 68.7663 45.4486 29.4993 - OK TSS109 hESC 0 71.0395 71.7679 47.4324 30.7869 - OK TSS109 Fibroblasts 1 386.773 322.723 263.827 167.75 - OK TSS109 Fibroblasts 0 186.297 221.672 181.218 115.224 - OK TSS11 iPS 0 21.2489 22.1789 37.9206 68.1122 - OK TSS11 iPS 1 14.0147 13.5021 23.0854 41.4654 - OK TSS11 hESC 1 124.639 123.374 81.5396 157.065 - OK TSS11 hESC 0 123.429 124.695 82.4125 158.746 - OK TSS11 Fibroblasts 1 34.9914 29.1968 23.8685 43.3015 - OK TSS11 Fibroblasts 0 29.2978 34.8611 28.4991 51.7022 - OK TSS110 iPS 0 6 6.2626 10.7076 9.53485 - OK TSS110 iPS 1 6.56544 6.32529 10.8147 9.6303 - OK TSS110 hESC 1 19.5286 19.3304 12.7757 11.7705 - OK TSS110 hESC 0 13.9605 14.1036 9.3213 8.58788 - OK TSS110 Fibroblasts 1 101.227 84.4641 69.0496 61.791 - OK TSS110 Fibroblasts 0 86.7033 103.167 84.3394 75.4735 - OK TSS111 iPS 0 0 0 0 0 - OK TSS111 iPS 1 0 0 0 0 - OK TSS111 hESC 1 0 0 0 0 - OK TSS111 hESC 0 0 0 0 0 - OK TSS111 Fibroblasts 1 0 0 0 0 - OK TSS111 Fibroblasts 0 0 0 0 0 - OK TSS112 iPS 0 633 660.705 1129.65 178.631 - OK TSS112 iPS 1 367 353.576 604.531 95.5945 - OK TSS112 hESC 1 1007 996.78 658.786 104.797 - OK TSS112 hESC 0 772 779.916 515.457 81.9967 - OK TSS112 Fibroblasts 1 11318 9443.73 7720.28 1221.87 - OK TSS112 Fibroblasts 0 6482 7712.85 6305.28 997.925 - OK TSS113 iPS 0 76.0205 79.3477 135.666 65.1076 - OK TSS113 iPS 1 95.0359 91.5597 156.545 75.128 - OK TSS113 hESC 1 38.5535 38.1622 25.222 12.3267 - OK TSS113 hESC 0 75.4218 76.1951 50.3584 24.6116 - OK TSS113 Fibroblasts 1 326.723 272.617 222.865 107.24 - OK TSS113 Fibroblasts 0 631.052 750.881 613.847 295.375 - OK TSS114 iPS 0 31.9795 33.3791 57.0704 28.8986 - OK TSS114 iPS 1 6.96411 6.70938 11.4715 5.80878 - OK TSS114 hESC 1 246.447 243.945 161.227 83.2243 - OK TSS114 hESC 0 157.578 159.194 105.214 54.3105 - OK TSS114 Fibroblasts 1 1919.28 1601.44 1309.18 664.788 - OK TSS114 Fibroblasts 0 1368.95 1628.89 1331.63 676.183 - OK TSS115 iPS 0 93 97.0703 165.967 181.635 - OK TSS115 iPS 1 138 132.952 227.317 248.776 - OK TSS115 hESC 1 355 351.397 232.243 264.325 - OK TSS115 hESC 0 275 277.82 183.615 207.776 - OK TSS115 Fibroblasts 1 238 198.587 162.345 178.752 - OK TSS115 Fibroblasts 0 327 389.093 318.085 349.306 - OK TSS116 iPS 0 161 168.046 287.32 112.156 - OK TSS116 iPS 1 207 199.428 340.975 132.661 - OK TSS116 hESC 1 1610.5 1594.15 1053.6 418.517 - OK TSS116 hESC 0 1485.5 1500.73 991.855 393.655 - OK TSS116 Fibroblasts 1 830 692.552 566.163 220.016 - OK TSS116 Fibroblasts 0 1166 1387.41 1134.21 439.399 - OK TSS117 iPS 0 110.753 115.6 197.648 53.3301 - OK TSS117 iPS 1 65.2254 62.8396 107.441 28.99 - OK TSS117 hESC 1 1396.37 1382.2 913.514 249.013 - OK TSS117 hESC 0 1468.64 1483.7 980.599 267.299 - OK TSS117 Fibroblasts 1 258.98 216.093 176.657 47.7372 - OK TSS117 Fibroblasts 0 150.739 179.363 146.63 39.6231 - OK TSS118 iPS 0 252.41 263.457 450.449 123.282 - OK TSS118 iPS 1 316.532 304.954 521.399 142.7 - OK TSS118 hESC 1 1004.86 994.664 657.388 181.788 - OK TSS118 hESC 0 753.209 760.931 502.911 139.07 - OK TSS118 Fibroblasts 1 580.628 484.476 396.06 108.56 - OK TSS118 Fibroblasts 0 416.003 494.997 404.661 110.918 - OK TSS119 iPS 0 64.8376 67.6753 115.709 30.7979 - OK TSS119 iPS 1 11.2425 10.8313 18.519 4.92915 - OK TSS119 hESC 1 163.794 162.131 107.155 28.8094 - OK TSS119 hESC 0 128.16 129.474 85.5712 23.0065 - OK TSS119 Fibroblasts 1 151.504 126.415 103.344 27.5474 - OK TSS119 Fibroblasts 0 62.3362 74.1731 60.6367 16.1633 - OK TSS12 iPS 0 26.3266 27.4788 46.9823 36.2069 - OK TSS12 iPS 1 17.3938 16.7576 28.6515 22.0803 - OK TSS12 hESC 1 447.755 443.211 292.924 232.477 - OK TSS12 hESC 0 441.772 446.302 294.967 234.098 - OK TSS12 Fibroblasts 1 157.415 131.347 107.376 83.1034 - OK TSS12 Fibroblasts 0 150.063 178.559 145.972 112.974 - OK TSS120 iPS 0 134 139.865 239.136 93.6381 - OK TSS120 iPS 1 45 43.354 74.1251 29.0251 - OK TSS120 hESC 1 151 149.467 98.7852 39.2591 - OK TSS120 hESC 0 152 153.558 101.489 40.3336 - OK TSS120 Fibroblasts 1 1306 1089.73 890.854 349.587 - OK TSS120 Fibroblasts 0 749 891.226 728.579 285.907 - OK TSS121 iPS 0 16 16.7003 28.5535 83.0164 - OK TSS121 iPS 1 30 28.9027 49.4167 143.674 - OK TSS121 hESC 1 124 122.742 81.1216 264.792 - OK TSS121 hESC 0 106 107.087 70.7752 231.02 - OK TSS121 Fibroblasts 1 9 7.5096 6.13911 18.1401 - OK TSS121 Fibroblasts 0 7 8.32921 6.80915 20.1199 - OK TSS122 iPS 0 1109.06 1157.6 1979.22 522.399 - OK TSS122 iPS 1 1239.38 1194.05 2041.54 538.955 - OK TSS122 hESC 1 6306 6242 4125.43 1101.12 - OK TSS122 hESC 0 6545.35 6612.46 4370.27 1166.01 - OK TSS122 Fibroblasts 1 6934.84 5786.43 4730.42 1250.17 - OK TSS122 Fibroblasts 0 4194.95 4991.52 4080.58 1078.03 - OK TSS123 iPS 0 34.6885 36.2067 61.9049 100.939 - OK TSS123 iPS 1 88.119 84.8958 145.152 236.676 - OK TSS123 hESC 1 0 0 0 0 - OK TSS123 hESC 0 18.7304 18.9224 12.5061 21.7232 - OK TSS123 Fibroblasts 1 78.0099 65.0914 53.2124 87.5535 - OK TSS123 Fibroblasts 0 33.5142 39.8782 32.6005 53.6395 - OK TSS124 iPS 0 10.2501 10.6987 18.2922 13.8332 - OK TSS124 iPS 1 0 0 0 0 - OK TSS124 hESC 1 0 0 0 0 - OK TSS124 hESC 0 39.9233 40.3326 26.6564 20.7482 - OK TSS124 Fibroblasts 1 277.148 231.252 189.049 143.564 - OK TSS124 Fibroblasts 0 357.534 425.425 347.786 264.109 - OK TSS125 iPS 0 2768.63 2889.8 4940.87 802.075 - OK TSS125 iPS 1 3371.62 3248.3 5553.82 864.044 - OK TSS125 hESC 1 5285.35 5231.71 3457.71 533.398 - OK TSS125 hESC 0 5571.53 5628.66 3720.06 562.166 - OK TSS125 Fibroblasts 1 9309.85 7768.14 6350.47 1154.54 - OK TSS125 Fibroblasts 0 4896.13 5825.85 4762.64 846.957 - OK TSS126 iPS 0 0 0 0 0 - OK TSS126 iPS 1 0 0 0 0 - OK TSS126 hESC 1 0 0 0 0 - OK TSS126 hESC 0 23.6385 23.8809 15.7832 2.13723 - OK TSS126 Fibroblasts 1 373.562 311.7 254.816 34.3558 - OK TSS126 Fibroblasts 0 0 0 0 0 - OK TSS127 iPS 0 260.373 271.768 464.659 77.006 - OK TSS127 iPS 1 276.377 266.268 455.255 75.4475 - OK TSS127 hESC 1 781.646 773.713 511.358 85.2765 - OK TSS127 hESC 0 867.829 876.727 579.442 96.6552 - OK TSS127 Fibroblasts 1 237.084 197.823 161.721 26.8258 - OK TSS127 Fibroblasts 0 149.868 178.327 145.782 24.182 - OK TSS128 iPS 0 987 1030.2 1761.39 1412.22 - OK TSS128 iPS 1 1065 1026.04 1754.29 1404.74 - OK TSS128 hESC 1 13196 13062.1 8632.91 7131.86 - OK TSS128 hESC 0 13588 13727.3 9072.58 7500.15 - OK TSS128 Fibroblasts 1 18899.5 15769.7 12891.8 10368.6 - OK TSS128 Fibroblasts 0 22201 26416.7 21595.7 17372.9 - OK TSS129 iPS 0 27.0769 28.2619 48.3212 60.771 - OK TSS129 iPS 1 46.3858 44.6891 76.4078 99.6565 - OK TSS129 hESC 1 91.2783 90.3519 59.7149 82.0919 - OK TSS129 hESC 0 121.481 122.727 81.1119 111.2 - OK TSS129 Fibroblasts 1 70.8432 59.1116 48.3239 60.4077 - OK TSS129 Fibroblasts 0 147.858 175.934 143.826 185.94 - OK TSS13 iPS 0 17.9569 18.7428 32.0458 46.1833 - OK TSS13 iPS 1 9.72988 9.37399 16.0273 23.098 - OK TSS13 hESC 1 188.786 186.87 123.505 188.186 - OK TSS13 hESC 0 181.802 183.666 121.388 184.96 - OK TSS13 Fibroblasts 1 63.5465 53.0231 43.3466 62.9707 - OK TSS13 Fibroblasts 0 40.0211 47.6206 38.9299 56.5546 - OK TSS130 iPS 0 106.64 111.308 190.31 213.733 - OK TSS130 iPS 1 68.4561 65.9521 112.762 126.641 - OK TSS130 hESC 1 193.766 191.799 126.763 148.64 - OK TSS130 hESC 0 173.706 175.487 115.982 135.998 - OK TSS130 Fibroblasts 1 636.642 531.214 434.269 490.761 - OK TSS130 Fibroblasts 0 498.66 593.35 485.065 548.165 - OK TSS131 iPS 0 12.2827 12.8203 21.9197 30.5023 - OK TSS131 iPS 1 14.1581 13.6403 23.3216 32.4531 - OK TSS131 hESC 1 33.9557 33.6111 22.214 32.618 - OK TSS131 hESC 0 24.8128 25.0672 16.5673 24.3266 - OK TSS131 Fibroblasts 1 19.5146 16.283 13.3114 18.6668 - OK TSS131 Fibroblasts 0 5.48206 6.52303 5.3326 7.47801 - OK TSS132 iPS 0 159 165.959 283.75 265.276 - OK TSS132 iPS 1 130 125.245 214.139 197.646 - OK TSS132 hESC 1 1128.5 1117.05 738.272 699.009 - OK TSS132 hESC 0 1139 1150.68 760.5 732.278 - OK TSS132 Fibroblasts 1 1717 1432.66 1171.21 1366.05 - OK TSS132 Fibroblasts 0 1648 1960.93 1603.07 1776.12 - OK TSS133 iPS 0 0 0 0 0 - OK TSS133 iPS 1 0 0 0 0 - OK TSS133 hESC 1 0 0 0 0 - OK TSS133 hESC 0 0 0 0 0 - OK TSS133 Fibroblasts 1 0 0 0 0 - OK TSS133 Fibroblasts 0 0 0 0 0 - OK TSS134 iPS 0 3124 3260.73 5575.07 1949.32 - OK TSS134 iPS 1 3262 3142.68 5373.24 1878.45 - OK TSS134 hESC 1 8537 8450.36 5584.96 1977.36 - OK TSS134 hESC 0 12073 12196.8 8061.03 2856.06 - OK TSS134 Fibroblasts 1 10008 8350.67 6826.7 2389.86 - OK TSS134 Fibroblasts 0 9042 10759 8795.48 3079.08 - OK TSS135 iPS 0 21 21.9191 37.4765 25.6157 - OK TSS135 iPS 1 22 21.1953 36.2389 24.7698 - OK TSS135 hESC 1 2 1.9797 1.30841 0.917903 - OK TSS135 hESC 0 2 2.02051 1.33538 0.936822 - OK TSS135 Fibroblasts 1 22 18.3568 15.0067 10.2962 - OK TSS135 Fibroblasts 0 16 19.0382 15.5638 10.6784 - OK TSS136 iPS 0 412 430.032 735.253 298.392 - OK TSS136 iPS 1 622 599.249 1024.57 415.809 - OK TSS136 hESC 1 1113 1101.7 728.132 300.08 - OK TSS136 hESC 0 1164 1175.93 777.192 320.299 - OK TSS136 Fibroblasts 1 953 795.183 650.064 264.412 - OK TSS136 Fibroblasts 0 1005 1195.84 977.6 397.637 - OK TSS137 iPS 0 25.2549 26.3602 45.0697 27.7045 - OK TSS137 iPS 1 47.4264 45.6917 78.1219 46.2428 - OK TSS137 hESC 1 349 345.458 228.318 72.7105 - OK TSS137 hESC 0 330 333.384 220.338 78.0844 - OK TSS137 Fibroblasts 1 0 0 0 0 - OK TSS137 Fibroblasts 0 3.99971 4.7592 3.89066 1.09247 - OK TSS138 iPS 0 9.7451 10.1716 17.391 9.21532 - OK TSS138 iPS 1 17.5736 16.9308 28.9476 15.339 - OK TSS138 hESC 1 0 0 0 0 - OK TSS138 hESC 0 0 0 0 0 - OK TSS138 Fibroblasts 1 0 0 0 0 - OK TSS138 Fibroblasts 0 0.000292256 0.000347751 0.000284288 0.000151083 - OK TSS139 iPS 0 0 0 0 0 - OK TSS139 iPS 1 0 0 0 0 - OK TSS139 hESC 1 53.6808 53.136 35.1183 18.315 - OK TSS139 hESC 0 56.7225 57.3041 37.8731 19.7517 - OK TSS139 Fibroblasts 1 17.4744 14.5807 11.9197 6.11415 - OK TSS139 Fibroblasts 0 25.6658 30.5395 24.9661 12.8062 - OK TSS14 iPS 0 9 9.3939 16.0613 10.1857 - OK TSS14 iPS 1 2 1.92684 3.29445 2.19245 - OK TSS14 hESC 1 59 58.4012 38.5982 24.5627 - OK TSS14 hESC 0 52 52.5332 34.7199 21.6849 - OK TSS14 Fibroblasts 1 107 89.2808 72.9873 44.6519 - OK TSS14 Fibroblasts 0 116 138.027 112.837 72.7904 - OK TSS140 iPS 0 174.999 182.658 312.301 190.415 - OK TSS140 iPS 1 157.5 151.739 259.438 149.462 - OK TSS140 hESC 1 1357.9 1344.12 888.347 565.926 - OK TSS140 hESC 0 1235.39 1248.05 824.857 543.694 - OK TSS140 Fibroblasts 1 1025.67 855.823 699.637 437.919 - OK TSS140 Fibroblasts 0 714.334 849.978 694.859 387.592 - OK TSS141 iPS 0 52 54.2759 92.7989 95.1547 - OK TSS141 iPS 1 35 33.7198 57.6528 59.1164 - OK TSS141 hESC 1 32.5 32.1702 21.2617 22.6755 - OK TSS141 hESC 0 41.5 41.9255 27.7092 29.5516 - OK TSS141 Fibroblasts 1 535 446.404 364.936 376.331 - OK TSS141 Fibroblasts 0 340 404.562 330.73 341.057 - OK TSS142 iPS 0 111 115.858 198.09 174.527 - OK TSS142 iPS 1 155 149.33 255.32 224.949 - OK TSS142 hESC 1 623 616.677 407.571 371.39 - OK TSS142 hESC 0 533 538.465 355.879 324.287 - OK TSS142 Fibroblasts 1 4 3.3376 2.7285 2.41569 - OK TSS142 Fibroblasts 0 24 28.5573 23.3457 20.6692 - OK TSS143 iPS 0 315.5 329.308 563.039 778.344 - OK TSS143 iPS 1 312 300.588 513.934 700.977 - OK TSS143 hESC 1 1847 1828.25 1208.32 1754.96 - OK TSS143 hESC 0 1624 1640.65 1084.33 1578.97 - OK TSS143 Fibroblasts 1 2086 1740.56 1422.91 1986.29 - OK TSS143 Fibroblasts 0 1290 1534.95 1254.83 1766.01 - OK TSS144 iPS 0 2 2.08753 3.56919 6.9543 - OK TSS144 iPS 1 0 0 0 0 - OK TSS144 hESC 1 2 1.9797 1.30841 3.66236 - OK TSS144 hESC 0 2 2.02051 1.33538 3.73785 - OK TSS144 Fibroblasts 1 2 1.6688 1.36425 2.65814 - OK TSS144 Fibroblasts 0 0 0 0 0 - OK TSS145 iPS 0 0 0 0 0 - OK TSS145 iPS 1 0 0 0 0 - OK TSS145 hESC 1 6.73468 6.66633 4.40587 2.55177 - OK TSS145 hESC 0 5.35203 5.40691 3.5735 2.06969 - OK TSS145 Fibroblasts 1 0 0 0 0 - OK TSS145 Fibroblasts 0 0 0 0 0 - OK TSS146 iPS 0 1.1068 1.15524 1.97519 1.77902 - OK TSS146 iPS 1 1.1557 1.11343 1.9037 1.71463 - OK TSS146 hESC 1 4.67799 4.63051 3.06037 2.85302 - OK TSS146 hESC 0 2.20873 2.23138 1.47475 1.37483 - OK TSS146 Fibroblasts 1 23.6964 19.7722 16.1639 14.6313 - OK TSS146 Fibroblasts 0 4.41645 5.25508 4.29604 3.88872 - OK TSS147 iPS 0 195 203.535 347.996 104.885 - OK TSS147 iPS 1 331.668 319.536 546.331 193.516 - OK TSS147 hESC 1 1869.96 1850.98 1223.34 334.446 - OK TSS147 hESC 0 1994.87 2015.32 1331.96 386.127 - OK TSS147 Fibroblasts 1 3424.07 2857.04 2335.64 625.358 - OK TSS147 Fibroblasts 0 1753.75 2086.77 1705.94 502.348 - OK TSS148 iPS 0 1 1.04377 1.78459 3.29327 - OK TSS148 iPS 1 3.33225 3.21037 5.48896 9.83419 - OK TSS148 hESC 1 1.04328 1.03269 0.682521 2.19742 - OK TSS148 hESC 0 10.1322 10.2361 6.76515 15.5261 - OK TSS148 Fibroblasts 1 7.92867 6.61568 5.40833 13.0236 - OK TSS148 Fibroblasts 0 9.24602 11.0017 8.99394 19.2261 - OK TSS149 iPS 0 1339 1397.6 2389.57 1190.97 - OK TSS149 iPS 1 647 623.334 1065.75 531.193 - OK TSS149 hESC 1 3045.5 3014.59 1992.39 1012.93 - OK TSS149 hESC 0 2721 2748.9 1816.79 923.474 - OK TSS149 Fibroblasts 1 40380.2 33693.2 27544.3 13772 - OK TSS149 Fibroblasts 0 14288 17001.1 13898.5 6948.19 - OK TSS15 iPS 0 136 141.952 242.705 694.225 - OK TSS15 iPS 1 80 77.0738 131.778 376.933 - OK TSS15 hESC 1 536 530.56 350.655 1123.84 - OK TSS15 hESC 0 469 473.809 313.147 1003.63 - OK TSS15 Fibroblasts 1 1854 1546.98 1264.66 3675.44 - OK TSS15 Fibroblasts 0 998 1187.51 970.791 2821.38 - OK TSS150 iPS 0 1260 1315.15 2248.59 707.831 - OK TSS150 iPS 1 1124 1082.89 1851.48 583 - OK TSS150 hESC 1 4691.5 4643.89 3069.21 978.226 - OK TSS150 hESC 0 4311.5 4355.71 2878.75 919.556 - OK TSS150 Fibroblasts 1 12340 10296.5 8417.41 2648.91 - OK TSS150 Fibroblasts 0 10035 11940.5 9761.41 3074.85 - OK TSS151 iPS 0 278 290.167 496.117 494.029 - OK TSS151 iPS 1 309 297.698 508.992 506.85 - OK TSS151 hESC 1 1805 1786.68 1180.84 1221.6 - OK TSS151 hESC 0 1856 1875.03 1239.23 1282.01 - OK TSS151 Fibroblasts 1 671 559.882 457.705 458.299 - OK TSS151 Fibroblasts 0 699 831.731 679.943 680.824 - OK TSS152 iPS 0 258 269.292 460.425 185.743 - OK TSS152 iPS 1 318.096 306.46 523.974 211.25 - OK TSS152 hESC 1 1726.07 1708.55 1129.21 461.712 - OK TSS152 hESC 0 1501 1516.39 1002.2 409.802 - OK TSS152 Fibroblasts 1 0 0 0 0 - OK TSS152 Fibroblasts 0 22.9337 27.2886 22.3085 8.99378 - OK TSS153 iPS 0 0 0 0 0 - OK TSS153 iPS 1 7.40444 7.1336 12.1968 8.69605 - OK TSS153 hESC 1 22.4298 22.2022 14.6738 9.70689 - OK TSS153 hESC 0 23.1709 23.4084 15.471 11.3073 - OK TSS153 Fibroblasts 1 2 1.6688 1.36425 0.976754 - OK TSS153 Fibroblasts 0 10.0663 11.9777 9.79182 7.01063 - OK TSS154 iPS 0 19 19.8316 33.9073 14.1337 - OK TSS154 iPS 1 24 23.1221 39.5334 16.479 - OK TSS154 hESC 1 145 143.528 94.86 39.0304 - OK TSS154 hESC 0 107 108.097 71.4429 29.575 - OK TSS154 Fibroblasts 1 6387 5329.31 4356.72 1764.21 - OK TSS154 Fibroblasts 0 2561 3047.3 2491.18 1010.17 - OK TSS155 iPS 0 2341.65 2444.14 4178.9 367.537 - OK TSS155 iPS 1 2013.2 1939.56 3316.18 291.391 - OK TSS155 hESC 1 1111.15 1099.87 726.919 64.1451 - OK TSS155 hESC 0 1357.31 1371.23 906.263 79.9709 - OK TSS155 Fibroblasts 1 4503.34 3757.59 3071.84 270.301 - OK TSS155 Fibroblasts 0 1318.3 1568.63 1282.36 112.839 - OK TSS156 iPS 0 95.0463 99.2062 169.619 17.4137 - OK TSS156 iPS 1 103.377 99.5954 170.284 17.4821 - OK TSS156 hESC 1 877.351 868.447 573.969 59.1542 - OK TSS156 hESC 0 1067.43 1078.37 712.712 73.4533 - OK TSS156 Fibroblasts 1 1276.67 1065.25 870.844 89.4549 - OK TSS156 Fibroblasts 0 997.165 1186.51 969.979 99.6383 - OK TSS157 iPS 0 61.4648 64.1549 109.69 39.8411 - OK TSS157 iPS 1 66.4282 63.9984 109.422 39.7439 - OK TSS157 hESC 1 0 0 0 0 - OK TSS157 hESC 0 0 0 0 0 - OK TSS157 Fibroblasts 1 0 0 0 0 - OK TSS157 Fibroblasts 0 0 0 0 0 - OK TSS158 iPS 0 0 0 0 0 - OK TSS158 iPS 1 0 0 0 0 - OK TSS158 hESC 1 135.292 133.918 88.5086 22.971 - OK TSS158 hESC 0 99.8053 100.829 66.6391 17.2952 - OK TSS158 Fibroblasts 1 180.992 151.02 123.459 31.7774 - OK TSS158 Fibroblasts 0 393.634 468.38 382.902 98.556 - OK TSS159 iPS 0 0 0 0 0 - OK TSS159 iPS 1 0 0 0 0 - OK TSS159 hESC 1 17.2114 17.0367 11.2598 3.98354 - OK TSS159 hESC 0 24.4551 24.7058 16.3284 5.77674 - OK TSS159 Fibroblasts 1 0 0 0 0 - OK TSS159 Fibroblasts 0 15.898 18.9168 15.4646 5.40974 - OK TSS16 iPS 0 465 485.352 829.836 164.14 - OK TSS16 iPS 1 494.333 476.252 814.277 161.062 - OK TSS16 hESC 1 14186.7 14042.7 9281.01 1849.52 - OK TSS16 hESC 0 14148 14293.1 9446.49 1882.49 - OK TSS16 Fibroblasts 1 23277.1 19422.4 15877.9 3144.04 - OK TSS16 Fibroblasts 0 10113.6 12034 9837.85 1948.03 - OK TSS160 iPS 0 1 1.04377 1.78459 1.60382 - OK TSS160 iPS 1 0 0 0 0 - OK TSS160 hESC 1 2 1.9797 1.30841 1.36757 - OK TSS160 hESC 0 2 2.02051 1.33538 1.39576 - OK TSS160 Fibroblasts 1 0 0 0 0 - OK TSS160 Fibroblasts 0 0 0 0 0 - OK TSS161 iPS 0 116 121.077 207.013 76.3378 - OK TSS161 iPS 1 60 57.8053 98.8334 36.0181 - OK TSS161 hESC 1 37 36.6245 24.2056 8.96689 - OK TSS161 hESC 0 45 45.4614 30.0461 11.2309 - OK TSS161 Fibroblasts 1 0 0 0 0 - OK TSS161 Fibroblasts 0 0 0 0 0 - OK TSS162 iPS 0 1 1.04377 1.78459 2.81427 - OK TSS162 iPS 1 0 0 0 0 - OK TSS162 hESC 1 0 0 0 0 - OK TSS162 hESC 0 2 2.02051 1.33538 2.58093 - OK TSS162 Fibroblasts 1 0 0 0 0 - OK TSS162 Fibroblasts 0 0 0 0 0 - OK TSS163 iPS 0 0 0 0 0 - OK TSS163 iPS 1 5 4.81711 8.23612 7.21151 - OK TSS163 hESC 1 3 2.96955 1.96262 1.55706 - OK TSS163 hESC 0 0 0 0 0 - OK TSS163 Fibroblasts 1 0 0 0 0 - OK TSS163 Fibroblasts 0 0 0 0 0 - OK TSS164 iPS 0 0 0 0 0 - OK TSS164 iPS 1 1.33333 1.28456 2.1963 2.15969 - OK TSS164 hESC 1 0 0 0 0 - OK TSS164 hESC 0 0 0 0 0 - OK TSS164 Fibroblasts 1 0 0 0 0 - OK TSS164 Fibroblasts 0 0 0 0 0 - OK TSS165 iPS 0 0 0 0 0 - OK TSS165 iPS 1 0 0 0 0 - OK TSS165 hESC 1 0 0 0 0 - OK TSS165 hESC 0 0 0 0 0 - OK TSS165 Fibroblasts 1 0 0 0 0 - OK TSS165 Fibroblasts 0 0 0 0 0 - OK TSS166 iPS 0 0 0 0 0 - OK TSS166 iPS 1 0 0 0 0 - OK TSS166 hESC 1 0 0 0 0 - OK TSS166 hESC 0 0 0 0 0 - OK TSS166 Fibroblasts 1 0 0 0 0 - OK TSS166 Fibroblasts 0 0 0 0 0 - OK TSS167 iPS 0 0 0 0 0 - OK TSS167 iPS 1 0 0 0 0 - OK TSS167 hESC 1 0 0 0 0 - OK TSS167 hESC 0 0 0 0 0 - OK TSS167 Fibroblasts 1 0 0 0 0 - OK TSS167 Fibroblasts 0 0 0 0 0 - OK TSS168 iPS 0 0 0 0 0 - OK TSS168 iPS 1 0.45 0.43354 0.741251 0.621345 - OK TSS168 hESC 1 0 0 0 0 - OK TSS168 hESC 0 0 0 0 0 - OK TSS168 Fibroblasts 1 0 0 0 0 - OK TSS168 Fibroblasts 0 0 0 0 0 - OK TSS169 iPS 0 0 0 0 0 - OK TSS169 iPS 1 0.2 0.192684 0.329445 0.27485 - OK TSS169 hESC 1 0 0 0 0 - OK TSS169 hESC 0 0 0 0 0 - OK TSS169 Fibroblasts 1 0 0 0 0 - OK TSS169 Fibroblasts 0 0 0 0 0 - OK TSS17 iPS 0 8 8.35014 14.2767 25.7423 - OK TSS17 iPS 1 6 5.78053 9.88334 17.3988 - OK TSS17 hESC 1 28 27.7158 18.3178 35.5057 - OK TSS17 hESC 0 24 24.2461 16.0246 31.8673 - OK TSS17 Fibroblasts 1 19 15.8536 12.9604 23.8311 - OK TSS17 Fibroblasts 0 65 77.3427 63.2279 115.929 - OK TSS170 iPS 0 0 0 0 0 - OK TSS170 iPS 1 0 0 0 0 - OK TSS170 hESC 1 0 0 0 0 - OK TSS170 hESC 0 0 0 0 0 - OK TSS170 Fibroblasts 1 0 0 0 0 - OK TSS170 Fibroblasts 0 0 0 0 0 - OK TSS171 iPS 0 0 0 0 0 - OK TSS171 iPS 1 0 0 0 0 - OK TSS171 hESC 1 0 0 0 0 - OK TSS171 hESC 0 0 0 0 0 - OK TSS171 Fibroblasts 1 0 0 0 0 - OK TSS171 Fibroblasts 0 0 0 0 0 - OK TSS172 iPS 0 0 0 0 0 - OK TSS172 iPS 1 0 0 0 0 - OK TSS172 hESC 1 0 0 0 0 - OK TSS172 hESC 0 0 0 0 0 - OK TSS172 Fibroblasts 1 0 0 0 0 - OK TSS172 Fibroblasts 0 0 0 0 0 - OK TSS173 iPS 0 0 0 0 0 - OK TSS173 iPS 1 0.2 0.192684 0.329445 0.27485 - OK TSS173 hESC 1 0 0 0 0 - OK TSS173 hESC 0 0 0 0 0 - OK TSS173 Fibroblasts 1 0 0 0 0 - OK TSS173 Fibroblasts 0 0 0 0 0 - OK TSS174 iPS 0 0 0 0 0 - OK TSS174 iPS 1 0 0 0 0 - OK TSS174 hESC 1 1 0.989851 0.654207 0.594357 - OK TSS174 hESC 0 0 0 0 0 - OK TSS174 Fibroblasts 1 0 0 0 0 - OK TSS174 Fibroblasts 0 0 0 0 0 - OK TSS175 iPS 0 0 0 0 0 - OK TSS175 iPS 1 0 0 0 0 - OK TSS175 hESC 1 0 0 0 0 - OK TSS175 hESC 0 0 0 0 0 - OK TSS175 Fibroblasts 1 0 0 0 0 - OK TSS175 Fibroblasts 0 0 0 0 0 - OK TSS176 iPS 0 922 962.353 1645.4 881.769 - OK TSS176 iPS 1 1933 1862.3 3184.08 1706.61 - OK TSS176 hESC 1 4789.78 4741.16 3133.5 1713.79 - OK TSS176 hESC 0 4713.74 4762.07 3147.32 1721.22 - OK TSS176 Fibroblasts 1 194 161.874 132.332 71.0962 - OK TSS176 Fibroblasts 0 287 341.498 279.175 150.019 - OK TSS177 iPS 0 0 0 0 0 - OK TSS177 iPS 1 0 0 0 0 - OK TSS177 hESC 1 28.2243 27.9379 18.4645 10.5389 - OK TSS177 hESC 0 9.25743 9.35235 6.1811 3.52794 - OK TSS177 Fibroblasts 1 0 0 0 0 - OK TSS177 Fibroblasts 0 0 0 0 0 - OK TSS178 iPS 0 0 0 0 0 - OK TSS178 iPS 1 0 0 0 0 - OK TSS178 hESC 1 0 0 0 0 - OK TSS178 hESC 0 0 0 0 0 - OK TSS178 Fibroblasts 1 0 0 0 0 - OK TSS178 Fibroblasts 0 0 0 0 0 - OK TSS179 iPS 0 0 0 0 0 - OK TSS179 iPS 1 0 0 0 0 - OK TSS179 hESC 1 0 0 0 0 - OK TSS179 hESC 0 64.2026 64.8609 42.8675 24.4573 - OK TSS179 Fibroblasts 1 106.059 88.4955 72.3453 40.5337 - OK TSS179 Fibroblasts 0 38.8498 46.2269 37.7906 21.1734 - OK TSS18 iPS 0 0 0 0 0 - OK TSS18 iPS 1 0 0 0 0 - OK TSS18 hESC 1 2 1.9797 1.30841 1.32641 - OK TSS18 hESC 0 3 3.03076 2.00307 2.03063 - OK TSS18 Fibroblasts 1 0 0 0 0 - OK TSS18 Fibroblasts 0 0 0 0 0 - OK TSS180 iPS 0 155.699 162.514 277.86 52.2444 - OK TSS180 iPS 1 227.216 218.905 374.275 72.199 - OK TSS180 hESC 1 274.017 271.236 179.263 33.4873 - OK TSS180 hESC 0 232.526 234.911 155.256 29.0028 - OK TSS180 Fibroblasts 1 48.7621 40.687 33.2618 6.04786 - OK TSS180 Fibroblasts 0 144.201 171.583 140.269 25.8655 - OK TSS181 iPS 0 0 0 0 0 - OK TSS181 iPS 1 0 0 0 0 - OK TSS181 hESC 1 3.76812 3.72987 2.46513 1.82725 - OK TSS181 hESC 0 3.3885 3.42324 2.26247 1.67704 - OK TSS181 Fibroblasts 1 0 0 0 0 - OK TSS181 Fibroblasts 0 0 0 0 0 - OK TSS182 iPS 0 461.938 482.156 824.372 196.471 - OK TSS182 iPS 1 413.582 398.454 681.262 157.864 - OK TSS182 hESC 1 787.976 779.978 515.499 121.532 - OK TSS182 hESC 0 648.291 654.938 432.858 101.184 - OK TSS182 Fibroblasts 1 2893.45 2414.3 1973.69 553.315 - OK TSS182 Fibroblasts 0 1323.43 1574.73 1287.35 309.088 - OK TSS183 iPS 0 64.6634 67.4936 115.398 42.1273 - OK TSS183 iPS 1 78 75.1469 128.483 48.6918 - OK TSS183 hESC 1 225.266 222.98 147.371 49.6114 - OK TSS183 hESC 0 260.966 263.642 174.245 62.0809 - OK TSS183 Fibroblasts 1 27.6455 23.0674 18.8577 4.56321 - OK TSS183 Fibroblasts 0 51.7136 61.5333 50.3037 19.0785 - OK TSS184 iPS 0 8.83086 9.21737 15.7595 6.06681 - OK TSS184 iPS 1 0 0 0 0 - OK TSS184 hESC 1 83.2965 82.4511 54.4931 21.2858 - OK TSS184 hESC 0 64.0713 64.7282 42.7798 16.7104 - OK TSS184 Fibroblasts 1 134.538 112.258 91.7715 35.4038 - OK TSS184 Fibroblasts 0 59.5045 70.8037 57.8822 22.3299 - OK TSS185 iPS 0 0 0 0 0 - OK TSS185 iPS 1 0 0 0 0 - OK TSS185 hESC 1 0 0 0 0 - OK TSS185 hESC 0 0.0140505 0.0141946 0.0093814 0.00387759 - OK TSS185 Fibroblasts 1 0 0 0 0 - OK TSS185 Fibroblasts 0 60.9357 72.5066 59.2744 24.1793 - OK TSS186 iPS 0 30.7741 32.121 54.9193 22.2883 - OK TSS186 iPS 1 0 0 0 0 - OK TSS186 hESC 1 0 0 0 0 - OK TSS186 hESC 0 0 0 0 0 - OK TSS186 Fibroblasts 1 889.777 742.43 606.938 246.871 - OK TSS186 Fibroblasts 0 384.865 457.946 374.372 152.275 - OK TSS187 iPS 0 2.45438 2.5618 4.38007 1.92088 - OK TSS187 iPS 1 0 0 0 0 - OK TSS187 hESC 1 307.106 303.989 200.911 89.5863 - OK TSS187 hESC 0 243.534 246.031 162.605 72.5057 - OK TSS187 Fibroblasts 1 1070.39 893.135 730.14 320.98 - OK TSS187 Fibroblasts 0 226.983 270.084 220.794 97.0643 - OK TSS188 iPS 0 6.78866 7.08578 12.115 3.9301 - OK TSS188 iPS 1 16.325 15.7279 26.8909 8.72341 - OK TSS188 hESC 1 14.1026 13.9595 9.22603 3.02987 - OK TSS188 hESC 0 31.3239 31.6451 20.9147 6.86848 - OK TSS188 Fibroblasts 1 100.757 84.0713 68.7285 22.3355 - OK TSS188 Fibroblasts 0 19.999 23.7966 19.4538 6.32212 - OK TSS189 iPS 0 11.0687 11.5532 19.7532 15.7461 - OK TSS189 iPS 1 55.589 53.5557 91.5675 71.5437 - OK TSS189 hESC 1 181.18 179.341 118.529 97.4026 - OK TSS189 hESC 0 89.4969 90.4145 59.7562 48.2456 - OK TSS189 Fibroblasts 1 34.2972 28.6176 23.3949 18.7315 - OK TSS189 Fibroblasts 0 56.138 66.7979 54.6074 43.7219 - OK TSS19 iPS 0 0 0 0 0 - OK TSS19 iPS 1 0 0 0 0 - OK TSS19 hESC 1 29.9663 29.6622 19.6042 13.6046 - OK TSS19 hESC 0 10.9619 11.0743 7.31919 5.07923 - OK TSS19 Fibroblasts 1 0 0 0 0 - OK TSS19 Fibroblasts 0 0 0 0 0 - OK TSS190 iPS 0 53.9313 56.2917 96.2454 78.0853 - OK TSS190 iPS 1 94.411 90.9577 155.516 123.632 - OK TSS190 hESC 1 271.82 269.062 177.827 145.226 - OK TSS190 hESC 0 334.503 337.933 223.345 181.961 - OK TSS190 Fibroblasts 1 1515.7 1264.7 1033.9 836.291 - OK TSS190 Fibroblasts 0 662.862 788.731 644.79 515.509 - OK TSS1906 iPS 0 11.7714 12.2866 21.0072 44.0537 - OK TSS1906 iPS 1 0 0 0 0 - OK TSS1906 hESC 1 308.23 305.101 201.646 459.054 - OK TSS1906 hESC 0 183.028 184.905 122.206 278.207 - OK TSS1906 Fibroblasts 1 269.295 224.699 183.692 389.73 - OK TSS1906 Fibroblasts 0 349.578 415.959 340.048 721.461 - OK TSS1907 iPS 0 316.752 330.615 565.273 544.026 - OK TSS1907 iPS 1 270.131 260.25 444.966 446.438 - OK TSS1907 hESC 1 145.071 143.599 94.9065 98.9784 - OK TSS1907 hESC 0 130.874 132.216 87.3835 91.1326 - OK TSS1907 Fibroblasts 1 101.753 84.9031 69.4085 70.0438 - OK TSS1907 Fibroblasts 0 83.3839 99.2175 81.1105 81.853 - OK TSS1908 iPS 0 41.2984 43.1059 73.7009 66.0867 - OK TSS1908 iPS 1 67.9161 65.4319 111.873 100.315 - OK TSS1908 hESC 1 0.0224971 0.0222688 0.0147178 0.0136576 - OK TSS1908 hESC 0 0 0 0 0 - OK TSS1908 Fibroblasts 1 10.3764 8.65805 7.07798 6.37832 - OK TSS1908 Fibroblasts 0 0 0 0 0 - OK TSS1909 iPS 0 243.465 254.121 434.486 278.436 - OK TSS1909 iPS 1 231.139 222.684 380.737 246.952 - OK TSS1909 hESC 1 516.735 511.49 338.051 296.036 - OK TSS1909 hESC 0 529.869 535.302 353.789 302.784 - OK TSS1909 Fibroblasts 1 411.192 343.098 280.484 295.783 - OK TSS1909 Fibroblasts 0 500.044 594.996 486.411 420.858 - OK TSS191 iPS 0 3.48482 3.63734 6.21899 1.78711 - OK TSS191 iPS 1 11.3592 10.9437 18.7112 5.37691 - OK TSS191 hESC 1 36.7099 36.3374 24.0159 6.97666 - OK TSS191 hESC 0 28.2328 28.5223 18.8508 5.47619 - OK TSS191 Fibroblasts 1 11.9829 9.99849 8.17379 2.35258 - OK TSS191 Fibroblasts 0 8.66672 10.3124 8.43043 2.42645 - OK TSS1910 iPS 0 0 0 0 0 - OK TSS1910 iPS 1 0 0 0 0 - OK TSS1910 hESC 1 0 0 0 0 - OK TSS1910 hESC 0 0 0 0 0 - OK TSS1910 Fibroblasts 1 0 0 0 0 - OK TSS1910 Fibroblasts 0 0 0 0 0 - OK TSS1911 iPS 0 31.7356 33.1245 56.6351 145.784 - OK TSS1911 iPS 1 45.5666 43.8999 75.0583 193.207 - OK TSS1911 hESC 1 153.782 152.221 100.605 286.708 - OK TSS1911 hESC 0 102.01 103.056 68.1115 194.107 - OK TSS1911 Fibroblasts 1 104.383 87.0974 71.2023 185.924 - OK TSS1911 Fibroblasts 0 96.1734 114.436 93.5513 244.282 - OK TSS1912 iPS 0 35.4775 37.0302 63.3129 104.805 - OK TSS1912 iPS 1 8.74769 8.42772 14.4094 23.8526 - OK TSS1912 hESC 1 22.1603 21.9354 14.4974 25.5907 - OK TSS1912 hESC 0 199.219 201.261 133.016 234.799 - OK TSS1912 Fibroblasts 1 0 0 0 0 - OK TSS1912 Fibroblasts 0 229.82 273.46 223.554 373.474 - OK TSS1913 iPS 0 3 3.1313 5.35378 7.87617 - OK TSS1913 iPS 1 8 7.70738 13.1778 19.3864 - OK TSS1913 hESC 1 25 24.7463 16.3552 25.4692 - OK TSS1913 hESC 0 9 9.09228 6.00922 9.35791 - OK TSS1913 Fibroblasts 1 0 0 0 0 - OK TSS1913 Fibroblasts 0 6 7.13933 5.83642 8.65652 - OK TSS1914 iPS 0 14 14.6127 24.9843 16.0241 - OK TSS1914 iPS 1 9 8.6708 14.825 9.50827 - OK TSS1914 hESC 1 6 5.9391 3.92524 2.57971 - OK TSS1914 hESC 0 5.5 5.55639 3.6723 2.41348 - OK TSS1914 Fibroblasts 1 37.6667 31.4291 25.6933 16.5374 - OK TSS1914 Fibroblasts 0 16.5 19.6331 16.0501 10.3306 - OK TSS1915 iPS 0 15.5488 16.2293 27.7482 9.56295 - OK TSS1915 iPS 1 38.7376 37.3207 63.8095 21.9908 - OK TSS1915 hESC 1 97.058 96.073 63.496 22.17 - OK TSS1915 hESC 0 66.4132 67.0942 44.3435 15.4828 - OK TSS1915 Fibroblasts 1 23.2257 19.3795 15.8428 5.47035 - OK TSS1915 Fibroblasts 0 1.64525 1.95767 1.6004 0.552601 - OK TSS1916 iPS 0 243.238 253.883 434.08 148.765 - OK TSS1916 iPS 1 307.386 296.143 506.334 173.527 - OK TSS1916 hESC 1 1241.54 1228.94 812.223 281.992 - OK TSS1916 hESC 0 1368.78 1382.81 913.919 317.299 - OK TSS1916 Fibroblasts 1 181.629 151.551 123.893 42.5403 - OK TSS1916 Fibroblasts 0 101.282 120.514 98.5202 33.8281 - OK TSS1917 iPS 0 182.21 190.184 325.17 205.729 - OK TSS1917 iPS 1 259.811 250.308 427.967 322.532 - OK TSS1917 hESC 1 1305.54 1292.29 854.091 774.047 - OK TSS1917 hESC 0 1145.33 1157.07 764.727 729.134 - OK TSS1917 Fibroblasts 1 168.498 140.594 114.936 88.056 - OK TSS1917 Fibroblasts 0 68.8899 81.9713 67.0117 45.0021 - OK TSS1918 iPS 0 110 114.814 196.305 241.563 - OK TSS1918 iPS 1 123 118.501 202.608 249.319 - OK TSS1918 hESC 1 291.5 288.542 190.701 246.048 - OK TSS1918 hESC 0 278 280.85 185.618 239.489 - OK TSS1918 Fibroblasts 1 71.8333 59.9377 48.9992 60.7083 - OK TSS1918 Fibroblasts 0 32 38.0764 31.1276 38.5659 - OK TSS1919 iPS 0 9 9.3939 16.0613 14.7863 - OK TSS1919 iPS 1 13 12.5245 21.4139 19.7139 - OK TSS1919 hESC 1 3 2.96955 1.96262 1.87158 - OK TSS1919 hESC 0 4 4.04101 2.67076 2.54688 - OK TSS1919 Fibroblasts 1 16 13.3504 10.914 10.0989 - OK TSS1919 Fibroblasts 0 5 5.94944 4.86368 4.50045 - OK TSS192 iPS 0 2.51518 2.62526 4.48857 1.90183 - OK TSS192 iPS 1 3.64078 3.50761 5.99718 2.54104 - OK TSS192 hESC 1 7.96989 7.889 5.21396 2.24494 - OK TSS192 hESC 0 4.77731 4.82629 3.18976 1.3734 - OK TSS192 Fibroblasts 1 4.87936 4.07134 3.32833 1.41354 - OK TSS192 Fibroblasts 0 0 0 0 0 - OK TSS1920 iPS 0 0 0 0 0 - OK TSS1920 iPS 1 0 0 0 0 - OK TSS1920 hESC 1 0 0 0 0 - OK TSS1920 hESC 0 2 2.02051 1.33538 8.77096 - OK TSS1920 Fibroblasts 1 2 1.6688 1.36425 6.01699 - OK TSS1920 Fibroblasts 0 2 2.37978 1.94547 8.58047 - OK TSS1921 iPS 0 51.5489 53.805 91.9938 31.627 - OK TSS1921 iPS 1 71.938 69.3067 118.498 40.739 - OK TSS1921 hESC 1 464.767 460.05 304.054 105.901 - OK TSS1921 hESC 0 417.681 421.964 278.882 97.1336 - OK TSS1921 Fibroblasts 1 137.552 114.773 93.8273 32.3187 - OK TSS1921 Fibroblasts 0 235.171 279.827 228.76 78.796 - OK TSS1922 iPS 0 630.045 657.62 1124.37 616.783 - OK TSS1922 iPS 1 659.222 635.109 1085.89 630.218 - OK TSS1922 hESC 1 4363.57 4319.28 2854.67 1637.85 - OK TSS1922 hESC 0 4948.79 4999.53 3304.26 1880.6 - OK TSS1922 Fibroblasts 1 3818.3 3185.99 2604.55 1451.29 - OK TSS1922 Fibroblasts 0 5371.16 6391.08 5224.72 2862.29 - OK TSS1923 iPS 0 5 5.21883 8.92297 12.0608 - OK TSS1923 iPS 1 3 2.89027 4.94167 6.67944 - OK TSS1923 hESC 1 24 23.7564 15.701 22.3583 - OK TSS1923 hESC 0 8.90922 9.00057 5.9486 8.47086 - OK TSS1923 Fibroblasts 1 35.3244 29.4746 24.0956 32.8138 - OK TSS1923 Fibroblasts 0 29 34.5067 28.2093 38.416 - OK TSS1924 iPS 0 0 0 0 0 - OK TSS1924 iPS 1 0 0 0 0 - OK TSS1924 hESC 1 0 0 0 0 - OK TSS1924 hESC 0 3.09078 3.12247 2.06369 1.03541 - OK TSS1924 Fibroblasts 1 12.6756 10.5766 8.64636 4.26944 - OK TSS1924 Fibroblasts 0 0 0 0 0 - OK TSS1925 iPS 0 26 27.1379 46.3994 82.6075 - OK TSS1925 iPS 1 8 7.70738 13.1778 23.4611 - OK TSS1925 hESC 1 43 42.5636 28.1309 51.3532 - OK TSS1925 hESC 0 22 22.2256 14.6892 27.5356 - OK TSS1925 Fibroblasts 1 45 37.548 30.6956 54.2469 - OK TSS1925 Fibroblasts 0 6 7.13933 5.83642 10.4941 - OK TSS1926 iPS 0 0 0 0 0 - OK TSS1926 iPS 1 2.80275 2.70024 4.61676 3.83585 - OK TSS1926 hESC 1 0.00324721 0.00321426 0.00212435 0.00182192 - OK TSS1926 hESC 0 0 0 0 0 - OK TSS1926 Fibroblasts 1 39.4905 32.9509 26.9374 22.4842 - OK TSS1926 Fibroblasts 0 0 0 0 0 - OK TSS1927 iPS 0 33.0748 34.5224 59.0252 39.8376 - OK TSS1927 iPS 1 41.0184 39.5181 67.5665 52.1277 - OK TSS1927 hESC 1 90.6068 89.6872 59.2756 44.6426 - OK TSS1927 hESC 0 103.949 105.014 69.4055 55.2725 - OK TSS1927 Fibroblasts 1 136.562 113.947 93.152 84.0236 - OK TSS1927 Fibroblasts 0 89.9711 107.055 87.5181 78.8897 - OK TSS1928 iPS 0 22.5467 23.5335 40.2368 31.4193 - OK TSS1928 iPS 1 28.1245 27.0957 46.3273 36.1751 - OK TSS1928 hESC 1 140.969 139.539 92.2232 74.1911 - OK TSS1928 hESC 0 205.387 207.493 137.135 110.321 - OK TSS1928 Fibroblasts 1 114.317 95.3864 77.9786 61.1541 - OK TSS1928 Fibroblasts 0 1.43664 1.70943 1.39747 1.09595 - OK TSS1929 iPS 0 15.3784 16.0515 27.4442 15.3049 - OK TSS1929 iPS 1 19.0544 18.3574 31.3868 17.5036 - OK TSS1929 hESC 1 75.4205 74.655 49.3406 32.1235 - OK TSS1929 hESC 0 109.665 110.789 73.2221 48.8152 - OK TSS1929 Fibroblasts 1 115.63 96.482 78.8743 48.7395 - OK TSS1929 Fibroblasts 0 226.592 269.619 220.414 151.696 - OK TSS193 iPS 0 0 0 0 0 - OK TSS193 iPS 1 0 0 0 0 - OK TSS193 hESC 1 0 0 0 0 - OK TSS193 hESC 0 0 0 0 0 - OK TSS193 Fibroblasts 1 0 0 0 0 - OK TSS193 Fibroblasts 0 0 0 0 0 - OK TSS1930 iPS 0 0 0 0 0 - OK TSS1930 iPS 1 1 0.963422 1.64722 0.692545 - OK TSS1930 hESC 1 24 23.7564 15.701 6.70718 - OK TSS1930 hESC 0 19 19.1948 12.6861 5.4193 - OK TSS1930 Fibroblasts 1 0 0 0 0 - OK TSS1930 Fibroblasts 0 0 0 0 0 - OK TSS1931 iPS 0 0.999948 1.04371 1.7845 2.82188 - OK TSS1931 iPS 1 1.00001 0.96343 1.64724 2.60482 - OK TSS1931 hESC 1 16.6149 16.4462 10.8696 18.2746 - OK TSS1931 hESC 0 0 0 0 0 - OK TSS1931 Fibroblasts 1 0.000142285 0.000118723 9.70561e-05 0.00015483 - OK TSS1931 Fibroblasts 0 0 0 0 0 - OK TSS1932 iPS 0 5.17384e-05 5.40028e-05 9.23319e-05 0.000129247 - OK TSS1932 iPS 1 0.999992 0.963414 1.64721 2.83969 - OK TSS1932 hESC 1 20.3851 20.1782 13.3361 19.2818 - OK TSS1932 hESC 0 36 36.3691 24.0369 34.7535 - OK TSS1932 Fibroblasts 1 7.99986 6.67508 5.45689 9.49778 - OK TSS1932 Fibroblasts 0 15 17.8483 14.591 20.5837 - OK TSS1933 iPS 0 0 0 0 0 - OK TSS1933 iPS 1 1 0.963422 1.64722 2.59032 - OK TSS1933 hESC 1 3 2.96955 1.96262 2.01036 - OK TSS1933 hESC 0 1 1.01025 0.667691 0.638442 - OK TSS1933 Fibroblasts 1 5 4.172 3.41062 5.41031 - OK TSS1933 Fibroblasts 0 4 4.75955 3.89094 6.17226 - OK TSS1934 iPS 0 78.2584 81.6836 139.659 58.5954 - OK TSS1934 iPS 1 90.5319 87.2204 149.126 62.5672 - OK TSS1934 hESC 1 401.707 397.63 262.799 112.027 - OK TSS1934 hESC 0 355.653 359.3 237.466 101.228 - OK TSS1934 Fibroblasts 1 216.96 181.032 147.994 62.2363 - OK TSS1934 Fibroblasts 0 197.795 235.354 192.403 80.9116 - OK TSS1935 iPS 0 764.044 797.484 1363.51 1037.42 - OK TSS1935 iPS 1 548.65 528.582 903.749 687.948 - OK TSS1935 hESC 1 2893.42 2864.06 1892.9 1486.3 - OK TSS1935 hESC 0 2982.7 3013.28 1991.52 1562.61 - OK TSS1935 Fibroblasts 1 15002.9 12518.4 10233.8 7813.59 - OK TSS1935 Fibroblasts 0 13422.2 15970.9 13056.2 9962.91 - OK TSS1936 iPS 0 10.6976 11.1658 19.0909 44.7448 - OK TSS1936 iPS 1 4.81789 4.64166 7.93614 18.6006 - OK TSS1936 hESC 1 115.869 114.693 75.8022 194.828 - OK TSS1936 hESC 0 146.151 147.649 97.5835 250.811 - OK TSS1936 Fibroblasts 1 59.1226 49.3318 40.3289 95.7614 - OK TSS1936 Fibroblasts 0 54.0399 64.3014 52.5665 124.82 - OK TSS1937 iPS 0 7 7.30637 12.4922 20.3456 - OK TSS1937 iPS 1 5 4.81711 8.23612 13.4139 - OK TSS1937 hESC 1 49 48.5027 32.0561 55.6135 - OK TSS1937 hESC 0 28 28.2871 18.6953 32.4342 - OK TSS1937 Fibroblasts 1 30 25.032 20.4637 33.631 - OK TSS1937 Fibroblasts 0 73 86.8618 71.0097 116.701 - OK TSS1938 iPS 0 8.27318 8.63527 14.7643 9.97114 - OK TSS1938 iPS 1 21.7352 20.9402 35.8027 24.1796 - OK TSS1938 hESC 1 44.3818 43.9313 29.0348 20.1196 - OK TSS1938 hESC 0 28.1807 28.4697 18.816 13.0385 - OK TSS1938 Fibroblasts 1 0 0 0 0 - OK TSS1938 Fibroblasts 0 70.7855 84.2268 68.8556 46.6761 - OK TSS1939 iPS 0 404.727 422.44 722.273 485.064 - OK TSS1939 iPS 1 426.265 410.673 702.153 471.738 - OK TSS1939 hESC 1 1436.62 1422.04 939.845 648.686 - OK TSS1939 hESC 0 1666.82 1683.91 1112.92 768.336 - OK TSS1939 Fibroblasts 1 3240 2703.45 2210.08 1499.42 - OK TSS1939 Fibroblasts 0 3673.21 4370.71 3573.07 2415.1 - OK TSS194 iPS 0 0 0 0 0 - OK TSS194 iPS 1 0 0 0 0 - OK TSS194 hESC 1 0 0 0 0 - OK TSS194 hESC 0 0 0 0 0 - OK TSS194 Fibroblasts 1 0 0 0 0 - OK TSS194 Fibroblasts 0 0 0 0 0 - OK TSS1940 iPS 0 25.1584 26.2595 44.8974 20.8672 - OK TSS1940 iPS 1 0 0 0 0 - OK TSS1940 hESC 1 389.534 385.581 254.836 120.547 - OK TSS1940 hESC 0 543.832 549.408 363.112 171.766 - OK TSS1940 Fibroblasts 1 273.615 228.304 186.639 86.9683 - OK TSS1940 Fibroblasts 0 253.495 301.631 246.584 114.901 - OK TSS1941 iPS 0 65.7163 68.5925 117.277 32.1656 - OK TSS1941 iPS 1 42.7309 41.1679 70.3873 19.3051 - OK TSS1941 hESC 1 603.687 597.561 394.936 109.448 - OK TSS1941 hESC 0 645.092 651.706 430.722 119.365 - OK TSS1941 Fibroblasts 1 495.361 413.329 337.897 92.8157 - OK TSS1941 Fibroblasts 0 305.242 363.204 296.92 81.5597 - OK TSS1942 iPS 0 161.987 169.077 289.081 113.857 - OK TSS1942 iPS 1 108.453 104.486 178.645 70.3611 - OK TSS1942 hESC 1 811.742 803.504 531.047 212.301 - OK TSS1942 hESC 0 539.414 544.944 360.162 143.984 - OK TSS1942 Fibroblasts 1 2556.81 2133.4 1744.06 688.41 - OK TSS1942 Fibroblasts 0 2407.08 2864.16 2341.46 924.213 - OK TSS1943 iPS 0 26.1737 27.3193 46.7095 37.1504 - OK TSS1943 iPS 1 10.9073 10.5084 17.9668 14.2899 - OK TSS1943 hESC 1 208.706 206.588 136.537 111.941 - OK TSS1943 hESC 0 235.687 238.103 157.366 129.018 - OK TSS1943 Fibroblasts 1 211.874 176.788 144.525 115.455 - OK TSS1943 Fibroblasts 0 187.616 223.242 182.501 145.793 - OK TSS1944 iPS 0 104.87 109.46 187.151 97.5972 - OK TSS1944 iPS 1 69.6447 67.0973 114.72 59.8254 - OK TSS1944 hESC 1 304.914 301.819 199.477 106.105 - OK TSS1944 hESC 0 239.672 242.13 160.027 85.1209 - OK TSS1944 Fibroblasts 1 361.353 301.513 246.488 128.912 - OK TSS1944 Fibroblasts 0 217.147 258.38 211.227 110.47 - OK TSS1945 iPS 0 616.129 643.095 1099.54 830.612 - OK TSS1945 iPS 1 701.605 675.942 1155.7 874.53 - OK TSS1945 hESC 1 4841.22 4792.08 3167.16 2602.7 - OK TSS1945 hESC 0 4494.8 4540.88 3001.13 2403.36 - OK TSS1945 Fibroblasts 1 4810.25 4013.67 3281.19 2603.82 - OK TSS1945 Fibroblasts 0 4476.75 5326.83 4354.7 3333.51 - OK TSS1946 iPS 0 73.7245 76.9513 131.568 92.384 - OK TSS1946 iPS 1 42.0296 40.4922 69.2321 48.5308 - OK TSS1946 hESC 1 557.309 551.653 364.596 262.739 - OK TSS1946 hESC 0 669.868 676.736 447.265 322.416 - OK TSS1946 Fibroblasts 1 322.499 269.093 219.984 154.792 - OK TSS1946 Fibroblasts 0 618.172 735.555 601.318 423.576 - OK TSS1947 iPS 0 222.901 232.656 397.787 204.205 - OK TSS1947 iPS 1 168.483 162.32 277.529 142.47 - OK TSS1947 hESC 1 2100.48 2079.16 1374.15 719.299 - OK TSS1947 hESC 0 1870.48 1889.66 1248.91 653.742 - OK TSS1947 Fibroblasts 1 2789.77 2327.78 1902.97 979.669 - OK TSS1947 Fibroblasts 0 3112.67 3703.73 3027.81 1558.75 - OK TSS1948 iPS 0 49.3747 51.5357 88.1137 29.4346 - OK TSS1948 iPS 1 56.4872 54.421 93.047 31.0826 - OK TSS1948 hESC 1 936.881 927.372 612.914 207.349 - OK TSS1948 hESC 0 819.648 828.052 547.272 185.142 - OK TSS1948 Fibroblasts 1 87.7291 73.2011 59.8421 20.0274 - OK TSS1948 Fibroblasts 0 84.656 100.731 82.348 27.5594 - OK TSS1949 iPS 0 1613.54 1684.16 2879.52 1999.22 - OK TSS1949 iPS 1 111 106.94 182.842 133.761 - OK TSS1949 hESC 1 313.521 310.339 205.108 152.852 - OK TSS1949 hESC 0 253.012 255.606 168.934 122.714 - OK TSS1949 Fibroblasts 1 26497.4 22109.4 18074.5 13184.9 - OK TSS1949 Fibroblasts 0 22614.8 26909.1 21998.3 15318 - OK TSS195 iPS 0 0 0 0 0 - OK TSS195 iPS 1 0 0 0 0 - OK TSS195 hESC 1 0 0 0 0 - OK TSS195 hESC 0 1.11969 1.13117 0.74761 0.913746 - OK TSS195 Fibroblasts 1 0 0 0 0 - OK TSS195 Fibroblasts 0 1 1.18989 0.972737 1.14406 - OK TSS1950 iPS 0 4.45588 4.6509 7.95193 4.39301 - OK TSS1950 iPS 1 0 0 0 0 - OK TSS1950 hESC 1 42.479 42.0479 27.7901 15.6781 - OK TSS1950 hESC 0 57.9877 58.5823 38.7179 21.8431 - OK TSS1950 Fibroblasts 1 76.2886 63.6552 52.0383 28.8363 - OK TSS1950 Fibroblasts 0 17.4931 20.8148 17.0162 9.42927 - OK TSS1951 iPS 0 345.475 360.596 616.533 1421.47 - OK TSS1951 iPS 1 393.813 379.408 648.698 1495.62 - OK TSS1951 hESC 1 1477.45 1462.46 966.561 2439.94 - OK TSS1951 hESC 0 1000.85 1011.11 668.257 1686.92 - OK TSS1951 Fibroblasts 1 1664.9 1389.19 1135.67 2652.13 - OK TSS1951 Fibroblasts 0 1539.62 1831.98 1497.65 3497.47 - OK TSS1952 iPS 0 142.469 148.705 254.25 494.538 - OK TSS1952 iPS 1 68.2766 65.7792 112.467 214.542 - OK TSS1952 hESC 1 578.642 572.77 378.552 801.238 - OK TSS1952 hESC 0 675.569 682.496 451.071 958.774 - OK TSS1952 Fibroblasts 1 1115.54 930.803 760.934 1546.79 - OK TSS1952 Fibroblasts 0 1276.5 1518.89 1241.7 2431.45 - OK TSS1953 iPS 0 273.055 285.006 487.293 838.021 - OK TSS1953 iPS 1 198.91 191.635 327.649 563.475 - OK TSS1953 hESC 1 705.903 698.739 461.807 849.081 - OK TSS1953 hESC 0 803.584 811.823 536.545 986.496 - OK TSS1953 Fibroblasts 1 923.565 770.622 629.986 1093.8 - OK TSS1953 Fibroblasts 0 1528.87 1819.19 1487.19 2582.12 - OK TSS1954 iPS 0 8.90054 9.29009 15.8838 8.18071 - OK TSS1954 iPS 1 3.01497 2.90469 4.96633 2.55783 - OK TSS1954 hESC 1 46.5548 46.0823 30.4565 15.9958 - OK TSS1954 hESC 0 42.8177 43.2568 28.589 15.015 - OK TSS1954 Fibroblasts 1 13.2597 11.0639 9.04479 4.67165 - OK TSS1954 Fibroblasts 0 15.9027 18.9224 15.4691 7.98983 - OK TSS1955 iPS 0 120.615 125.894 215.25 72.5904 - OK TSS1955 iPS 1 279.181 268.969 459.874 155.087 - OK TSS1955 hESC 1 490.114 485.14 320.636 109.519 - OK TSS1955 hESC 0 475.318 480.192 317.366 108.402 - OK TSS1955 Fibroblasts 1 545.242 454.949 371.922 125.66 - OK TSS1955 Fibroblasts 0 329.234 391.752 320.258 108.205 - OK TSS1956 iPS 0 6.45637 6.73894 11.522 6.03529 - OK TSS1956 iPS 1 8.53526 8.22306 14.0595 7.36444 - OK TSS1956 hESC 1 229.648 227.317 150.237 80.2757 - OK TSS1956 hESC 0 378.395 382.275 252.651 134.998 - OK TSS1956 Fibroblasts 1 99.7203 83.2066 68.0216 35.7335 - OK TSS1956 Fibroblasts 0 26.8704 31.9727 26.1378 13.7309 - OK TSS1957 iPS 0 989.028 1032.31 1765.01 587.444 - OK TSS1957 iPS 1 1197.27 1153.48 1972.17 655.443 - OK TSS1957 hESC 1 4017.68 3976.91 2628.39 990.805 - OK TSS1957 hESC 0 4102.47 4144.53 2739.18 1043.4 - OK TSS1957 Fibroblasts 1 6034.78 5035.42 4116.47 1306.58 - OK TSS1957 Fibroblasts 0 2787.99 3317.4 2711.98 916.779 - OK TSS1958 iPS 0 793.019 827.727 1415.22 3465.63 - OK TSS1958 iPS 1 665.96 641.601 1096.99 2672.39 - OK TSS1958 hESC 1 2465.26 2440.24 1612.79 4380.59 - OK TSS1958 hESC 0 2663.25 2690.56 1778.23 4850.39 - OK TSS1958 Fibroblasts 1 4347.97 3627.95 2965.86 7505.39 - OK TSS1958 Fibroblasts 0 3861.14 4594.33 3755.87 9517.68 - OK TSS1959 iPS 0 31 32.3568 55.3224 56.8329 - OK TSS1959 iPS 1 30 28.9027 49.4167 52.4369 - OK TSS1959 hESC 1 97 96.0155 63.458 68.5127 - OK TSS1959 hESC 0 111 112.138 74.1137 80.8782 - OK TSS1959 Fibroblasts 1 62 51.7328 42.2917 45.9671 - OK TSS1959 Fibroblasts 0 156 185.622 151.747 154.699 - OK TSS196 iPS 0 0 0 0 0 - OK TSS196 iPS 1 0 0 0 0 - OK TSS196 hESC 1 0 0 0 0 - OK TSS196 hESC 0 0 0 0 0 - OK TSS196 Fibroblasts 1 0 0 0 0 - OK TSS196 Fibroblasts 0 0 0 0 0 - OK TSS1960 iPS 0 19 19.8316 33.9073 50.5661 - OK TSS1960 iPS 1 5 4.81711 8.23612 12.2826 - OK TSS1960 hESC 1 107 105.914 70.0001 110.591 - OK TSS1960 hESC 0 60 60.6152 40.0615 63.2919 - OK TSS1960 Fibroblasts 1 235 196.084 160.299 241.04 - OK TSS1960 Fibroblasts 0 149 177.293 144.938 217.941 - OK TSS1961 iPS 0 1333 1391.34 2378.86 2480.16 - OK TSS1961 iPS 1 1436 1383.47 2365.41 2238.34 - OK TSS1961 hESC 1 4461 4415.72 2918.42 3468.08 - OK TSS1961 hESC 0 4517 4563.31 3015.96 3554.63 - OK TSS1961 Fibroblasts 1 8418 7023.98 5742.12 6624.84 - OK TSS1961 Fibroblasts 0 5904 7025.1 5743.03 6526.55 - OK TSS1962 iPS 0 23.3991 24.4232 41.7579 40.4156 - OK TSS1962 iPS 1 13.7098 13.2083 22.5831 21.8572 - OK TSS1962 hESC 1 239.531 237.1 156.703 157.392 - OK TSS1962 hESC 0 334.844 338.278 223.573 224.556 - OK TSS1962 Fibroblasts 1 178.778 149.173 121.949 118.663 - OK TSS1962 Fibroblasts 0 496.144 590.356 482.618 469.614 - OK TSS1963 iPS 0 0 0 0 0 - OK TSS1963 iPS 1 13.0039 12.5283 21.4204 17.7243 - OK TSS1963 hESC 1 719.946 712.639 470.993 376 - OK TSS1963 hESC 0 469.46 474.273 313.454 262.277 - OK TSS1963 Fibroblasts 1 359.553 300.011 245.26 192.69 - OK TSS1963 Fibroblasts 0 687.402 817.931 668.66 529.367 - OK TSS1964 iPS 0 111.123 115.986 198.309 130.126 - OK TSS1964 iPS 1 98.689 95.0792 162.563 107.864 - OK TSS1964 hESC 1 2694.63 2667.28 1762.85 1153.34 - OK TSS1964 hESC 0 2975.46 3005.97 1986.69 1270.73 - OK TSS1964 Fibroblasts 1 3796.02 3167.39 2589.35 1733.71 - OK TSS1964 Fibroblasts 0 3298.4 3924.73 3208.48 2038.54 - OK TSS1965 iPS 0 2.66719 2.78393 4.75986 69.6961 - OK TSS1965 iPS 1 2.83334 2.7297 4.66714 68.3386 - OK TSS1965 hESC 1 64.4625 63.8083 42.1718 1431.38 - OK TSS1965 hESC 0 64.5588 65.2207 43.1053 1463.07 - OK TSS1965 Fibroblasts 1 47.1615 39.3515 32.17 524.22 - OK TSS1965 Fibroblasts 0 57.5295 68.4536 55.961 911.904 - OK TSS1966 iPS 0 0 0 0 0 - OK TSS1966 iPS 1 6.42392 6.18895 10.5816 9.29978 - OK TSS1966 hESC 1 218.266 216.051 142.791 129.781 - OK TSS1966 hESC 0 166.04 167.743 110.864 100.762 - OK TSS1966 Fibroblasts 1 51.4805 42.9553 35.1161 31.0126 - OK TSS1966 Fibroblasts 0 11.8055 14.0472 11.4837 10.1417 - OK TSS1967 iPS 0 31.0722 32.4322 55.4513 57.4876 - OK TSS1967 iPS 1 17.9504 17.2938 29.5683 30.6988 - OK TSS1967 hESC 1 403.254 399.161 263.812 283.861 - OK TSS1967 hESC 0 320.996 324.288 214.326 230.419 - OK TSS1967 Fibroblasts 1 559.514 466.859 381.658 392.933 - OK TSS1967 Fibroblasts 0 104.941 124.868 102.08 108.31 - OK TSS1968 iPS 0 2.56821 2.68062 4.58322 11.4436 - OK TSS1968 iPS 1 13.3895 12.8998 22.0556 52.5943 - OK TSS1968 hESC 1 19.525 19.3269 12.7734 30.4886 - OK TSS1968 hESC 0 20.4132 20.6225 13.6297 32.0738 - OK TSS1968 Fibroblasts 1 120.421 100.479 82.142 168.954 - OK TSS1968 Fibroblasts 0 48.0921 57.2242 46.7809 96.2594 - OK TSS1969 iPS 0 4.33386 4.52354 7.73418 65.2115 - OK TSS1969 iPS 1 6.50001 6.26225 10.707 90.2768 - OK TSS1969 hESC 1 42.5834 42.1512 27.8583 344.309 - OK TSS1969 hESC 0 37.3333 37.7161 24.9271 308.081 - OK TSS1969 Fibroblasts 1 46.3343 38.6613 31.6057 279.885 - OK TSS1969 Fibroblasts 0 62.9169 74.864 61.2015 541.972 - OK TSS197 iPS 0 344 359.056 613.9 385.691 - OK TSS197 iPS 1 263 253.38 433.22 272.176 - OK TSS197 hESC 1 1184 1171.98 774.581 498.411 - OK TSS197 hESC 0 1055 1065.82 704.414 453.262 - OK TSS197 Fibroblasts 1 4284 3574.57 2922.22 1842.31 - OK TSS197 Fibroblasts 0 4116 4897.58 4003.78 2524.19 - OK TSS1970 iPS 0 295.587 308.524 527.503 146.486 - OK TSS1970 iPS 1 152.627 147.044 251.411 90.4431 - OK TSS1970 hESC 1 1014.76 1004.46 663.86 191.841 - OK TSS1970 hESC 0 867.415 876.309 579.165 169.866 - OK TSS1970 Fibroblasts 1 498.087 415.603 339.757 99.5861 - OK TSS1970 Fibroblasts 0 2568.35 3056.05 2498.33 625.245 - OK TSS1971 iPS 0 57.0396 59.536 101.792 28.9515 - OK TSS1971 iPS 1 216.467 208.55 356.57 101.415 - OK TSS1971 hESC 1 928.282 918.86 607.288 174.59 - OK TSS1971 hESC 0 1445 1459.81 964.81 277.374 - OK TSS1971 Fibroblasts 1 756.72 631.407 516.177 147.04 - OK TSS1971 Fibroblasts 0 1574.18 1873.09 1531.26 436.201 - OK TSS1972 iPS 0 126.818 132.368 226.318 203.135 - OK TSS1972 iPS 1 219.831 211.79 362.111 214.168 - OK TSS1972 hESC 1 2033.4 2012.76 1330.26 620.803 - OK TSS1972 hESC 0 2024.9 2045.66 1352.01 659.445 - OK TSS1972 Fibroblasts 1 2392.61 1996.39 1632.05 865.641 - OK TSS1972 Fibroblasts 0 692.234 823.681 673.361 510.175 - OK TSS1973 iPS 0 17.391 18.1522 31.0359 41.2793 - OK TSS1973 iPS 1 23.2414 22.3912 38.2837 50.9193 - OK TSS1973 hESC 1 120.065 118.847 78.5474 109.97 - OK TSS1973 hESC 0 151.857 153.414 101.393 141.955 - OK TSS1973 Fibroblasts 1 472.23 394.028 322.119 431.605 - OK TSS1973 Fibroblasts 0 235.572 280.304 229.15 307.035 - OK TSS1974 iPS 0 14.0896 14.7063 25.1443 12.4645 - OK TSS1974 iPS 1 8.7504 8.43033 14.4139 7.14525 - OK TSS1974 hESC 1 11.913 11.792 7.79354 3.93678 - OK TSS1974 hESC 0 66.4 67.0808 44.3346 22.3949 - OK TSS1974 Fibroblasts 1 13.3676 11.1539 9.11837 4.53257 - OK TSS1974 Fibroblasts 0 0 0 0 0 - OK TSS1975 iPS 0 413.924 432.041 738.687 341.416 - OK TSS1975 iPS 1 397.798 383.248 655.263 302.858 - OK TSS1975 hESC 1 1418.96 1404.55 928.291 436.636 - OK TSS1975 hESC 0 1913.28 1932.9 1277.48 600.882 - OK TSS1975 Fibroblasts 1 3513.28 2931.48 2396.49 1127.31 - OK TSS1975 Fibroblasts 0 2821.71 3357.52 2744.78 1271.87 - OK TSS1976 iPS 0 22.8299 23.8291 40.7421 19.3102 - OK TSS1976 iPS 1 95.532 92.0377 157.363 74.5839 - OK TSS1976 hESC 1 1117.49 1106.14 731.067 352.783 - OK TSS1976 hESC 0 965.977 975.881 644.974 311.239 - OK TSS1976 Fibroblasts 1 0 0 0 0 - OK TSS1976 Fibroblasts 0 0 0 0 0 - OK TSS1977 iPS 0 76.0915 79.4218 135.792 55.2204 - OK TSS1977 iPS 1 56.0422 53.9924 92.3141 37.5398 - OK TSS1977 hESC 1 332.249 328.877 217.359 89.762 - OK TSS1977 hESC 0 342.775 346.29 228.868 94.5147 - OK TSS1977 Fibroblasts 1 6.11291 5.10061 4.16976 1.69946 - OK TSS1977 Fibroblasts 0 8.82647 10.5025 8.58583 3.49931 - OK TSS1978 iPS 0 27.5645 28.7709 49.1913 55.0708 - OK TSS1978 iPS 1 31.877 30.7111 52.5086 58.7846 - OK TSS1978 hESC 1 288.396 285.469 188.67 220.5 - OK TSS1978 hESC 0 277.066 279.907 184.995 216.204 - OK TSS1978 Fibroblasts 1 72.2432 60.2797 49.2788 55.5119 - OK TSS1978 Fibroblasts 0 26.9589 32.078 26.2239 29.5408 - OK TSS1979 iPS 0 5777 6029.84 10309.6 4928.26 - OK TSS1979 iPS 1 4587 4419.22 7555.81 3612.13 - OK TSS1979 hESC 1 16007 15844.5 10471.9 5097.08 - OK TSS1979 hESC 0 14333 14480 9570.01 4657.99 - OK TSS1979 Fibroblasts 1 52401.3 43723.7 35744.2 17130 - OK TSS1979 Fibroblasts 0 34521.2 41076.3 33580 16093.3 - OK TSS198 iPS 0 1 1.04377 1.78459 3.35246 - OK TSS198 iPS 1 0 0 0 0 - OK TSS198 hESC 1 0 0 0 0 - OK TSS198 hESC 0 0 0 0 0 - OK TSS198 Fibroblasts 1 5 4.172 3.41062 8.35087 - OK TSS198 Fibroblasts 0 1 1.18989 0.972736 2.38173 - OK TSS1980 iPS 0 25.1105 26.2095 44.812 66.6878 - OK TSS1980 iPS 1 38 36.6101 62.5945 93.1511 - OK TSS1980 hESC 1 210.282 208.148 137.568 216.855 - OK TSS1980 hESC 0 210.024 212.177 140.231 221.053 - OK TSS1980 Fibroblasts 1 0 0 0 0 - OK TSS1980 Fibroblasts 0 0 0 0 0 - OK TSS1981 iPS 0 12.8895 13.4536 23.0025 41.1599 - OK TSS1981 iPS 1 0 0 0 0 - OK TSS1981 hESC 1 78.7182 77.9192 51.4979 98.7936 - OK TSS1981 hESC 0 54.9763 55.54 36.7072 70.419 - OK TSS1981 Fibroblasts 1 20 16.688 13.6425 24.6549 - OK TSS1981 Fibroblasts 0 12 14.2787 11.6728 21.0954 - OK TSS1982 iPS 0 0 0 0 0 - OK TSS1982 iPS 1 0 0 0 0 - OK TSS1982 hESC 1 3.0775 3.04627 2.01332 1.51781 - OK TSS1982 hESC 0 4.61746 4.66481 3.08304 2.32425 - OK TSS1982 Fibroblasts 1 0 0 0 0 - OK TSS1982 Fibroblasts 0 0 0 0 0 - OK TSS1983 iPS 0 0 0 0 0 - OK TSS1983 iPS 1 0 0 0 0 - OK TSS1983 hESC 1 3.9225 3.88269 2.56612 1.43229 - OK TSS1983 hESC 0 2.38254 2.40697 1.5908 0.887906 - OK TSS1983 Fibroblasts 1 0 0 0 0 - OK TSS1983 Fibroblasts 0 0 0 0 0 - OK TSS1984 iPS 0 2.99944 3.13071 5.35277 2.28802 - OK TSS1984 iPS 1 0 0 0 0 - OK TSS1984 hESC 1 3.99971 3.95912 2.61664 0.824479 - OK TSS1984 hESC 0 5 5.05127 3.33845 1.05198 - OK TSS1984 Fibroblasts 1 0 0 0 0 - OK TSS1984 Fibroblasts 0 0 0 0 0 - OK TSS1985 iPS 0 0.000563651 0.000588321 0.00100589 0.000591751 - OK TSS1985 iPS 1 1 0.963422 1.64722 0.96904 - OK TSS1985 hESC 1 0.00028917 0.000286235 0.000189177 0.000113807 - OK TSS1985 hESC 0 0 0 0 0 - OK TSS1985 Fibroblasts 1 0 0 0 0 - OK TSS1985 Fibroblasts 0 0 0 0 0 - OK TSS1986 iPS 0 6 6.2626 10.7076 7.75152 - OK TSS1986 iPS 1 0 0 0 0 - OK TSS1986 hESC 1 17 16.8275 11.1215 9.07601 - OK TSS1986 hESC 0 14 14.1435 9.34767 7.62842 - OK TSS1986 Fibroblasts 1 0 0 0 0 - OK TSS1986 Fibroblasts 0 0 0 0 0 - OK TSS1987 iPS 0 0 0 0 0 - OK TSS1987 iPS 1 11.4567 11.0377 18.8718 24.5918 - OK TSS1987 hESC 1 53.3133 52.7722 34.8779 47.7902 - OK TSS1987 hESC 0 23.713 23.9562 15.833 21.6946 - OK TSS1987 Fibroblasts 1 26.7216 22.2965 18.2274 23.9242 - OK TSS1987 Fibroblasts 0 23.3972 27.84 22.7593 29.8724 - OK TSS1988 iPS 0 154.602 161.368 275.901 556.769 - OK TSS1988 iPS 1 87.0217 83.8386 143.344 262.023 - OK TSS1988 hESC 1 1262.25 1249.44 825.771 2063.75 - OK TSS1988 hESC 0 1135.83 1147.48 758.383 1874.08 - OK TSS1988 Fibroblasts 1 1644.68 1372.32 1121.88 2312.87 - OK TSS1988 Fibroblasts 0 1423.1 1693.32 1384.3 3085.26 - OK TSS1989 iPS 0 5.48239 5.72233 9.78383 6.59497 - OK TSS1989 iPS 1 7.0498 6.79193 11.6126 7.82769 - OK TSS1989 hESC 1 66.7793 66.1015 43.6874 30.2139 - OK TSS1989 hESC 0 46.9877 47.4695 31.3733 21.6975 - OK TSS1989 Fibroblasts 1 147.776 123.305 100.802 68.2012 - OK TSS1989 Fibroblasts 0 131.727 156.74 128.136 86.695 - OK TSS199 iPS 0 0 0 0 0 - OK TSS199 iPS 1 0 0 0 0 - OK TSS199 hESC 1 0 0 0 0 - OK TSS199 hESC 0 0 0 0 0 - OK TSS199 Fibroblasts 1 0 0 0 0 - OK TSS199 Fibroblasts 0 0 0 0 0 - OK TSS1990 iPS 0 27 28.1817 48.184 55.4527 - OK TSS1990 iPS 1 29 27.9392 47.7695 53.9717 - OK TSS1990 hESC 1 186.5 184.607 122.01 125.877 - OK TSS1990 hESC 0 133 134.364 88.8029 102.11 - OK TSS1990 Fibroblasts 1 126 105.134 85.9476 95.9388 - OK TSS1990 Fibroblasts 0 97 115.419 94.3554 106.395 - OK TSS1991 iPS 0 237.448 247.841 423.749 324.969 - OK TSS1991 iPS 1 199.411 192.117 328.474 251.904 - OK TSS1991 hESC 1 871.038 862.198 569.839 449.673 - OK TSS1991 hESC 0 929.605 939.136 620.689 489.788 - OK TSS1991 Fibroblasts 1 1472.86 1228.95 1004.67 773.275 - OK TSS1991 Fibroblasts 0 1397.28 1662.6 1359.18 1045.78 - OK TSS1992 iPS 0 186 194.141 331.934 189.749 - OK TSS1992 iPS 1 168 161.855 276.734 158.193 - OK TSS1992 hESC 1 993 982.922 649.627 379.511 - OK TSS1992 hESC 0 905 914.279 604.26 353.008 - OK TSS1992 Fibroblasts 1 1064 887.801 725.78 416.203 - OK TSS1992 Fibroblasts 0 1040 1237.48 1011.65 580.134 - OK TSS1993 iPS 0 2 2.08753 3.56919 4.43838 - OK TSS1993 iPS 1 4 3.85369 6.58889 8.19347 - OK TSS1993 hESC 1 3 2.96955 1.96262 2.56025 - OK TSS1993 hESC 0 4 4.04101 2.67076 3.48402 - OK TSS1993 Fibroblasts 1 0 0 0 0 - OK TSS1993 Fibroblasts 0 0 0 0 0 - OK TSS1994 iPS 0 1.45105 1.51456 2.58953 1.65824 - OK TSS1994 iPS 1 0 0 0 0 - OK TSS1994 hESC 1 0 0 0 0 - OK TSS1994 hESC 0 2 2.02051 1.33538 0.950006 - OK TSS1994 Fibroblasts 1 19.823 16.5403 13.5217 9.40505 - OK TSS1994 Fibroblasts 0 4.68468 5.57424 4.55695 3.16959 - OK TSS1995 iPS 0 2.74854 2.86883 4.90502 2.08863 - OK TSS1995 iPS 1 0 0 0 0 - OK TSS1995 hESC 1 4.44265 4.39756 2.90641 1.23759 - OK TSS1995 hESC 0 0 0 0 0 - OK TSS1995 Fibroblasts 1 44.0376 36.7449 30.0391 13.5036 - OK TSS1995 Fibroblasts 0 13.922 16.5656 13.5424 6.08777 - OK TSS1996 iPS 0 1.05904 1.10539 1.88996 1.0336 - OK TSS1996 iPS 1 0 0 0 0 - OK TSS1996 hESC 1 0 0 0 0 - OK TSS1996 hESC 0 0 0 0 0 - OK TSS1996 Fibroblasts 1 0 0 0 0 - OK TSS1996 Fibroblasts 0 3.31306 3.94217 3.22274 1.76783 - OK TSS1997 iPS 0 0 0 0 0 - OK TSS1997 iPS 1 1.03182 0.994078 1.69964 0.879212 - OK TSS1997 hESC 1 41.9443 41.5186 27.4402 14.4761 - OK TSS1997 hESC 0 32.3442 32.6758 21.5959 11.393 - OK TSS1997 Fibroblasts 1 14.3432 11.968 9.78387 5.07563 - OK TSS1997 Fibroblasts 0 0 0 0 0 - OK TSS1998 iPS 0 1 1.04377 1.78459 1.1361 - OK TSS1998 iPS 1 0 0 0 0 - OK TSS1998 hESC 1 0 0 0 0 - OK TSS1998 hESC 0 0 0 0 0 - OK TSS1998 Fibroblasts 1 0 0 0 0 - OK TSS1998 Fibroblasts 0 1 1.18989 0.972736 0.672289 - OK TSS1999 iPS 0 0 0 0 0 - OK TSS1999 iPS 1 0 0 0 0 - OK TSS1999 hESC 1 0 0 0 0 - OK TSS1999 hESC 0 0 0 0 0 - OK TSS1999 Fibroblasts 1 7 5.8408 4.77487 15.1876 - OK TSS1999 Fibroblasts 0 1 1.18989 0.972736 3.09402 - OK TSS2 iPS 0 178.505 186.317 318.558 174.487 - OK TSS2 iPS 1 224.46 216.249 369.735 202.519 - OK TSS2 hESC 1 1093.38 1082.28 715.295 400.032 - OK TSS2 hESC 0 882.376 891.423 589.154 329.487 - OK TSS2 Fibroblasts 1 70.2161 58.5883 47.8961 26.3142 - OK TSS2 Fibroblasts 0 60.8503 72.4051 59.1913 32.5198 - OK TSS20 iPS 0 0 0 0 0 - OK TSS20 iPS 1 0 0 0 0 - OK TSS20 hESC 1 12.0337 11.9115 7.8725 5.89099 - OK TSS20 hESC 0 19.0381 19.2333 12.7115 9.51204 - OK TSS20 Fibroblasts 1 0 0 0 0 - OK TSS20 Fibroblasts 0 0 0 0 0 - OK TSS200 iPS 0 0 0 0 0 - OK TSS200 iPS 1 0 0 0 0 - OK TSS200 hESC 1 1 0.989851 0.654207 1.31945 - OK TSS200 hESC 0 1.00024 1.01049 0.667851 1.34697 - OK TSS200 Fibroblasts 1 0 0 0 0 - OK TSS200 Fibroblasts 0 0 0 0 0 - OK TSS2000 iPS 0 335.942 350.645 599.52 134.515 - OK TSS2000 iPS 1 0 0 0 0 - OK TSS2000 hESC 1 301.021 297.966 196.93 44.5614 - OK TSS2000 hESC 0 261.833 264.517 174.823 39.559 - OK TSS2000 Fibroblasts 1 932.526 778.099 636.098 142.899 - OK TSS2000 Fibroblasts 0 186.661 222.105 181.572 40.79 - OK TSS2001 iPS 0 189.058 197.332 337.391 65.6972 - OK TSS2001 iPS 1 80 77.0738 131.778 25.6599 - OK TSS2001 hESC 1 1455.98 1441.2 952.511 186.841 - OK TSS2001 hESC 0 1300.67 1314 868.444 170.351 - OK TSS2001 Fibroblasts 1 546.474 455.978 372.763 72.663 - OK TSS2001 Fibroblasts 0 301.839 359.155 293.61 57.2336 - OK TSS2002 iPS 0 226 235.891 403.318 305.597 - OK TSS2002 iPS 1 198 190.758 326.15 219.733 - OK TSS2002 hESC 1 1310 1296.7 857.011 561.665 - OK TSS2002 hESC 0 1409.5 1423.95 941.11 654.169 - OK TSS2002 Fibroblasts 1 787 656.672 536.831 430.489 - OK TSS2002 Fibroblasts 0 748 890.036 727.607 601.162 - OK TSS2003 iPS 0 0 0 0 0 - OK TSS2003 iPS 1 0 0 0 0 - OK TSS2003 hESC 1 33.9276 33.5832 22.1957 10.1236 - OK TSS2003 hESC 0 40.4666 40.8815 27.0192 12.3237 - OK TSS2003 Fibroblasts 1 154.919 129.265 105.674 47.5041 - OK TSS2003 Fibroblasts 0 57.1672 68.0225 55.6086 24.9979 - OK TSS2004 iPS 0 468 488.483 835.19 190.905 - OK TSS2004 iPS 1 562 541.443 925.74 211.603 - OK TSS2004 hESC 1 2740.07 2712.26 1792.57 413.292 - OK TSS2004 hESC 0 2830.53 2859.56 1889.92 435.737 - OK TSS2004 Fibroblasts 1 1274.08 1063.09 869.081 198.903 - OK TSS2004 Fibroblasts 0 1116.83 1328.91 1086.38 248.636 - OK TSS2005 iPS 0 851 888.246 1518.69 866.052 - OK TSS2005 iPS 1 918 884.422 1512.15 862.324 - OK TSS2005 hESC 1 3442 3407.07 2251.78 1312.24 - OK TSS2005 hESC 0 3632 3669.24 2425.05 1413.21 - OK TSS2005 Fibroblasts 1 3434 2865.33 2342.41 1340.01 - OK TSS2005 Fibroblasts 0 2628 3127.02 2556.35 1462.4 - OK TSS2006 iPS 0 529.5 552.675 944.942 302.093 - OK TSS2006 iPS 1 386 371.881 635.828 228.48 - OK TSS2006 hESC 1 894.5 885.422 585.188 169.468 - OK TSS2006 hESC 0 951 960.751 634.974 197.611 - OK TSS2006 Fibroblasts 1 2836 2366.36 1934.5 629.224 - OK TSS2006 Fibroblasts 0 1838 2187.01 1787.89 502.383 - OK TSS2007 iPS 0 296 308.955 528.24 494.997 - OK TSS2007 iPS 1 313 301.551 515.581 476.14 - OK TSS2007 hESC 1 907 897.795 593.365 576.84 - OK TSS2007 hESC 0 852 860.736 568.873 550.296 - OK TSS2007 Fibroblasts 1 1991 1661.29 1358.11 1291.14 - OK TSS2007 Fibroblasts 0 1130 1344.57 1099.19 1045.05 - OK TSS2008 iPS 0 0 0 0 0 - OK TSS2008 iPS 1 0 0 0 0 - OK TSS2008 hESC 1 1 0.989851 0.654207 1.09258 - OK TSS2008 hESC 0 0 0 0 0 - OK TSS2008 Fibroblasts 1 0 0 0 0 - OK TSS2008 Fibroblasts 0 0 0 0 0 - OK TSS2009 iPS 0 64.775 67.6101 115.597 37.0393 - OK TSS2009 iPS 1 115.978 111.736 191.042 58.3559 - OK TSS2009 hESC 1 725.809 718.442 474.829 142.446 - OK TSS2009 hESC 0 808.322 816.61 539.709 166.455 - OK TSS2009 Fibroblasts 1 478.463 399.229 326.371 96.8478 - OK TSS2009 Fibroblasts 0 374.992 446.198 364.768 107.96 - OK TSS201 iPS 0 864.025 901.841 1541.93 448.998 - OK TSS201 iPS 1 1036.43 998.519 1707.23 479.703 - OK TSS201 hESC 1 852.26 843.61 557.554 141.97 - OK TSS201 hESC 0 870.658 879.585 581.33 165.343 - OK TSS201 Fibroblasts 1 2548.6 2126.55 1738.46 440.751 - OK TSS201 Fibroblasts 0 1282.2 1525.68 1247.25 310.619 - OK TSS2010 iPS 0 12.225 12.76 21.8166 7.34337 - OK TSS2010 iPS 1 31.5486 30.3946 51.9676 17.4921 - OK TSS2010 hESC 1 146.191 144.708 95.6394 32.6044 - OK TSS2010 hESC 0 146.592 148.095 97.8783 33.3677 - OK TSS2010 Fibroblasts 1 35.9814 30.0229 24.5438 8.27673 - OK TSS2010 Fibroblasts 0 28.0237 33.3451 27.2597 9.1926 - OK TSS2011 iPS 0 0 0 0 0 - OK TSS2011 iPS 1 1.47307 1.41919 2.42648 2.90503 - OK TSS2011 hESC 1 0 0 0 0 - OK TSS2011 hESC 0 13.0856 13.2197 8.73712 10.9532 - OK TSS2011 Fibroblasts 1 4.55571 3.80128 3.10756 3.74518 - OK TSS2011 Fibroblasts 0 2.98438 3.55108 2.90301 3.49867 - OK TSS2012 iPS 0 0 0 0 0 - OK TSS2012 iPS 1 0 0 0 0 - OK TSS2012 hESC 1 25.0147 24.7608 16.3648 3.78105 - OK TSS2012 hESC 0 21.6419 21.8638 14.4501 3.33866 - OK TSS2012 Fibroblasts 1 20.1399 16.8047 13.7379 3.15076 - OK TSS2012 Fibroblasts 0 7.73821 9.2076 7.52724 1.72636 - OK TSS2013 iPS 0 11.8401 12.3583 21.1298 3.94968 - OK TSS2013 iPS 1 12.21 11.7634 20.1126 3.75955 - OK TSS2013 hESC 1 11.7261 11.6071 7.67132 1.4441 - OK TSS2013 hESC 0 0 0 0 0 - OK TSS2013 Fibroblasts 1 0 0 0 0 - OK TSS2013 Fibroblasts 0 12.3032 14.6394 11.9677 2.23938 - OK TSS2014 iPS 0 29.6942 30.9939 52.9921 7.90844 - OK TSS2014 iPS 1 22.7733 21.9403 37.5126 5.59831 - OK TSS2014 hESC 1 168.426 166.716 110.185 16.5366 - OK TSS2014 hESC 0 108.905 110.022 72.715 10.9131 - OK TSS2014 Fibroblasts 1 2.86014 2.3865 1.95097 0.291399 - OK TSS2014 Fibroblasts 0 4.95861 5.90019 4.82342 0.720431 - OK TSS2015 iPS 0 3.46516 3.61682 6.18391 2.63199 - OK TSS2015 iPS 1 5.60457 5.39957 9.23198 3.9293 - OK TSS2015 hESC 1 23.589 23.3496 15.4321 6.67497 - OK TSS2015 hESC 0 15.98 16.1439 10.6697 4.61506 - OK TSS2015 Fibroblasts 1 0 0 0 0 - OK TSS2015 Fibroblasts 0 0 0 0 0 - OK TSS2016 iPS 0 0.000455821 0.000475771 0.000813456 0.000566688 - OK TSS2016 iPS 1 1.41214 1.36049 2.32612 1.62047 - OK TSS2016 hESC 1 2.2445 2.22172 1.46836 1.05043 - OK TSS2016 hESC 0 14.4729 14.6213 9.66343 6.91298 - OK TSS2016 Fibroblasts 1 0 0 0 0 - OK TSS2016 Fibroblasts 0 0 0 0 0 - OK TSS2017 iPS 0 1832 1912.18 3269.38 2414.78 - OK TSS2017 iPS 1 1990 1917.21 3277.97 2421.51 - OK TSS2017 hESC 1 8611 8523.61 5633.37 4278.12 - OK TSS2017 hESC 0 9112 9205.43 6084 4619.11 - OK TSS2017 Fibroblasts 1 21278.5 17754.8 14514.6 10772.8 - OK TSS2017 Fibroblasts 0 12153.8 14461.7 11822.5 8788.16 - OK TSS2018 iPS 0 2727 2846.35 4866.59 1476.3 - OK TSS2018 iPS 1 2954 2845.95 4865.9 1476.02 - OK TSS2018 hESC 1 6366 6301.39 4164.68 1280.16 - OK TSS2018 hESC 0 6855 6925.28 4577.02 1406.1 - OK TSS2018 Fibroblasts 1 12805.4 10684.8 8734.89 2657.82 - OK TSS2018 Fibroblasts 0 8580.99 10210.4 8347.04 2539.21 - OK TSS2019 iPS 0 43.987 45.9122 78.4989 45.0556 - OK TSS2019 iPS 1 32.0621 30.8893 52.8134 30.3131 - OK TSS2019 hESC 1 278.358 275.533 182.104 106.826 - OK TSS2019 hESC 0 230.512 232.876 153.911 90.2876 - OK TSS2019 Fibroblasts 1 410.974 342.916 280.335 161.414 - OK TSS2019 Fibroblasts 0 665.989 792.452 647.832 373.015 - OK TSS202 iPS 0 4.97505 5.19279 8.87843 4.55115 - OK TSS202 iPS 1 10.5704 10.1838 17.4118 8.92541 - OK TSS202 hESC 1 7.76279 7.684 5.07847 2.65441 - OK TSS202 hESC 0 3.3424 3.37667 2.23169 1.16646 - OK TSS202 Fibroblasts 1 4.57777 3.81969 3.12261 1.60521 - OK TSS202 Fibroblasts 0 4.7962 5.70694 4.66544 2.39832 - OK TSS2020 iPS 0 118.206 123.379 210.949 239.575 - OK TSS2020 iPS 1 124.064 119.526 204.361 232.093 - OK TSS2020 hESC 1 969.031 959.196 633.946 752.081 - OK TSS2020 hESC 0 2082.37 2103.72 1390.38 1649.47 - OK TSS2020 Fibroblasts 1 1460.89 1218.97 996.511 1138.88 - OK TSS2020 Fibroblasts 0 3943.33 4692.12 3835.82 4383.84 - OK TSS2021 iPS 0 0.00569922 0.00594866 0.0101708 0.0114045 - OK TSS2021 iPS 1 0.00634237 0.00611038 0.0104473 0.0117145 - OK TSS2021 hESC 1 0 0 0 0 - OK TSS2021 hESC 0 0 0 0 0 - OK TSS2021 Fibroblasts 1 26.3826 22.0136 17.9962 20.3048 - OK TSS2021 Fibroblasts 0 55.1981 65.6795 53.6932 60.5811 - OK TSS2022 iPS 0 75.1316 78.4199 134.079 130.215 - OK TSS2022 iPS 1 76.0136 73.2332 125.211 121.603 - OK TSS2022 hESC 1 110.669 109.546 72.4003 72.9778 - OK TSS2022 hESC 0 175.149 176.944 116.945 117.878 - OK TSS2022 Fibroblasts 1 82.6222 68.94 56.3586 55.0294 - OK TSS2022 Fibroblasts 0 175.932 209.34 171.136 167.1 - OK TSS2023 iPS 0 174.021 181.637 310.556 389.956 - OK TSS2023 iPS 1 257.062 247.66 423.439 531.699 - OK TSS2023 hESC 1 1906.97 1887.61 1247.55 1644.11 - OK TSS2023 hESC 0 1020.03 1030.49 681.068 897.561 - OK TSS2023 Fibroblasts 1 1039.27 867.17 708.914 896.376 - OK TSS2023 Fibroblasts 0 299.251 356.075 291.092 368.067 - OK TSS2024 iPS 0 103.136 107.65 184.056 159.091 - OK TSS2024 iPS 1 76.8536 74.0425 126.595 109.424 - OK TSS2024 hESC 1 1738.33 1720.69 1137.23 1016.75 - OK TSS2024 hESC 0 1966.95 1987.12 1313.32 1173.07 - OK TSS2024 Fibroblasts 1 490.826 409.545 334.804 291.1 - OK TSS2024 Fibroblasts 0 2056.29 2446.75 2000.23 1739.19 - OK TSS2025 iPS 0 0 0 0 0 - OK TSS2025 iPS 1 0 0 0 0 - OK TSS2025 hESC 1 5 4.94925 3.27103 3.85589 - OK TSS2025 hESC 0 0 0 0 0 - OK TSS2025 Fibroblasts 1 1 0.8344 0.682124 0.804087 - OK TSS2025 Fibroblasts 0 0 0 0 0 - OK TSS2026 iPS 0 9 9.3939 16.0613 5.55285 - OK TSS2026 iPS 1 11 10.5976 18.1195 6.2644 - OK TSS2026 hESC 1 25 24.7463 16.3552 5.72889 - OK TSS2026 hESC 0 31 31.3179 20.6984 7.25024 - OK TSS2026 Fibroblasts 1 2 1.6688 1.36425 0.47256 - OK TSS2026 Fibroblasts 0 7 8.32921 6.80915 2.35862 - OK TSS2027 iPS 0 26 27.1379 46.3994 60.1895 - OK TSS2027 iPS 1 20.0001 19.2685 32.9446 39.4975 - OK TSS2027 hESC 1 450.151 445.582 294.492 408.812 - OK TSS2027 hESC 0 378.001 381.876 252.388 304.253 - OK TSS2027 Fibroblasts 1 12 10.0128 8.18552 11.4428 - OK TSS2027 Fibroblasts 0 25.0006 29.7479 24.319 33.2419 - OK TSS2028 iPS 0 27.9492 29.1724 49.8779 20.0069 - OK TSS2028 iPS 1 9.53459 9.18583 15.7056 6.2998 - OK TSS2028 hESC 1 130.122 128.801 85.1264 34.6685 - OK TSS2028 hESC 0 140.503 141.944 93.8129 38.2061 - OK TSS2028 Fibroblasts 1 0 0 0 0 - OK TSS2028 Fibroblasts 0 8.13245 9.6767 7.91072 3.18018 - OK TSS2029 iPS 0 0 0 0 0 - OK TSS2029 iPS 1 9.64219 9.2895 15.8828 4.61288 - OK TSS2029 hESC 1 264.739 262.052 173.194 50.8563 - OK TSS2029 hESC 0 144.831 146.316 96.7022 28.3954 - OK TSS2029 Fibroblasts 1 9.01567 7.52268 6.14981 1.78897 - OK TSS2029 Fibroblasts 0 11.5347 13.7249 11.2202 3.26393 - OK TSS203 iPS 0 291.594 304.356 520.377 467.496 - OK TSS203 iPS 1 329.719 317.658 543.12 494.512 - OK TSS203 hESC 1 458.577 453.923 300.004 276.12 - OK TSS203 hESC 0 449.543 454.153 300.156 276.496 - OK TSS203 Fibroblasts 1 628.255 524.216 428.548 382.772 - OK TSS203 Fibroblasts 0 266.147 316.685 258.891 231.565 - OK TSS2030 iPS 0 0 0 0 0 - OK TSS2030 iPS 1 56.005 53.9564 92.2527 28.6332 - OK TSS2030 hESC 1 372.156 368.379 243.467 76.4587 - OK TSS2030 hESC 0 226.295 228.616 151.095 47.4503 - OK TSS2030 Fibroblasts 1 0 0 0 0 - OK TSS2030 Fibroblasts 0 0 0 0 0 - OK TSS2031 iPS 0 0 0 0 0 - OK TSS2031 iPS 1 0.00402203 0.00387491 0.00662518 0.00206856 - OK TSS2031 hESC 1 420.455 416.188 275.064 86.9026 - OK TSS2031 hESC 0 292.018 295.013 194.978 61.6005 - OK TSS2031 Fibroblasts 1 0 0 0 0 - OK TSS2031 Fibroblasts 0 0 0 0 0 - OK TSS2032 iPS 0 63.1812 65.9465 112.753 35.0729 - OK TSS2032 iPS 1 0 0 0 0 - OK TSS2032 hESC 1 255.222 252.632 166.968 52.5516 - OK TSS2032 hESC 0 163.568 165.246 109.213 34.3738 - OK TSS2032 Fibroblasts 1 123.233 102.825 84.0599 26.1927 - OK TSS2032 Fibroblasts 0 127.931 152.223 124.443 38.7758 - OK TSS2033 iPS 0 41.5735 43.393 74.1918 23.4494 - OK TSS2033 iPS 1 27.6967 26.6836 45.6227 14.4197 - OK TSS2033 hESC 1 70.6144 69.8977 46.1964 14.7766 - OK TSS2033 hESC 0 0 0 0 0 - OK TSS2033 Fibroblasts 1 0 0 0 0 - OK TSS2033 Fibroblasts 0 26 30.9371 25.2911 8.0076 - OK TSS2034 iPS 0 0.0254435 0.0265571 0.0454063 0.013916 - OK TSS2034 iPS 1 0 0 0 0 - OK TSS2034 hESC 1 0.0441982 0.0437497 0.0289148 0.00896501 - OK TSS2034 hESC 0 66.6777 67.3614 44.5201 13.8034 - OK TSS2034 Fibroblasts 1 0.0513583 0.0428534 0.0350327 0.0107549 - OK TSS2034 Fibroblasts 0 0.0287989 0.0342674 0.0280137 0.00860012 - OK TSS2035 iPS 0 28.4645 29.7103 50.7975 15.6429 - OK TSS2035 iPS 1 0 0 0 0 - OK TSS2035 hESC 1 230.114 227.779 150.542 46.9017 - OK TSS2035 hESC 0 285.068 287.991 190.337 59.2999 - OK TSS2035 Fibroblasts 1 57.9464 48.3504 39.5266 12.1928 - OK TSS2035 Fibroblasts 0 69.4901 82.6854 67.5955 20.8512 - OK TSS2036 iPS 0 9.91938 10.3535 17.7021 5.74062 - OK TSS2036 iPS 1 43.7443 42.1442 72.0566 20.1697 - OK TSS2036 hESC 1 37.0334 36.6575 24.2275 7.95641 - OK TSS2036 hESC 0 26.6604 26.9337 17.8009 5.84589 - OK TSS2036 Fibroblasts 1 32.754 27.3299 22.3423 6.2636 - OK TSS2036 Fibroblasts 0 8.42733 10.0276 8.19757 2.66406 - OK TSS2037 iPS 0 19.8868 20.7572 35.4899 36.3645 - OK TSS2037 iPS 1 14.8732 14.3292 24.4995 25.1033 - OK TSS2037 hESC 1 134.349 132.986 87.8923 93.6659 - OK TSS2037 hESC 0 94.3768 95.3445 63.0145 67.1539 - OK TSS2037 Fibroblasts 1 0 0 0 0 - OK TSS2037 Fibroblasts 0 20.4554 24.3396 19.8977 20.504 - OK TSS2038 iPS 0 492 513.533 878.02 466.126 - OK TSS2038 iPS 1 615 592.505 1013.04 537.807 - OK TSS2038 hESC 1 474 469.189 310.094 167.976 - OK TSS2038 hESC 0 596 602.111 397.944 215.563 - OK TSS2038 Fibroblasts 1 993 828.559 677.349 360.546 - OK TSS2038 Fibroblasts 0 700 832.921 680.915 362.549 - OK TSS2039 iPS 0 221.848 231.558 395.909 92.1166 - OK TSS2039 iPS 1 341.428 328.939 562.408 129.348 - OK TSS2039 hESC 1 1070.51 1059.65 700.337 211.766 - OK TSS2039 hESC 0 1162.82 1174.74 776.404 224.574 - OK TSS2039 Fibroblasts 1 1982.33 1654.05 1352.19 412.771 - OK TSS2039 Fibroblasts 0 1657.86 1972.66 1612.66 494.716 - OK TSS204 iPS 0 0 0 0 0 - OK TSS204 iPS 1 0 0 0 0 - OK TSS204 hESC 1 0 0 0 0 - OK TSS204 hESC 0 0 0 0 0 - OK TSS204 Fibroblasts 1 0 0 0 0 - OK TSS204 Fibroblasts 0 0 0 0 0 - OK TSS2040 iPS 0 163.152 170.292 291.16 124.522 - OK TSS2040 iPS 1 198.572 191.309 327.092 139.89 - OK TSS2040 hESC 1 511.487 506.296 334.618 145.447 - OK TSS2040 hESC 0 553.181 558.853 369.354 160.545 - OK TSS2040 Fibroblasts 1 2240.67 1869.62 1528.42 655.216 - OK TSS2040 Fibroblasts 0 1299.14 1545.84 1263.72 541.745 - OK TSS2041 iPS 0 0 0 0 0 - OK TSS2041 iPS 1 11.2802 10.8676 18.5811 22.096 - OK TSS2041 hESC 1 0 0 0 0 - OK TSS2041 hESC 0 0 0 0 0 - OK TSS2041 Fibroblasts 1 0 0 0 0 - OK TSS2041 Fibroblasts 0 0 0 0 0 - OK TSS2042 iPS 0 846.87 883.935 1511.32 684.701 - OK TSS2042 iPS 1 1058.52 1019.8 1743.62 789.868 - OK TSS2042 hESC 1 4434.94 4389.93 2901.37 1336.78 - OK TSS2042 hESC 0 4661.5 4709.29 3112.44 1435.26 - OK TSS2042 Fibroblasts 1 4872.16 4065.33 3323.42 1510.79 - OK TSS2042 Fibroblasts 0 4381.46 5213.44 4262 1935.59 - OK TSS2043 iPS 0 0 0 0 0 - OK TSS2043 iPS 1 0 0 0 0 - OK TSS2043 hESC 1 0 0 0 0 - OK TSS2043 hESC 0 0 0 0 0 - OK TSS2043 Fibroblasts 1 0 0 0 0 - OK TSS2043 Fibroblasts 0 0 0 0 0 - OK TSS2044 iPS 0 0 0 0 0 - OK TSS2044 iPS 1 0.995479 0.959067 1.63978 4.87776 - OK TSS2044 hESC 1 1.00016 0.990007 0.65431 1.43944 - OK TSS2044 hESC 0 0 0 0 0 - OK TSS2044 Fibroblasts 1 0 0 0 0 - OK TSS2044 Fibroblasts 0 0 0 0 0 - OK TSS2045 iPS 0 0 0 0 0 - OK TSS2045 iPS 1 0.00452118 0.00435581 0.00744739 0.0219686 - OK TSS2045 hESC 1 0 0 0 0 - OK TSS2045 hESC 0 0 0 0 0 - OK TSS2045 Fibroblasts 1 0 0 0 0 - OK TSS2045 Fibroblasts 0 0 0 0 0 - OK TSS2046 iPS 0 0 0 0 0 - OK TSS2046 iPS 1 0 0 0 0 - OK TSS2046 hESC 1 1 0.989851 0.654207 0.491457 - OK TSS2046 hESC 0 0 0 0 0 - OK TSS2046 Fibroblasts 1 2 1.6688 1.36425 1.13004 - OK TSS2046 Fibroblasts 0 2 2.37978 1.94547 1.61149 - OK TSS2047 iPS 0 559.152 583.624 997.859 476.782 - OK TSS2047 iPS 1 1019.36 982.072 1679.11 802.286 - OK TSS2047 hESC 1 1242.94 1230.33 813.142 395.628 - OK TSS2047 hESC 0 1530.98 1546.67 1022.22 497.354 - OK TSS2047 Fibroblasts 1 7990.59 6667.34 5450.57 2611.2 - OK TSS2047 Fibroblasts 0 3945.58 4694.8 3838.01 1838.67 - OK TSS2048 iPS 0 74.8479 78.1238 133.573 95.0181 - OK TSS2048 iPS 1 152.642 147.059 251.436 178.861 - OK TSS2048 hESC 1 42.057 41.6302 27.514 20.11 - OK TSS2048 hESC 0 48.0231 48.5155 32.0646 23.436 - OK TSS2048 Fibroblasts 1 221.414 184.748 151.032 107.861 - OK TSS2048 Fibroblasts 0 50.4173 59.9909 49.0427 35.0244 - OK TSS2049 iPS 0 6.46822 6.75132 11.5431 2.65999 - OK TSS2049 iPS 1 0 0 0 0 - OK TSS2049 hESC 1 1734.34 1716.74 1134.62 263.745 - OK TSS2049 hESC 0 2441.25 2466.28 1630 378.897 - OK TSS2049 Fibroblasts 1 13661.1 11398.8 9318.59 2150.1 - OK TSS2049 Fibroblasts 0 5458.83 6495.4 5310.01 1225.19 - OK TSS205 iPS 0 722 753.6 1288.48 461.128 - OK TSS205 iPS 1 446 429.686 734.662 262.925 - OK TSS205 hESC 1 3288.5 3255.12 2151.36 780.441 - OK TSS205 hESC 0 3265 3298.48 2180.01 790.835 - OK TSS205 Fibroblasts 1 9458 7891.75 6451.53 2313.48 - OK TSS205 Fibroblasts 0 6764.5 8048.99 6580.07 2359.58 - OK TSS2050 iPS 0 588.782 614.551 1050.74 189.594 - OK TSS2050 iPS 1 621.037 598.321 1022.99 183.691 - OK TSS2050 hESC 1 5632.1 5574.93 3684.55 668.859 - OK TSS2050 hESC 0 5464.97 5521.01 3648.91 662.278 - OK TSS2050 Fibroblasts 1 2016.47 1682.54 1375.48 248.438 - OK TSS2050 Fibroblasts 0 1722.4 2049.46 1675.44 302.159 - OK TSS2051 iPS 0 0 0 0 0 - OK TSS2051 iPS 1 0 0 0 0 - OK TSS2051 hESC 1 7.97023 7.88934 5.21418 3.11034 - OK TSS2051 hESC 0 0 0 0 0 - OK TSS2051 Fibroblasts 1 247.921 206.865 169.113 98.9852 - OK TSS2051 Fibroblasts 0 10.8285 12.8847 10.5333 6.16535 - OK TSS2052 iPS 0 66.7494 69.6708 119.121 66.2735 - OK TSS2052 iPS 1 114.963 110.758 189.369 105.357 - OK TSS2052 hESC 1 4.59208 4.54547 3.00417 1.70709 - OK TSS2052 hESC 0 15.7819 15.9437 10.5374 5.98779 - OK TSS2052 Fibroblasts 1 22.4705 18.7494 15.3277 8.55394 - OK TSS2052 Fibroblasts 0 6.94078 8.25875 6.75155 3.76784 - OK TSS2053 iPS 0 237.189 247.57 423.286 285.188 - OK TSS2053 iPS 1 542.967 523.107 894.388 602.592 - OK TSS2053 hESC 1 477.018 472.176 312.068 215.718 - OK TSS2053 hESC 0 464.441 469.203 310.103 214.36 - OK TSS2053 Fibroblasts 1 433.088 361.369 295.42 199.782 - OK TSS2053 Fibroblasts 0 238.539 283.835 232.036 156.917 - OK TSS2054 iPS 0 14367.8 14996.6 25640.7 22759.6 - OK TSS2054 iPS 1 14435 13907 23777.7 20925.2 - OK TSS2054 hESC 1 83742.1 82892.2 54784.7 52048.6 - OK TSS2054 hESC 0 87846.9 88747.6 58654.6 55048.2 - OK TSS2054 Fibroblasts 1 85982.4 71743.7 58650.7 57685.2 - OK TSS2054 Fibroblasts 0 95290.3 113385 92692.3 84823.1 - OK TSS2055 iPS 0 0 0 0 0 - OK TSS2055 iPS 1 0 0 0 0 - OK TSS2055 hESC 1 0 0 0 0 - OK TSS2055 hESC 0 1 1.01025 0.667691 0.716409 - OK TSS2055 Fibroblasts 1 2 1.6688 1.36425 1.25394 - OK TSS2055 Fibroblasts 0 0 0 0 0 - OK TSS2056 iPS 0 0.00061045 0.000637168 0.00108941 0.000835455 - OK TSS2056 iPS 1 0 0 0 0 - OK TSS2056 hESC 1 0.000663217 0.000656486 0.000433881 0.000342616 - OK TSS2056 hESC 0 0.000625617 0.000632031 0.000417719 0.000329853 - OK TSS2056 Fibroblasts 1 25.5048 21.2812 17.3974 13.3987 - OK TSS2056 Fibroblasts 0 0 0 0 0 - OK TSS2057 iPS 0 3.99939 4.17443 7.13728 7.62139 - OK TSS2057 iPS 1 0 0 0 0 - OK TSS2057 hESC 1 6.99934 6.9283 4.57901 3.76288 - OK TSS2057 hESC 0 3.99937 4.04038 2.67035 2.1944 - OK TSS2057 Fibroblasts 1 6.84072 5.7079 4.66622 8.86318 - OK TSS2057 Fibroblasts 0 3.59756 4.2807 3.49948 2.80192 - OK TSS2058 iPS 0 0 0 0 0 - OK TSS2058 iPS 1 0.068101 0.0656101 0.112178 0.133732 - OK TSS2058 hESC 1 0 0 0 0 - OK TSS2058 hESC 0 0 0 0 0 - OK TSS2058 Fibroblasts 1 226.806 189.247 154.71 96.8034 - OK TSS2058 Fibroblasts 0 19.3779 23.0575 18.8496 11.996 - OK TSS2059 iPS 0 0 0 0 0 - OK TSS2059 iPS 1 3.9319 3.78808 6.47672 4.08359 - OK TSS2059 hESC 1 0 0 0 0 - OK TSS2059 hESC 0 0 0 0 0 - OK TSS2059 Fibroblasts 1 258.848 215.983 176.567 111.715 - OK TSS2059 Fibroblasts 0 0.0245503 0.0292121 0.023881 0.0151097 - OK TSS206 iPS 0 6.58615 6.8744 11.7536 5.72814 - OK TSS206 iPS 1 8.74409 8.42425 14.4035 7.01957 - OK TSS206 hESC 1 10.937 10.826 7.15508 3.55212 - OK TSS206 hESC 0 33 33.3384 22.0338 10.9386 - OK TSS206 Fibroblasts 1 21.6547 18.0687 14.7712 7.2182 - OK TSS206 Fibroblasts 0 23.8815 28.4163 23.2304 11.3519 - OK TSS2060 iPS 0 13.0605 13.6322 23.3077 31.5606 - OK TSS2060 iPS 1 8.40637 8.09889 13.8472 21.6686 - OK TSS2060 hESC 1 62.543 61.9083 40.9161 71.9932 - OK TSS2060 hESC 0 43.1125 43.5546 28.7858 50.1443 - OK TSS2060 Fibroblasts 1 68.7159 57.3365 46.8727 75.4031 - OK TSS2060 Fibroblasts 0 72.9337 86.7829 70.9453 118.273 - OK TSS2061 iPS 0 169 176.397 301.596 113.267 - OK TSS2061 iPS 1 126 121.391 207.55 77.9474 - OK TSS2061 hESC 1 735 727.54 480.842 183.171 - OK TSS2061 hESC 0 965 974.894 644.322 245.446 - OK TSS2061 Fibroblasts 1 321 267.842 218.962 82.404 - OK TSS2061 Fibroblasts 0 152 180.863 147.856 55.6441 - OK TSS2062 iPS 0 0 0 0 0 - OK TSS2062 iPS 1 0 0 0 0 - OK TSS2062 hESC 1 0 0 0 0 - OK TSS2062 hESC 0 2.00011 2.02062 1.33545 1.17967 - OK TSS2062 Fibroblasts 1 0 0 0 0 - OK TSS2062 Fibroblasts 0 0 0 0 0 - OK TSS2063 iPS 0 30 31.313 53.5378 96.6544 - OK TSS2063 iPS 1 25 24.0856 41.1806 74.3453 - OK TSS2063 hESC 1 203 200.94 132.804 257.213 - OK TSS2063 hESC 0 175 176.794 116.846 226.306 - OK TSS2063 Fibroblasts 1 61 50.8984 41.6096 75.8761 - OK TSS2063 Fibroblasts 0 25 29.7472 24.3184 44.3453 - OK TSS2064 iPS 0 5.46781 5.70712 9.75782 6.67606 - OK TSS2064 iPS 1 0 0 0 0 - OK TSS2064 hESC 1 379.326 375.476 248.157 174.265 - OK TSS2064 hESC 0 262.114 264.802 175.011 122.899 - OK TSS2064 Fibroblasts 1 1586.09 1323.44 1081.91 743.025 - OK TSS2064 Fibroblasts 0 957.557 1139.39 931.45 639.692 - OK TSS2065 iPS 0 875.532 913.852 1562.47 443.156 - OK TSS2065 iPS 1 1079 1039.53 1777.35 504.384 - OK TSS2065 hESC 1 8561.65 8474.75 5601.09 1606.64 - OK TSS2065 hESC 0 8265.87 8350.63 5519.05 1583.09 - OK TSS2065 Fibroblasts 1 22197.8 18521.8 15141.6 4278.59 - OK TSS2065 Fibroblasts 0 14496.9 17249.6 14101.6 3987.73 - OK TSS2066 iPS 0 470.5 491.092 839.651 424.835 - OK TSS2066 iPS 1 638 614.663 1050.93 530.624 - OK TSS2066 hESC 1 1999 1978.71 1307.76 674.333 - OK TSS2066 hESC 0 1901 1920.49 1269.28 652.675 - OK TSS2066 Fibroblasts 1 1509 1259.11 1029.32 521.629 - OK TSS2066 Fibroblasts 0 998 1187.51 970.791 491.743 - OK TSS2067 iPS 0 3.41925 3.5689 6.10197 7.3302 - OK TSS2067 iPS 1 10.5268 10.1417 17.3399 20.8302 - OK TSS2067 hESC 1 8.67217 8.58416 5.67339 7.13768 - OK TSS2067 hESC 0 0 0 0 0 - OK TSS2067 Fibroblasts 1 7.66318 6.39415 5.22724 6.32133 - OK TSS2067 Fibroblasts 0 5.98425 7.12059 5.8211 7.03949 - OK TSS2068 iPS 0 176.581 184.309 315.125 339.832 - OK TSS2068 iPS 1 152.473 146.896 251.157 269.392 - OK TSS2068 hESC 1 260.328 257.686 170.308 190.68 - OK TSS2068 hESC 0 280 282.871 186.953 207.194 - OK TSS2068 Fibroblasts 1 1478.34 1233.52 1008.41 1097.88 - OK TSS2068 Fibroblasts 0 861.016 1024.51 837.541 906.553 - OK TSS2069 iPS 0 774 807.876 1381.28 829.138 - OK TSS2069 iPS 1 758 730.274 1248.6 730.43 - OK TSS2069 hESC 1 2750 2722.09 1799.07 1195.92 - OK TSS2069 hESC 0 2488 2513.51 1661.22 1095.38 - OK TSS2069 Fibroblasts 1 2536 2116.04 1729.87 1108.33 - OK TSS2069 Fibroblasts 0 1968 2341.7 1914.34 1203.86 - OK TSS207 iPS 0 1.41385 1.47573 2.52316 2.26823 - OK TSS207 iPS 1 1.25591 1.20997 2.06876 1.85975 - OK TSS207 hESC 1 9.06297 8.97099 5.92906 5.51644 - OK TSS207 hESC 0 0 0 0 0 - OK TSS207 Fibroblasts 1 13.3453 11.1353 9.10315 8.22425 - OK TSS207 Fibroblasts 0 1.11848 1.33087 1.08799 0.982944 - OK TSS2070 iPS 0 36.704 38.3104 65.5016 12.3376 - OK TSS2070 iPS 1 21.7167 20.9224 35.7723 6.99686 - OK TSS2070 hESC 1 286.945 284.033 187.721 52.2838 - OK TSS2070 hESC 0 398.422 402.507 266.023 65.1752 - OK TSS2070 Fibroblasts 1 9.75683 8.14109 6.65536 1.75708 - OK TSS2070 Fibroblasts 0 7.67741 9.13526 7.4681 2.49757 - OK TSS2071 iPS 0 17.8811 18.6637 31.9105 14.6435 - OK TSS2071 iPS 1 3.65457 3.5209 6.0199 2.7625 - OK TSS2071 hESC 1 169.673 167.951 111.001 51.8319 - OK TSS2071 hESC 0 156.907 158.516 104.766 48.9202 - OK TSS2071 Fibroblasts 1 20.2432 16.8909 13.8084 6.35267 - OK TSS2071 Fibroblasts 0 12.3226 14.6625 11.9866 5.51457 - OK TSS2072 iPS 0 1.41494 1.47687 2.5251 1.70128 - OK TSS2072 iPS 1 3.62872 3.49599 5.97731 4.0272 - OK TSS2072 hESC 1 4.38197 4.3375 2.86672 1.98163 - OK TSS2072 hESC 0 1.67078 1.68791 1.11556 0.771137 - OK TSS2072 Fibroblasts 1 0 0 0 0 - OK TSS2072 Fibroblasts 0 0 0 0 0 - OK TSS2073 iPS 0 0 0 0 0 - OK TSS2073 iPS 1 3 2.89027 4.94167 3.33734 - OK TSS2073 hESC 1 16 15.8376 10.4673 7.33957 - OK TSS2073 hESC 0 4 4.04101 2.67076 1.85068 - OK TSS2073 Fibroblasts 1 0 0 0 0 - OK TSS2073 Fibroblasts 0 1 1.18989 0.972736 0.667027 - OK TSS2074 iPS 0 55 57.4072 98.1526 61.9867 - OK TSS2074 iPS 1 85 81.8909 140.014 87.5571 - OK TSS2074 hESC 1 138 136.599 90.2805 58.4119 - OK TSS2074 hESC 0 130 131.333 86.7998 58.4985 - OK TSS2074 Fibroblasts 1 33 27.5352 22.5101 14.0413 - OK TSS2074 Fibroblasts 0 26 30.9371 25.2911 15.7761 - OK TSS2075 iPS 0 318.944 332.903 569.185 1218.93 - OK TSS2075 iPS 1 307.708 296.453 506.864 1085.46 - OK TSS2075 hESC 1 497.229 492.183 325.291 757.606 - OK TSS2075 hESC 0 97.0452 98.0402 64.7962 150.911 - OK TSS2075 Fibroblasts 1 2743.89 2289.5 1871.68 4056.21 - OK TSS2075 Fibroblasts 0 874.884 1041.01 851.031 1844.31 - OK TSS2076 iPS 0 384.056 400.865 685.384 876.963 - OK TSS2076 iPS 1 527.292 508.005 868.568 1111.35 - OK TSS2076 hESC 1 4608.77 4562 3015.09 4052.8 - OK TSS2076 hESC 0 5754.45 5813.46 3842.2 5164.57 - OK TSS2076 Fibroblasts 1 5327.11 4444.94 3633.75 4682.54 - OK TSS2076 Fibroblasts 0 8593.12 10224.8 8358.84 10771.4 - OK TSS2077 iPS 0 1599.5 1669.51 2854.46 1534.67 - OK TSS2077 iPS 1 1481.5 1427.31 2440.36 1312.96 - OK TSS2077 hESC 1 3534 3498.13 2311.97 1268.32 - OK TSS2077 hESC 0 3985.5 4026.36 2661.08 1460.03 - OK TSS2077 Fibroblasts 1 4078.5 3403.1 2782.04 1498.22 - OK TSS2077 Fibroblasts 0 3373.5 4014.09 3281.53 1766.71 - OK TSS2078 iPS 0 85.3722 89.1087 152.355 55.9409 - OK TSS2078 iPS 1 102.021 98.2893 168.051 61.7044 - OK TSS2078 hESC 1 642.931 636.406 420.61 156.599 - OK TSS2078 hESC 0 464.712 469.477 310.284 115.523 - OK TSS2078 Fibroblasts 1 425.555 355.083 290.281 106.801 - OK TSS2078 Fibroblasts 0 655.066 779.455 637.206 234.442 - OK TSS2079 iPS 0 1783.63 1861.69 3183.05 526.219 - OK TSS2079 iPS 1 2313.98 2229.34 3811.64 630.137 - OK TSS2079 hESC 1 7868.07 7788.21 5147.34 856.275 - OK TSS2079 hESC 0 8422.29 8508.64 5623.49 935.482 - OK TSS2079 Fibroblasts 1 5758.95 4805.26 3928.31 650.018 - OK TSS2079 Fibroblasts 0 3857.93 4590.51 3752.75 620.968 - OK TSS208 iPS 0 4 4.17507 7.13837 7.47676 - OK TSS208 iPS 1 9 8.6708 14.825 15.5278 - OK TSS208 hESC 1 53 52.4621 34.673 37.805 - OK TSS208 hESC 0 37 37.3794 24.7046 26.9362 - OK TSS208 Fibroblasts 1 0 0 0 0 - OK TSS208 Fibroblasts 0 0 0 0 0 - OK TSS2080 iPS 0 171.409 178.911 305.895 316.644 - OK TSS2080 iPS 1 166.494 160.404 274.252 283.89 - OK TSS2080 hESC 1 2525.13 2499.5 1651.96 1779.18 - OK TSS2080 hESC 0 1803.3 1821.79 1204.05 1296.78 - OK TSS2080 Fibroblasts 1 133.851 111.685 91.3029 95.0546 - OK TSS2080 Fibroblasts 0 47.9997 57.1143 46.6911 48.6097 - OK TSS2081 iPS 0 1.59271 1.66242 2.84234 3.95914 - OK TSS2081 iPS 1 3.50637 3.37811 5.77577 8.04516 - OK TSS2081 hESC 1 6.78983 6.72092 4.44195 6.52912 - OK TSS2081 hESC 0 2.09052 2.11195 1.39582 2.05169 - OK TSS2081 Fibroblasts 1 0 0 0 0 - OK TSS2081 Fibroblasts 0 0 0 0 0 - OK TSS2082 iPS 0 1588.83 1658.37 2835.42 3981.87 - OK TSS2082 iPS 1 2092 2015.48 3445.99 4904.84 - OK TSS2082 hESC 1 7541.67 7465.12 4933.81 7273.6 - OK TSS2082 hESC 0 6850.33 6920.57 4573.91 6721.97 - OK TSS2082 Fibroblasts 1 2086.5 1740.97 1423.25 1944.38 - OK TSS2082 Fibroblasts 0 2147.33 2555.09 2088.79 2727.94 - OK TSS2083 iPS 0 0.00410908 0.00428892 0.00733303 0.00147752 - OK TSS2083 iPS 1 85.5158 82.3878 140.864 28.3824 - OK TSS2083 hESC 1 327.75 324.424 214.416 43.5322 - OK TSS2083 hESC 0 628.709 635.156 419.784 85.2271 - OK TSS2083 Fibroblasts 1 2821.72 2354.44 1924.76 388.25 - OK TSS2083 Fibroblasts 0 789.537 939.461 768.012 154.918 - OK TSS2084 iPS 0 308.038 321.52 549.723 112.088 - OK TSS2084 iPS 1 242.655 233.779 399.707 81.5 - OK TSS2084 hESC 1 719.435 712.133 470.659 96.7082 - OK TSS2084 hESC 0 664.419 671.231 443.626 91.1537 - OK TSS2084 Fibroblasts 1 1743.12 1454.46 1189.02 242.714 - OK TSS2084 Fibroblasts 0 1482.05 1763.48 1441.65 294.282 - OK TSS2085 iPS 0 26.8507 28.0259 47.9176 54.5076 - OK TSS2085 iPS 1 41.6733 40.149 68.6453 78.0859 - OK TSS2085 hESC 1 34.4024 34.0533 22.5063 26.7451 - OK TSS2085 hESC 0 37.3111 37.6936 24.9123 29.6043 - OK TSS2085 Fibroblasts 1 171.462 143.068 116.958 133.884 - OK TSS2085 Fibroblasts 0 71.993 85.6636 70.0302 80.1649 - OK TSS2086 iPS 0 0 0 0 0 - OK TSS2086 iPS 1 2 1.92684 3.29445 6.80779 - OK TSS2086 hESC 1 11.0013 10.8896 7.19712 16.125 - OK TSS2086 hESC 0 4 4.04102 2.67077 5.9838 - OK TSS2086 Fibroblasts 1 16.0001 13.3505 10.914 22.8136 - OK TSS2086 Fibroblasts 0 6.00085 7.14034 5.83725 12.2016 - OK TSS2087 iPS 0 41 42.7944 73.1683 195.455 - OK TSS2087 iPS 1 304 292.88 500.756 1337.67 - OK TSS2087 hESC 1 5 4.94925 3.27103 9.7133 - OK TSS2087 hESC 0 3 3.03076 2.00307 5.9481 - OK TSS2087 Fibroblasts 1 0 0 0 0 - OK TSS2087 Fibroblasts 0 0 0 0 0 - OK TSS2088 iPS 0 672 701.411 1199.25 767.67 - OK TSS2088 iPS 1 544 524.102 896.09 572.948 - OK TSS2088 hESC 1 1835 1816.38 1200.47 794.197 - OK TSS2088 hESC 0 1680 1697.23 1121.72 738.142 - OK TSS2088 Fibroblasts 1 1913 1596.21 1304.9 844.54 - OK TSS2088 Fibroblasts 0 3211 3820.73 3123.46 2030.91 - OK TSS2089 iPS 0 306.66 320.081 547.263 644.824 - OK TSS2089 iPS 1 345.585 332.945 569.256 670.738 - OK TSS2089 hESC 1 392.059 388.08 256.488 316.218 - OK TSS2089 hESC 0 450.116 454.731 300.538 370.526 - OK TSS2089 Fibroblasts 1 345.983 288.688 236.003 279.897 - OK TSS2089 Fibroblasts 0 262.062 311.824 254.917 302.328 - OK TSS209 iPS 0 44.3994 46.3427 79.235 33.7036 - OK TSS209 iPS 1 0 0 0 0 - OK TSS209 hESC 1 139.274 137.86 91.1138 39.3861 - OK TSS209 hESC 0 65.4972 66.1687 43.7319 18.9042 - OK TSS209 Fibroblasts 1 496.146 413.984 338.433 144.296 - OK TSS209 Fibroblasts 0 0 0 0 0 - OK TSS2090 iPS 0 485.34 506.582 866.135 764.511 - OK TSS2090 iPS 1 414.243 399.091 682.35 616.625 - OK TSS2090 hESC 1 549.941 544.359 359.775 334.165 - OK TSS2090 hESC 0 581.884 587.851 388.519 362.893 - OK TSS2090 Fibroblasts 1 523.086 436.463 356.81 309.701 - OK TSS2090 Fibroblasts 0 704.359 838.108 685.155 595.613 - OK TSS2091 iPS 0 0 0 0 0 - OK TSS2091 iPS 1 1.172 1.12913 1.93054 31.3204 - OK TSS2091 hESC 1 0 0 0 0 - OK TSS2091 hESC 0 0 0 0 0 - OK TSS2091 Fibroblasts 1 11.9303 9.9546 8.13791 149.845 - OK TSS2091 Fibroblasts 0 1.57958 1.87952 1.53651 28.2921 - OK TSS2092 iPS 0 0 0 0 0 - OK TSS2092 iPS 1 0 0 0 0 - OK TSS2092 hESC 1 0 0 0 0 - OK TSS2092 hESC 0 0 0 0 0 - OK TSS2092 Fibroblasts 1 0 0 0 0 - OK TSS2092 Fibroblasts 0 0 0 0 0 - OK TSS2093 iPS 0 0 0 0 0 - OK TSS2093 iPS 1 0 0 0 0 - OK TSS2093 hESC 1 0 0 0 0 - OK TSS2093 hESC 0 0 0 0 0 - OK TSS2093 Fibroblasts 1 0 0 0 0 - OK TSS2093 Fibroblasts 0 0 0 0 0 - OK TSS2094 iPS 0 0 0 0 0 - OK TSS2094 iPS 1 0.25 0.240856 0.411806 0.348287 - OK TSS2094 hESC 1 0 0 0 0 - OK TSS2094 hESC 0 0 0 0 0 - OK TSS2094 Fibroblasts 1 0 0 0 0 - OK TSS2094 Fibroblasts 0 0 0 0 0 - OK TSS2095 iPS 0 0 0 0 0 - OK TSS2095 iPS 1 0 0 0 0 - OK TSS2095 hESC 1 0 0 0 0 - OK TSS2095 hESC 0 0 0 0 0 - OK TSS2095 Fibroblasts 1 0 0 0 0 - OK TSS2095 Fibroblasts 0 0 0 0 0 - OK TSS2096 iPS 0 0 0 0 0 - OK TSS2096 iPS 1 0.45 0.43354 0.741251 0.675373 - OK TSS2096 hESC 1 0 0 0 0 - OK TSS2096 hESC 0 0 0 0 0 - OK TSS2096 Fibroblasts 1 0 0 0 0 - OK TSS2096 Fibroblasts 0 0 0 0 0 - OK TSS2097 iPS 0 0 0 0 0 - OK TSS2097 iPS 1 0.45 0.43354 0.741251 0.669318 - OK TSS2097 hESC 1 0 0 0 0 - OK TSS2097 hESC 0 0 0 0 0 - OK TSS2097 Fibroblasts 1 0 0 0 0 - OK TSS2097 Fibroblasts 0 0 0 0 0 - OK TSS2098 iPS 0 0 0 0 0 - OK TSS2098 iPS 1 0 0 0 0 - OK TSS2098 hESC 1 0 0 0 0 - OK TSS2098 hESC 0 0 0 0 0 - OK TSS2098 Fibroblasts 1 0 0 0 0 - OK TSS2098 Fibroblasts 0 0 0 0 0 - OK TSS2099 iPS 0 0 0 0 0 - OK TSS2099 iPS 1 0 0 0 0 - OK TSS2099 hESC 1 0 0 0 0 - OK TSS2099 hESC 0 0 0 0 0 - OK TSS2099 Fibroblasts 1 0 0 0 0 - OK TSS2099 Fibroblasts 0 0 0 0 0 - OK TSS21 iPS 0 10.9992 11.4806 19.629 9.94308 - OK TSS21 iPS 1 7.57915 7.30192 12.4846 6.32402 - OK TSS21 hESC 1 62.8886 62.2503 41.1421 21.1543 - OK TSS21 hESC 0 22.4367 22.6667 14.9808 7.66534 - OK TSS21 Fibroblasts 1 83.2026 69.4242 56.7545 28.4923 - OK TSS21 Fibroblasts 0 60.6561 72.1739 59.0024 29.6859 - OK TSS210 iPS 0 949.353 990.903 1694.21 753.27 - OK TSS210 iPS 1 511.806 493.085 843.059 374.836 - OK TSS210 hESC 1 2615.49 2588.94 1711.07 773.697 - OK TSS210 hESC 0 2856.85 2886.14 1907.49 862.515 - OK TSS210 Fibroblasts 1 8757.38 7307.15 5973.62 2662.49 - OK TSS210 Fibroblasts 0 3122.51 3715.43 3037.38 1353.79 - OK TSS2100 iPS 0 0 0 0 0 - OK TSS2100 iPS 1 0 0 0 0 - OK TSS2100 hESC 1 0 0 0 0 - OK TSS2100 hESC 0 0 0 0 0 - OK TSS2100 Fibroblasts 1 0 0 0 0 - OK TSS2100 Fibroblasts 0 0 0 0 0 - OK TSS2101 iPS 0 0 0 0 0 - OK TSS2101 iPS 1 0.333333 0.321141 0.549074 0.401868 - OK TSS2101 hESC 1 0 0 0 0 - OK TSS2101 hESC 0 0 0 0 0 - OK TSS2101 Fibroblasts 1 0 0 0 0 - OK TSS2101 Fibroblasts 0 0 0 0 0 - OK TSS2102 iPS 0 0 0 0 0 - OK TSS2102 iPS 1 0 0 0 0 - OK TSS2102 hESC 1 0 0 0 0 - OK TSS2102 hESC 0 0 0 0 0 - OK TSS2102 Fibroblasts 1 0 0 0 0 - OK TSS2102 Fibroblasts 0 0 0 0 0 - OK TSS2103 iPS 0 0 0 0 0 - OK TSS2103 iPS 1 1 0.963422 1.64722 1.38982 - OK TSS2103 hESC 1 0 0 0 0 - OK TSS2103 hESC 0 0 0 0 0 - OK TSS2103 Fibroblasts 1 0 0 0 0 - OK TSS2103 Fibroblasts 0 0 0 0 0 - OK TSS2104 iPS 0 0 0 0 0 - OK TSS2104 iPS 1 1.33333 1.28456 2.1963 1.60762 - OK TSS2104 hESC 1 0 0 0 0 - OK TSS2104 hESC 0 0 0 0 0 - OK TSS2104 Fibroblasts 1 0 0 0 0 - OK TSS2104 Fibroblasts 0 0 0 0 0 - OK TSS2105 iPS 0 0 0 0 0 - OK TSS2105 iPS 1 0 0 0 0 - OK TSS2105 hESC 1 0 0 0 0 - OK TSS2105 hESC 0 0 0 0 0 - OK TSS2105 Fibroblasts 1 0 0 0 0 - OK TSS2105 Fibroblasts 0 0 0 0 0 - OK TSS2106 iPS 0 4 4.17507 7.13837 5.80813 - OK TSS2106 iPS 1 6 5.78053 9.88334 8.04156 - OK TSS2106 hESC 1 15 14.8478 9.8131 8.23632 - OK TSS2106 hESC 0 15 15.1538 10.0154 8.40609 - OK TSS2106 Fibroblasts 1 0 0 0 0 - OK TSS2106 Fibroblasts 0 0 0 0 0 - OK TSS2107 iPS 0 8.48853 8.86004 15.1486 3.14638 - OK TSS2107 iPS 1 37.675 36.297 62.0592 12.8898 - OK TSS2107 hESC 1 89.2283 88.3227 58.3737 12.2197 - OK TSS2107 hESC 0 45.0907 45.553 30.1067 6.3024 - OK TSS2107 Fibroblasts 1 11.8905 9.92146 8.11082 1.68656 - OK TSS2107 Fibroblasts 0 0 0 0 0 - OK TSS2108 iPS 0 1 1.04377 1.78459 0.813015 - OK TSS2108 iPS 1 0 0 0 0 - OK TSS2108 hESC 1 10.3202 10.2154 6.75152 3.3111 - OK TSS2108 hESC 0 12.8702 13.0021 8.59329 4.21435 - OK TSS2108 Fibroblasts 1 1.13779 0.949372 0.776114 0.374731 - OK TSS2108 Fibroblasts 0 10.3333 12.2954 10.0516 4.85319 - OK TSS2109 iPS 0 173.654 181.254 309.902 182.179 - OK TSS2109 iPS 1 249.842 240.703 411.545 257.227 - OK TSS2109 hESC 1 852.671 844.017 557.823 428.728 - OK TSS2109 hESC 0 676.733 683.672 451.849 359.27 - OK TSS2109 Fibroblasts 1 471.876 393.733 321.878 221.243 - OK TSS2109 Fibroblasts 0 288.505 343.289 280.639 203.631 - OK TSS211 iPS 0 207.248 216.318 369.853 209.193 - OK TSS211 iPS 1 415.194 400.007 683.917 413.437 - OK TSS211 hESC 1 503.239 498.131 329.222 196.326 - OK TSS211 hESC 0 125.652 126.94 83.8964 55.0512 - OK TSS211 Fibroblasts 1 1406.48 1173.56 959.391 525.557 - OK TSS211 Fibroblasts 0 309.991 368.855 301.54 166.987 - OK TSS2110 iPS 0 0 0 0 0 - OK TSS2110 iPS 1 0 0 0 0 - OK TSS2110 hESC 1 0 0 0 0 - OK TSS2110 hESC 0 0 0 0 0 - OK TSS2110 Fibroblasts 1 57.1239 47.6642 38.9656 31.8842 - OK TSS2110 Fibroblasts 0 37.0946 44.1384 36.0832 29.5257 - OK TSS2111 iPS 0 91.3461 95.3441 163.016 141.423 - OK TSS2111 iPS 1 142.158 136.958 234.166 203.149 - OK TSS2111 hESC 1 32.3289 32.0008 21.1498 18.9668 - OK TSS2111 hESC 0 120.267 121.5 80.3009 72.0127 - OK TSS2111 Fibroblasts 1 0 0 0 0 - OK TSS2111 Fibroblasts 0 90.4002 107.566 87.9355 76.6549 - OK TSS2112 iPS 0 80 83.5014 142.767 99.5559 - OK TSS2112 iPS 1 125 120.428 205.903 143.582 - OK TSS2112 hESC 1 247.477 244.966 161.901 115.938 - OK TSS2112 hESC 0 250 252.563 166.923 119.533 - OK TSS2112 Fibroblasts 1 72.824 60.7643 49.675 34.7737 - OK TSS2112 Fibroblasts 0 75 89.2416 72.9552 51.0704 - OK TSS2113 iPS 0 70 73.0637 124.922 68.9048 - OK TSS2113 iPS 1 75 72.2567 123.542 68.1437 - OK TSS2113 hESC 1 155 153.427 101.402 57.116 - OK TSS2113 hESC 0 162 163.661 108.166 60.9259 - OK TSS2113 Fibroblasts 1 105 87.612 71.623 39.6268 - OK TSS2113 Fibroblasts 0 74 88.0517 71.9825 39.8257 - OK TSS2114 iPS 0 212 221.279 378.334 230.308 - OK TSS2114 iPS 1 118 113.684 194.372 126.389 - OK TSS2114 hESC 1 885.5 876.513 579.3 350.205 - OK TSS2114 hESC 0 829 837.5 553.516 332.522 - OK TSS2114 Fibroblasts 1 1560 1301.66 1064.11 601.953 - OK TSS2114 Fibroblasts 0 1288 1532.58 1252.88 720.125 - OK TSS2115 iPS 0 268.029 279.76 478.323 248.397 - OK TSS2115 iPS 1 12.1711 11.7259 20.0485 10.4665 - OK TSS2115 hESC 1 13.0413 12.909 8.53172 4.51777 - OK TSS2115 hESC 0 7.3635 7.439 4.91654 2.61808 - OK TSS2115 Fibroblasts 1 847.769 707.378 578.283 300.905 - OK TSS2115 Fibroblasts 0 740.912 881.601 720.711 374.821 - OK TSS2116 iPS 0 94.9715 99.1282 169.486 106.671 - OK TSS2116 iPS 1 12.8287 12.3594 21.1317 13.2999 - OK TSS2116 hESC 1 15.9588 15.7968 10.4404 6.73019 - OK TSS2116 hESC 0 1.63616 1.65293 1.09245 0.704227 - OK TSS2116 Fibroblasts 1 702.228 585.939 479.006 302.529 - OK TSS2116 Fibroblasts 0 792.088 942.496 770.493 486.625 - OK TSS2117 iPS 0 6.50038 6.78488 11.6005 19.7101 - OK TSS2117 iPS 1 5.50004 5.29886 9.0598 8.36235 - OK TSS2117 hESC 1 49.5004 48.998 32.3835 34.9834 - OK TSS2117 hESC 0 27.5001 27.7821 18.3616 18.9473 - OK TSS2117 Fibroblasts 1 54.2691 45.2822 37.0183 38.3729 - OK TSS2117 Fibroblasts 0 55 65.4438 53.5005 53.5162 - OK TSS2118 iPS 0 332 346.531 592.485 233.19 - OK TSS2118 iPS 1 428 412.345 705.012 281.349 - OK TSS2118 hESC 1 2049 2028.2 1340.47 508.99 - OK TSS2118 hESC 0 2557.5 2583.72 1707.62 651.486 - OK TSS2118 Fibroblasts 1 2259 1884.91 1540.92 578.063 - OK TSS2118 Fibroblasts 0 3461 4118.2 3366.64 1262.97 - OK TSS2119 iPS 0 0 0 0 0 - OK TSS2119 iPS 1 44.3126 42.6918 72.9928 56.0998 - OK TSS2119 hESC 1 703.736 696.594 460.389 364.361 - OK TSS2119 hESC 0 561.01 566.762 374.581 296.452 - OK TSS2119 Fibroblasts 1 316.759 264.303 216.069 167.349 - OK TSS2119 Fibroblasts 0 229.661 273.271 223.4 172.907 - OK TSS212 iPS 0 645.31 673.553 1151.62 135.082 - OK TSS212 iPS 1 806.699 777.191 1328.81 155.867 - OK TSS212 hESC 1 2973.2 2943.02 1945.09 229.165 - OK TSS212 hESC 0 3251.83 3285.17 2171.22 255.807 - OK TSS212 Fibroblasts 1 5098.49 4254.17 3477.8 408.203 - OK TSS212 Fibroblasts 0 1397.53 1662.91 1359.43 159.562 - OK TSS2120 iPS 0 182 189.966 324.796 160.558 - OK TSS2120 iPS 1 167.687 161.554 276.219 136.545 - OK TSS2120 hESC 1 2105.76 2084.39 1377.6 693.892 - OK TSS2120 hESC 0 2017.99 2038.68 1347.39 678.675 - OK TSS2120 Fibroblasts 1 38.2415 31.9087 26.0854 12.9302 - OK TSS2120 Fibroblasts 0 4.33866 5.16252 4.22037 2.09199 - OK TSS2121 iPS 0 17 17.744 30.3381 30.84 - OK TSS2121 iPS 1 15 14.4513 24.7084 25.1171 - OK TSS2121 hESC 1 97 96.0155 63.458 67.0708 - OK TSS2121 hESC 0 61 61.6254 40.7291 43.0479 - OK TSS2121 Fibroblasts 1 253 211.103 172.577 176.423 - OK TSS2121 Fibroblasts 0 185 220.129 179.956 183.966 - OK TSS2122 iPS 0 23.4303 24.4558 41.8136 25.6435 - OK TSS2122 iPS 1 18.3519 17.6806 30.2297 18.5393 - OK TSS2122 hESC 1 5.04507 4.99386 3.30052 2.07191 - OK TSS2122 hESC 0 5.98566 6.04703 3.99657 2.50886 - OK TSS2122 Fibroblasts 1 44.414 37.059 30.2959 18.643 - OK TSS2122 Fibroblasts 0 20.706 24.6378 20.1415 12.3944 - OK TSS2123 iPS 0 6.1265 6.39464 10.9333 5.35606 - OK TSS2123 iPS 1 23.4595 22.6014 38.643 18.9306 - OK TSS2123 hESC 1 15.7593 15.5994 10.3098 5.14538 - OK TSS2123 hESC 0 37.8755 38.2638 25.2891 12.6211 - OK TSS2123 Fibroblasts 1 133.25 111.184 90.8932 44.6479 - OK TSS2123 Fibroblasts 0 39.8427 47.4083 38.7564 19.0376 - OK TSS2124 iPS 0 373.274 389.611 666.143 335.631 - OK TSS2124 iPS 1 295.849 285.028 487.33 245.538 - OK TSS2124 hESC 1 774.747 766.884 506.845 260.3 - OK TSS2124 hESC 0 752.693 760.411 502.566 258.103 - OK TSS2124 Fibroblasts 1 1645.34 1372.87 1122.32 567.052 - OK TSS2124 Fibroblasts 0 996.451 1185.67 969.284 489.73 - OK TSS2125 iPS 0 34.5024 36.0125 61.5728 31.1562 - OK TSS2125 iPS 1 27.3395 26.3395 45.0342 22.7876 - OK TSS2125 hESC 1 2.44885 2.424 1.60205 0.826367 - OK TSS2125 hESC 0 3.44577 3.4811 2.30071 1.18674 - OK TSS2125 Fibroblasts 1 0 0 0 0 - OK TSS2125 Fibroblasts 0 0 0 0 0 - OK TSS2126 iPS 0 0 0 0 0 - OK TSS2126 iPS 1 1.98872 1.91597 3.27586 2.50951 - OK TSS2126 hESC 1 0 0 0 0 - OK TSS2126 hESC 0 0 0 0 0 - OK TSS2126 Fibroblasts 1 1.26129 1.05242 0.860354 0.350249 - OK TSS2126 Fibroblasts 0 0 0 0 0 - OK TSS2127 iPS 0 94.3451 98.4743 168.368 45.7964 - OK TSS2127 iPS 1 72.8546 70.1897 120.008 32.6424 - OK TSS2127 hESC 1 266.512 263.807 174.354 47.9146 - OK TSS2127 hESC 0 268.711 271.466 179.416 49.3056 - OK TSS2127 Fibroblasts 1 116.113 96.8847 79.2035 21.5759 - OK TSS2127 Fibroblasts 0 45.3856 54.0037 44.1482 12.0265 - OK TSS2128 iPS 0 0 0 0 0 - OK TSS2128 iPS 1 0 0 0 0 - OK TSS2128 hESC 1 19.9255 19.7233 13.0354 52.1823 - OK TSS2128 hESC 0 42.5912 43.0279 28.4378 113.84 - OK TSS2128 Fibroblasts 1 17.2834 14.4212 11.7894 41.8251 - OK TSS2128 Fibroblasts 0 6.5016 7.73618 6.32434 22.4368 - OK TSS2129 iPS 0 4.15492 4.33676 7.41484 10.9883 - OK TSS2129 iPS 1 1.64543 1.58525 2.7104 4.01662 - OK TSS2129 hESC 1 61.3959 60.7728 40.1656 63.034 - OK TSS2129 hESC 0 36.0315 36.401 24.0579 37.7553 - OK TSS2129 Fibroblasts 1 21.7702 18.165 14.85 22.1882 - OK TSS2129 Fibroblasts 0 8.2795 9.85167 8.05377 12.0336 - OK TSS213 iPS 0 170.69 178.161 304.612 36.7262 - OK TSS213 iPS 1 220.301 212.243 362.886 43.7521 - OK TSS213 hESC 1 2008.8 1988.41 1314.17 159.167 - OK TSS213 hESC 0 1498.17 1513.53 1000.32 121.154 - OK TSS213 Fibroblasts 1 2166.51 1807.74 1477.83 178.297 - OK TSS213 Fibroblasts 0 1506.47 1792.53 1465.4 176.796 - OK TSS2130 iPS 0 17.6943 18.4687 31.5771 19.2987 - OK TSS2130 iPS 1 26.6837 25.7076 43.9539 26.863 - OK TSS2130 hESC 1 29.1475 28.8517 19.0685 11.928 - OK TSS2130 hESC 0 29.7601 30.0653 19.8706 12.4297 - OK TSS2130 Fibroblasts 1 2 1.6688 1.36425 0.8366 - OK TSS2130 Fibroblasts 0 1.24322 1.47929 1.20933 0.741598 - OK TSS2131 iPS 0 603.573 629.99 1077.13 472.786 - OK TSS2131 iPS 1 356.128 343.102 586.622 271.284 - OK TSS2131 hESC 1 775.836 767.962 507.557 218.65 - OK TSS2131 hESC 0 772.925 780.85 516.075 229.049 - OK TSS2131 Fibroblasts 1 3621.67 3021.92 2470.43 949.369 - OK TSS2131 Fibroblasts 0 2044.18 2432.35 1988.45 820.408 - OK TSS2132 iPS 0 32.771 34.2053 58.4829 61.5286 - OK TSS2132 iPS 1 36.9033 35.5535 60.788 63.9537 - OK TSS2132 hESC 1 146.661 145.173 95.9468 105.1 - OK TSS2132 hESC 0 266.41 269.142 177.88 194.849 - OK TSS2132 Fibroblasts 1 1191.48 994.17 812.737 860.059 - OK TSS2132 Fibroblasts 0 664.287 790.427 646.176 683.8 - OK TSS2133 iPS 0 2.68826 2.80591 4.79744 3.31274 - OK TSS2133 iPS 1 6.202 5.97515 10.2161 7.05442 - OK TSS2133 hESC 1 2.28495 2.26176 1.49483 1.05972 - OK TSS2133 hESC 0 18.7197 18.9116 12.4989 8.86078 - OK TSS2133 Fibroblasts 1 3.87295 3.23159 2.64183 1.83122 - OK TSS2133 Fibroblasts 0 9.53692 11.3479 9.27691 6.43042 - OK TSS2134 iPS 0 17.4175 18.1798 31.0831 15.3816 - OK TSS2134 iPS 1 0 0 0 0 - OK TSS2134 hESC 1 5.21766 5.1647 3.41342 1.72116 - OK TSS2134 hESC 0 5.20691 5.2603 3.47661 1.75302 - OK TSS2134 Fibroblasts 1 123.259 102.847 84.078 41.7203 - OK TSS2134 Fibroblasts 0 83.2424 99.049 80.9729 40.1795 - OK TSS2135 iPS 0 75.398 78.6979 134.555 153.926 - OK TSS2135 iPS 1 74.885 72.1459 123.352 141.111 - OK TSS2135 hESC 1 60.2547 59.6432 39.4191 47.1204 - OK TSS2135 hESC 0 43.2814 43.7252 28.8986 34.5445 - OK TSS2135 Fibroblasts 1 218.458 182.281 149.015 171.552 - OK TSS2135 Fibroblasts 0 114.965 136.795 111.831 128.744 - OK TSS2136 iPS 0 27.0809 28.2661 48.3284 34.0873 - OK TSS2136 iPS 1 9.54524 9.1961 15.7231 11.1045 - OK TSS2136 hESC 1 319.492 316.249 209.014 156.865 - OK TSS2136 hESC 0 302.069 305.166 201.689 149.854 - OK TSS2136 Fibroblasts 1 163.355 136.303 111.428 80.7939 - OK TSS2136 Fibroblasts 0 116.977 139.19 113.788 83.1311 - OK TSS2137 iPS 0 72.5743 75.7507 129.516 71.0509 - OK TSS2137 iPS 1 60.2374 58.0341 99.2245 54.4335 - OK TSS2137 hESC 1 432.17 427.784 282.729 158.368 - OK TSS2137 hESC 0 381.228 385.137 254.543 142.58 - OK TSS2137 Fibroblasts 1 70.4689 58.7992 48.0685 26.45 - OK TSS2137 Fibroblasts 0 111.873 133.117 108.823 59.8807 - OK TSS2138 iPS 0 52.9093 55.225 94.4216 75.3919 - OK TSS2138 iPS 1 57.936 55.8168 95.4335 76.3856 - OK TSS2138 hESC 1 356.855 353.233 233.457 193.339 - OK TSS2138 hESC 0 339.792 343.276 226.876 187.061 - OK TSS2138 Fibroblasts 1 161.765 134.977 110.344 89.0566 - OK TSS2138 Fibroblasts 0 113.751 135.35 110.649 88.8078 - OK TSS2139 iPS 0 20.0375 20.9145 35.7588 118.036 - OK TSS2139 iPS 1 11.8964 11.4612 19.596 64.6843 - OK TSS2139 hESC 1 112.062 110.925 73.3117 276.275 - OK TSS2139 hESC 0 75.2958 76.0678 50.2743 189.458 - OK TSS2139 Fibroblasts 1 91.6198 76.4475 62.496 210.123 - OK TSS2139 Fibroblasts 0 63.1003 75.0823 61.3799 206.37 - OK TSS214 iPS 0 0 0 0 0 - OK TSS214 iPS 1 0 0 0 0 - OK TSS214 hESC 1 0 0 0 0 - OK TSS214 hESC 0 0 0 0 0 - OK TSS214 Fibroblasts 1 0 0 0 0 - OK TSS214 Fibroblasts 0 0 0 0 0 - OK TSS2140 iPS 0 3 3.1313 5.35378 3.75843 - OK TSS2140 iPS 1 0 0 0 0 - OK TSS2140 hESC 1 23.6706 23.4304 15.4855 12.2077 - OK TSS2140 hESC 0 19.9057 20.1098 13.2909 10.4776 - OK TSS2140 Fibroblasts 1 0 0 0 0 - OK TSS2140 Fibroblasts 0 0 0 0 0 - OK TSS2141 iPS 0 0 0 0 0 - OK TSS2141 iPS 1 0 0 0 0 - OK TSS2141 hESC 1 6.32936 6.26512 4.14071 6.16319 - OK TSS2141 hESC 0 1.09428 1.1055 0.730644 1.08752 - OK TSS2141 Fibroblasts 1 0 0 0 0 - OK TSS2141 Fibroblasts 0 0 0 0 0 - OK TSS2142 iPS 0 31 32.3567 55.3223 19.5518 - OK TSS2142 iPS 1 15.1729 14.6179 24.9931 8.83296 - OK TSS2142 hESC 1 163.257 161.601 106.804 38.2544 - OK TSS2142 hESC 0 162.04 163.702 108.193 38.7518 - OK TSS2142 Fibroblasts 1 7.14659 5.96311 4.87486 1.72622 - OK TSS2142 Fibroblasts 0 3.1165 3.70828 3.03153 1.07348 - OK TSS2143 iPS 0 0 0 0 0 - OK TSS2143 iPS 1 6.82711 6.57739 11.2458 3.7629 - OK TSS2143 hESC 1 18.7425 18.5523 12.2615 4.15502 - OK TSS2143 hESC 0 10.4596 10.5669 6.98379 2.36658 - OK TSS2143 Fibroblasts 1 5.35341 4.46688 3.65169 1.22414 - OK TSS2143 Fibroblasts 0 6.8835 8.19059 6.69583 2.24461 - OK TSS2144 iPS 0 5.00001 5.21884 8.92298 65.8754 - OK TSS2144 iPS 1 16 15.4148 26.3556 194.575 - OK TSS2144 hESC 1 96 95.0257 62.8038 641.809 - OK TSS2144 hESC 0 62 62.6357 41.3968 423.045 - OK TSS2144 Fibroblasts 1 96 80.1024 65.4839 504.172 - OK TSS2144 Fibroblasts 0 28 33.3169 27.2366 209.699 - OK TSS2145 iPS 0 749 781.781 1336.66 2028.45 - OK TSS2145 iPS 1 728 701.372 1199.18 1820.34 - OK TSS2145 hESC 1 5035 4983.9 3293.93 5301.65 - OK TSS2145 hESC 0 4471.5 4517.35 2985.58 4805.58 - OK TSS2145 Fibroblasts 1 1021.34 852.203 696.678 1066.36 - OK TSS2145 Fibroblasts 0 2433.2 2895.23 2366.86 3622.54 - OK TSS2146 iPS 0 0 0 0 0 - OK TSS2146 iPS 1 0 0 0 0 - OK TSS2146 hESC 1 0 0 0 0 - OK TSS2146 hESC 0 0 0 0 0 - OK TSS2146 Fibroblasts 1 5.66359 4.7257 3.86327 6.03667 - OK TSS2146 Fibroblasts 0 50.8044 60.4516 49.4193 77.2511 - OK TSS2147 iPS 0 24.23 25.2905 43.2408 57.8935 - OK TSS2147 iPS 1 33.4064 32.1845 55.0278 73.6747 - OK TSS2147 hESC 1 422.062 417.778 276.116 389.272 - OK TSS2147 hESC 0 391.511 395.526 261.409 368.538 - OK TSS2147 Fibroblasts 1 257.075 214.504 175.357 236.528 - OK TSS2147 Fibroblasts 0 167.737 199.589 163.164 220.082 - OK TSS2148 iPS 0 330.735 345.21 590.227 218.455 - OK TSS2148 iPS 1 475.575 458.18 783.379 290.847 - OK TSS2148 hESC 1 4138.14 4096.14 2707.2 1016.6 - OK TSS2148 hESC 0 4168.74 4211.48 2783.43 1046.38 - OK TSS2148 Fibroblasts 1 1516.66 1265.5 1034.55 383.796 - OK TSS2148 Fibroblasts 0 1174.97 1398.08 1142.93 426.315 - OK TSS2149 iPS 0 0.371325 0.387577 0.662664 1.02722 - OK TSS2149 iPS 1 0 0 0 0 - OK TSS2149 hESC 1 23.4869 23.2485 15.3653 25.292 - OK TSS2149 hESC 0 20.591 20.8022 13.7484 22.6306 - OK TSS2149 Fibroblasts 1 25.2638 21.0801 17.2331 26.9443 - OK TSS2149 Fibroblasts 0 40.2952 47.9467 39.1966 61.2846 - OK TSS215 iPS 0 0 0 0 0 - OK TSS215 iPS 1 2.53558 2.44284 4.17667 2.04325 - OK TSS215 hESC 1 32.0838 31.7582 20.9894 10.4605 - OK TSS215 hESC 0 0 0 0 0 - OK TSS215 Fibroblasts 1 0 0 0 0 - OK TSS215 Fibroblasts 0 0 0 0 0 - OK TSS2150 iPS 0 10.6637 11.1304 19.0304 18.2935 - OK TSS2150 iPS 1 21.0184 20.2496 34.622 33.2814 - OK TSS2150 hESC 1 25.3149 25.058 16.5612 16.5167 - OK TSS2150 hESC 0 31.1574 31.4769 20.8035 20.7477 - OK TSS2150 Fibroblasts 1 0 0 0 0 - OK TSS2150 Fibroblasts 0 0 0 0 0 - OK TSS2151 iPS 0 678.5 708.196 1210.85 1755.76 - OK TSS2151 iPS 1 557.5 537.108 918.327 1331.6 - OK TSS2151 hESC 1 1528 1512.49 999.628 1533.05 - OK TSS2151 hESC 0 1629 1645.7 1087.67 1668.07 - OK TSS2151 Fibroblasts 1 5250 4380.6 3581.15 5234.69 - OK TSS2151 Fibroblasts 0 3746.5 4457.91 3644.36 5327.08 - OK TSS2152 iPS 0 54 56.3634 96.3681 40.9253 - OK TSS2152 iPS 1 40 38.5369 65.8889 22.4268 - OK TSS2152 hESC 1 294 291.016 192.337 68.4869 - OK TSS2152 hESC 0 276 278.83 184.283 63.3521 - OK TSS2152 Fibroblasts 1 7 5.8408 4.77487 1.68269 - OK TSS2152 Fibroblasts 0 0 0 0 0 - OK TSS2153 iPS 0 2150.25 2244.36 3837.33 1435.05 - OK TSS2153 iPS 1 5599.22 5394.41 9223.16 3449.19 - OK TSS2153 hESC 1 19452.6 19255.2 12726 4827.01 - OK TSS2153 hESC 0 13822.6 13964.3 9229.22 3500.67 - OK TSS2153 Fibroblasts 1 2552.99 2130.22 1741.46 652.602 - OK TSS2153 Fibroblasts 0 2961.64 3524.02 2880.9 1079.6 - OK TSS2154 iPS 0 1174.75 1226.16 2096.45 755.835 - OK TSS2154 iPS 1 1740.28 1676.63 2866.63 1033.51 - OK TSS2154 hESC 1 4406.9 4362.18 2883.03 1053.7 - OK TSS2154 hESC 0 6689.41 6758 4466.46 1632.42 - OK TSS2154 Fibroblasts 1 674.005 562.39 459.755 166.087 - OK TSS2154 Fibroblasts 0 542.356 645.343 527.569 190.585 - OK TSS2155 iPS 0 1 1.04377 1.78459 1.00135 - OK TSS2155 iPS 1 0 0 0 0 - OK TSS2155 hESC 1 0 0 0 0 - OK TSS2155 hESC 0 0 0 0 0 - OK TSS2155 Fibroblasts 1 0 0 0 0 - OK TSS2155 Fibroblasts 0 0 0 0 0 - OK TSS2156 iPS 0 0.0237338 0.0247726 0.0423552 0.0194935 - OK TSS2156 iPS 1 239.448 230.69 394.425 181.529 - OK TSS2156 hESC 1 915.163 905.875 598.706 280.398 - OK TSS2156 hESC 0 520.382 525.718 347.454 162.727 - OK TSS2156 Fibroblasts 1 651.249 543.402 444.232 204.973 - OK TSS2156 Fibroblasts 0 122.173 145.373 118.842 54.8351 - OK TSS2157 iPS 0 354.976 370.513 633.488 283.939 - OK TSS2157 iPS 1 78.5516 75.6783 129.392 61.1234 - OK TSS2157 hESC 1 1218.84 1206.47 797.371 363.783 - OK TSS2157 hESC 0 1704.62 1722.1 1138.16 511.905 - OK TSS2157 Fibroblasts 1 1089.75 909.288 743.345 328.008 - OK TSS2157 Fibroblasts 0 1118.83 1331.28 1088.32 480.233 - OK TSS2158 iPS 0 280 292.255 499.686 124.716 - OK TSS2158 iPS 1 192 184.977 316.267 78.9369 - OK TSS2158 hESC 1 524 518.682 342.804 86.3707 - OK TSS2158 hESC 0 557 562.711 371.904 93.7024 - OK TSS2158 Fibroblasts 1 2194.5 1831.09 1496.92 374.131 - OK TSS2158 Fibroblasts 0 951 1131.58 925.072 231.207 - OK TSS2159 iPS 0 3.11566 3.25202 5.56018 10.1678 - OK TSS2159 iPS 1 6.24469 6.01627 10.2864 18.8106 - OK TSS2159 hESC 1 24.9557 24.7024 16.3262 32.0592 - OK TSS2159 hESC 0 78.9506 79.7601 52.7146 103.514 - OK TSS2159 Fibroblasts 1 188.005 156.871 128.243 236.908 - OK TSS2159 Fibroblasts 0 112.582 133.96 109.513 202.307 - OK TSS216 iPS 0 8.83685 9.22362 15.7702 9.63746 - OK TSS216 iPS 1 7.1705 6.90822 11.8114 7.0571 - OK TSS216 hESC 1 80.8746 80.0538 52.9087 32.9744 - OK TSS216 hESC 0 38.9899 39.3896 26.0332 16.5179 - OK TSS216 Fibroblasts 1 0 0 0 0 - OK TSS216 Fibroblasts 0 0.999999 1.18989 0.972735 0.616835 - OK TSS2160 iPS 0 3.31221 3.45717 5.91094 3.53168 - OK TSS2160 iPS 1 0 0 0 0 - OK TSS2160 hESC 1 320.851 317.594 209.903 128.294 - OK TSS2160 hESC 0 159.865 161.505 106.741 65.2408 - OK TSS2160 Fibroblasts 1 910.05 759.345 620.767 372.124 - OK TSS2160 Fibroblasts 0 351.089 417.756 341.517 204.725 - OK TSS2161 iPS 0 0 0 0 0 - OK TSS2161 iPS 1 0 0 0 0 - OK TSS2161 hESC 1 32.0869 31.7613 20.9915 11.0166 - OK TSS2161 hESC 0 103.332 104.392 68.9939 36.2088 - OK TSS2161 Fibroblasts 1 41.6399 34.7443 28.4036 14.6598 - OK TSS2161 Fibroblasts 0 49.6479 59.0755 48.2943 24.9259 - OK TSS2162 iPS 0 0 0 0 0 - OK TSS2162 iPS 1 0 0 0 0 - OK TSS2162 hESC 1 394.998 390.989 258.41 137.04 - OK TSS2162 hESC 0 536.685 542.188 358.34 190.035 - OK TSS2162 Fibroblasts 1 0 0 0 0 - OK TSS2162 Fibroblasts 0 32.0309 38.1131 31.1576 16.2472 - OK TSS2163 iPS 0 27.995 29.2203 49.9598 21.328 - OK TSS2163 iPS 1 49.1172 47.3206 80.907 34.5394 - OK TSS2163 hESC 1 1511.72 1496.38 988.977 429.082 - OK TSS2163 hESC 0 2427.85 2452.75 1621.06 703.319 - OK TSS2163 Fibroblasts 1 1489.18 1242.57 1015.8 434.674 - OK TSS2163 Fibroblasts 0 1208.18 1437.59 1175.24 502.897 - OK TSS2164 iPS 0 10.4191 10.8751 18.5939 7.94738 - OK TSS2164 iPS 1 3.13978 3.02494 5.17192 2.21058 - OK TSS2164 hESC 1 1698.86 1681.61 1111.4 482.791 - OK TSS2164 hESC 0 1274.82 1287.89 851.183 369.752 - OK TSS2164 Fibroblasts 1 335.621 280.042 228.935 98.0826 - OK TSS2164 Fibroblasts 0 940.238 1118.78 914.604 391.844 - OK TSS2165 iPS 0 3686.95 3848.32 6579.71 592.354 - OK TSS2165 iPS 1 4388.19 4227.68 7228.32 650.747 - OK TSS2165 hESC 1 11372.1 11256.6 7439.68 672.049 - OK TSS2165 hESC 0 14294.2 14440.8 9544.13 862.15 - OK TSS2165 Fibroblasts 1 13155.3 10976.7 8973.52 808.264 - OK TSS2165 Fibroblasts 0 5958.27 7089.67 5795.83 522.042 - OK TSS2166 iPS 0 41.4309 43.2442 73.9373 34.9265 - OK TSS2166 iPS 1 55.7358 53.6971 91.8093 43.3688 - OK TSS2166 hESC 1 11.1148 11.0019 7.27135 3.49693 - OK TSS2166 hESC 0 22.0004 22.226 14.6895 7.06446 - OK TSS2166 Fibroblasts 1 21.2268 17.7116 14.4793 6.85761 - OK TSS2166 Fibroblasts 0 9.36491 11.1432 9.10958 4.31444 - OK TSS2167 iPS 0 51.4174 53.6678 91.7592 43.9023 - OK TSS2167 iPS 1 44.1163 42.5026 72.6694 34.7687 - OK TSS2167 hESC 1 593.921 587.893 388.547 189.305 - OK TSS2167 hESC 0 617.353 623.683 412.201 200.83 - OK TSS2167 Fibroblasts 1 548.362 457.553 374.051 179.439 - OK TSS2167 Fibroblasts 0 341.659 406.535 332.344 159.431 - OK TSS2168 iPS 0 0 0 0 0 - OK TSS2168 iPS 1 0 0 0 0 - OK TSS2168 hESC 1 0 0 0 0 - OK TSS2168 hESC 0 0 0 0 0 - OK TSS2168 Fibroblasts 1 0 0 0 0 - OK TSS2168 Fibroblasts 0 2.30952 2.74808 2.24656 1.59155 - OK TSS2169 iPS 0 187.34 195.54 334.326 84.6997 - OK TSS2169 iPS 1 351.708 338.843 579.341 146.773 - OK TSS2169 hESC 1 29.5369 29.2371 19.3232 4.9425 - OK TSS2169 hESC 0 26.4732 26.7446 17.6759 4.52114 - OK TSS2169 Fibroblasts 1 31.0003 25.8666 21.146 5.36473 - OK TSS2169 Fibroblasts 0 26.3342 31.3348 25.6162 6.49883 - OK TSS217 iPS 0 0 0 0 0 - OK TSS217 iPS 1 3.46455 3.33782 5.70688 10.2217 - OK TSS217 hESC 1 9.26048 9.16649 6.05827 12.5589 - OK TSS217 hESC 0 6.45269 6.51885 4.3084 6.95428 - OK TSS217 Fibroblasts 1 0 0 0 0 - OK TSS217 Fibroblasts 0 0 0 0 0 - OK TSS2170 iPS 0 30.7025 32.0462 54.7915 30.9091 - OK TSS2170 iPS 1 65.0197 62.6414 107.102 60.4186 - OK TSS2170 hESC 1 31.7283 31.4063 20.7568 11.9631 - OK TSS2170 hESC 0 38.1927 38.5843 25.5009 14.6973 - OK TSS2170 Fibroblasts 1 19.4119 16.1973 13.2413 7.49306 - OK TSS2170 Fibroblasts 0 10.8097 12.8623 10.515 5.95027 - OK TSS2171 iPS 0 520.298 543.069 928.52 323.048 - OK TSS2171 iPS 1 509.98 491.326 840.051 292.041 - OK TSS2171 hESC 1 2534.27 2508.55 1657.94 584.113 - OK TSS2171 hESC 0 2624.81 2651.72 1752.56 617.411 - OK TSS2171 Fibroblasts 1 9814.59 8189.29 6694.76 2331.94 - OK TSS2171 Fibroblasts 0 7006.19 8336.58 6815.17 2374.01 - OK TSS2172 iPS 0 6.5 6.78449 11.5999 8.41669 - OK TSS2172 iPS 1 8.5 8.18909 14.0014 9.22686 - OK TSS2172 hESC 1 22.5 22.2716 14.7196 9.94659 - OK TSS2172 hESC 0 30.5 30.8127 20.3646 13.761 - OK TSS2172 Fibroblasts 1 22 18.3568 15.0067 9.92548 - OK TSS2172 Fibroblasts 0 17 20.2281 16.5365 10.9373 - OK TSS2173 iPS 0 8.5 8.87202 15.169 19.9877 - OK TSS2173 iPS 1 5.5 5.29882 9.05973 11.9377 - OK TSS2173 hESC 1 22 21.7767 14.3925 19.9528 - OK TSS2173 hESC 0 17 17.1743 11.3507 15.7358 - OK TSS2173 Fibroblasts 1 14 11.6816 9.54973 12.6755 - OK TSS2173 Fibroblasts 0 13.5 16.0635 13.1319 17.4303 - OK TSS2174 iPS 0 205 213.972 365.842 442.371 - OK TSS2174 iPS 1 140 134.879 230.611 276.327 - OK TSS2174 hESC 1 894.5 885.422 585.188 725.941 - OK TSS2174 hESC 0 851.5 860.231 568.539 705.322 - OK TSS2174 Fibroblasts 1 3508.5 2927.49 2393.23 2942.51 - OK TSS2174 Fibroblasts 0 2992 3560.14 2910.43 3479.57 - OK TSS2175 iPS 0 537.003 560.506 958.331 963.112 - OK TSS2175 iPS 1 977.092 941.352 1609.49 1617.52 - OK TSS2175 hESC 1 0 0 0 0 - OK TSS2175 hESC 0 0 0 0 0 - OK TSS2175 Fibroblasts 1 0 0 0 0 - OK TSS2175 Fibroblasts 0 0 0 0 0 - OK TSS2176 iPS 0 33.7947 35.2738 60.3099 44.5135 - OK TSS2176 iPS 1 33.7739 32.5385 55.6331 41.0617 - OK TSS2176 hESC 1 128.835 127.528 84.2849 63.9842 - OK TSS2176 hESC 0 153.557 155.131 102.528 77.8337 - OK TSS2176 Fibroblasts 1 37.2376 31.0711 25.4007 18.8245 - OK TSS2176 Fibroblasts 0 179.712 213.837 174.812 129.553 - OK TSS2177 iPS 0 1674.7 1748 2988.66 2891.64 - OK TSS2177 iPS 1 1156.13 1113.85 1904.41 1833.98 - OK TSS2177 hESC 1 8310.66 8226.32 5436.89 5460.8 - OK TSS2177 hESC 0 7669.44 7748.08 5120.82 5138.56 - OK TSS2177 Fibroblasts 1 30146.1 25153.9 20563.4 19961 - OK TSS2177 Fibroblasts 0 19366.3 23043.7 18838.3 18328.8 - OK TSS2178 iPS 0 18.9247 19.7529 33.7728 23.1401 - OK TSS2178 iPS 1 0 0 0 0 - OK TSS2178 hESC 1 0 0 0 0 - OK TSS2178 hESC 0 0 0 0 0 - OK TSS2178 Fibroblasts 1 249.738 208.381 170.352 117.163 - OK TSS2178 Fibroblasts 0 0 0 0 0 - OK TSS2179 iPS 0 66.3241 69.2269 118.362 59.6782 - OK TSS2179 iPS 1 34.9776 33.6982 57.616 29.0501 - OK TSS2179 hESC 1 192.671 190.715 126.047 64.7807 - OK TSS2179 hESC 0 142.694 144.157 95.2754 48.9661 - OK TSS2179 Fibroblasts 1 1083.26 903.871 738.917 373.604 - OK TSS2179 Fibroblasts 0 1045.22 1243.7 1016.73 514.068 - OK TSS218 iPS 0 0 0 0 0 - OK TSS218 iPS 1 0 0 0 0 - OK TSS218 hESC 1 0 0 0 0 - OK TSS218 hESC 0 0 0 0 0 - OK TSS218 Fibroblasts 1 0 0 0 0 - OK TSS218 Fibroblasts 0 0 0 0 0 - OK TSS2180 iPS 0 17.1779 17.9297 30.6555 26.356 - OK TSS2180 iPS 1 6.94564 6.69159 11.441 10.4579 - OK TSS2180 hESC 1 16.3292 16.1635 10.6827 10.1021 - OK TSS2180 hESC 0 22.2903 22.5188 14.883 12.393 - OK TSS2180 Fibroblasts 1 272.317 227.221 185.754 133.327 - OK TSS2180 Fibroblasts 0 114.045 135.701 110.936 83.267 - OK TSS2181 iPS 0 2.57336 2.68599 4.59241 7.40279 - OK TSS2181 iPS 1 2.07672 2.00076 3.42083 5.51425 - OK TSS2181 hESC 1 0 0 0 0 - OK TSS2181 hESC 0 0.0159428 0.0161062 0.0106448 0.0182659 - OK TSS2181 Fibroblasts 1 8.68604 7.24763 5.92496 9.63659 - OK TSS2181 Fibroblasts 0 16.7297 19.9065 16.2736 26.468 - OK TSS2182 iPS 0 0 0 0 0 - OK TSS2182 iPS 1 0 0 0 0 - OK TSS2182 hESC 1 0 0 0 0 - OK TSS2182 hESC 0 0 0 0 0 - OK TSS2182 Fibroblasts 1 0 0 0 0 - OK TSS2182 Fibroblasts 0 0 0 0 0 - OK TSS2183 iPS 0 0 0 0 0 - OK TSS2183 iPS 1 0 0 0 0 - OK TSS2183 hESC 1 0 0 0 0 - OK TSS2183 hESC 0 0 0 0 0 - OK TSS2183 Fibroblasts 1 0.000514113 0.000428976 0.000350689 0.000664325 - OK TSS2183 Fibroblasts 0 0 0 0 0 - OK TSS2184 iPS 0 64 66.8011 114.214 214.004 - OK TSS2184 iPS 1 16 15.4148 26.3556 48.502 - OK TSS2184 hESC 1 34 33.6549 22.243 44.1426 - OK TSS2184 hESC 0 25 25.2563 16.6923 31.5939 - OK TSS2184 Fibroblasts 1 3.99949 3.33717 2.72814 5.41459 - OK TSS2184 Fibroblasts 0 12 14.2787 11.6728 20.8292 - OK TSS2185 iPS 0 0 0 0 0 - OK TSS2185 iPS 1 0 0 0 0 - OK TSS2185 hESC 1 0 0 0 0 - OK TSS2185 hESC 0 0 0 0 0 - OK TSS2185 Fibroblasts 1 0 0 0 0 - OK TSS2185 Fibroblasts 0 0 0 0 0 - OK TSS2186 iPS 0 0 0 0 0 - OK TSS2186 iPS 1 0 0 0 0 - OK TSS2186 hESC 1 0 0 0 0 - OK TSS2186 hESC 0 0 0 0 0 - OK TSS2186 Fibroblasts 1 0 0 0 0 - OK TSS2186 Fibroblasts 0 0 0 0 0 - OK TSS2187 iPS 0 0 0 0 0 - OK TSS2187 iPS 1 0 0 0 0 - OK TSS2187 hESC 1 1 0.989851 0.654207 0.751535 - OK TSS2187 hESC 0 1 1.01025 0.667691 0.767025 - OK TSS2187 Fibroblasts 1 0 0 0 0 - OK TSS2187 Fibroblasts 0 0 0 0 0 - OK TSS2188 iPS 0 0 0 0 0 - OK TSS2188 iPS 1 0 0 0 0 - OK TSS2188 hESC 1 0 0 0 0 - OK TSS2188 hESC 0 0 0 0 0 - OK TSS2188 Fibroblasts 1 12 10.0128 8.18549 4.69349 - OK TSS2188 Fibroblasts 0 0 0 0 0 - OK TSS2189 iPS 0 163.814 170.984 292.342 287.269 - OK TSS2189 iPS 1 21.8198 21.0217 35.9421 35.3185 - OK TSS2189 hESC 1 9.38461 9.28936 6.13947 6.26433 - OK TSS2189 hESC 0 10.187 10.2914 6.80174 6.94006 - OK TSS2189 Fibroblasts 1 7482.52 6243.42 5104.01 5042.8 - OK TSS2189 Fibroblasts 0 756.316 899.931 735.696 726.874 - OK TSS219 iPS 0 4.662 4.86605 8.31978 6.00285 - OK TSS219 iPS 1 15.3296 14.7689 25.2512 18.2192 - OK TSS219 hESC 1 132.114 130.773 86.4298 64.0989 - OK TSS219 hESC 0 85.2244 86.0982 56.9035 42.2014 - OK TSS219 Fibroblasts 1 3.00124 2.50423 2.04722 1.48301 - OK TSS219 Fibroblasts 0 3 3.56966 2.91821 2.11396 - OK TSS2190 iPS 0 272.186 284.099 485.741 314.821 - OK TSS2190 iPS 1 24.1802 23.2957 39.8301 25.8149 - OK TSS2190 hESC 1 320.615 317.361 209.749 139.338 - OK TSS2190 hESC 0 255.813 258.436 170.804 113.467 - OK TSS2190 Fibroblasts 1 19175.5 16000 13080 8507.96 - OK TSS2190 Fibroblasts 0 10520.7 12518.4 10233.9 6656.64 - OK TSS2191 iPS 0 386.5 403.416 689.745 426.336 - OK TSS2191 iPS 1 348 335.271 573.234 354.319 - OK TSS2191 hESC 1 842 833.454 550.842 348.578 - OK TSS2191 hESC 0 864 872.859 576.885 365.058 - OK TSS2191 Fibroblasts 1 3250 2711.8 2216.9 1374.97 - OK TSS2191 Fibroblasts 0 2690 3200.8 2616.66 1622.91 - OK TSS2192 iPS 0 3765 3929.78 6718.99 4855.09 - OK TSS2192 iPS 1 3377 3253.48 5562.67 4018.93 - OK TSS2192 hESC 1 10413 10307.3 6812.25 5059.07 - OK TSS2192 hESC 0 10272.5 10377.8 6858.85 5092.86 - OK TSS2192 Fibroblasts 1 25871 21586.8 17647.2 12796.8 - OK TSS2192 Fibroblasts 0 17600 20942 17120.2 12415.7 - OK TSS2193 iPS 0 4.70673 4.91273 8.3996 7.22497 - OK TSS2193 iPS 1 0.054298 0.052312 0.089441 0.0841479 - OK TSS2193 hESC 1 41.2764 40.8575 27.0033 26.3366 - OK TSS2193 hESC 0 9.68437 9.78366 6.46616 5.74775 - OK TSS2193 Fibroblasts 1 234.42 195.6 159.904 149.967 - OK TSS2193 Fibroblasts 0 22.9773 27.3404 22.3509 21.1379 - OK TSS2194 iPS 0 0 0 0 0 - OK TSS2194 iPS 1 0 0 0 0 - OK TSS2194 hESC 1 31.4543 31.135 20.5776 16.5636 - OK TSS2194 hESC 0 0 0 0 0 - OK TSS2194 Fibroblasts 1 36.0383 30.0703 24.5826 19.2894 - OK TSS2194 Fibroblasts 0 4.97463 5.91925 4.839 3.79706 - OK TSS2195 iPS 0 66.2933 69.1947 118.307 46.4151 - OK TSS2195 iPS 1 114.946 110.741 189.341 74.2638 - OK TSS2195 hESC 1 693.269 686.233 453.541 180.585 - OK TSS2195 hESC 0 461.316 466.046 308.016 122.601 - OK TSS2195 Fibroblasts 1 103.541 86.3948 70.628 27.7696 - OK TSS2195 Fibroblasts 0 84.0481 100.008 81.7566 32.1452 - OK TSS2196 iPS 0 28.4972 29.7444 50.8559 19.6443 - OK TSS2196 iPS 1 23.6936 22.827 39.0287 15.0573 - OK TSS2196 hESC 1 648.398 641.817 424.186 166.061 - OK TSS2196 hESC 0 500.899 506.034 334.445 133.072 - OK TSS2196 Fibroblasts 1 351.612 293.385 239.843 94.4916 - OK TSS2196 Fibroblasts 0 670.343 797.633 652.067 256.652 - OK TSS2197 iPS 0 55.5028 57.932 99.0499 48.3889 - OK TSS2197 iPS 1 79.3064 76.4056 130.635 63.8193 - OK TSS2197 hESC 1 541.602 536.105 354.32 176.334 - OK TSS2197 hESC 0 435.101 439.563 290.513 144.58 - OK TSS2197 Fibroblasts 1 300.388 250.644 204.902 100.372 - OK TSS2197 Fibroblasts 0 341.657 406.534 332.342 162.799 - OK TSS2198 iPS 0 92.6496 96.7046 165.342 78.7086 - OK TSS2198 iPS 1 12.9241 12.4513 21.2888 10.1342 - OK TSS2198 hESC 1 201.9 199.851 132.085 64.0226 - OK TSS2198 hESC 0 163.894 165.574 109.43 53.0419 - OK TSS2198 Fibroblasts 1 360.578 300.866 245.959 117.394 - OK TSS2198 Fibroblasts 0 140.412 167.074 136.584 65.1901 - OK TSS2199 iPS 0 599.67 625.916 1070.17 328.552 - OK TSS2199 iPS 1 549.096 529.011 904.483 277.685 - OK TSS2199 hESC 1 506.223 501.085 331.174 102.861 - OK TSS2199 hESC 0 547.604 553.219 365.63 113.563 - OK TSS2199 Fibroblasts 1 820.563 684.677 559.726 172.133 - OK TSS2199 Fibroblasts 0 405.524 482.527 394.467 121.311 - OK TSS22 iPS 0 0.000838242 0.000874929 0.00149592 0.000895675 - OK TSS22 iPS 1 1.42085 1.36888 2.34045 1.36663 - OK TSS22 hESC 1 166.111 164.426 108.671 65.4652 - OK TSS22 hESC 0 142.563 144.025 95.1882 57.3244 - OK TSS22 Fibroblasts 1 100.797 84.1053 68.7563 39.9813 - OK TSS22 Fibroblasts 0 48.3439 57.5238 47.0259 27.6682 - OK TSS220 iPS 0 1872 1953.93 3340.76 1415.29 - OK TSS220 iPS 1 1485.01 1430.69 2446.15 1019.75 - OK TSS220 hESC 1 4807 4758.21 3144.77 1320.15 - OK TSS220 hESC 0 5110 5162.39 3411.9 1431.55 - OK TSS220 Fibroblasts 1 17052.2 14228.4 11631.7 5130.04 - OK TSS220 Fibroblasts 0 13927 16571.6 13547.3 5605.57 - OK TSS2200 iPS 0 677.174 706.811 1208.48 632.505 - OK TSS2200 iPS 1 558.048 537.636 919.23 462.248 - OK TSS2200 hESC 1 778.014 770.118 508.982 243.497 - OK TSS2200 hESC 0 1193.99 1206.24 797.219 396.533 - OK TSS2200 Fibroblasts 1 3403.83 2840.15 2321.83 1087.39 - OK TSS2200 Fibroblasts 0 3711.35 4416.09 3610.17 1574.67 - OK TSS2201 iPS 0 924.104 964.549 1649.15 691.217 - OK TSS2201 iPS 1 476.147 458.731 784.321 366.778 - OK TSS2201 hESC 1 309.315 306.176 202.356 90.6375 - OK TSS2201 hESC 0 293.519 296.528 195.98 89.2976 - OK TSS2201 Fibroblasts 1 7971.18 6651.15 5437.33 2206.91 - OK TSS2201 Fibroblasts 0 2997.75 3566.98 2916.02 1224.9 - OK TSS2202 iPS 0 434.903 453.937 776.125 648.655 - OK TSS2202 iPS 1 218.285 210.3 359.564 300.51 - OK TSS2202 hESC 1 867.547 858.742 567.555 489.726 - OK TSS2202 hESC 0 906.99 916.289 605.589 522.544 - OK TSS2202 Fibroblasts 1 2562.85 2138.44 1748.18 1467.83 - OK TSS2202 Fibroblasts 0 1001.46 1191.63 974.161 817.941 - OK TSS2203 iPS 0 39.7499 41.4896 70.9374 20.099 - OK TSS2203 iPS 1 0 0 0 0 - OK TSS2203 hESC 1 0 0 0 0 - OK TSS2203 hESC 0 74.3082 75.0701 49.6149 14.2089 - OK TSS2203 Fibroblasts 1 3245.28 2707.86 2213.68 628.196 - OK TSS2203 Fibroblasts 0 1274.4 1516.39 1239.65 351.787 - OK TSS2204 iPS 0 1043.23 1088.89 1861.75 470.076 - OK TSS2204 iPS 1 1344.85 1295.65 2215.26 557.728 - OK TSS2204 hESC 1 1455.75 1440.97 952.36 242.063 - OK TSS2204 hESC 0 1499.2 1514.57 1001 254.426 - OK TSS2204 Fibroblasts 1 4907.82 4095.09 3347.74 851.323 - OK TSS2204 Fibroblasts 0 2295.87 2731.83 2233.28 570.995 - OK TSS2205 iPS 0 1.78751 1.86575 3.18998 0.794085 - OK TSS2205 iPS 1 4.50145 4.3368 7.4149 1.8458 - OK TSS2205 hESC 1 0 0 0 0 - OK TSS2205 hESC 0 0 0 0 0 - OK TSS2205 Fibroblasts 1 1272.82 1062.04 868.219 216.424 - OK TSS2205 Fibroblasts 0 824.255 980.77 801.782 199.863 - OK TSS2206 iPS 0 721.885 753.48 1288.27 300.795 - OK TSS2206 iPS 1 418.006 402.717 688.55 159.265 - OK TSS2206 hESC 1 2570.06 2543.98 1681.35 396.408 - OK TSS2206 hESC 0 2736.34 2764.4 1827.03 431.54 - OK TSS2206 Fibroblasts 1 3924.73 3274.79 2677.15 625.582 - OK TSS2206 Fibroblasts 0 2979.71 3545.52 2898.47 678.1 - OK TSS2207 iPS 0 239.383 249.86 427.201 345.801 - OK TSS2207 iPS 1 194.31 187.203 320.072 259.085 - OK TSS2207 hESC 1 49.7573 49.2523 32.5516 27.176 - OK TSS2207 hESC 0 0 0 0 0 - OK TSS2207 Fibroblasts 1 0 0 0 0 - OK TSS2207 Fibroblasts 0 0 0 0 0 - OK TSS2208 iPS 0 60.9611 63.6292 108.791 80.1291 - OK TSS2208 iPS 1 98.337 94.74 161.983 119.307 - OK TSS2208 hESC 1 57.4308 56.8479 37.5716 28.4611 - OK TSS2208 hESC 0 82.1529 82.9952 54.8527 41.5518 - OK TSS2208 Fibroblasts 1 168.346 140.468 114.833 84.9247 - OK TSS2208 Fibroblasts 0 39.2618 46.7172 38.1914 28.2445 - OK TSS2209 iPS 0 0 0 0 0 - OK TSS2209 iPS 1 0 0 0 0 - OK TSS2209 hESC 1 23.2977 23.0612 15.2415 4.2945 - OK TSS2209 hESC 0 43.8355 44.285 29.2686 8.24683 - OK TSS2209 Fibroblasts 1 813.754 678.996 555.081 155.001 - OK TSS2209 Fibroblasts 0 372.389 443.101 362.236 101.151 - OK TSS221 iPS 0 571 595.991 1019 765.712 - OK TSS221 iPS 1 297 286.136 489.225 374.9 - OK TSS221 hESC 1 1076 1065.08 703.926 536.078 - OK TSS221 hESC 0 1088 1099.16 726.448 554.099 - OK TSS221 Fibroblasts 1 7603 6343.94 5186.19 4177.2 - OK TSS221 Fibroblasts 0 4647 5529.41 4520.31 3362.54 - OK TSS2210 iPS 0 146.278 152.68 261.047 75.0611 - OK TSS2210 iPS 1 400.012 385.38 658.908 189.462 - OK TSS2210 hESC 1 214.735 212.555 140.481 40.8351 - OK TSS2210 hESC 0 0 0 0 0 - OK TSS2210 Fibroblasts 1 5020.8 4189.35 3424.81 986.331 - OK TSS2210 Fibroblasts 0 3499.15 4163.6 3403.75 980.268 - OK TSS2211 iPS 0 106.805 111.48 190.603 88.01 - OK TSS2211 iPS 1 10.4885 10.1049 17.2769 12.0209 - OK TSS2211 hESC 1 578.808 572.934 378.66 111.854 - OK TSS2211 hESC 0 562.007 567.769 375.247 126.245 - OK TSS2211 Fibroblasts 1 9697.5 8091.59 6614.9 2062.54 - OK TSS2211 Fibroblasts 0 3651.4 4344.75 3551.85 1029.74 - OK TSS2212 iPS 0 189.417 197.707 338.032 96.2387 - OK TSS2212 iPS 1 0 0 0 0 - OK TSS2212 hESC 1 2267.66 2244.64 1483.52 426.931 - OK TSS2212 hESC 0 2214.16 2236.86 1478.37 425.45 - OK TSS2212 Fibroblasts 1 18399.9 15352.9 12551 3578.95 - OK TSS2212 Fibroblasts 0 14769.1 17573.5 14366.4 4096.6 - OK TSS2213 iPS 0 88.5 92.3734 157.937 118.236 - OK TSS2213 iPS 1 66 63.5859 108.717 81.3883 - OK TSS2213 hESC 1 128.5 127.196 84.0656 64.756 - OK TSS2213 hESC 0 110.667 111.801 73.8911 56.9186 - OK TSS2213 Fibroblasts 1 1191.83 994.465 812.978 611.143 - OK TSS2213 Fibroblasts 0 590.667 702.827 574.563 431.919 - OK TSS2214 iPS 0 5.37569 5.61097 9.59343 4.26672 - OK TSS2214 iPS 1 0 0 0 0 - OK TSS2214 hESC 1 106.868 105.783 69.9135 31.623 - OK TSS2214 hESC 0 50.6987 51.2186 33.8511 15.3114 - OK TSS2214 Fibroblasts 1 0 0 0 0 - OK TSS2214 Fibroblasts 0 0.000380988 0.000453333 0.000370601 0.000165232 - OK TSS2215 iPS 0 45.7051 47.7055 81.565 36.8323 - OK TSS2215 iPS 1 0.0547094 0.0527083 0.0901186 0.0406948 - OK TSS2215 hESC 1 454.833 450.217 297.555 136.687 - OK TSS2215 hESC 0 118.157 119.368 78.8922 36.2405 - OK TSS2215 Fibroblasts 1 7.9893 6.66627 5.44969 2.46707 - OK TSS2215 Fibroblasts 0 3.99285 4.75104 3.88399 1.75827 - OK TSS2216 iPS 0 16.9192 17.6597 30.1939 12.8395 - OK TSS2216 iPS 1 78.9453 76.0577 130.041 57.7163 - OK TSS2216 hESC 1 79.2992 78.4944 51.8781 22.4188 - OK TSS2216 hESC 0 397.145 401.217 265.17 119.316 - OK TSS2216 Fibroblasts 1 0.0106965 0.00892518 0.00729636 0.00326853 - OK TSS2216 Fibroblasts 0 0.00677162 0.00805747 0.006587 0.00295076 - OK TSS2217 iPS 0 170.841 178.318 304.882 124.231 - OK TSS2217 iPS 1 168.667 162.497 277.832 113.209 - OK TSS2217 hESC 1 169.348 167.629 110.789 45.8456 - OK TSS2217 hESC 0 196.008 198.018 130.873 54.1566 - OK TSS2217 Fibroblasts 1 203.066 169.438 138.516 56.5689 - OK TSS2217 Fibroblasts 0 104.435 124.266 101.588 41.4875 - OK TSS2218 iPS 0 1253.38 1308.24 2236.77 1019.2 - OK TSS2218 iPS 1 1241.99 1196.57 2045.84 941.917 - OK TSS2218 hESC 1 2831.52 2802.78 1852.4 727.303 - OK TSS2218 hESC 0 3035.92 3067.05 2027.06 809.697 - OK TSS2218 Fibroblasts 1 6098.68 5088.74 4160.06 1563.6 - OK TSS2218 Fibroblasts 0 3644.75 4336.85 3545.38 1365.17 - OK TSS2219 iPS 0 31.7785 33.1693 56.7117 41.7489 - OK TSS2219 iPS 1 32.3387 31.1558 53.2691 39.2146 - OK TSS2219 hESC 1 9.13456 9.04185 5.97589 4.52441 - OK TSS2219 hESC 0 9.0707 9.1637 6.05642 4.58538 - OK TSS2219 Fibroblasts 1 4.25003 3.54623 2.89905 2.14287 - OK TSS2219 Fibroblasts 0 1.31319 1.56255 1.27738 0.944197 - OK TSS222 iPS 0 3.91158 4.08278 6.98059 6.91385 - OK TSS222 iPS 1 0 0 0 0 - OK TSS222 hESC 1 14.6041 14.4559 9.55408 10.0555 - OK TSS222 hESC 0 21.8118 22.0354 14.5635 13.1237 - OK TSS222 Fibroblasts 1 20.5904 17.1806 14.0452 8.0772 - OK TSS222 Fibroblasts 0 9.60665 11.4308 9.34474 5.37404 - OK TSS2220 iPS 0 12.1492 12.681 21.6814 8.97156 - OK TSS2220 iPS 1 12.8678 12.3971 21.1961 8.77075 - OK TSS2220 hESC 1 717.199 709.92 469.197 197.217 - OK TSS2220 hESC 0 630.088 636.548 420.704 176.834 - OK TSS2220 Fibroblasts 1 654.973 546.509 446.773 185.294 - OK TSS2220 Fibroblasts 0 1572.35 1870.91 1529.48 634.332 - OK TSS2221 iPS 0 775.275 809.206 1383.55 138.605 - OK TSS2221 iPS 1 582.468 561.163 959.455 96.121 - OK TSS2221 hESC 1 13489.9 13353 8825.16 887.458 - OK TSS2221 hESC 0 12636.8 12766.4 8437.5 848.476 - OK TSS2221 Fibroblasts 1 102145 85230 69675.7 6984.02 - OK TSS2221 Fibroblasts 0 19486.2 23186.3 18954.9 1899.98 - OK TSS2222 iPS 0 9.83732 10.2679 17.5556 36.5985 - OK TSS2222 iPS 1 8.17343 7.87446 13.4635 28.0675 - OK TSS2222 hESC 1 0 0 0 0 - OK TSS2222 hESC 0 0 0 0 0 - OK TSS2222 Fibroblasts 1 224.404 187.243 153.071 322.826 - OK TSS2222 Fibroblasts 0 0 0 0 0 - OK TSS2223 iPS 0 24 25.0504 42.8302 16.2188 - OK TSS2223 iPS 1 0.0359824 0.0346663 0.0592711 0.0224445 - OK TSS2223 hESC 1 337 333.58 220.468 84.6913 - OK TSS2223 hESC 0 249.997 252.561 166.921 64.1217 - OK TSS2223 Fibroblasts 1 0.0411402 0.0343274 0.0280627 0.0101707 - OK TSS2223 Fibroblasts 0 0 0 0 0 - OK TSS2224 iPS 0 0 0 0 0 - OK TSS2224 iPS 1 24.964 24.0509 41.1213 15.6555 - OK TSS2224 hESC 1 0 0 0 0 - OK TSS2224 hESC 0 0.00274652 0.00277468 0.00183383 0.0007083 - OK TSS2224 Fibroblasts 1 5.95886 4.97207 4.06468 1.48074 - OK TSS2224 Fibroblasts 0 0 0 0 0 - OK TSS2225 iPS 0 0 0 0 0 - OK TSS2225 iPS 1 1 0.963422 1.64722 6.80245 - OK TSS2225 hESC 1 1 0.989851 0.654207 1.81454 - OK TSS2225 hESC 0 0 0 0 0 - OK TSS2225 Fibroblasts 1 0 0 0 0 - OK TSS2225 Fibroblasts 0 0 0 0 0 - OK TSS2226 iPS 0 2590 2703.36 4622.1 790.27 - OK TSS2226 iPS 1 3200 3082.95 5271.11 929.38 - OK TSS2226 hESC 1 3743 3705.01 2448.7 415.507 - OK TSS2226 hESC 0 4069 4110.72 2716.83 459.261 - OK TSS2226 Fibroblasts 1 9159 7642.27 6247.57 1046.87 - OK TSS2226 Fibroblasts 0 4420 5259.3 4299.49 720.529 - OK TSS2227 iPS 0 6.4626 6.74545 11.5331 11.1016 - OK TSS2227 iPS 1 15.6097 15.0387 25.7126 24.7506 - OK TSS2227 hESC 1 0 0 0 0 - OK TSS2227 hESC 0 8.61787 8.70623 5.75407 5.74673 - OK TSS2227 Fibroblasts 1 0.429547 0.358414 0.293004 0.283549 - OK TSS2227 Fibroblasts 0 0 0 0 0 - OK TSS2228 iPS 0 3051.04 3184.57 5444.86 3155.48 - OK TSS2228 iPS 1 3215.39 3097.78 5296.47 3064.79 - OK TSS2228 hESC 1 8115 8032.64 5308.89 3106.08 - OK TSS2228 hESC 0 7695.38 7774.28 5138.14 3011.06 - OK TSS2228 Fibroblasts 1 11006.1 9183.46 7507.5 4345.45 - OK TSS2228 Fibroblasts 0 10297.5 12252.9 10016.8 5801.7 - OK TSS2229 iPS 0 94.5819 98.7215 168.79 57.5815 - OK TSS2229 iPS 1 4.74298 4.56949 7.81274 2.66525 - OK TSS2229 hESC 1 93.9997 93.0456 61.4952 21.2511 - OK TSS2229 hESC 0 68.9997 69.7072 46.0705 15.9207 - OK TSS2229 Fibroblasts 1 1343.15 1120.73 916.196 313.143 - OK TSS2229 Fibroblasts 0 647.443 770.385 629.791 215.254 - OK TSS223 iPS 0 1.95473 2.04028 3.4884 3.12207 - OK TSS223 iPS 1 0 0 0 0 - OK TSS223 hESC 1 24.8787 24.6262 16.2758 16.9505 - OK TSS223 hESC 0 8.10623 8.18935 5.41246 6.47536 - OK TSS223 Fibroblasts 1 3.45245 2.88072 2.355 2.11816 - OK TSS223 Fibroblasts 0 6.39844 7.61343 6.22399 6.78524 - OK TSS2230 iPS 0 87.0895 90.9012 155.419 50.8378 - OK TSS2230 iPS 1 19.0504 18.3536 31.3803 10.2645 - OK TSS2230 hESC 1 0 0 0 0 - OK TSS2230 hESC 0 0 0 0 0 - OK TSS2230 Fibroblasts 1 492.698 411.107 336.081 110.131 - OK TSS2230 Fibroblasts 0 413.161 491.615 401.896 131.698 - OK TSS2231 iPS 0 105 109.596 187.382 255.239 - OK TSS2231 iPS 1 3 2.89027 4.94167 9.62698 - OK TSS2231 hESC 1 1.36964 1.35574 0.896026 0.92831 - OK TSS2231 hESC 0 2.64117 2.66825 1.76348 1.82702 - OK TSS2231 Fibroblasts 1 933.735 779.108 636.923 748.708 - OK TSS2231 Fibroblasts 0 532.061 633.092 517.555 605.982 - OK TSS2232 iPS 0 0 0 0 0 - OK TSS2232 iPS 1 0 0 0 0 - OK TSS2232 hESC 1 3.63036 3.59352 2.37501 10.5196 - OK TSS2232 hESC 0 0.358831 0.362511 0.239589 1.06121 - OK TSS2232 Fibroblasts 1 82.2651 68.6419 56.115 217.637 - OK TSS2232 Fibroblasts 0 7.43924 8.85186 7.23642 28.0658 - OK TSS2233 iPS 0 54.6225 57.0132 97.479 57.8266 - OK TSS2233 iPS 1 55.5936 53.5602 91.5751 54.3243 - OK TSS2233 hESC 1 25.7854 25.5237 16.869 10.2353 - OK TSS2233 hESC 0 78.1707 78.9722 52.1938 31.6687 - OK TSS2233 Fibroblasts 1 147.427 123.013 100.563 59.8523 - OK TSS2233 Fibroblasts 0 229.328 272.874 223.075 132.768 - OK TSS2234 iPS 0 22.8536 23.8539 40.7844 21.9901 - OK TSS2234 iPS 1 48.431 46.6595 79.7767 43.014 - OK TSS2234 hESC 1 304.211 301.123 199.017 109.526 - OK TSS2234 hESC 0 212.429 214.608 141.837 78.0578 - OK TSS2234 Fibroblasts 1 112.315 93.7159 76.613 41.4315 - OK TSS2234 Fibroblasts 0 81.2724 96.705 79.0566 42.753 - OK TSS2235 iPS 0 352.524 367.953 629.112 224.92 - OK TSS2235 iPS 1 345.975 333.32 569.898 203.965 - OK TSS2235 hESC 1 2623.35 2596.72 1716.21 621.61 - OK TSS2235 hESC 0 2566.43 2592.74 1713.58 621.008 - OK TSS2235 Fibroblasts 1 2415.15 2015.2 1647.43 590.364 - OK TSS2235 Fibroblasts 0 2045.4 2433.8 1989.63 712.435 - OK TSS2236 iPS 0 0 0 0 0 - OK TSS2236 iPS 1 0 0 0 0 - OK TSS2236 hESC 1 103.655 102.603 67.8115 61.9915 - OK TSS2236 hESC 0 0 0 0 0 - OK TSS2236 Fibroblasts 1 0 0 0 0 - OK TSS2236 Fibroblasts 0 0 0 0 0 - OK TSS2237 iPS 0 0 0 0 0 - OK TSS2237 iPS 1 0 0 0 0 - OK TSS2237 hESC 1 0 0 0 0 - OK TSS2237 hESC 0 6.97245 7.04394 4.65544 13.8243 - OK TSS2237 Fibroblasts 1 0.105505 0.0880333 0.0719674 0.195125 - OK TSS2237 Fibroblasts 0 0 0 0 0 - OK TSS2238 iPS 0 33 34.4443 58.8916 16.5798 - OK TSS2238 iPS 1 39 37.5735 64.2417 18.086 - OK TSS2238 hESC 1 560 554.316 366.356 104.243 - OK TSS2238 hESC 0 463 467.747 309.141 87.9633 - OK TSS2238 Fibroblasts 1 154 128.498 105.047 29.62 - OK TSS2238 Fibroblasts 0 322 383.144 313.221 88.3184 - OK TSS2239 iPS 0 1194.11 1246.37 2131 2692.57 - OK TSS2239 iPS 1 826.959 796.711 1362.19 1721.15 - OK TSS2239 hESC 1 3049.42 3018.47 1994.95 2646.35 - OK TSS2239 hESC 0 4085.97 4127.86 2728.17 3618.98 - OK TSS2239 Fibroblasts 1 1416.56 1181.97 966.267 1229.48 - OK TSS2239 Fibroblasts 0 960.159 1142.48 933.981 1188.4 - OK TSS224 iPS 0 12.1337 12.6647 21.6537 14.083 - OK TSS224 iPS 1 5.5 5.29882 9.05973 6.26325 - OK TSS224 hESC 1 265.017 262.328 173.376 119.213 - OK TSS224 hESC 0 167.582 169.3 111.893 76.7613 - OK TSS224 Fibroblasts 1 5.4572 4.55349 3.72249 2.36666 - OK TSS224 Fibroblasts 0 6.99491 8.32315 6.8042 4.35371 - OK TSS2240 iPS 0 7.95208 8.30012 14.1912 22.144 - OK TSS2240 iPS 1 14.7359 14.1969 24.2733 37.876 - OK TSS2240 hESC 1 96.4006 95.4222 63.0659 104.54 - OK TSS2240 hESC 0 52.6225 53.162 35.1355 58.2416 - OK TSS2240 Fibroblasts 1 133.034 111.003 90.7456 142.83 - OK TSS2240 Fibroblasts 0 50.0435 59.5461 48.6791 76.6189 - OK TSS2241 iPS 0 33.942 35.4275 60.5726 59.5216 - OK TSS2241 iPS 1 0 0 0 0 - OK TSS2241 hESC 1 74.9549 74.1941 49.036 50.0332 - OK TSS2241 hESC 0 46.336 46.8111 30.9381 31.5673 - OK TSS2241 Fibroblasts 1 0 0 0 0 - OK TSS2241 Fibroblasts 0 24.0612 28.6301 23.4052 23.1245 - OK TSS2242 iPS 0 9.6662 10.0893 17.2502 16.6729 - OK TSS2242 iPS 1 15.6672 15.0941 25.8074 26.3479 - OK TSS2242 hESC 1 41.3397 40.9202 27.0447 27.6432 - OK TSS2242 hESC 0 41.8101 42.2387 27.9162 29.3823 - OK TSS2242 Fibroblasts 1 289.799 241.809 197.679 192.089 - OK TSS2242 Fibroblasts 0 159.411 189.681 155.065 153.94 - OK TSS2243 iPS 0 146.914 153.344 262.182 250.619 - OK TSS2243 iPS 1 150.019 144.532 247.115 247.412 - OK TSS2243 hESC 1 770.434 762.615 504.023 511.801 - OK TSS2243 hESC 0 708.728 715.995 473.211 494.486 - OK TSS2243 Fibroblasts 1 517.245 431.589 352.825 343.864 - OK TSS2243 Fibroblasts 0 830.677 988.412 808.029 789.043 - OK TSS2244 iPS 0 4.47761 4.67359 7.99072 10.4997 - OK TSS2244 iPS 1 1.31357 1.26553 2.16375 2.84314 - OK TSS2244 hESC 1 16.2712 16.106 10.6447 14.7138 - OK TSS2244 hESC 0 7.12591 7.19897 4.75791 6.57668 - OK TSS2244 Fibroblasts 1 3.95574 3.30067 2.6983 3.57145 - OK TSS2244 Fibroblasts 0 4.35154 5.17785 4.23291 5.60264 - OK TSS2245 iPS 0 174.815 182.466 311.973 301.446 - OK TSS2245 iPS 1 71.5388 68.9221 117.84 112.304 - OK TSS2245 hESC 1 572.84 567.026 374.756 394.35 - OK TSS2245 hESC 0 465.911 470.688 311.085 319.692 - OK TSS2245 Fibroblasts 1 2858 2384.71 1949.51 1963.85 - OK TSS2245 Fibroblasts 0 1601 1905.01 1557.35 1534.37 - OK TSS2246 iPS 0 6.18545 6.45617 11.0385 7.83655 - OK TSS2246 iPS 1 6.46116 6.22482 10.643 7.55574 - OK TSS2246 hESC 1 30.16 29.8539 19.7309 14.3916 - OK TSS2246 hESC 0 23.0887 23.3254 15.4161 11.2444 - OK TSS2246 Fibroblasts 1 0 0 0 0 - OK TSS2246 Fibroblasts 0 0 0 0 0 - OK TSS2247 iPS 0 153 159.696 273.043 202.266 - OK TSS2247 iPS 1 172 165.709 283.322 209.881 - OK TSS2247 hESC 1 243 240.534 158.972 125.843 - OK TSS2247 hESC 0 267 269.738 178.273 143.79 - OK TSS2247 Fibroblasts 1 246 205.262 167.802 124.816 - OK TSS2247 Fibroblasts 0 215 255.826 209.138 157.817 - OK TSS2248 iPS 0 0 0 0 0 - OK TSS2248 iPS 1 1 0.963422 1.64722 1.45038 - OK TSS2248 hESC 1 0 0 0 0 - OK TSS2248 hESC 0 0 0 0 0 - OK TSS2248 Fibroblasts 1 0 0 0 0 - OK TSS2248 Fibroblasts 0 0 0 0 0 - OK TSS2249 iPS 0 1712 1786.93 3055.22 1828.56 - OK TSS2249 iPS 1 2426.5 2337.74 3996.99 2360.36 - OK TSS2249 hESC 1 3485 3449.63 2279.91 1484.15 - OK TSS2249 hESC 0 4117 4159.21 2748.88 1729.48 - OK TSS2249 Fibroblasts 1 5400 4505.76 3683.47 2452.58 - OK TSS2249 Fibroblasts 0 3806 4528.71 3702.23 2436.37 - OK TSS225 iPS 0 0 0 0 0 - OK TSS225 iPS 1 3.43769 3.31195 5.66264 5.33818 - OK TSS225 hESC 1 4.15042 4.1083 2.71523 2.65369 - OK TSS225 hESC 0 11.8214 11.9426 7.89306 7.71415 - OK TSS225 Fibroblasts 1 0 0 0 0 - OK TSS225 Fibroblasts 0 0 0 0 0 - OK TSS2250 iPS 0 0 0 0 0 - OK TSS2250 iPS 1 0 0 0 0 - OK TSS2250 hESC 1 6.02753 5.96636 3.94325 2.26253 - OK TSS2250 hESC 0 1.1269 1.13845 0.752418 0.431717 - OK TSS2250 Fibroblasts 1 0 0 0 0 - OK TSS2250 Fibroblasts 0 0 0 0 0 - OK TSS2251 iPS 0 0 0 0 0 - OK TSS2251 iPS 1 1.82042 1.75384 2.99864 0.904129 - OK TSS2251 hESC 1 14.8365 14.6859 9.70615 2.96008 - OK TSS2251 hESC 0 1.0683 1.07925 0.713293 0.217532 - OK TSS2251 Fibroblasts 1 0 0 0 0 - OK TSS2251 Fibroblasts 0 0 0 0 0 - OK TSS2252 iPS 0 0 0 0 0 - OK TSS2252 iPS 1 8.71183 8.39317 14.3503 4.59422 - OK TSS2252 hESC 1 0 0 0 0 - OK TSS2252 hESC 0 5.21741 5.27091 3.48362 0.883374 - OK TSS2252 Fibroblasts 1 0 0 0 0 - OK TSS2252 Fibroblasts 0 0 0 0 0 - OK TSS2253 iPS 0 0 0 0 0 - OK TSS2253 iPS 1 1.46775 1.41406 2.4177 0.694196 - OK TSS2253 hESC 1 1.13595 1.12442 0.743146 0.215708 - OK TSS2253 hESC 0 5.58739 5.64468 3.73065 1.08287 - OK TSS2253 Fibroblasts 1 0 0 0 0 - OK TSS2253 Fibroblasts 0 0 0 0 0 - OK TSS2254 iPS 0 4.98739 5.20567 8.90046 4.9655 - OK TSS2254 iPS 1 9 8.6708 14.825 8.27077 - OK TSS2254 hESC 1 0 0 0 0 - OK TSS2254 hESC 0 5.94333 6.00427 3.96831 2.26131 - OK TSS2254 Fibroblasts 1 5.98438 4.99336 4.08209 2.28441 - OK TSS2254 Fibroblasts 0 0 0 0 0 - OK TSS2255 iPS 0 0.0126134 0.0131654 0.0225097 0.01245 - OK TSS2255 iPS 1 0 0 0 0 - OK TSS2255 hESC 1 23 22.7666 15.0468 8.25825 - OK TSS2255 hESC 0 10.0567 10.1598 6.71475 3.68532 - OK TSS2255 Fibroblasts 1 0.0156201 0.0130334 0.0106549 0.00591119 - OK TSS2255 Fibroblasts 0 9 10.709 8.75463 4.85695 - OK TSS2256 iPS 0 133 138.821 237.351 83.6945 - OK TSS2256 iPS 1 183 176.306 301.442 112.067 - OK TSS2256 hESC 1 434 429.595 283.926 207.294 - OK TSS2256 hESC 0 449 453.604 299.793 224.774 - OK TSS2256 Fibroblasts 1 1 0.8344 0.682124 0.218329 - OK TSS2256 Fibroblasts 0 0 0 0 0 - OK TSS2257 iPS 0 0 0 0 0 - OK TSS2257 iPS 1 0 0 0 0 - OK TSS2257 hESC 1 0 0 0 0 - OK TSS2257 hESC 0 0 0 0 0 - OK TSS2257 Fibroblasts 1 0 0 0 0 - OK TSS2257 Fibroblasts 0 0 0 0 0 - OK TSS2258 iPS 0 6.82145 7.12 12.1735 7.39209 - OK TSS2258 iPS 1 18.7736 18.0869 30.9243 18.7781 - OK TSS2258 hESC 1 19.658 19.4585 12.8604 7.99159 - OK TSS2258 hESC 0 15.8749 16.0376 10.5995 6.58664 - OK TSS2258 Fibroblasts 1 97.0685 80.9939 66.2127 40.3414 - OK TSS2258 Fibroblasts 0 149.936 178.408 145.849 88.8612 - OK TSS2259 iPS 0 212.727 222.038 379.632 213.478 - OK TSS2259 iPS 1 76.1263 73.3418 125.397 70.147 - OK TSS2259 hESC 1 421.342 417.066 275.645 157.528 - OK TSS2259 hESC 0 339.725 343.209 226.832 129.874 - OK TSS2259 Fibroblasts 1 662.724 552.976 452.06 254.261 - OK TSS2259 Fibroblasts 0 308.756 367.385 300.338 168.694 - OK TSS226 iPS 0 72.2641 75.4268 128.962 28.1148 - OK TSS226 iPS 1 73.9625 71.2572 121.833 26.5606 - OK TSS226 hESC 1 2885.41 2856.12 1887.65 414.925 - OK TSS226 hESC 0 3037.49 3068.63 2028.1 445.797 - OK TSS226 Fibroblasts 1 776.38 647.812 529.588 115.594 - OK TSS226 Fibroblasts 0 387.688 461.305 377.118 82.3142 - OK TSS2260 iPS 0 0 0 0 0 - OK TSS2260 iPS 1 0 0 0 0 - OK TSS2260 hESC 1 0 0 0 0 - OK TSS2260 hESC 0 3.7548 3.7933 2.50705 1.3733 - OK TSS2260 Fibroblasts 1 16.4776 13.7489 11.2398 6.05059 - OK TSS2260 Fibroblasts 0 0 0 0 0 - OK TSS2261 iPS 0 4.45108 4.64589 7.94337 7.56384 - OK TSS2261 iPS 1 7.10004 6.84034 11.6954 11.1366 - OK TSS2261 hESC 1 0 0 0 0 - OK TSS2261 hESC 0 7.64494 7.72333 5.10446 5.04101 - OK TSS2261 Fibroblasts 1 22.7301 18.966 15.5048 14.842 - OK TSS2261 Fibroblasts 0 17.3076 20.5941 16.8357 16.116 - OK TSS227 iPS 0 46.9292 48.9832 83.7496 48.423 - OK TSS227 iPS 1 47.8798 46.1285 78.8687 45.6009 - OK TSS227 hESC 1 84.0245 83.1717 54.9694 32.4887 - OK TSS227 hESC 0 75.8964 76.6746 50.6754 29.9508 - OK TSS227 Fibroblasts 1 12.5398 10.4632 8.55368 4.96147 - OK TSS227 Fibroblasts 0 4.84492 5.76492 4.71283 2.73363 - OK TSS228 iPS 0 183.784 191.827 327.979 77.7189 - OK TSS228 iPS 1 137.034 132.021 225.725 53.4884 - OK TSS228 hESC 1 583.404 577.483 381.667 91.2537 - OK TSS228 hESC 0 688.408 695.467 459.644 109.897 - OK TSS228 Fibroblasts 1 83.2756 69.4851 56.8043 13.4781 - OK TSS228 Fibroblasts 0 84.8119 100.917 82.4996 19.5749 - OK TSS229 iPS 0 10.1897 10.6357 18.1845 11.3993 - OK TSS229 iPS 1 19.6863 18.9663 32.4278 20.3281 - OK TSS229 hESC 1 143.182 141.729 93.6708 60.1366 - OK TSS229 hESC 0 155.887 157.485 104.084 66.8221 - OK TSS229 Fibroblasts 1 123.471 103.024 84.2224 52.98 - OK TSS229 Fibroblasts 0 74.3219 88.4347 72.2956 45.4774 - OK TSS23 iPS 0 154.33 161.085 275.417 368.636 - OK TSS23 iPS 1 133.91 129.012 220.579 294.617 - OK TSS23 hESC 1 896.894 887.791 586.754 820.157 - OK TSS23 hESC 0 834.373 842.928 557.103 781.647 - OK TSS23 Fibroblasts 1 761.597 635.476 519.503 703.437 - OK TSS23 Fibroblasts 0 757 900.745 736.362 986.82 - OK TSS230 iPS 0 0 0 0 0 - OK TSS230 iPS 1 5 4.81711 8.23612 3.16629 - OK TSS230 hESC 1 2.9493 2.91937 1.92945 0.752634 - OK TSS230 hESC 0 5.99842 6.05992 4.00509 1.56229 - OK TSS230 Fibroblasts 1 0 0 0 0 - OK TSS230 Fibroblasts 0 0 0 0 0 - OK TSS231 iPS 0 27 28.1817 48.184 28.8303 - OK TSS231 iPS 1 0 0 0 0 - OK TSS231 hESC 1 7.50324 7.42709 4.90867 2.91827 - OK TSS231 hESC 0 0 0 0 0 - OK TSS231 Fibroblasts 1 2.82618e-05 2.35817e-05 1.92781e-05 1.11079e-05 - OK TSS231 Fibroblasts 0 0 0 0 0 - OK TSS232 iPS 0 0 0 0 0 - OK TSS232 iPS 1 0 0 0 0 - OK TSS232 hESC 1 6.54746 6.48101 4.28339 3.24822 - OK TSS232 hESC 0 0.00158422 0.00160047 0.00105777 0.000802138 - OK TSS232 Fibroblasts 1 1.99997 1.66878 1.36423 0.925111 - OK TSS232 Fibroblasts 0 0 0 0 0 - OK TSS233 iPS 0 3 3.1313 5.35378 2.50891 - OK TSS233 iPS 1 19 18.305 31.2972 14.6666 - OK TSS233 hESC 1 59 58.4012 38.5982 18.4124 - OK TSS233 hESC 0 23 23.2358 15.3569 7.32565 - OK TSS233 Fibroblasts 1 2 1.6688 1.36425 0.605715 - OK TSS233 Fibroblasts 0 0 0 0 0 - OK TSS234 iPS 0 4 4.17507 7.13837 4.81405 - OK TSS234 iPS 1 3 2.89027 4.94167 3.33261 - OK TSS234 hESC 1 11 10.8884 7.19627 6.13506 - OK TSS234 hESC 0 7 7.07177 4.67384 3.23397 - OK TSS234 Fibroblasts 1 0 0 0 0 - OK TSS234 Fibroblasts 0 0 0 0 0 - OK TSS235 iPS 0 0 0 0 0 - OK TSS235 iPS 1 0 0 0 0 - OK TSS235 hESC 1 1 0.989851 0.654207 0.394296 - OK TSS235 hESC 0 0 0 0 0 - OK TSS235 Fibroblasts 1 0 0 0 0 - OK TSS235 Fibroblasts 0 0 0 0 0 - OK TSS236 iPS 0 136.701 142.684 243.956 87.0104 - OK TSS236 iPS 1 127.905 123.226 210.687 83.6653 - OK TSS236 hESC 1 475.158 470.336 310.852 112.234 - OK TSS236 hESC 0 521.989 527.341 348.527 127.611 - OK TSS236 Fibroblasts 1 102.668 85.6658 70.032 26.163 - OK TSS236 Fibroblasts 0 93.509 111.265 90.9596 30.5849 - OK TSS237 iPS 0 273.846 285.831 488.703 169.538 - OK TSS237 iPS 1 262.049 252.464 431.653 149.747 - OK TSS237 hESC 1 2154.78 2132.91 1409.67 495.497 - OK TSS237 hESC 0 2011.07 2031.69 1342.77 471.983 - OK TSS237 Fibroblasts 1 1035.62 864.123 706.422 244.637 - OK TSS237 Fibroblasts 0 726.82 864.834 707.004 245.172 - OK TSS238 iPS 0 0 0 0 0 - OK TSS238 iPS 1 0 0 0 0 - OK TSS238 hESC 1 6.1377 6.0754 4.01532 3.17249 - OK TSS238 hESC 0 4.86669 4.91659 3.24944 2.56737 - OK TSS238 Fibroblasts 1 17.6226 14.7043 12.0208 9.2629 - OK TSS238 Fibroblasts 0 0 0 0 0 - OK TSS239 iPS 0 47.863 49.9578 85.416 27.265 - OK TSS239 iPS 1 41.9688 40.4337 69.1321 22.0671 - OK TSS239 hESC 1 120.46 119.237 78.8055 25.4604 - OK TSS239 hESC 0 121.37 122.614 81.0376 26.1816 - OK TSS239 Fibroblasts 1 0 0 0 0 - OK TSS239 Fibroblasts 0 0 0 0 0 - OK TSS24 iPS 0 17.9684 18.7549 32.0663 25.7063 - OK TSS24 iPS 1 12.3329 11.8818 20.3151 16.2858 - OK TSS24 hESC 1 26.8896 26.6167 17.5913 14.5404 - OK TSS24 hESC 0 27.9675 28.2543 18.6737 15.435 - OK TSS24 Fibroblasts 1 31.5573 26.3314 21.526 17.3332 - OK TSS24 Fibroblasts 0 18.485 21.9951 17.981 14.4788 - OK TSS240 iPS 0 0 0 0 0 - OK TSS240 iPS 1 0 0 0 0 - OK TSS240 hESC 1 39.7841 39.3803 26.027 11.2922 - OK TSS240 hESC 0 0 0 0 0 - OK TSS240 Fibroblasts 1 1878.36 1567.31 1281.28 515.524 - OK TSS240 Fibroblasts 0 611.75 727.914 595.072 239.428 - OK TSS241 iPS 0 4.83364 5.04519 8.62608 4.19671 - OK TSS241 iPS 1 0 0 0 0 - OK TSS241 hESC 1 14.4365 14.29 9.44447 4.68047 - OK TSS241 hESC 0 19.3789 19.5776 12.9391 6.41233 - OK TSS241 Fibroblasts 1 0 0 0 0 - OK TSS241 Fibroblasts 0 0 0 0 0 - OK TSS242 iPS 0 10.2567 10.7056 18.304 12.3676 - OK TSS242 iPS 1 11.5775 11.154 19.0707 12.8857 - OK TSS242 hESC 1 105.747 104.674 69.1806 47.962 - OK TSS242 hESC 0 91.8262 92.7677 61.3115 42.5065 - OK TSS242 Fibroblasts 1 45.7231 38.1513 31.1888 21.1525 - OK TSS242 Fibroblasts 0 11.4206 13.5892 11.1092 7.53435 - OK TSS243 iPS 0 10 10.4377 17.8459 14.9238 - OK TSS243 iPS 1 3 2.89027 4.94167 4.1325 - OK TSS243 hESC 1 28 27.7158 18.3178 15.8155 - OK TSS243 hESC 0 33 33.3384 22.0338 19.0239 - OK TSS243 Fibroblasts 1 14 11.6816 9.54973 8.02307 - OK TSS243 Fibroblasts 0 7 8.32921 6.80915 5.72061 - OK TSS244 iPS 0 36.7035 38.3099 65.5008 52.184 - OK TSS244 iPS 1 49 47.2077 80.7139 64.3042 - OK TSS244 hESC 1 761.22 753.494 497.995 408.998 - OK TSS244 hESC 0 736.058 743.605 491.459 403.63 - OK TSS244 Fibroblasts 1 0 0 0 0 - OK TSS244 Fibroblasts 0 0 0 0 0 - OK TSS245 iPS 0 3.29651 3.44079 5.88293 4.84798 - OK TSS245 iPS 1 0 0 0 0 - OK TSS245 hESC 1 6.77975 6.71094 4.43535 3.77191 - OK TSS245 hESC 0 4.94215 4.99282 3.29983 2.80624 - OK TSS245 Fibroblasts 1 0 0 0 0 - OK TSS245 Fibroblasts 0 0 0 0 0 - OK TSS246 iPS 0 0 0 0 0 - OK TSS246 iPS 1 0 0 0 0 - OK TSS246 hESC 1 0.0207428 0.0205323 0.0135701 0.00495709 - OK TSS246 hESC 0 77.0041 77.7936 51.4149 18.7817 - OK TSS246 Fibroblasts 1 6 5.0064 4.09274 1.41447 - OK TSS246 Fibroblasts 0 0 0 0 0 - OK TSS247 iPS 0 0 0 0 0 - OK TSS247 iPS 1 3 2.89027 4.94167 1.18806 - OK TSS247 hESC 1 1 0.989851 0.654207 0.455146 - OK TSS247 hESC 0 11 11.1128 7.3446 1.78164 - OK TSS247 Fibroblasts 1 0 0 0 0 - OK TSS247 Fibroblasts 0 0 0 0 0 - OK TSS248 iPS 0 637.5 665.401 1137.68 764.687 - OK TSS248 iPS 1 699 673.432 1151.41 773.916 - OK TSS248 hESC 1 2168 2146 1418.32 978.03 - OK TSS248 hESC 0 2119.5 2141.23 1415.17 975.859 - OK TSS248 Fibroblasts 1 2660.5 2219.92 1814.79 1224.35 - OK TSS248 Fibroblasts 0 3138 3733.87 3052.45 2059.34 - OK TSS249 iPS 0 60.7971 63.458 108.498 85.5927 - OK TSS249 iPS 1 89.5145 86.2403 147.45 114.691 - OK TSS249 hESC 1 475.65 470.822 311.173 258.841 - OK TSS249 hESC 0 478.126 483.028 319.24 269.87 - OK TSS249 Fibroblasts 1 656.402 547.701 447.747 372.368 - OK TSS249 Fibroblasts 0 638.891 760.208 621.472 504.15 - OK TSS25 iPS 0 137 142.996 244.489 170.826 - OK TSS25 iPS 1 94 90.5617 154.839 108.187 - OK TSS25 hESC 1 380 376.143 248.599 178.383 - OK TSS25 hESC 0 421 425.317 281.098 201.703 - OK TSS25 Fibroblasts 1 1474 1229.91 1005.45 705.236 - OK TSS25 Fibroblasts 0 1239 1474.27 1205.22 845.357 - OK TSS250 iPS 0 80.2029 83.7132 143.13 128.751 - OK TSS250 iPS 1 27.4855 26.4801 45.2747 40.7263 - OK TSS250 hESC 1 137.35 135.956 89.8556 83.6573 - OK TSS250 hESC 0 81.8742 82.7137 54.6667 50.8958 - OK TSS250 Fibroblasts 1 249.598 208.265 170.257 153.917 - OK TSS250 Fibroblasts 0 165.109 196.462 160.608 145.194 - OK TSS251 iPS 0 246.502 257.291 439.906 257.574 - OK TSS251 iPS 1 248.502 239.412 409.338 239.118 - OK TSS251 hESC 1 1886.58 1867.43 1234.21 783.441 - OK TSS251 hESC 0 1993.03 2013.46 1330.73 831.019 - OK TSS251 Fibroblasts 1 16141.4 13468.4 11010.4 7987.4 - OK TSS251 Fibroblasts 0 18146.5 21592.4 17651.8 12875.9 - OK TSS252 iPS 0 0 0 0 0 - OK TSS252 iPS 1 0 0 0 0 - OK TSS252 hESC 1 5.06918 5.01773 3.31629 2.55873 - OK TSS252 hESC 0 0 0 0 0 - OK TSS252 Fibroblasts 1 10.9015 9.09622 7.43618 5.59896 - OK TSS252 Fibroblasts 0 0 0 0 0 - OK TSS253 iPS 0 0 0 0 0 - OK TSS253 iPS 1 0 0 0 0 - OK TSS253 hESC 1 0 0 0 0 - OK TSS253 hESC 0 0 0 0 0 - OK TSS253 Fibroblasts 1 73.8844 61.6491 50.3983 37.2721 - OK TSS253 Fibroblasts 0 24.8472 29.5654 24.1698 17.8748 - OK TSS254 iPS 0 542.998 566.763 969.03 739.532 - OK TSS254 iPS 1 142.998 137.768 235.55 179.764 - OK TSS254 hESC 1 21.8518 21.6301 14.2956 11.2322 - OK TSS254 hESC 0 54.4715 55.03 36.3702 28.5763 - OK TSS254 Fibroblasts 1 1052.8 878.46 718.143 550.382 - OK TSS254 Fibroblasts 0 4872.27 5797.46 4739.44 3632.29 - OK TSS255 iPS 0 3 3.1313 5.35378 4.17135 - OK TSS255 iPS 1 2 1.92684 3.29445 2.56684 - OK TSS255 hESC 1 49 48.5027 32.0561 25.7298 - OK TSS255 hESC 0 37 37.3794 24.7046 19.8291 - OK TSS255 Fibroblasts 1 0 0 0 0 - OK TSS255 Fibroblasts 0 0 0 0 0 - OK TSS256 iPS 0 389 406.025 694.207 154.925 - OK TSS256 iPS 1 383 368.991 630.887 140.794 - OK TSS256 hESC 1 1009 998.759 660.095 148.558 - OK TSS256 hESC 0 1120 1131.48 747.814 168.3 - OK TSS256 Fibroblasts 1 633 528.175 431.784 96.4793 - OK TSS256 Fibroblasts 0 358 425.98 348.24 77.8118 - OK TSS257 iPS 0 0 0 0 0 - OK TSS257 iPS 1 1 0.963422 1.64722 0.965415 - OK TSS257 hESC 1 0 0 0 0 - OK TSS257 hESC 0 0 0 0 0 - OK TSS257 Fibroblasts 1 0 0 0 0 - OK TSS257 Fibroblasts 0 7.85395 9.34532 7.63982 4.12838 - OK TSS258 iPS 0 0 0 0 0 - OK TSS258 iPS 1 0 0 0 0 - OK TSS258 hESC 1 0 0 0 0 - OK TSS258 hESC 0 3 3.03076 2.00307 1.69429 - OK TSS258 Fibroblasts 1 82 68.4208 55.9342 46.0621 - OK TSS258 Fibroblasts 0 309.146 367.849 300.718 247.643 - OK TSS259 iPS 0 0 0 0 0 - OK TSS259 iPS 1 0 0 0 0 - OK TSS259 hESC 1 2 1.9797 1.30841 0.680701 - OK TSS259 hESC 0 0 0 0 0 - OK TSS259 Fibroblasts 1 0 0 0 0 - OK TSS259 Fibroblasts 0 0 0 0 0 - OK TSS26 iPS 0 9 9.3939 16.0613 9.50402 - OK TSS26 iPS 1 3 2.89027 4.94167 2.92415 - OK TSS26 hESC 1 5 4.94925 3.27103 1.97961 - OK TSS26 hESC 0 8 8.08203 5.34153 3.23266 - OK TSS26 Fibroblasts 1 14 11.6816 9.54973 5.66941 - OK TSS26 Fibroblasts 0 5 5.94944 4.86368 2.88743 - OK TSS260 iPS 0 7 7.30637 12.4922 6.30307 - OK TSS260 iPS 1 22 21.1953 36.2389 18.2848 - OK TSS260 hESC 1 63 62.3606 41.215 21.1976 - OK TSS260 hESC 0 44 44.4511 29.3784 15.1098 - OK TSS260 Fibroblasts 1 0 0 0 0 - OK TSS260 Fibroblasts 0 2 2.37978 1.94547 0.984354 - OK TSS261 iPS 0 5 5.21883 8.92297 3.34557 - OK TSS261 iPS 1 5 4.81711 8.23612 2.92695 - OK TSS261 hESC 1 76.3492 75.5743 49.9482 19.0335 - OK TSS261 hESC 0 71.4298 72.1621 47.693 17.5125 - OK TSS261 Fibroblasts 1 5 4.172 3.41062 1.09175 - OK TSS261 Fibroblasts 0 0 0 0 0 - OK TSS262 iPS 0 0 0 0 0 - OK TSS262 iPS 1 0 0 0 0 - OK TSS262 hESC 1 2.65079 2.62389 1.73417 0.91282 - OK TSS262 hESC 0 3.57025 3.60685 2.38382 1.25478 - OK TSS262 Fibroblasts 1 0 0 0 0 - OK TSS262 Fibroblasts 0 0 0 0 0 - OK TSS263 iPS 0 77 80.3701 137.414 248.748 - OK TSS263 iPS 1 75 72.2567 123.542 226.169 - OK TSS263 hESC 1 144 142.539 94.2058 184.972 - OK TSS263 hESC 0 89 89.9125 59.4245 114.155 - OK TSS263 Fibroblasts 1 236 196.918 160.981 291.3 - OK TSS263 Fibroblasts 0 91 108.28 88.519 160.178 - OK TSS264 iPS 0 913.5 953.481 1630.23 925.553 - OK TSS264 iPS 1 366.279 352.881 603.343 342.545 - OK TSS264 hESC 1 924.831 915.445 605.031 350.994 - OK TSS264 hESC 0 805.87 814.133 538.072 312.15 - OK TSS264 Fibroblasts 1 6385.24 5327.84 4355.52 2480.6 - OK TSS264 Fibroblasts 0 3454.21 4110.12 3360.04 1913.64 - OK TSS265 iPS 0 0 0 0 0 - OK TSS265 iPS 1 4.72093 4.54825 7.77642 7.38003 - OK TSS265 hESC 1 195.169 193.188 127.681 125.655 - OK TSS265 hESC 0 167.13 168.843 111.591 109.82 - OK TSS265 Fibroblasts 1 1701.76 1419.95 1160.81 1107.44 - OK TSS265 Fibroblasts 0 573.79 682.746 558.146 532.486 - OK TSS266 iPS 0 3.0001 3.1314 5.35396 3.33702 - OK TSS266 iPS 1 1 0.963423 1.64722 1.02668 - OK TSS266 hESC 1 15 14.8478 9.8131 6.26305 - OK TSS266 hESC 0 21.0005 21.2159 14.0219 8.94923 - OK TSS266 Fibroblasts 1 14 11.6816 9.54973 5.97272 - OK TSS266 Fibroblasts 0 1 1.18989 0.972736 0.608381 - OK TSS267 iPS 0 0 0 0 0 - OK TSS267 iPS 1 0 0 0 0 - OK TSS267 hESC 1 12 11.8782 7.85048 52475.4 - OK TSS267 hESC 0 1 1.01025 0.667691 4463.09 - OK TSS267 Fibroblasts 1 12 10.0128 8.18549 18756.5 - OK TSS267 Fibroblasts 0 1.5 1.78483 1.4591 3343.43 - OK TSS268 iPS 0 154.75 161.523 276.166 96.7239 - OK TSS268 iPS 1 125 120.428 205.903 73.7202 - OK TSS268 hESC 1 236 233.605 154.393 54.89 - OK TSS268 hESC 0 252.667 255.257 168.703 64.7504 - OK TSS268 Fibroblasts 1 2976.33 2483.45 2030.23 722.729 - OK TSS268 Fibroblasts 0 972.083 1156.67 945.581 330.492 - OK TSS269 iPS 0 858.5 896.074 1532.07 899.79 - OK TSS269 iPS 1 1037 999.069 1708.17 998.973 - OK TSS269 hESC 1 13224.5 13090.3 8651.56 5187.44 - OK TSS269 hESC 0 12639.5 12769.1 8439.28 5044.74 - OK TSS269 Fibroblasts 1 255.6 213.273 174.351 102.615 - OK TSS269 Fibroblasts 0 20 23.7978 19.4547 11.3731 - OK TSS27 iPS 0 146.981 153.414 262.302 242.85 - OK TSS27 iPS 1 167.54 161.412 275.976 257.933 - OK TSS27 hESC 1 925.738 916.342 605.624 572.756 - OK TSS27 hESC 0 886.752 895.844 592.076 558.947 - OK TSS27 Fibroblasts 1 996.361 831.363 679.642 619.084 - OK TSS27 Fibroblasts 0 568.356 676.28 552.861 503.646 - OK TSS270 iPS 0 0 0 0 0 - OK TSS270 iPS 1 0 0 0 0 - OK TSS270 hESC 1 0 0 0 0 - OK TSS270 hESC 0 0 0 0 0 - OK TSS270 Fibroblasts 1 45.3998 37.8815 30.9683 18.3927 - OK TSS270 Fibroblasts 0 0 0 0 0 - OK TSS271 iPS 0 18.4148 19.2207 32.8629 12.0916 - OK TSS271 iPS 1 15.6222 15.0508 25.7332 9.46828 - OK TSS271 hESC 1 102.993 101.948 67.3789 25.1391 - OK TSS271 hESC 0 77.795 78.5926 51.943 19.3799 - OK TSS271 Fibroblasts 1 92.7857 77.4203 63.2913 23.3348 - OK TSS271 Fibroblasts 0 23.9138 28.4547 23.2618 8.57636 - OK TSS272 iPS 0 4.94082 5.15706 8.81735 15.2191 - OK TSS272 iPS 1 3.03528 2.92425 4.99978 8.62985 - OK TSS272 hESC 1 10.028 9.92623 6.56039 12.1092 - OK TSS272 hESC 0 8.85521 8.94601 5.91255 10.9134 - OK TSS272 Fibroblasts 1 217.038 181.097 148.047 257.995 - OK TSS272 Fibroblasts 0 35.7461 42.5338 34.7715 60.5947 - OK TSS273 iPS 0 0 0 0 0 - OK TSS273 iPS 1 1 0.963422 1.64722 2.79543 - OK TSS273 hESC 1 0 0 0 0 - OK TSS273 hESC 0 0 0 0 0 - OK TSS273 Fibroblasts 1 0 0 0 0 - OK TSS273 Fibroblasts 0 0 0 0 0 - OK TSS274 iPS 0 0 0 0 0 - OK TSS274 iPS 1 0 0 0 0 - OK TSS274 hESC 1 0 0 0 0 - OK TSS274 hESC 0 0 0 0 0 - OK TSS274 Fibroblasts 1 0 0 0 0 - OK TSS274 Fibroblasts 0 0 0 0 0 - OK TSS275 iPS 0 18.6169 19.4317 33.2235 50.3965 - OK TSS275 iPS 1 0 0 0 0 - OK TSS275 hESC 1 8.84975 8.75993 5.78956 9.31318 - OK TSS275 hESC 0 0 0 0 0 - OK TSS275 Fibroblasts 1 11.5596 9.6453 7.88506 12.0618 - OK TSS275 Fibroblasts 0 0 0 0 0 - OK TSS276 iPS 0 205.383 214.372 366.525 596.948 - OK TSS276 iPS 1 124 119.464 204.256 332.665 - OK TSS276 hESC 1 389.15 385.201 254.585 441.674 - OK TSS276 hESC 0 386 389.958 257.729 447.128 - OK TSS276 Fibroblasts 1 526.44 439.262 359.098 590.158 - OK TSS276 Fibroblasts 0 276 328.409 268.475 441.225 - OK TSS277 iPS 0 3380 3527.93 6031.93 4381.8 - OK TSS277 iPS 1 2402 2314.14 3956.63 2859.62 - OK TSS277 hESC 1 3237 3204.15 2117.67 1589.07 - OK TSS277 hESC 0 3415 3450.01 2280.16 1717.14 - OK TSS277 Fibroblasts 1 18228 15209.4 12433.8 9119.64 - OK TSS277 Fibroblasts 0 14738 17536.6 14336.2 10507 - OK TSS278 iPS 0 342.051 357.021 610.421 101.598 - OK TSS278 iPS 1 278.549 268.36 458.833 75.9092 - OK TSS278 hESC 1 1116.33 1105 730.31 123.896 - OK TSS278 hESC 0 2423.66 2448.51 1618.26 273.402 - OK TSS278 Fibroblasts 1 2097.7 1750.32 1430.89 237.17 - OK TSS278 Fibroblasts 0 1223.04 1455.28 1189.7 197.521 - OK TSS279 iPS 0 27.9495 29.1728 49.8785 35.4101 - OK TSS279 iPS 1 41.4509 39.9347 68.2788 48.4731 - OK TSS279 hESC 1 27.6707 27.3899 18.1024 13.2037 - OK TSS279 hESC 0 71.3361 72.0676 47.6305 34.7413 - OK TSS279 Fibroblasts 1 39.3039 32.7951 26.8101 19.1081 - OK TSS279 Fibroblasts 0 9.95743 11.8482 9.68596 6.90339 - OK TSS28 iPS 0 0 0 0 0 - OK TSS28 iPS 1 2 1.92684 3.29445 14.4039 - OK TSS28 hESC 1 23 22.7666 15.0468 78.7253 - OK TSS28 hESC 0 16 16.1641 10.6831 55.8942 - OK TSS28 Fibroblasts 1 0 0 0 0 - OK TSS28 Fibroblasts 0 0 0 0 0 - OK TSS280 iPS 0 25 26.0942 44.6148 33.549 - OK TSS280 iPS 1 28 26.9758 46.1223 32.8679 - OK TSS280 hESC 1 277 274.189 181.215 113.972 - OK TSS280 hESC 0 146 147.497 97.4829 62.4911 - OK TSS280 Fibroblasts 1 0 0 0 0 - OK TSS280 Fibroblasts 0 0 0 0 0 - OK TSS281 iPS 0 0 0 0 0 - OK TSS281 iPS 1 0 0 0 0 - OK TSS281 hESC 1 0 0 0 0 - OK TSS281 hESC 0 0 0 0 0 - OK TSS281 Fibroblasts 1 0 0 0 0 - OK TSS281 Fibroblasts 0 0 0 0 0 - OK TSS282 iPS 0 0 0 0 0 - OK TSS282 iPS 1 0 0 0 0 - OK TSS282 hESC 1 0 0 0 0 - OK TSS282 hESC 0 0 0 0 0 - OK TSS282 Fibroblasts 1 0 0 0 0 - OK TSS282 Fibroblasts 0 0 0 0 0 - OK TSS283 iPS 0 0 0 0 0 - OK TSS283 iPS 1 0 0 0 0 - OK TSS283 hESC 1 0 0 0 0 - OK TSS283 hESC 0 0 0 0 0 - OK TSS283 Fibroblasts 1 0 0 0 0 - OK TSS283 Fibroblasts 0 0 0 0 0 - OK TSS284 iPS 0 0 0 0 0 - OK TSS284 iPS 1 0 0 0 0 - OK TSS284 hESC 1 0 0 0 0 - OK TSS284 hESC 0 0 0 0 0 - OK TSS284 Fibroblasts 1 0 0 0 0 - OK TSS284 Fibroblasts 0 0 0 0 0 - OK TSS285 iPS 0 110 114.814 196.305 60.7793 - OK TSS285 iPS 1 115 110.794 189.431 58.4908 - OK TSS285 hESC 1 1577.5 1561.49 1032.01 336.729 - OK TSS285 hESC 0 1302 1315.35 869.334 272.242 - OK TSS285 Fibroblasts 1 1597 1332.54 1089.35 352.35 - OK TSS285 Fibroblasts 0 5239 6233.82 5096.16 1551 - OK TSS286 iPS 0 2715 2833.83 4845.17 2376.64 - OK TSS286 iPS 1 3522 3393.17 5801.52 2847.65 - OK TSS286 hESC 1 12455.5 12329.1 8148.47 4068.49 - OK TSS286 hESC 0 12256 12381.7 8183.22 4092.03 - OK TSS286 Fibroblasts 1 7173.33 5985.43 4893.1 2404.89 - OK TSS286 Fibroblasts 0 4751 5653.16 4621.47 2271.53 - OK TSS287 iPS 0 3.47603 3.62816 6.2033 12.1952 - OK TSS287 iPS 1 0.170186 0.163961 0.280334 0.551116 - OK TSS287 hESC 1 4.30731 4.26359 2.81787 5.98178 - OK TSS287 hESC 0 0 0 0 0 - OK TSS287 Fibroblasts 1 83.1586 69.3875 56.7245 112.74 - OK TSS287 Fibroblasts 0 17.736 21.1039 17.2525 34.2893 - OK TSS288 iPS 0 8.3148e-05 8.67871e-05 0.000148385 0.000117987 - OK TSS288 iPS 1 0 0 0 0 - OK TSS288 hESC 1 0 0 0 0 - OK TSS288 hESC 0 0 0 0 0 - OK TSS288 Fibroblasts 1 0 0 0 0 - OK TSS288 Fibroblasts 0 0 0 0 0 - OK TSS289 iPS 0 0.999917 1.04368 1.78445 1.55335 - OK TSS289 iPS 1 0 0 0 0 - OK TSS289 hESC 1 0 0 0 0 - OK TSS289 hESC 0 0 0 0 0 - OK TSS289 Fibroblasts 1 0 0 0 0 - OK TSS289 Fibroblasts 0 0 0 0 0 - OK TSS29 iPS 0 161 168.046 287.32 173.564 - OK TSS29 iPS 1 287 276.502 472.753 282.342 - OK TSS29 hESC 1 1309 1295.71 856.357 538.809 - OK TSS29 hESC 0 1294.5 1307.77 864.326 535.053 - OK TSS29 Fibroblasts 1 1437 1199.03 980.212 587.348 - OK TSS29 Fibroblasts 0 587 698.464 570.996 348.628 - OK TSS290 iPS 0 1296.14 1352.87 2313.09 7450.62 - OK TSS290 iPS 1 1396.21 1345.14 2299.87 7404.81 - OK TSS290 hESC 1 3585.36 3548.97 2345.56 8595.14 - OK TSS290 hESC 0 3744.84 3783.24 2500.4 9172.92 - OK TSS290 Fibroblasts 1 27260.3 22746 18594.9 60976.3 - OK TSS290 Fibroblasts 0 20203 24039.3 19652.2 64456.3 - OK TSS291 iPS 0 6961.36 7266.04 12423.2 40656.7 - OK TSS291 iPS 1 6065.79 5843.92 9991.72 32217.2 - OK TSS291 hESC 1 31082 30766.5 20334 76427.6 - OK TSS291 hESC 0 27560.7 27843.2 18402 68886.2 - OK TSS291 Fibroblasts 1 28263.5 23583 19279.2 64903.5 - OK TSS291 Fibroblasts 0 13762 16375.3 13386.8 44891.4 - OK TSS292 iPS 0 1409.05 1470.72 2514.58 744.997 - OK TSS292 iPS 1 1562.26 1505.12 2573.4 762.424 - OK TSS292 hESC 1 2522.1 2496.5 1649.97 494.345 - OK TSS292 hESC 0 2794.38 2823.03 1865.78 559.003 - OK TSS292 Fibroblasts 1 5747.97 4796.1 3920.82 1163.53 - OK TSS292 Fibroblasts 0 4474.46 5324.1 4352.47 1291.62 - OK TSS293 iPS 0 595 621.041 1061.83 1035.17 - OK TSS293 iPS 1 683 658.017 1125.05 1097.18 - OK TSS293 hESC 1 1727 1709.47 1129.81 1145.35 - OK TSS293 hESC 0 1959 1979.09 1308.01 1323 - OK TSS293 Fibroblasts 1 2283 1904.93 1557.29 1529.76 - OK TSS293 Fibroblasts 0 1957 2328.61 1903.64 1867.85 - OK TSS294 iPS 0 608 634.61 1085.03 1046.9 - OK TSS294 iPS 1 648.5 624.779 1068.22 1033.36 - OK TSS294 hESC 1 4010.33 3969.63 2623.59 2643.83 - OK TSS294 hESC 0 4225 4268.32 2820.99 2863.93 - OK TSS294 Fibroblasts 1 1116 931.19 761.25 747.731 - OK TSS294 Fibroblasts 0 1678 1996.63 1632.25 1607.33 - OK TSS295 iPS 0 1826 1905.92 3258.67 2053.69 - OK TSS295 iPS 1 1918 1847.84 3159.37 1991.11 - OK TSS295 hESC 1 2013.5 1993.06 1317.25 850.301 - OK TSS295 hESC 0 2796 2824.67 1866.86 1205.09 - OK TSS295 Fibroblasts 1 4027 3360.13 2746.91 1737.21 - OK TSS295 Fibroblasts 0 2970 3533.97 2889.03 1827.09 - OK TSS296 iPS 0 0 0 0 0 - OK TSS296 iPS 1 0 0 0 0 - OK TSS296 hESC 1 0 0 0 0 - OK TSS296 hESC 0 0 0 0 0 - OK TSS296 Fibroblasts 1 0 0 0 0 - OK TSS296 Fibroblasts 0 0 0 0 0 - OK TSS297 iPS 0 0.000560585 0.00058512 0.00100042 0.000537764 - OK TSS297 iPS 1 25.7499 24.8081 42.4159 22.8003 - OK TSS297 hESC 1 63.9885 63.339 41.8617 22.9664 - OK TSS297 hESC 0 72.9965 73.745 48.7391 26.7396 - OK TSS297 Fibroblasts 1 0 0 0 0 - OK TSS297 Fibroblasts 0 0 0 0 0 - OK TSS298 iPS 0 17.9994 18.7872 32.1217 18.3164 - OK TSS298 iPS 1 1.25006 1.20434 2.05913 1.15059 - OK TSS298 hESC 1 0.0115437 0.0114266 0.00755199 0.0043104 - OK TSS298 hESC 0 0.0034833 0.00351901 0.00232577 0.00132746 - OK TSS298 Fibroblasts 1 2 1.6688 1.36425 0.825854 - OK TSS298 Fibroblasts 0 1 1.18989 0.972736 0.588849 - OK TSS299 iPS 0 1296.17 1352.9 2313.14 756.655 - OK TSS299 iPS 1 267.47 257.687 440.583 132.702 - OK TSS299 hESC 1 523.373 518.061 342.394 132.387 - OK TSS299 hESC 0 609.108 615.353 406.696 151.84 - OK TSS299 Fibroblasts 1 10507.6 8767.56 7167.5 2063.7 - OK TSS299 Fibroblasts 0 4059.4 4830.22 3948.72 1183.42 - OK TSS3 iPS 0 238.995 249.455 426.51 144.543 - OK TSS3 iPS 1 333.074 320.891 548.647 187.936 - OK TSS3 hESC 1 1443.19 1428.55 944.147 321.951 - OK TSS3 hESC 0 1572.74 1588.86 1050.1 358.076 - OK TSS3 Fibroblasts 1 49.6506 41.4284 33.8678 11.6942 - OK TSS3 Fibroblasts 0 76.2497 90.7285 74.1708 25.3731 - OK TSS30 iPS 0 27.6667 28.8776 49.3738 18.9195 - OK TSS30 iPS 1 9.33333 8.99194 15.3741 5.89119 - OK TSS30 hESC 1 244.667 242.183 160.063 62.2307 - OK TSS30 hESC 0 298.167 301.224 199.083 77.4015 - OK TSS30 Fibroblasts 1 47.4833 39.6201 32.3895 12.4376 - OK TSS30 Fibroblasts 0 49.5 58.8994 48.1504 18.4899 - OK TSS300 iPS 0 20.8286 21.7402 37.1706 20.4708 - OK TSS300 iPS 1 27.5297 26.5227 45.3475 24.974 - OK TSS300 hESC 1 11.627 11.509 7.60648 4.27763 - OK TSS300 hESC 0 18.8919 19.0856 12.614 7.09368 - OK TSS300 Fibroblasts 1 25.3773 21.1748 17.3105 9.56238 - OK TSS300 Fibroblasts 0 10.6042 12.6178 10.315 5.69808 - OK TSS301 iPS 0 218.353 227.909 389.671 360.378 - OK TSS301 iPS 1 146.317 140.965 241.016 222.898 - OK TSS301 hESC 1 154.955 153.383 101.373 97.129 - OK TSS301 hESC 0 204.471 206.567 136.523 130.808 - OK TSS301 Fibroblasts 1 366.42 305.741 249.944 232.342 - OK TSS301 Fibroblasts 0 213.8 254.398 207.971 193.325 - OK TSS302 iPS 0 11.6473 12.157 20.7856 28.4758 - OK TSS302 iPS 1 74.6834 71.9517 123.02 146.729 - OK TSS302 hESC 1 28.0447 27.7601 18.347 25.8599 - OK TSS302 hESC 0 18.529 18.719 12.3717 16.6931 - OK TSS302 Fibroblasts 1 338.58 282.511 230.953 288.025 - OK TSS302 Fibroblasts 0 71.1998 84.7197 69.2586 83.8956 - OK TSS303 iPS 0 3 3.1313 5.35378 2.00057 - OK TSS303 iPS 1 1 0.963422 1.64722 0.615525 - OK TSS303 hESC 1 10 9.89851 6.54207 2.47943 - OK TSS303 hESC 0 9 9.09228 6.00922 2.27748 - OK TSS303 Fibroblasts 1 1 0.8344 0.682124 0.244094 - OK TSS303 Fibroblasts 0 0 0 0 0 - OK TSS304 iPS 0 1056.49 1102.73 1885.41 708.271 - OK TSS304 iPS 1 1530.18 1474.21 2520.54 945.676 - OK TSS304 hESC 1 3040.53 3009.67 1989.13 757.939 - OK TSS304 hESC 0 3392.58 3427.36 2265.19 863.129 - OK TSS304 Fibroblasts 1 4817.27 4019.53 3285.97 1232.51 - OK TSS304 Fibroblasts 0 4059.28 4830.09 3948.61 1480.11 - OK TSS305 iPS 0 43.7934 45.7101 78.1534 49.6746 - OK TSS305 iPS 1 31.4446 30.2944 51.7962 32.9218 - OK TSS305 hESC 1 114.443 113.281 74.8691 48.7518 - OK TSS305 hESC 0 102.86 103.915 68.6787 44.7208 - OK TSS305 Fibroblasts 1 69.0144 57.5856 47.0764 30.0273 - OK TSS305 Fibroblasts 0 41.4381 49.3067 40.3084 25.7104 - OK TSS306 iPS 0 374.714 391.114 668.712 433.493 - OK TSS306 iPS 1 344.378 331.781 567.267 384.329 - OK TSS306 hESC 1 2628.03 2601.36 1719.28 1096.48 - OK TSS306 hESC 0 1947.06 1967.03 1300.04 830.295 - OK TSS306 Fibroblasts 1 541.716 452.008 369.518 289.027 - OK TSS306 Fibroblasts 0 318.279 378.716 309.601 202.413 - OK TSS31 iPS 0 110.185 115.008 196.636 122.83 - OK TSS31 iPS 1 112.049 107.95 184.57 115.293 - OK TSS31 hESC 1 824.577 816.209 539.444 345.07 - OK TSS31 hESC 0 1120.97 1132.47 748.464 478.775 - OK TSS31 Fibroblasts 1 228.261 190.461 155.702 97.5972 - OK TSS31 Fibroblasts 0 758.56 902.601 737.879 462.516 - OK TSS32 iPS 0 351.166 366.536 626.689 386.972 - OK TSS32 iPS 1 163.734 157.745 269.706 165.141 - OK TSS32 hESC 1 662.792 656.065 433.603 282.756 - OK TSS32 hESC 0 493.339 498.397 329.398 225.925 - OK TSS32 Fibroblasts 1 373.976 312.045 255.098 161.808 - OK TSS32 Fibroblasts 0 390.46 464.603 379.814 225.067 - OK TSS33 iPS 0 14.8152 15.4637 26.4392 37.3051 - OK TSS33 iPS 1 15.0505 14.5 24.7916 34.9804 - OK TSS33 hESC 1 424.364 420.057 277.622 413.658 - OK TSS33 hESC 0 265.688 268.412 177.397 264.323 - OK TSS33 Fibroblasts 1 230.096 191.992 156.954 223.198 - OK TSS33 Fibroblasts 0 294.047 349.883 286.03 406.751 - OK TSS34 iPS 0 552.125 576.29 985.32 603.599 - OK TSS34 iPS 1 406.015 391.164 668.798 409.981 - OK TSS34 hESC 1 1518.29 1502.88 993.276 621.894 - OK TSS34 hESC 0 2597.95 2624.59 1734.63 1088.73 - OK TSS34 Fibroblasts 1 1352.79 1128.77 922.769 566.978 - OK TSS34 Fibroblasts 0 1892.66 2252.05 1841.06 1133.8 - OK TSS35 iPS 0 38.3303 40.0079 68.4041 44.7651 - OK TSS35 iPS 1 129.518 124.78 213.345 139.617 - OK TSS35 hESC 1 1791.79 1773.6 1172.2 786.459 - OK TSS35 hESC 0 707.886 715.144 472.649 317.113 - OK TSS35 Fibroblasts 1 2008.65 1676.01 1370.15 899.906 - OK TSS35 Fibroblasts 0 2343.04 2787.95 2279.16 1496.94 - OK TSS36 iPS 0 1 1.04377 1.78459 2.8669 - OK TSS36 iPS 1 1 0.963422 1.64722 2.64622 - OK TSS36 hESC 1 14 13.8579 9.15889 15.6591 - OK TSS36 hESC 0 6 6.06152 4.00615 6.84937 - OK TSS36 Fibroblasts 1 10 8.344 6.82124 9.2071 - OK TSS36 Fibroblasts 0 0 0 0 0 - OK TSS37 iPS 0 72.2416 75.4034 128.922 61.8378 - OK TSS37 iPS 1 55.3354 53.3114 91.1498 43.9436 - OK TSS37 hESC 1 576.294 570.446 377.016 184.846 - OK TSS37 hESC 0 618.558 624.9 413.006 202.013 - OK TSS37 Fibroblasts 1 1461.41 1219.4 996.866 467.871 - OK TSS37 Fibroblasts 0 707.73 842.119 688.435 325.691 - OK TSS38 iPS 0 4.22439 4.40928 7.53882 3.86058 - OK TSS38 iPS 1 7.38194 7.11192 12.1597 6.27444 - OK TSS38 hESC 1 159.366 157.749 104.258 54.8787 - OK TSS38 hESC 0 207.102 209.226 138.28 72.5689 - OK TSS38 Fibroblasts 1 190.394 158.864 129.872 66.7419 - OK TSS38 Fibroblasts 0 108.136 128.67 105.188 54.2293 - OK TSS39 iPS 0 0 0 0 0 - OK TSS39 iPS 1 0 0 0 0 - OK TSS39 hESC 1 28.7306 28.439 18.7958 8.60342 - OK TSS39 hESC 0 0 0 0 0 - OK TSS39 Fibroblasts 1 200.771 167.523 136.951 61.7799 - OK TSS39 Fibroblasts 0 115.331 137.231 112.187 50.6086 - OK TSS4 iPS 0 0 0 0 0 - OK TSS4 iPS 1 0 0 0 0 - OK TSS4 hESC 1 0 0 0 0 - OK TSS4 hESC 0 0 0 0 0 - OK TSS4 Fibroblasts 1 0 0 0 0 - OK TSS4 Fibroblasts 0 0 0 0 0 - OK TSS40 iPS 0 0 0 0 0 - OK TSS40 iPS 1 0.197963 0.190722 0.326089 0.190408 - OK TSS40 hESC 1 242.387 239.927 158.571 94.6701 - OK TSS40 hESC 0 273.703 276.509 182.749 109.105 - OK TSS40 Fibroblasts 1 183.559 153.162 125.21 73.3486 - OK TSS40 Fibroblasts 0 62.1814 73.9889 60.4861 35.4331 - OK TSS41 iPS 0 16.4096 17.1278 29.2844 19.3524 - OK TSS41 iPS 1 0.247454 0.238403 0.407612 0.269367 - OK TSS41 hESC 1 0 0 0 0 - OK TSS41 hESC 0 0 0 0 0 - OK TSS41 Fibroblasts 1 0 0 0 0 - OK TSS41 Fibroblasts 0 49.6212 59.0437 48.2684 32.0146 - OK TSS42 iPS 0 1.12442 1.17363 2.00664 6.7982 - OK TSS42 iPS 1 3.8372 3.69684 6.32072 21.4137 - OK TSS42 hESC 1 97.2222 96.2355 63.6034 246.925 - OK TSS42 hESC 0 86.6367 87.525 57.8466 224.576 - OK TSS42 Fibroblasts 1 12.8616 10.7317 8.77319 30.2889 - OK TSS42 Fibroblasts 0 0 0 0 0 - OK TSS43 iPS 0 5.06147 5.283 9.03267 11.2226 - OK TSS43 iPS 1 5.5 5.29882 9.05973 11.9599 - OK TSS43 hESC 1 73.1318 72.3895 47.8433 64.4779 - OK TSS43 hESC 0 59.9962 60.6113 40.0589 54.4603 - OK TSS43 Fibroblasts 1 9.69795 8.09197 6.6152 8.79699 - OK TSS43 Fibroblasts 0 1.59183 1.8941 1.54843 2.05912 - OK TSS44 iPS 0 0 0 0 0 - OK TSS44 iPS 1 0 0 0 0 - OK TSS44 hESC 1 0 0 0 0 - OK TSS44 hESC 0 0 0 0 0 - OK TSS44 Fibroblasts 1 0.000266517 0.000222382 0.000181798 0.000352411 - OK TSS44 Fibroblasts 0 19.2402 22.8937 18.7156 36.2798 - OK TSS45 iPS 0 1.43853 1.50149 2.56719 5.32049 - OK TSS45 iPS 1 0 0 0 0 - OK TSS45 hESC 1 8.36824 8.28331 5.47456 12.3046 - OK TSS45 hESC 0 5.50384 5.56027 3.67487 8.25962 - OK TSS45 Fibroblasts 1 3.30178 2.755 2.25222 4.72177 - OK TSS45 Fibroblasts 0 0.0013166 0.0015666 0.0012807 0.00268498 - OK TSS46 iPS 0 0 0 0 0 - OK TSS46 iPS 1 0 0 0 0 - OK TSS46 hESC 1 79.2032 78.3994 51.8153 106.944 - OK TSS46 hESC 0 37.3306 37.7134 24.9253 51.4446 - OK TSS46 Fibroblasts 1 76.242 63.6163 52.0065 100.675 - OK TSS46 Fibroblasts 0 36.3335 43.2328 35.3429 68.4177 - OK TSS47 iPS 0 7.50053 7.8288 13.3854 27.8227 - OK TSS47 iPS 1 3.00001 2.89027 4.94168 10.2717 - OK TSS47 hESC 1 13.7969 13.6569 9.02603 20.3516 - OK TSS47 hESC 0 11.1694 11.2839 7.4577 16.8154 - OK TSS47 Fibroblasts 1 9.25985 7.72641 6.31636 13.2816 - OK TSS47 Fibroblasts 0 0 0 0 0 - OK TSS48 iPS 0 51.9318 54.2047 92.6772 79.9112 - OK TSS48 iPS 1 34.5665 33.3022 56.9388 49.0957 - OK TSS48 hESC 1 119.863 118.646 78.4149 69.8784 - OK TSS48 hESC 0 151.117 152.667 100.9 89.9153 - OK TSS48 Fibroblasts 1 203.297 169.631 138.673 120.144 - OK TSS48 Fibroblasts 0 54.3773 64.7029 52.8948 45.8269 - OK TSS49 iPS 0 2 2.08753 3.56919 6.70016 - OK TSS49 iPS 1 1 0.963422 1.64722 3.09221 - OK TSS49 hESC 1 3 2.96955 1.96262 3.96399 - OK TSS49 hESC 0 2 2.02051 1.33538 2.69713 - OK TSS49 Fibroblasts 1 3 2.5032 2.04637 3.88173 - OK TSS49 Fibroblasts 0 10 11.8989 9.72736 18.4517 - OK TSS5 iPS 0 60.5 63.1479 107.968 151.289 - OK TSS5 iPS 1 40.75 39.2595 67.1244 85.754 - OK TSS5 hESC 1 166.417 164.728 108.871 175.394 - OK TSS5 hESC 0 213.75 215.942 142.719 207.802 - OK TSS5 Fibroblasts 1 348.75 290.997 237.891 272.138 - OK TSS5 Fibroblasts 0 229.75 273.377 223.486 303.073 - OK TSS50 iPS 0 3 3.1313 5.35378 8.11241 - OK TSS50 iPS 1 1 0.963422 1.64722 2.49598 - OK TSS50 hESC 1 30 29.6955 19.6262 31.5351 - OK TSS50 hESC 0 23 23.2358 15.3569 24.6753 - OK TSS50 Fibroblasts 1 2 1.6688 1.36425 1.75278 - OK TSS50 Fibroblasts 0 0 0 0 0 - OK TSS51 iPS 0 12 12.5252 21.4151 17.236 - OK TSS51 iPS 1 5 4.81711 8.23612 6.62886 - OK TSS51 hESC 1 79 78.1982 51.6823 42.8944 - OK TSS51 hESC 0 76 76.7792 50.7445 42.116 - OK TSS51 Fibroblasts 1 0 0 0 0 - OK TSS51 Fibroblasts 0 1 1.18989 0.972736 0.786404 - OK TSS52 iPS 0 170.001 177.441 303.382 199 - OK TSS52 iPS 1 186.632 179.806 307.425 201.652 - OK TSS52 hESC 1 1884.02 1864.9 1232.54 828.909 - OK TSS52 hESC 0 1923.55 1943.28 1284.34 863.746 - OK TSS52 Fibroblasts 1 0 0 0 0 - OK TSS52 Fibroblasts 0 0 0 0 0 - OK TSS53 iPS 0 0 0 0 0 - OK TSS53 iPS 1 0 0 0 0 - OK TSS53 hESC 1 0 0 0 0 - OK TSS53 hESC 0 0 0 0 0 - OK TSS53 Fibroblasts 1 120.037 100.159 81.8803 59.8043 - OK TSS53 Fibroblasts 0 37.6607 44.812 36.634 26.7569 - OK TSS54 iPS 0 0.00607722 0.0063432 0.0108454 0.008228 - OK TSS54 iPS 1 0 0 0 0 - OK TSS54 hESC 1 0 0 0 0 - OK TSS54 hESC 0 0 0 0 0 - OK TSS54 Fibroblasts 1 0 0 0 0 - OK TSS54 Fibroblasts 0 0 0 0 0 - OK TSS55 iPS 0 44.3701 46.312 79.1826 60.8233 - OK TSS55 iPS 1 92.7775 89.3839 152.825 117.391 - OK TSS55 hESC 1 132.518 131.173 86.694 68.5732 - OK TSS55 hESC 0 74.5923 75.3571 49.8046 39.3944 - OK TSS55 Fibroblasts 1 0 0 0 0 - OK TSS55 Fibroblasts 0 6.05089 7.19988 5.88592 4.54047 - OK TSS56 iPS 0 0 0 0 0 - OK TSS56 iPS 1 0 0 0 0 - OK TSS56 hESC 1 30.6889 30.3774 20.0769 18.6306 - OK TSS56 hESC 0 0 0 0 0 - OK TSS56 Fibroblasts 1 96.0027 80.1046 65.4857 59.0124 - OK TSS56 Fibroblasts 0 12.4633 14.8299 12.1235 10.9251 - OK TSS57 iPS 0 4.61364 4.81556 8.23347 6.92623 - OK TSS57 iPS 1 3.41092 3.28615 5.61854 7.60888 - OK TSS57 hESC 1 40.8547 40.4401 26.7274 23.9031 - OK TSS57 hESC 0 18.4025 18.5912 12.2872 12.3495 - OK TSS57 Fibroblasts 1 0 0 0 0 - OK TSS57 Fibroblasts 0 0 0 0 0 - OK TSS58 iPS 0 8.92532 9.31595 15.9281 13.3199 - OK TSS58 iPS 1 2.10726 2.03018 3.47113 2.90276 - OK TSS58 hESC 1 29.8919 29.5885 19.5555 16.8841 - OK TSS58 hESC 0 32.2258 32.5563 21.5169 18.5776 - OK TSS58 Fibroblasts 1 0 0 0 0 - OK TSS58 Fibroblasts 0 0 0 0 0 - OK TSS59 iPS 0 591 616.866 1054.69 269.372 - OK TSS59 iPS 1 527 507.724 868.087 221.712 - OK TSS59 hESC 1 4208 4165.29 2752.9 709.915 - OK TSS59 hESC 0 4521 4567.35 3018.63 778.44 - OK TSS59 Fibroblasts 1 8777.5 7323.94 5987.34 1531.34 - OK TSS59 Fibroblasts 0 7039 8375.62 6847.09 1751.24 - OK TSS6 iPS 0 16 16.7003 28.5535 14.0463 - OK TSS6 iPS 1 4 3.85369 6.58889 3.24126 - OK TSS6 hESC 1 98 97.0054 64.1123 32.1328 - OK TSS6 hESC 0 71 71.728 47.4061 23.7597 - OK TSS6 Fibroblasts 1 2 1.6688 1.36425 0.67294 - OK TSS6 Fibroblasts 0 1 1.18989 0.972736 0.47982 - OK TSS60 iPS 0 1142.05 1192.04 2038.1 984.731 - OK TSS60 iPS 1 850.089 818.995 1400.29 675.221 - OK TSS60 hESC 1 2553.21 2527.3 1670.33 820.931 - OK TSS60 hESC 0 2444.4 2469.46 1632.1 802.898 - OK TSS60 Fibroblasts 1 12436.1 10376.7 8482.99 4109.29 - OK TSS60 Fibroblasts 0 7918.72 9422.39 7702.83 3728.02 - OK TSS61 iPS 0 0 0 0 0 - OK TSS61 iPS 1 0 0 0 0 - OK TSS61 hESC 1 9.64033 9.54249 6.30677 1.93379 - OK TSS61 hESC 0 0 0 0 0 - OK TSS61 Fibroblasts 1 0 0 0 0 - OK TSS61 Fibroblasts 0 5.21414 6.20424 5.07199 1.54004 - OK TSS62 iPS 0 1.62965 1.70097 2.90826 0.762323 - OK TSS62 iPS 1 3.58948 3.45819 5.91268 1.78465 - OK TSS62 hESC 1 6.35967 6.29512 4.16054 1.1016 - OK TSS62 hESC 0 9 9.09228 6.00922 1.63069 - OK TSS62 Fibroblasts 1 2 1.6688 1.36425 0.512637 - OK TSS62 Fibroblasts 0 11.7859 14.0238 11.4645 3.21076 - OK TSS63 iPS 0 0.370352 0.386561 0.660928 0.450882 - OK TSS63 iPS 1 1.41052 1.35892 2.32344 1.58504 - OK TSS63 hESC 1 0 0 0 0 - OK TSS63 hESC 0 0 0 0 0 - OK TSS63 Fibroblasts 1 0 0 0 0 - OK TSS63 Fibroblasts 0 0 0 0 0 - OK TSS64 iPS 0 43.8004 45.7174 78.1659 90.0735 - OK TSS64 iPS 1 2 1.92684 3.29445 4.12813 - OK TSS64 hESC 1 9.55735 9.46035 6.25248 6.65285 - OK TSS64 hESC 0 5 5.05127 3.33846 1.97078 - OK TSS64 Fibroblasts 1 1659.14 1384.39 1131.74 1065.01 - OK TSS64 Fibroblasts 0 789.393 939.289 767.871 687.923 - OK TSS65 iPS 0 449.363 469.03 801.93 450.4 - OK TSS65 iPS 1 349.942 337.142 576.432 322.064 - OK TSS65 hESC 1 2361.29 2337.33 1544.77 882.472 - OK TSS65 hESC 0 1974.25 1994.49 1318.19 753.072 - OK TSS65 Fibroblasts 1 2795.89 2332.89 1907.14 1071.41 - OK TSS65 Fibroblasts 0 2439.65 2902.91 2373.14 1333.86 - OK TSS66 iPS 0 3.57802 3.73462 6.38531 3.75796 - OK TSS66 iPS 1 100.526 96.8493 165.589 97.4546 - OK TSS66 hESC 1 23.9319 23.689 15.6564 9.42276 - OK TSS66 hESC 0 233.905 236.304 156.177 93.9943 - OK TSS66 Fibroblasts 1 142.766 119.124 97.3844 57.5007 - OK TSS66 Fibroblasts 0 172.037 204.704 167.346 98.8097 - OK TSS67 iPS 0 4 4.17507 7.13837 1.18893 - OK TSS67 iPS 1 3 2.89027 4.94167 0.823042 - OK TSS67 hESC 1 50 49.4925 32.7103 5.48297 - OK TSS67 hESC 0 46 46.4716 30.7138 5.14828 - OK TSS67 Fibroblasts 1 84 70.0896 57.2984 9.55332 - OK TSS67 Fibroblasts 0 43 51.1652 41.8277 6.92723 - OK TSS68 iPS 0 132.195 137.98 235.914 122.037 - OK TSS68 iPS 1 172.188 165.89 283.632 146.721 - OK TSS68 hESC 1 644.582 638.04 421.69 222.463 - OK TSS68 hESC 0 685.785 692.816 457.892 241.562 - OK TSS68 Fibroblasts 1 4.94735 4.12806 3.3747 1.75071 - OK TSS68 Fibroblasts 0 3.92704 4.67274 3.81998 1.98171 - OK TSS69 iPS 0 0 0 0 0 - OK TSS69 iPS 1 0 0 0 0 - OK TSS69 hESC 1 115.911 114.734 75.8295 53.9465 - OK TSS69 hESC 0 143.532 145.004 95.8353 68.179 - OK TSS69 Fibroblasts 1 0 0 0 0 - OK TSS69 Fibroblasts 0 9.01851 10.731 8.77263 6.1018 - OK TSS7 iPS 0 22.095 23.062 39.4305 172.931 - OK TSS7 iPS 1 1.00001 0.963435 1.64724 7.22435 - OK TSS7 hESC 1 0 0 0 0 - OK TSS7 hESC 0 0 0 0 0 - OK TSS7 Fibroblasts 1 0 0 0 0 - OK TSS7 Fibroblasts 0 1 1.18989 0.972736 4.37202 - OK TSS70 iPS 0 11.3013 11.7959 20.1682 13.9198 - OK TSS70 iPS 1 29.2397 28.1702 48.1643 33.2422 - OK TSS70 hESC 1 175.107 173.329 114.556 81.1706 - OK TSS70 hESC 0 86.6778 87.5665 57.874 41.0076 - OK TSS70 Fibroblasts 1 0 0 0 0 - OK TSS70 Fibroblasts 0 0.0544537 0.0647937 0.052969 0.0366983 - OK TSS71 iPS 0 4.50409 4.70122 8.03797 9.20262 - OK TSS71 iPS 1 3.57218 3.44152 5.88417 6.73675 - OK TSS71 hESC 1 21.4006 21.1834 14.0004 14.8891 - OK TSS71 hESC 0 31.5053 31.8283 21.0358 22.2985 - OK TSS71 Fibroblasts 1 0.0526524 0.0439331 0.0359154 0.0309458 - OK TSS71 Fibroblasts 0 0 0 0 0 - OK TSS72 iPS 0 598 624.173 1067.19 668.692 - OK TSS72 iPS 1 405 390.186 667.125 418.016 - OK TSS72 hESC 1 1231 1218.51 805.328 516.786 - OK TSS72 hESC 0 1157 1168.86 772.518 495.731 - OK TSS72 Fibroblasts 1 5990 4998.05 4085.92 2569.85 - OK TSS72 Fibroblasts 0 4549 5412.8 4424.98 2784.35 - OK TSS73 iPS 0 8.08297 8.43674 14.4248 7.62123 - OK TSS73 iPS 1 7.71621 7.43397 12.7103 9.93507 - OK TSS73 hESC 1 174.428 172.657 114.112 61.5073 - OK TSS73 hESC 0 178.345 180.173 119.079 64.2761 - OK TSS73 Fibroblasts 1 0 0 0 0 - OK TSS73 Fibroblasts 0 14.9997 17.8479 14.5907 8.75874 - OK TSS74 iPS 0 1.93893 2.0238 3.46021 3.45294 - OK TSS74 iPS 1 0 0 0 0 - OK TSS74 hESC 1 41.4437 41.0231 27.1127 17.9435 - OK TSS74 hESC 0 12.6552 12.7849 8.44974 7.08261 - OK TSS74 Fibroblasts 1 0 0 0 0 - OK TSS74 Fibroblasts 0 0 0 0 0 - OK TSS75 iPS 0 1.97809 2.06467 3.53009 5.40695 - OK TSS75 iPS 1 1 0.963422 1.64722 2.52301 - OK TSS75 hESC 1 1.12877 1.11731 0.738447 1.20016 - OK TSS75 hESC 0 0 0 0 0 - OK TSS75 Fibroblasts 1 0 0 0 0 - OK TSS75 Fibroblasts 0 0 0 0 0 - OK TSS76 iPS 0 0 0 0 0 - OK TSS76 iPS 1 1.28379 1.23683 2.11469 1.73257 - OK TSS76 hESC 1 0 0 0 0 - OK TSS76 hESC 0 0 0 0 0 - OK TSS76 Fibroblasts 1 2 1.6688 1.36425 1.12281 - OK TSS76 Fibroblasts 0 0.000312782 0.000372175 0.000304254 0.000250409 - OK TSS77 iPS 0 0 0 0 0 - OK TSS77 iPS 1 1 0.963422 1.64722 1.16125 - OK TSS77 hESC 1 12 11.8782 7.85048 5.68504 - OK TSS77 hESC 0 1 1.01025 0.667691 0.483518 - OK TSS77 Fibroblasts 1 0 0 0 0 - OK TSS77 Fibroblasts 0 1 1.18989 0.972736 0.688434 - OK TSS78 iPS 0 3 3.1313 5.35378 20.0596 - OK TSS78 iPS 1 6 5.78053 9.88334 37.0309 - OK TSS78 hESC 1 37 36.6245 24.2056 105.561 - OK TSS78 hESC 0 23 23.2358 15.3569 66.9717 - OK TSS78 Fibroblasts 1 23 19.1912 15.6888 60.0249 - OK TSS78 Fibroblasts 0 14 16.6584 13.6183 52.1031 - OK TSS79 iPS 0 96 100.202 171.321 84.2743 - OK TSS79 iPS 1 75 72.2567 123.542 61.1137 - OK TSS79 hESC 1 336.5 333.085 220.141 118.403 - OK TSS79 hESC 0 378.5 382.381 252.721 126.535 - OK TSS79 Fibroblasts 1 346.5 289.119 236.356 137.139 - OK TSS79 Fibroblasts 0 240 285.573 233.457 115.803 - OK TSS8 iPS 0 98.2263 102.525 175.294 103.901 - OK TSS8 iPS 1 0 0 0 0 - OK TSS8 hESC 1 10.6666 10.5583 6.97813 4.23036 - OK TSS8 hESC 0 0 0 0 0 - OK TSS8 Fibroblasts 1 10.883 9.08075 7.42354 4.41456 - OK TSS8 Fibroblasts 0 0 0 0 0 - OK TSS80 iPS 0 3 3.1313 5.35378 4.55402 - OK TSS80 iPS 1 6 5.78053 9.88334 9.64836 - OK TSS80 hESC 1 21 20.7869 13.7383 20.0052 - OK TSS80 hESC 0 33 33.3384 22.0338 31.257 - OK TSS80 Fibroblasts 1 6 5.0064 4.09274 4.16177 - OK TSS80 Fibroblasts 0 4 4.75955 3.89094 4.06286 - OK TSS81 iPS 0 0 0 0 0 - OK TSS81 iPS 1 0 0 0 0 - OK TSS81 hESC 1 0 0 0 0 - OK TSS81 hESC 0 0 0 0 0 - OK TSS81 Fibroblasts 1 0 0 0 0 - OK TSS81 Fibroblasts 0 0 0 0 0 - OK TSS82 iPS 0 0 0 0 0 - OK TSS82 iPS 1 0 0 0 0 - OK TSS82 hESC 1 0 0 0 0 - OK TSS82 hESC 0 0 0 0 0 - OK TSS82 Fibroblasts 1 0 0 0 0 - OK TSS82 Fibroblasts 0 0 0 0 0 - OK TSS83 iPS 0 54 56.3634 96.3681 56.4297 - OK TSS83 iPS 1 169 162.818 278.381 152.909 - OK TSS83 hESC 1 204 201.93 133.458 77.1486 - OK TSS83 hESC 0 184 185.887 122.855 72.7169 - OK TSS83 Fibroblasts 1 0 0 0 0 - OK TSS83 Fibroblasts 0 4 4.75955 3.89094 2.53227 - OK TSS84 iPS 0 29.9069 31.2159 53.3717 25.5013 - OK TSS84 iPS 1 0 0 0 0 - OK TSS84 hESC 1 82.7346 81.8949 54.1255 26.3344 - OK TSS84 hESC 0 46.4222 46.8981 30.9957 15.0807 - OK TSS84 Fibroblasts 1 273.466 228.18 186.538 89.3643 - OK TSS84 Fibroblasts 0 109.37 130.138 106.388 50.967 - OK TSS85 iPS 0 43.571 45.478 77.7566 37.5077 - OK TSS85 iPS 1 81.8012 78.8091 134.745 66.4186 - OK TSS85 hESC 1 349.537 345.989 228.669 115.54 - OK TSS85 hESC 0 318.578 321.844 212.712 106.862 - OK TSS85 Fibroblasts 1 79.534 66.3631 54.252 26.3759 - OK TSS85 Fibroblasts 0 80.6304 95.9411 78.4321 38.1219 - OK TSS86 iPS 0 0 0 0 0 - OK TSS86 iPS 1 9.6599 9.30656 15.912 6.64057 - OK TSS86 hESC 1 5.93459 5.87436 3.88245 1.64609 - OK TSS86 hESC 0 0 0 0 0 - OK TSS86 Fibroblasts 1 0 0 0 0 - OK TSS86 Fibroblasts 0 0 0 0 0 - OK TSS87 iPS 0 6.522 6.80745 11.6391 5.05264 - OK TSS87 iPS 1 10.5389 10.1534 17.3599 8.26952 - OK TSS87 hESC 1 4.79429 4.74563 3.13645 1.38415 - OK TSS87 hESC 0 0 0 0 0 - OK TSS87 Fibroblasts 1 0 0 0 0 - OK TSS87 Fibroblasts 0 0 0 0 0 - OK TSS88 iPS 0 76.429 79.7741 136.395 63.9108 - OK TSS88 iPS 1 50.2544 48.4162 82.7803 32.7926 - OK TSS88 hESC 1 133.786 132.428 87.5235 45.9626 - OK TSS88 hESC 0 124.418 125.693 83.0725 37.6424 - OK TSS88 Fibroblasts 1 165.662 138.228 113.002 46.7147 - OK TSS88 Fibroblasts 0 82.3897 98.0345 80.1435 31.811 - OK TSS89 iPS 0 6.89352 7.19523 12.3021 13.9828 - OK TSS89 iPS 1 8.66915 8.35206 14.28 16.2309 - OK TSS89 hESC 1 23.6167 23.377 15.4502 18.3447 - OK TSS89 hESC 0 20.842 21.0557 13.916 16.5231 - OK TSS89 Fibroblasts 1 13.6065 11.3532 9.28128 10.6159 - OK TSS89 Fibroblasts 0 8.05482 9.58433 7.83521 8.96186 - OK TSS9 iPS 0 72.0849 75.2399 128.642 93.15 - OK TSS9 iPS 1 5.84031 5.62669 9.6203 6.96607 - OK TSS9 hESC 1 0 0 0 0 - OK TSS9 hESC 0 16.5335 16.703 11.0393 8.21721 - OK TSS9 Fibroblasts 1 73.2685 61.1352 49.9782 36.3346 - OK TSS9 Fibroblasts 0 51.6691 61.4804 50.2604 36.5397 - OK TSS90 iPS 0 11.6774 12.1885 20.8395 23.5164 - OK TSS90 iPS 1 2.07641 2.00046 3.42031 3.85966 - OK TSS90 hESC 1 29.5975 29.2971 19.3629 22.818 - OK TSS90 hESC 0 18.7417 18.9339 12.5137 14.7466 - OK TSS90 Fibroblasts 1 36.2967 30.286 24.7589 28.1144 - OK TSS90 Fibroblasts 0 7.56047 8.99611 7.35434 8.35107 - OK TSS91 iPS 0 23 24.0066 41.0457 53.7339 - OK TSS91 iPS 1 27 26.0124 44.475 58.2234 - OK TSS91 hESC 1 167 165.305 109.253 150.428 - OK TSS91 hESC 0 134 135.374 89.4706 123.19 - OK TSS91 Fibroblasts 1 8 6.6752 5.45699 7.1959 - OK TSS91 Fibroblasts 0 1 1.18989 0.972736 1.28271 - OK TSS92 iPS 0 64 66.8011 114.214 310.974 - OK TSS92 iPS 1 122 117.538 200.961 547.163 - OK TSS92 hESC 1 746 738.429 488.038 1480.3 - OK TSS92 hESC 0 778 785.977 519.464 1575.62 - OK TSS92 Fibroblasts 1 0 0 0 0 - OK TSS92 Fibroblasts 0 0 0 0 0 - OK TSS93 iPS 0 14.1697 14.7899 25.2872 10.6379 - OK TSS93 iPS 1 7.35392 7.08493 12.1135 5.09595 - OK TSS93 hESC 1 84.2866 83.4311 55.1408 23.5695 - OK TSS93 hESC 0 61.7049 62.3376 41.1998 17.6105 - OK TSS93 Fibroblasts 1 0 0 0 0 - OK TSS93 Fibroblasts 0 1 1.18989 0.972736 0.410165 - OK TSS94 iPS 0 5.83028 6.08546 10.4047 8.57926 - OK TSS94 iPS 1 9.64608 9.29325 15.8893 13.1016 - OK TSS94 hESC 1 330.713 327.357 216.355 184.103 - OK TSS94 hESC 0 242.128 244.611 161.667 137.568 - OK TSS94 Fibroblasts 1 0 0 0 0 - OK TSS94 Fibroblasts 0 0 0 0 0 - OK TSS95 iPS 0 4 4.17507 7.13837 5.7096 - OK TSS95 iPS 1 2 1.92684 3.29445 2.1216 - OK TSS95 hESC 1 4 3.9594 2.61683 1.67897 - OK TSS95 hESC 0 1 1.01025 0.667691 0.880753 - OK TSS95 Fibroblasts 1 11 9.1784 7.50336 9.49601 - OK TSS95 Fibroblasts 0 3 3.56966 2.91821 1.88601 - OK TSS96 iPS 0 138.892 144.97 247.865 167.607 - OK TSS96 iPS 1 135.004 130.066 222.382 144.996 - OK TSS96 hESC 1 589.382 583.4 385.578 264.704 - OK TSS96 hESC 0 496.701 501.794 331.643 226.31 - OK TSS96 Fibroblasts 1 443.652 370.183 302.626 203.195 - OK TSS96 Fibroblasts 0 339.121 403.515 329.875 221.941 - OK TSS97 iPS 0 18.1085 18.901 32.3163 19.7419 - OK TSS97 iPS 1 26.9959 26.0085 44.4683 27.1656 - OK TSS97 hESC 1 177.618 175.815 116.199 72.6541 - OK TSS97 hESC 0 238.299 240.742 159.11 99.4845 - OK TSS97 Fibroblasts 1 92.3477 77.0549 62.9926 38.6123 - OK TSS97 Fibroblasts 0 62.8794 74.8194 61.165 37.4921 - OK TSS98 iPS 0 310 323.568 553.224 223.493 - OK TSS98 iPS 1 496 477.858 817.023 330.063 - OK TSS98 hESC 1 2522 2496.4 1649.91 676.812 - OK TSS98 hESC 0 2395 2419.56 1599.12 655.977 - OK TSS98 Fibroblasts 1 3100 2586.64 2114.58 856.164 - OK TSS98 Fibroblasts 0 1712 2037.09 1665.32 674.265 - OK TSS99 iPS 0 47.0458 49.1048 83.9576 99.3385 - OK TSS99 iPS 1 18.0188 17.3597 29.6809 35.1184 - OK TSS99 hESC 1 184.711 182.836 120.839 149.632 - OK TSS99 hESC 0 136.245 137.642 90.9698 112.645 - OK TSS99 Fibroblasts 1 503.068 419.759 343.154 408.69 - OK TSS99 Fibroblasts 0 334.39 397.886 325.273 387.393 - OK cummeRbund/inst/reports/0000755000175200017520000000000014516027267016362 5ustar00biocbuildbiocbuildcummeRbund/inst/reports/runReport.Rmd0000644000175200017520000000171414516004263021020 0ustar00biocbuildbiocbuildRun Report ========== Run Parameters ------------------- ```{r} alpha=0.05 runInfo() ``` Global Statistics ----------------- ```{r} cuff ``` ### FPKM distributions ```{r fig.width=7, fig.height=6} csDensity(genes(cuff)) csDensity(isoforms(cuff)) ``` ### Scatterplots ```{r} csScatterMatrix(genes(cuff),logMode=T) ``` Replicate Information --------------------- Model fit --------- Differential Expression Analysis -------------------------------- ### Significant Genes ```{r fig.width=6,fit.height=6} sigMatrix(cuff,level="genes") ``` ```{r} csVolcanoMatrix(genes(cuff),alpha=alpha) ``` ```{r} sigGeneIDs<-getSig(cuff,alpha=alpha) sigGenes<-getGenes(cuff,sigGeneIDs) ``` There are `r length(sigGeneIDs)` significantly different genes at a `r alpha*100`$\%$ FDR. #### Visualizations ```{r fig.width=6,fit.height=10} csHeatmap(sigGenes,cluster="both",labRow=F) ``` ### Significant Isoforms ```{r fig.width=6,fit.height=6} sigMatrix(cuff,level="isoforms") ```cummeRbund/inst/reports/styles/0000755000175200017520000000000014516004263017674 5ustar00biocbuildbiocbuildcummeRbund/inst/reports/styles/report_style.css0000644000175200017520000000327014516004263023143 0ustar00biocbuildbiocbuildbody, td { font-family: sans-serif; background-color: white; font-size: 12px; margin: 8px; } tt, code, pre { font-family: 'DejaVu Sans Mono', 'Droid Sans Mono', 'Lucida Console', Consolas, Monaco, monospace; } h1 { font-size:2.2em; } h2 { font-size:1.8em; } h3 { font-size:1.4em; } h4 { font-size:1.0em; } h5 { font-size:0.9em; } h6 { font-size:0.8em; } a:visited { color: rgb(50%, 0%, 50%); } pre { margin-top: 0; max-width: 95%; border: 1px solid #ccc; white-space: pre-wrap; } pre code { display: block; padding: 0.5em; } code.r, code.cpp { background-color: #F8F8F8; } table, td, th { border: none; } blockquote { color:#666666; margin:0; padding-left: 1em; border-left: 0.5em #EEE solid; } hr { height: 0px; border-bottom: none; border-top-width: thin; border-top-style: dotted; border-top-color: #999999; } @media print { * { background: transparent !important; color: black !important; filter:none !important; -ms-filter: none !important; } body { font-size:12pt; max-width:100%; } a, a:visited { text-decoration: underline; } hr { visibility: hidden; page-break-before: always; } pre, blockquote { padding-right: 1em; page-break-inside: avoid; } tr, img { page-break-inside: avoid; } img { max-width: 100% !important; } @page :left { margin: 15mm 20mm 15mm 10mm; } @page :right { margin: 15mm 10mm 15mm 20mm; } p, h2, h3 { orphans: 3; widows: 3; } h2, h3 { page-break-after: avoid; } }cummeRbund/man/0000755000175200017520000000000014516004263014451 5ustar00biocbuildbiocbuildcummeRbund/man/CuffData-class.Rd0000644000175200017520000000342414516004263017523 0ustar00biocbuildbiocbuild\name{CuffData-class} \Rdversion{1.1} \docType{class} \alias{CuffData-class} \alias{dim,CuffData-method} \alias{getFeatures,CuffData-method} \alias{DB,CuffData-method} \alias{makeRnk} \alias{makeRnk,CuffData-method} \alias{annotation,CuffData-method} \title{Class "CuffData"} \description{ A 'pointer' class for all information (FPKM, annotation, differential expression) for a given feature type (genes, isoforms, TSS, CDS). The methods for this function communicate directly with the SQL backend to present data to the user. } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffData", DB, tables, filters, type, idField, ...)}. %% ~~ describe objects here ~~ } \section{Slots}{ \describe{ \item{\code{DB}:}{Object of class \code{"SQLiteConnection"} ~~ } \item{\code{tables}:}{Object of class \code{"list"} ~~ } \item{\code{filters}:}{Object of class \code{"list"} ~~ } \item{\code{type}:}{Object of class \code{"character"} ~~ } \item{\code{idField}:}{Object of class \code{"character"} ~~ } } } \section{Methods}{ \describe{ \item{dim}{\code{signature(x = "CuffData")}: ... } \item{getFeatures}{\code{signature(object = "CuffData")}: ... } \item{DB}{\code{signature(object = "CuffData")}: Accessor for @DB slot } \item{diffTable}{\code{signature(object = "CuffData")}: Create a Full table (wide format) of differential expression information for all pairwise comparisons } \item{makeRnk}{\code{signature(object = "CuffData")}: Internal method to create .rnk file. Should not be called directly } \item{annotation}{\code{signature(object="CuffData")}: Access annotation data} } } \references{ None } \author{ Loyal A. Goff } \note{ None } \seealso{ None } \examples{ showClass("CuffData") } \keyword{classes} cummeRbund/man/CuffDist-class.Rd0000644000175200017520000000214514516004263017554 0ustar00biocbuildbiocbuild\name{CuffDist-class} \Rdversion{1.1} \docType{class} \alias{CuffDist-class} \alias{dim,CuffDist-method} \alias{samples,CuffDist-method} \alias{DB,CuffDist-method} \title{Class "CuffDist"} \description{ A 'pointer' class to information relative to the distribution-level tests (promoters, splicing, and relative CDS usage) } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffDist", DB, table, type, idField, ...)}. } \section{Slots}{ \describe{ \item{\code{DB}:}{Object of class \code{"SQLiteConnection"} ~~ } \item{\code{table}:}{Object of class \code{"character"} ~~ } \item{\code{type}:}{Object of class \code{"character"} ~~ } \item{\code{idField}:}{Object of class \code{"character"} ~~ } } } \section{Methods}{ \describe{ \item{dim}{\code{signature(x = "CuffDist")}: ... } \item{samples}{\code{signature(x = "CuffDist")}: ... } \item{DB}{\code{signature(object = "CuffDist")}: Accessor for @DB slot } } } \references{ None } \author{ Loyal A. Goff } \note{ None } \seealso{ None } \examples{ showClass("CuffDist") } \keyword{classes} cummeRbund/man/CuffFeature-class.Rd0000644000175200017520000000346614516004263020253 0ustar00biocbuildbiocbuild\name{CuffFeature-class} \Rdversion{1.1} \docType{class} \alias{CuffFeature-class} \alias{annotation,CuffFeature-method} \alias{diffData,CuffFeature-method} \alias{fpkmMatrix,CuffFeature-method} \alias{length,CuffFeature-method} \alias{samples,CuffFeature-method} \title{Class "CuffFeature"} \description{ A 'data' container class for all FPKM, annotation, and differential expression data for a single feature (gene, isoform, TSS, or CDS). } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffFeature", annotation, fpkm, diff, ...)}. } \section{Slots}{ \describe{ \item{\code{annotation}:}{Object of class \code{"data.frame"} ~~ } \item{\code{fpkm}:}{Object of class \code{"data.frame"} ~~ } \item{\code{diff}:}{Object of class \code{"data.frame"} ~~ } \item{\code{repFpkm}:}{Object of class \code{"data.frame"} ~~ } \item{\code{count}:}{Object of class \code{"data.frame"} ~~ } \item{\code{genome}:}{Object of class \code{"character"} ~~ } } } \section{Methods}{ \describe{ \item{fpkmMatrix}{\code{signature(object="CuffFeature")}: ...} \item{repFpkmMatrix}{\code{signature(object = "CuffFeature")}: ... } \item{length}{\code{signature(x = "CuffFeature")}: ... } } } \section{Accessors}{ \describe{ \item{annotation}{\code{signature(object="CuffFeature")}: Access @annotation slot} \item{diffData}{\code{signature(object="CuffFeature")}: Access @diff slot} \item{samples}{\code{signature(object="CuffFeature")}: Get vector of samples} } } \references{ None } \author{ Loyal A. Goff } \note{ 'CuffGene' is a superclass of 'CuffFeature' that links gene information for a given gene with all isoform-, TSS-, and CDS-level data for the given gene. } \seealso{ \code{\linkS4class{CuffGene}} } \examples{ showClass("CuffFeature") } \keyword{classes} cummeRbund/man/CuffFeatureSet-class.Rd0000644000175200017520000000374114516004263020723 0ustar00biocbuildbiocbuild\name{CuffFeatureSet-class} \Rdversion{1.1} \docType{class} \alias{CuffFeatureSet-class} \alias{diffData,CuffFeatureSet-method} \alias{annotation} \alias{annotation,CuffFeatureSet-method} \alias{featureNames,CuffFeatureSet-method} \alias{features,CuffFeatureSet-method} \alias{samples,CuffFeatureSet-method} \alias{length,CuffFeatureSet-method} \title{Class "CuffFeatureSet"} \description{ A 'data' container class for all FPKM, annotation, and differential expression data for a set of features (genes, isoforms, TSS, CDS). } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffFeatureSet", annotation, fpkm, diff, ...)}. } \section{Slots}{ \describe{ \item{\code{annotation}:}{Object of class \code{"data.frame"} ~~ } \item{\code{fpkm}:}{Object of class \code{"data.frame"} ~~ } \item{\code{diff}:}{Object of class \code{"data.frame"} ~~ } \item{\code{repFpkm}:}{Object of class \code{"data.frame"} ~~ } \item{\code{count}:}{Object of class \code{"data.frame"} ~~ } \item{\code{genome}:}{Object of class \code{"character"} ~~ } } } \section{Methods}{ \describe{ \item{diffData}{\code{signature(object = "CuffFeatureSet")}: ... } \item{featureNames}{\code{signature(object = "CuffFeatureSet")}: ... } \item{features}{\code{signature(object = "CuffFeatureSet")}: ... } \item{fpkmMatrix}{\code{signature(object = "CuffFeatureSet")}: ... } \item{repFpkmMatrix}{\code{signature(object = "CuffFeatureSet")}: ... } \item{countMatrix}{\code{signature(object = "CuffFeatureSet")}: ... } \item{samples}{\code{signature(object = "CuffFeatureSet")}: ... } \item{length}{\code{signature(object = "CuffFeatureSet")}: ... } } } \section{Accessors}{ \describe{ \item{annotation}{\code{signature(object="CuffFeatureSet")}: Access @annotation slot} } } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \seealso{ \code{\linkS4class{CuffGeneSet}} } \examples{ showClass("CuffFeatureSet") } \keyword{classes} cummeRbund/man/CuffGene-class.Rd0000644000175200017520000000610714516004263017531 0ustar00biocbuildbiocbuild\name{CuffGene-class} \Rdversion{1.1} \docType{class} \alias{CuffGene-class} \alias{genes,CuffGene-method} \alias{isoforms,CuffGene-method} \alias{TSS,CuffGene-method} \alias{CDS,CuffGene-method} \alias{promoters,CuffGene-method} \alias{relCDS,CuffGene-method} \alias{splicing,CuffGene-method} \alias{length,CuffGene-method} \alias{makeGeneRegionTrack} \alias{makeGeneRegionTrack,CuffGene-method} \alias{genePlot} \alias{genePlot,CuffGene-method} \alias{csPie} \alias{csPie,CuffGene-method} \title{Class "CuffGene"} \description{ A 'data' container class for all FPKM, annotation, and differential expression Data (as well as for all linked features) for a given gene. } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffGene", id, isoforms, TSS, CDS, promoters, splicing, relCDS, annotation, fpkm, diff, ...)}. } \section{Slots}{ \describe{ \item{\code{id}:}{Object of class \code{"character"} ~~ } \item{\code{isoforms}:}{Object of class \code{"CuffFeature"} ~~ } \item{\code{TSS}:}{Object of class \code{"CuffFeature"} ~~ } \item{\code{CDS}:}{Object of class \code{"CuffFeature"} ~~ } \item{\code{promoters}:}{Object of class \code{"CuffFeature"} ~~ } \item{\code{relCDS}:}{Object of class \code{"CuffFeature"} ~~ } \item{\code{splicing}:}{Object of class \code{"CuffFeature"} ~~ } \item{\code{annotation}:}{Object of class \code{"data.frame"} ~~ } \item{\code{genome}:}{Object of class \code{"character"} ~~ } \item{\code{fpkm}:}{Object of class \code{"data.frame"} ~~ } \item{\code{diff}:}{Object of class \code{"data.frame"} ~~ } \item{\code{features}:}{Object of class \code{"data.frame"} ~~ } } } \section{Extends}{ Class \code{"\linkS4class{CuffFeature}"}, directly. } \section{Methods}{ \describe{ \item{length}{\code{signature(object="CuffFeature")}: Part of length validation (internal use only)} \item{makeGeneRegionTrack}{\code{signature(object="CuffFeature")}: Creates a GeneRegionTrack object (see package Gviz) from a CuffGene object.} \item{genePlot}{\code{signature(object="CuffFeature")}: Internal use only.} \item{csPie}{\code{signature(object="CuffGene")}: Allows for visualization of relative isoform proportion as a pie chart by condition (or optionally as stacked bar charts by adding + coord_cartesian()} } } \section{Accessors}{ \describe{ \item{genes}{\code{signature(object = "CuffGene")}: Access @genes slot } \item{isoforms}{\code{signature(object = "CuffGene")}: Access @isoforms slot } \item{TSS}{\code{signature(object = "CuffGene")}: Access @TSS slot } \item{CDS}{\code{signature(object = "CuffGene")}: Access @CDS slot } \item{promoters}{\code{signature(object = "CuffGene")}: Access @CDS slot } \item{relCDS}{\code{signature(object = "CuffGene")}: Access @CDS slot } \item{splicing}{\code{signature(object = "CuffGene")}: Access @CDS slot } \item{features}{\code{signature(object = "CuffGene")}: Access @features slot } } } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \seealso{ \code{\linkS4class{CuffFeature}} } \examples{ showClass("CuffGene") } \keyword{classes} cummeRbund/man/CuffGeneSet-class.Rd0000644000175200017520000000436314516004263020207 0ustar00biocbuildbiocbuild\name{CuffGeneSet-class} \Rdversion{1.1} \docType{class} \alias{CuffGeneSet-class} \alias{genes,CuffGeneSet-method} \alias{isoforms,CuffGeneSet-method} \alias{TSS,CuffGeneSet-method} \alias{CDS,CuffGeneSet-method} \alias{promoters,CuffGeneSet-method} \alias{relCDS,CuffGeneSet-method} \alias{splicing,CuffGeneSet-method} \title{Class "CuffGeneSet"} \description{ A 'data' container class for all FPKM, annotation, and differential expression data (an associated features) for a given set of genes. } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffGeneSet", annotation, fpkm, diff, ...)}. } \section{Slots}{ \describe{ \item{\code{ids}:}{Object of class \code{"character"} ~~ } \item{\code{isoforms}:}{Object of class \code{"CuffFeatureSet"} ~~ } \item{\code{TSS}:}{Object of class \code{"CuffFeatureSet"} ~~ } \item{\code{CDS}:}{Object of class \code{"CuffFeatureSet"} ~~ } \item{\code{promoters}:}{Object of class \code{"CuffFeatureSet"} ~~ } \item{\code{relCDS}:}{Object of class \code{"CuffFeatureSet"} ~~ } \item{\code{splicing}:}{Object of class \code{"CuffFeatureSet"} ~~ } \item{\code{annotation}:}{Object of class \code{"data.frame"} ~~ } \item{\code{fpkm}:}{Object of class \code{"data.frame"} ~~ } \item{\code{diff}:}{Object of class \code{"data.frame"} ~~ } } } \section{Extends}{ Class \code{"\linkS4class{CuffFeatureSet}"}, directly. } \section{Methods}{ No methods defined with class "CuffGeneSet" in the signature. } \section{Accessors}{ \describe{ \item{genes}{\code{signature(object = "CuffGeneSet")}: Access @genes slot } \item{isoforms}{\code{signature(object = "CuffGeneSet")}: Access @isoforms slot } \item{TSS}{\code{signature(object = "CuffGeneSet")}: Access @TSS slot } \item{CDS}{\code{signature(object = "CuffGeneSet")}: Access @CDS slot } \item{promoters}{\code{signature(object = "CuffGeneSet")}: Access @promoters slot } \item{relCDS}{\code{signature(object = "CuffGeneSet")}: Access @relCDS slot } \item{splicing}{\code{signature(object = "CuffGeneSet")}: Access @splicing slot } } } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \seealso{ \code{\linkS4class{CuffFeatureSet}} } \examples{ showClass("CuffGeneSet") } \keyword{classes} cummeRbund/man/CuffSet-class.Rd0000644000175200017520000000520014516004263017377 0ustar00biocbuildbiocbuild\name{CuffSet-class} \Rdversion{1.1} \docType{class} \alias{CuffSet-class} %Accessors \alias{DB} \alias{genes} \alias{isoforms} \alias{TSS} \alias{CDS} \alias{promoters} \alias{splicing} \alias{relCDS} \alias{conditions} \alias{varModel} \alias{DB,CuffSet-method} \alias{genes,CuffSet-method} \alias{isoforms,CuffSet-method} \alias{TSS,CuffSet-method} \alias{CDS,CuffSet-method} \alias{promoters,CuffSet-method} \alias{splicing,CuffSet-method} \alias{relCDS,CuffSet-method} \alias{conditions,CuffSet-method} \alias{varModel,CuffSet-method} \alias{[,CuffSet-method} \title{Class "CuffSet"} \description{ A 'pointer' class to connect to, and retrieve data from the SQLite backend database. } \section{Objects from the Class}{ Objects can be created by calls of the form \code{new("CuffSet", DB, conditions, genes, isoforms, TSS, CDS, promoters, splicing, relCDS, ...)}. Available methods are primary accessors to retrieve CuffGeneSet or CuffGene objects for manipulation. } \section{Slots}{ \describe{ \item{\code{DB}:}{Object of class \code{"SQLiteConnection"} ~~ } \item{\code{conditions}:}{Object of class \code{"data.frame"} ~~ } \item{\code{genes}:}{Object of class \code{"CuffData"} ~~ } \item{\code{isoforms}:}{Object of class \code{"CuffData"} ~~ } \item{\code{phenoData}:}{Object of class \code{"data.frame"} ~~ } \item{\code{TSS}:}{Object of class \code{"CuffData"} ~~ } \item{\code{CDS}:}{Object of class \code{"CuffData"} ~~ } \item{\code{promoters}:}{Object of class \code{"CuffDist"} ~~ } \item{\code{splicing}:}{Object of class \code{"CuffDist"} ~~ } \item{\code{relCDS}:}{Object of class \code{"CuffDist"} ~~ } \item{\code{conditions}:}{Object of class \code{"data.frame"} ~~ } } } \section{Methods}{ \describe{ \item{[}{\code{signature(x = "CuffSet")}: ... } } } \section{Accessors}{ \describe{ \item{DB}{\code{signature(object="CuffSet")}: Access @DB slot } \item{genes}{\code{signature(object = "CuffSet")}: Access @genes slot } \item{isoforms}{\code{signature(object = "CuffSet")}: Access @isoforms slot } \item{TSS}{\code{signature(object = "CuffSet")}: Access @TSS slot } \item{CDS}{\code{signature(object = "CuffSet")}: Access @CDS slot } \item{promoters}{\code{signature(object = "CuffSet")}: Access @promoters slot } \item{splicing}{\code{signature(object = "CuffSet")}: Access @splicing slot } \item{relCDS}{\code{signature(object = "CuffSet")}: Access @relCDS slot } \item{varModel}{\code{signature(object = "CuffSet")}: Access varModel info } } } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \seealso{ None. } \examples{ showClass("CuffSet") } \keyword{classes} cummeRbund/man/JSdist.Rd0000644000175200017520000000155214516004263016143 0ustar00biocbuildbiocbuild\name{JSdist} \alias{JSdist} \title{ Jensen-Shannon distance on columns } \description{ JSdist takes a matrix of expression probabilites (calculated directly or output from makeprobs()) and returns a dist object of the pairwise Jensen-Shannon distances between columns } \usage{ JSdist(mat,...) } \arguments{ \item{mat}{ A matrix of expression probabilities (e.g. from makeprobs()) } \item{\dots}{ Passthrough argument to as.dist() } } \details{ Returns pairwise Jensen-Shannon distance (in the form of a dist object) for a matrix of probabilities (by column) } \value{ A dist object of pairwise J-S distances between columns. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ mat<-matrix(sample(1:50,50),10) probs<-makeprobs(mat) js.distance<-JSdist(probs) } \keyword{ Jensen-Shannon } \keyword{ distance } \keyword{ metric } \keyword{ JS }cummeRbund/man/JSdistFromP.Rd0000644000175200017520000000166514516004263017114 0ustar00biocbuildbiocbuild\name{JSdistFromP} \alias{JSdistFromP} \title{ Jensen-Shannon distance on rows from a pre-defined vector of probabilities } \description{ JSdist takes a matrix of expression probabilites (calculated directly or output from makeprobs()) and returns a matrix of Jensen-Shannon distances between individual rows and a specific vector of probabilities (q)} \usage{ JSdistFromP(mat,q) } \arguments{ \item{mat}{ A matrix of expression probabilities (e.g. from makeprobs()) } \item{q}{ A vector of expression probabilities. } } \details{ Returns Jensen-Shannon distance for each row of a matrix of probabilities against a provided probability distribution (q) } \value{ A vector of JS distances } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ mat<-matrix(sample(1:50,50),10) q<-c(100,4,72,8,19) q<-q/sum(q) js.distance<-JSdistFromP(mat,q) } \keyword{ Jensen-Shannon } \keyword{ distance } \keyword{ metric } \keyword{ JS }cummeRbund/man/JSdistVec.Rd0000644000175200017520000000115514516004263016600 0ustar00biocbuildbiocbuild\name{JSdistVec} \alias{JSdistVec} \title{ JSdistVec } \description{ Returns the Jensen-Shannon Distance (square root of JS divergence) between two probability vectors. } \usage{ JSdistVec(p, q) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{p}{ A vector of probabilities } \item{q}{ A vector of probabilities } } \details{ Should not be called directly by user. } \value{ Returns the JS distance as a numeric } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ p<-sample(1:5000,20) q<-sample(1:5000,20) p<-makeprobsvec(p) q<-makeprobsvec(q) JSdistVec(p,q) }cummeRbund/man/MAplot.Rd0000644000175200017520000000243214516004263016135 0ustar00biocbuildbiocbuild\name{MAplot} \alias{MAplot} \alias{MAplot,CuffData-method} \title{ MAplot } \description{ Creates an M vs A plot (Avg intensity vs log ratio) for a given pair of conditions across all fpkms } \usage{ \S4method{MAplot}{CuffData}(object,x,y,logMode=T,pseudocount=1,smooth=FALSE,useCount=FALSE) } \arguments{ \item{object}{ An object of class 'CuffData'. } \item{x}{ Sample name from 'samples' table for comparison } \item{y}{ Sample name from 'samples' table for comparison } \item{logMode}{ A logical argument to log10-transform FPKM values prior to plotting. } \item{pseudocount}{ Value to be added to FPKM for appropriate log transformation and clustering. (Avoids zero-based errors) } \item{smooth}{ Logical argument whether or not to draw a smoothed line fit through data. } \item{useCount}{ Logical argument whether or not to use mean counts instead of FPKM values. } } \details{ None } \value{ Returns a ggplot MvsA plot object. } \references{ None. } \author{ Loyal A. Goff and Cole Trapnell } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object from sample data genes<-a@genes #Create CuffData object for all 'genes' d<-MAplot(genes,'hESC','Fibroblasts') #Create csDensity plot d #Render plot } \keyword{heatmap} cummeRbund/man/PINK1.Rd0000644000175200017520000000063314516004263015564 0ustar00biocbuildbiocbuild\name{PINK1} \alias{PINK1} \docType{data} \title{ PINK1 } \description{ A sample 'CuffGene' dataset } \usage{data(sampleData)} \format{ PINK1 is a CuffGene object (extends CuffFeature) with all sample gene-, isoform-, TSS-, and CDS-level data for the gene 'PINK1'. } \details{ Sample CuffGene data for gene 'PINK1' } \source{ None } \references{ None } \examples{ data(sampleData) PINK1 } \keyword{datasets} cummeRbund/man/QCplots.Rd0000644000175200017520000000232014516004263016322 0ustar00biocbuildbiocbuild\name{QCplots} \alias{fpkmSCVPlot} \alias{fpkmSCVPlot,CuffData-method} \title{ Quality Control visualizations } \description{ A collection of ggplot2 visualizations for quality control assessment of cuffdiff output. - fpkmSCVPlot: A measure of cross-replicate variability, the squared coefficient of variation is a normalized measure of variance between empirical repicate FPKM values per condition, across the range of FPKM estimates. } \usage{ \S4method{fpkmSCVPlot}{CuffData}(object,FPKMLowerBound=1, showPool = FALSE) } \arguments{ \item{object}{ An object of class CuffData. } \item{FPKMLowerBound}{ A lower limit cutoff for FPKM values from which a fit of squared Coefficient of variation (default: 1) } \item{showPool}{ Logical argument whether to display variability across all replicates independent of condition (TRUE) or the cross-replicate variability for each condition (FALSE) } } \details{ None } \value{ A ggplot2 plot object with a geom_box layer. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create CuffSet object genes<-a@genes #CuffData object for all genes csBoxplot(genes) } cummeRbund/man/addFeatures.Rd0000644000175200017520000000147614516004263017177 0ustar00biocbuildbiocbuild\name{addFeatures} \alias{addFeatures} \alias{addFeatures,CuffSet-method} \alias{addFeatures,CuffData-method} \title{ addFeatures } \description{ Adds a data.frame of features to a the SQLite backend database. } \usage{ \S4method{addFeatures}{CuffSet}(object, features, level="genes", ...) } \arguments{ \item{object}{ An object of class ('CuffSet' or 'CuffData') } \item{features}{ A data.frame of features to add. 1st column MUST contain ids (ie. gene_id for 'gene' features, isoform_id for 'isoform' features, etc) } \item{level}{ One of c('genes','isoforms','TSS','CDS') to indicate which type of featurs you are being added, and to what data-level. } \item{\dots}{ Additional arguments. } } \details{ None } \value{ None } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ #None yet. } cummeRbund/man/count.Rd0000644000175200017520000000143314516004263016071 0ustar00biocbuildbiocbuild\name{count-methods} \docType{methods} \alias{count} \alias{count-methods} \alias{count,CuffData-method} \alias{count,CuffFeature-method} \alias{count,CuffFeatureSet-method} \title{ Retrieve count values (raw and normalized) } \description{ Returns a data.frame from @count slot } \section{Methods}{ \describe{ \item{\code{signature(object = "CuffData")}}{ %% ~~describe this method here~~ } \item{\code{signature(object = "CuffFeature")}}{ %% ~~describe this method here~~ } \item{\code{signature(object = "CuffFeatureSet")}}{ %% ~~describe this method here~~ } }} \details{ Returns a data.frame of count values. } \value{ A data.frame of count-level values for a set of features. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) count(PINK1) }cummeRbund/man/countMatrix.Rd0000644000175200017520000000223514516004263017257 0ustar00biocbuildbiocbuild\name{countMatrix} \alias{countMatrix} \alias{countMatrix,CuffData-method} \alias{countMatrix,CuffFeatureSet-method} \alias{repCountMatrix} \alias{repCountMatrix,CuffData-method} \alias{repCountMatrix,CuffFeatureSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ countMatrix } \description{ Retrieve count values as gene by condition matrix } \usage{ \S4method{countMatrix}{CuffData}(object,fullnames=FALSE,sampleIdList) \S4method{repCountMatrix}{CuffData}(object,fullnames=FALSE,repIdList) } \arguments{ \item{object}{ An object of class ('CuffData','CuffFeatureSet','CuffGeneSet','CuffGene',or 'CuffFeature') } \item{fullnames}{ A logical value whether or not to concatenate gene_short_name and tracking_id values (easier to read labels) } \item{sampleIdList}{ A vector of sample names to subset the resulting matrix. } \item{repIdList}{ A vector of replicate names to subset the resulting replicate matrix. } } \details{ None. } \value{ A feature x condition matrix of count values. } \references{ None. } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) countMatrix(sampleGeneSet) repCountMatrix(sampleGeneSet) } cummeRbund/man/csBoxplot.Rd0000644000175200017520000000200514516004263016712 0ustar00biocbuildbiocbuild\name{csBoxplot} \alias{csBoxplot} \alias{csBoxplot,CuffData-method} \title{ csBoxplot } \description{ Creates a ggplot2 plot object with a geom_box layer displaying summary statistics for FPKM values across samples (x). } \usage{ \S4method{csBoxplot}{CuffData}(object, logMode=TRUE, pseudocount=0.0001, replicates=FALSE,...) } \arguments{ \item{object}{ An object of class CuffData. } \item{logMode}{ A logical argument to log10 -transform FPKM values. } \item{pseudocount}{ Value added to FPKM to avoid log-transform issues. } \item{replicates}{ A logical value whether or not to plot individual replicates or aggregate condition values. } \item{\dots}{ Additional arguments to csBoxplot } } \details{ None } \value{ A ggplot2 plot object with a geom_box layer. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create CuffSet object genes<-a@genes #CuffData object for all genes csBoxplot(genes) } cummeRbund/man/csCluster.Rd0000644000175200017520000000235214516004263016711 0ustar00biocbuildbiocbuild\name{csCluster} \alias{csCluster} \alias{csCluster,CuffFeatureSet-method} \title{ csCluster } \description{ Returns a ggplot2 plot object with geom_line layer plotting FPKM values over conditions faceted by k-means clustering clusters. (Euclidean). This is very crude at this point. This does not return any of the clustering information directly, but if you want it, you can retrieve it from the ggplot object returned. } \usage{ \S4method{csCluster}{CuffFeatureSet}(object,k,logMode=T,method = "none",pseudocount=1,...) } \arguments{ \item{object}{ An object of class CuffFeatureSet. } \item{k}{ Number of pre-defined clusters to attempt to find. } \item{logMode}{ A logical value whether or not to log-transform the FPKM values prior to clustering. } \item{method}{ Distance function to use when computing cluster solution. Default "none" will use the Jensen-Shannon distance (JSdist). Provide a function that returns a dist object on rows. } \item{pseudocount}{ Value added to FPKM to avoid log-transform issues. } \item{\dots}{ Additional arguments to pam. } } \details{ Uses 'kmeans' function. } \author{ Loyal A. Goff } \source{ None } \references{ None. } \examples{ data(sampleData) csCluster(sampleGeneSet,4) } \keyword{datasets} cummeRbund/man/csClusterPlot.Rd0000644000175200017520000000301514516004263017545 0ustar00biocbuildbiocbuild\name{csClusterPlot} \alias{csClusterPlot} %- Also NEED an '\alias' for EACH other topic documented here. \title{ csClusterPlot } \description{ Replaces the default plotting behavior of the old csCluster. Takes as an argument the output of csCluster and plots expression profiles of features facet by cluster. } \usage{ csClusterPlot(clustering, pseudocount=1.0,logMode=FALSE,drawSummary=TRUE,sumFun=mean_cl_boot) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{clustering}{ The output of csCluster. (Must be the output of csCluster. Only this data format contains the necessary information for csClusterPlot.) } \item{pseudocount}{ Value added to FPKM to avoid log transformation issues. } \item{logMode}{ Logical argument whether to plot FPKM with log axis (Y-axis). } \item{drawSummary}{ Logical value whether or not to draw a summary line for each cluster (by default this is the cluster mean) } \item{sumFun}{ Summary function used to by drawSummary (default: mean_cl_boot) } } \details{ This replaces the default plotting behavior of the old csCluster() method. This was necessary so as to preserve the cluster information obtained by csCluster in a stable format. The output of csClusterPlot is a ggplot2 object of expressionProfiles faceted by cluster ID. } \value{ A ggplot2 object of expressionProfiles faceted by cluster ID. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \examples{ data(sampleData) myClustering<-csCluster(sampleGeneSet,k=4) csClusterPlot(myClustering) } cummeRbund/man/csDendro.Rd0000644000175200017520000000222014516004263016475 0ustar00biocbuildbiocbuild\name{csDendro} \alias{csDendro} \alias{csDendro,CuffFeatureSet-method} \alias{csDendro,CuffData-method} \title{ csDendro } \description{ Creates a grid graphics plot of a dendrogram of Jensen-Shannon distances between conditions of a CuffFeatureSet or CuffGeneSet object. } \usage{ \S4method{csDendro}{CuffFeatureSet}(object,logMode=T,pseudocount=1,replicates=FALSE) \S4method{csDendro}{CuffData}(object,logMode=T,pseudocount=1,replicates=FALSE,...) } \arguments{ \item{object}{ An object of class 'CuffFeatureSet' or 'CuffGeneSet' } \item{logMode}{ A logical argument to log10-transform FPKM values prior to plotting. } \item{pseudocount}{ Value to be added to FPKM for appropriate log transformation and clustering. (Avoids zero-based errors) } \item{replicates}{ A logical value whether or not to plot individual replicates or aggregate condition values. } \item{\dots}{ Additional arguments to csHeatmap } } \details{ None } \value{ Returns a dendrogram object and plots that object by default. } \references{ None. } \author{ Loyal A. Goff and Cole Trapnell } \note{ None } \examples{ data(sampleData) csDendro(sampleGeneSet) } \keyword{heatmap} cummeRbund/man/csDensity.Rd0000644000175200017520000000337014516004263016710 0ustar00biocbuildbiocbuild\name{csDensity} \alias{csDensity} \alias{csDensity,CuffData-method} \alias{csDensity,CuffFeatureSet-method} \title{ Density plot of CuffData } \description{ Creates a smoothed density plot, by sample, for log10 FPKM values from a cuffdiff run. } \usage{ \S4method{csDensity}{CuffData}(object, logMode=TRUE, pseudocount=0, labels, features=FALSE, replicates=FALSE,...) \S4method{csDensity}{CuffFeatureSet}(object, logMode=TRUE, pseudocount=0, labels, features=FALSE, replicates=FALSE,...) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class CuffData. } \item{logMode}{ A logical value of whether or not to log10-transform FPKM values. By default this is TRUE. } \item{pseudocount}{ Pseudocount value added to FPKM to avoid errors in log-transformation of true zero values. } \item{labels}{ A list of tracking_id values or gene_short_name values used for 'callout' points on the density plot for reference. (Not implemented yet). } \item{features}{ Will include all fields from 'features' slot in returned ggplot object. Useful for further manipulations of plot object using feature-level attributes (e.g. gene_type, class_code, etc) } \item{replicates}{ A logical value whether or not to plot individual replicates or aggregate condition values. } \item{\dots}{ Additional arguments } } \details{ Creates a density plot, by sample, for log10-transformed FPKM values from a cuffdiff run. } \value{ A ggplot2 plot object } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object from sample data genes<-a@genes #Create CuffData object for all 'genes' d<-csDensity(genes) #Create csDensity plot d #Render plot } cummeRbund/man/csDistHeat.Rd0000644000175200017520000000317014516004263016774 0ustar00biocbuildbiocbuild\name{csDistHeat} \alias{csDistHeat} \alias{csDistHeat,CuffFeatureSet-method} \alias{csDistHeat,CuffData-method} \title{ csDistHeat } \description{ Creates a ggplot plot object with a geom_tile layer of JS Distance values between samples or genes. } \usage{ \S4method{csDistHeat}{CuffFeatureSet}(object, replicates=F, samples.not.genes=T, logMode=T, pseudocount=1.0, heatscale=c(low='lightyellow',mid='orange',high='darkred'), heatMidpoint=NULL, ...) } \arguments{ \item{object}{ An object of class 'CuffFeatureSet' or 'CuffGeneSet' } \item{replicates}{ A logical argument whether or not to use individual replicate FPKM values as opposed to condition FPKM estimates. (default: FALSE) } \item{samples.not.genes}{ Compute distances between samples rather than genes. If False, compute distances between genes. } \item{logMode}{ A logical argument to log10-transform FPKM values prior to plotting. } \item{pseudocount}{ Value to be added to FPKM for appropriate log transformation and clustering. (Avoids zero-based errors) } \item{heatscale}{ A list with min length=2, max length=3 that describe the the color scale. } \item{heatMidpoint}{ Value for midpoint of color scale. } \item{\dots}{ Additional arguments to csHeatmap } } \details{ None } \value{ A ggplot2 plot object with a geom_tile layer to display distance between samples or genes. } \references{ None } \author{ Loyal A. Goff, Cole Trapnell, and David Kelley } \note{ None } \examples{ data(sampleData) csDistHeat(sampleGeneSet) } \keyword{heatmap} \keyword{Jensen-Shannon} \keyword{distance} cummeRbund/man/csHeatmap.Rd0000644000175200017520000000611614516004263016651 0ustar00biocbuildbiocbuild\name{csHeatmap} \alias{csHeatmap} \alias{csFoldChangeHeatmap} \alias{csHeatmap,CuffFeatureSet-method} \alias{csFoldChangeHeatmap,CuffFeatureSet-method} \title{ csHeatmap } \description{ Creates a ggplot plot object with a geom_tile layer of FPKM values per feature and sample. } \usage{ \S4method{csHeatmap}{CuffFeatureSet}(object, rescaling='none', clustering='none', labCol=T, labRow=T, logMode=T, pseudocount=1.0, border=FALSE, heatscale= c(low='lightyellow',mid='orange',high='darkred'), heatMidpoint=NULL, fullnames = T, replicates=FALSE,method='none', ...) \S4method{csFoldChangeHeatmap}{CuffFeatureSet}(object, control_condition, replicate_num=NULL, clustering='none', labCol=T, labRow=T, logMode=F, pseudocount=1.0, border=FALSE, heatscale=c(low='steelblue',mid='white',high='tomato'), heatMidpoint=0,fullnames=T,replicates=FALSE,method='none',heatRange=3, ...) } \arguments{ \item{object}{ An object of class 'CuffFeatureSet' or 'CuffGeneSet' } \item{control_condition}{ A character argument indicating which condition should be used as the denominator for fold change. (e.g. "Day0", "Control", etc) } \item{replicate_num}{ If replicates == TRUE, you must specify both a control condition and a replicate number to use as the denominator. } \item{rescaling}{ Rescaling can either be 'row' or 'column' OR you can pass rescale a function that operates on a matrix to do your own rescaling. Default is 'none'. } \item{clustering}{ Clustering can either be 'row','column','none', or 'both', in which case the appropriate indices are re-ordered based on the pairwise Jensen-Shannon distance of FPKM values. } \item{labCol}{ A logical argument to display column labels. } \item{labRow}{ A logical argument to display row labels. } \item{logMode}{ A logical argument to log10-transform FPKM values prior to plotting. } \item{pseudocount}{ Value to be added to FPKM for appropriate log transformation and clustering. (Avoids zero-based errors) } \item{border}{ A logical argument to draw border around plot. } \item{heatscale}{ A list with min length=2, max length=3 that detail the low,mid,and high colors to build the color scale. } \item{heatMidpoint}{ Value for midpoint of color scale. } \item{fullnames}{ A logical value whether to use 'fullnames' (concatenated gene_short_name and gene_id) for rows in heatmap. Default [ TRUE ]. } \item{replicates}{ A logical value whether or not to plot individual replicates or aggregate condition values. } \item{method}{ Function to be used for clustering. Default is JS-distance. You can pass your own function to this argument as long as the output is an instance of the 'dist' class and is applied to the rows of the input matrix. } \item{heatRange}{ Numerical argument for upper bound on log fold change to be visualized. } \item{\dots}{ Additional arguments to csHeatmap } } \details{ None } \value{ A ggplot2 plot object with a geom_tile layer to display FPKM values by sample (x) and feature (y) } \references{ None. } \author{ Loyal A. Goff and Cole Trapnell } \note{ None } \examples{ data(sampleData) csHeatmap(sampleGeneSet) } \keyword{heatmap} cummeRbund/man/csScatter.Rd0000644000175200017520000000412414516004263016674 0ustar00biocbuildbiocbuild\name{csScatter} \alias{csScatter} \alias{csScatterMatrix} \alias{csScatter,CuffData-method} \alias{csScatterMatrix,CuffData-method} \alias{csScatter,CuffFeatureSet-method} \title{ Scatter Plot } \description{ A scatter plot comparing the FPKM values from two samples in a cuffdiff run. } \usage{ \S4method{csScatter}{CuffData}(object, x, y, logMode=TRUE, pseudocount=1.0, labels, smooth=FALSE, colorByStatus = FALSE, drawRug=TRUE, ...) \S4method{csScatterMatrix}{CuffData}(object,replicates=FALSE,logMode=TRUE,pseudocount=1.0, hexbin=FALSE, useCounts=FALSE, ...) } \arguments{ \item{object}{ An object of class ('CuffData','CuffFeatureSet') } \item{x}{ Sample name for x axis } \item{y}{ Sample name for y axis } \item{logMode}{ Logical argument to render axes on log10 scale (default: T ) } \item{replicates}{ Logical argument whether or not to draw individual replicate values instead of condition values. (default: T ) } \item{pseudocount}{ Value to add to zero FPKM values for log transformation (default: 0.0001) } \item{smooth}{ Logical argument to add a smooth-fit regression line } \item{labels}{ A list of tracking_ids or gene_short_names that will be 'callout' points in the plot for reference. Useful for finding genes of interest in the field. Not implemented yet. } \item{colorByStatus}{ A logical argument whether or not to color the points by 'significant' Y or N. [Default = FALSE] } \item{drawRug}{ A logical argument whether or not to draw the rug for x and y axes [Default = TRUE] } \item{hexbin}{ Logical value whether or not to visualize overplotting with hexbin. } \item{useCounts}{ Uses normalized counts instead of FPKM. } \item{\dots}{ Additional arguments to csScatter } } \details{ None } \value{ ggplot object with geom_point and geom_rug layers } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object from sample data genes<-a@genes #Create CuffData object for all genes s<-csScatter(genes,'hESC','Fibroblasts',smooth=TRUE) #Create plot object s #render plot object } cummeRbund/man/csSpecificity.Rd0000644000175200017520000000235314516004263017544 0ustar00biocbuildbiocbuild\name{csSpecificity} \alias{csSpecificity} \alias{csSpecificity,CuffFeatureSet-method} \alias{csSpecificity,CuffData-method} \title{ csSpecificity } \description{ Returns a matrix of 'Specificity scores' (S) defined as 1-JSD(p_g,q_i) where p_g is the Log10+1 expression profile of a gene g across all conditions j, collapsed into a probability distribution, and q_i is the unit vector of 'perfect expression' in a given condition i. } \usage{ \S4method{csSpecificity}{CuffFeatureSet}(object,logMode=T,pseudocount=1,relative=FALSE,...) \S4method{csSpecificity}{CuffData}(object,logMode=T,pseudocount=1,relative=FALSE,...) } \arguments{ \item{object}{ An object of class CuffFeatureSet, CuffGeneSet, or CuffData. } \item{logMode}{ A logical argument to log10-transform FPKM values prior to plotting. } \item{pseudocount}{ Value to be added to FPKM for appropriate log transformation and clustering. (Avoids zero-based errors) } \item{relative}{ A logical argument that when TRUE, will scale the S values from 0-1 by dividing by max(S) } \item{\dots}{ Additional arguments to fpkmMatrix. } } \details{ None } \author{ Loyal A. Goff } \source{ None } \references{ None. } \examples{ data(sampleData) csSpecificity(sampleGeneSet) } \keyword{datasets} cummeRbund/man/csVolcano.Rd0000644000175200017520000000375714516004263016703 0ustar00biocbuildbiocbuild\name{csVolcano} \alias{csVolcano} \alias{csVolcanoMatrix} \alias{csVolcano,CuffData-method} \alias{csVolcanoMatrix,CuffData-method} \alias{csVolcano,CuffFeatureSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Volcano Plot } \description{ Creates a volcano plot of log fold change in expression vs -log(pval) for a pair of samples (x,y) } \usage{ \S4method{csVolcano}{CuffData}(object, x, y, alpha=0.05, showSignificant=TRUE,features=FALSE, xlimits = c(-20, 20), ...) \S4method{csVolcanoMatrix}{CuffData}(object,alpha=0.05,xlimits=c(-20,20),mapping=aes(),...) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class CuffData, CuffFeatureSet, or CuffGeneSet } \item{x}{ Sample name from 'samples' table for comparison } \item{y}{ Sample name from 'samples' table for comparison } \item{alpha}{ Provide an alpha cutoff for visualizing significant genes } \item{showSignificant}{ A logical value whether or not to distinguish between significant features or not (by color). } \item{features}{ Will include all fields from 'features' slot in returned ggplot object. Useful for further manipulations of plot object using feature-level attributes (e.g. gene_type, class_code, etc) } \item{xlimits}{ Set boundaries for x limits to avoid infinity plotting errors. [Default c(-20,20)] } \item{mapping}{ Passthrough argument for ggplot aesthetics. Can be ignored completely. } \item{\dots}{ Additional arguments } } \details{ This creates a 'volcano' plot of fold change vs. significance for a pairwise comparison of genes or features across two different samples. } \value{ A ggplot2 plot object } \references{ None. } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object genes<-a@genes #Create cuffData object for all genes v<-csVolcano(genes,"hESC","Fibroblasts") # Volcano plot of all genes for conditions x='hESC' and y='Fibroblast' v #print plot } cummeRbund/man/cummeRbund-package.Rd0000644000175200017520000001235614516004263020441 0ustar00biocbuildbiocbuild\name{cummeRbund-package} \alias{cummeRbund-package} \alias{cummeRbund} \docType{package} \title{ cummeRbund: The finishing touch on your Tuxedo workflow. Analysis, manipulation, and visualization of Cufflinks HTS data. ~~ package title ~~ } \description{ Allows for persistent storage, access, and manipulation of Cufflinks high-throughput sequencing data. In addition, provides numerous plotting functions for commonly used visualizations. ~~ A concise (1-5 lines) description of the package ~~ } \details{ \tabular{ll}{ Package: \tab cummeRbund\cr Version: \tab 0.1.3\cr Suggests: \tab \cr Depends: \tab R (>= 2.7.0), RSQLite, reshape2, ggplot2, methods\cr License: \tab MIT License\cr Collate: \tab AllGenerics.R AllClasses.R database-setup.R methods-CuffSet.R methods-CuffData.R methods-CuffDist.R methods-CuffGeneSet.R methods-CuffFeatureSet.R methods-CuffGene.R methods-CuffFeature.R tools.R\cr LazyLoad: \tab yes\cr biocViews: \tab HighThroughputSequencing, HighThroughputSequencingData, RNAseq, RNAseqData, GeneExpression, DifferentialExpression, Infrastructure, DataImport, DataRepresentation, Visualization, Bioinformatics, Clustering, MultipleComparisons, QualityControl\cr Packaged: \tab 2011-08-05 18:03:50 UTC; lgoff\cr Built: \tab R 2.12.1; ; 2011-08-05 18:03:57 UTC; unix\cr } Index: \preformatted{ CuffData-class Class "CuffData" CuffDist-class Class "CuffDist" CuffFeature-class Class "CuffFeature" CuffFeatureSet-class Class "CuffFeatureSet" CuffGene-class Class "CuffGene" CuffGeneSet-class Class "CuffGeneSet" CuffSet-class Class "CuffSet" JSdist Jensen-Shannon distance on columns addFeatures addFeatures addFeatures-methods ~~ Methods for Function addFeatures in Package 'cummeRbund' ~~ createDB createDB csBoxplot csBoxplot csBoxplot-methods ~~ Methods for Function csBoxplot in Package 'cummeRbund' ~~ csDensity Density plot of CuffData csDensity-methods ~~ Methods for Function csDensity in Package 'cummeRbund' ~~ csHeatmap csHeatmap csHeatmap-methods ~~ Methods for Function csHeatmap in Package 'cummeRbund' ~~ csScatter Scatter Plot csScatter-methods ~~ Methods for Function csScatter in Package 'cummeRbund' ~~ csVolcano Volcano Plot csVolcano-methods ~~ Methods for Function csVolcano in Package 'cummeRbund' ~~ cummeRbund-package cummeRbund: The finishing touch on your Tuxedo workflow. Analysis, manipulation, and visualization of Cufflinks HTS data. diffData Differential comparison data diffData-methods ~~ Methods for Function diffData in Package 'cummeRbund' ~~ dim-methods ~~ Methods for Function dim in Package 'base' ~~ expressionBarplot Barplot expressionBarplot-methods ~~ Methods for Function expressionBarplot in Package 'cummeRbund' ~~ expressionPlot Expression Plot expressionPlot-methods ~~ Methods for Function expressionPlot in Package 'cummeRbund' ~~ featureNames Feature names featureNames-methods ~~ Methods for Function featureNames in Package 'cummeRbund' ~~ features Features features-methods ~~ Methods for Function features in Package 'cummeRbund' ~~ fpkm Retrieve FPKM values fpkm-methods ~~ Methods for Function fpkm in Package 'cummeRbund' ~~ fpkmMatrix Retrieve FPKM values as matrix fpkmMatrix-methods ~~ Methods for Function fpkmMatrix in Package 'cummeRbund' ~~ getGene getGene getGene-methods ~~ Methods for Function getGene in Package 'cummeRbund' ~~ getGenes getGenes getGenes-methods ~~ Methods for Function getGenes in Package 'cummeRbund' ~~ getLevels getLevels getLevels-methods ~~ Methods for Function getLevels in Package 'cummeRbund' ~~ length-methods ~~ Methods for Function length in Package 'base' ~~ makeprobs Transform a matrix into probabilities by columns readCufflinks readCufflinks samples Get sample list from CuffData object samples-methods ~~ Methods for Function samples in Package 'cummeRbund' ~~ shannon.entropy Shannon entropy } Further information is available in the following vignettes: \tabular{ll}{ \code{cummeRbund-manual} \tab An R package for visualization and analysis of Cufflinks high-throughput sequencing data (source, pdf)\cr } ~~ An overview of how to use the package, including the most important ~~ ~~ functions ~~ } \author{ L. Goff, C. Trapnell Maintainer: Loyal A. Goff } \references{ ~~ Literature or other references for background information ~~ } \keyword{ package } cummeRbund/man/diffData.Rd0000644000175200017520000000255314516004263016447 0ustar00biocbuildbiocbuild\name{diffData} \alias{diffData} \alias{diffData,CuffData-method} \alias{diffTable} \alias{diffTable,CuffData-method} \alias{diffTable,CuffFeatureSet-method} \title{ Differential comparison data } \description{ An accessor method to retrieve differential expression data from a 'CuffData', 'CuffFeatureSet', or 'CuffFeature' object } \usage{ \S4method{diffData}{CuffData}(object, x, y, features=FALSE) \S4method{diffTable}{CuffData}(object,logCutoffValue=99999) } \arguments{ \item{object}{ An object of class ('CuffData' or 'CuffFeatureSet') } \item{x}{ Optional, if x and y are both missing, data for all pairwise differential comparisons are returned, otherwise if x and y are sample names from the 'samples' table, than only differential data pertaining to those two samples are returned. } \item{y}{ See 'x' } \item{features}{ A logical value that returns all feature-level data as part of data.frame when true. object must be of class 'CuffData'. } \item{logCutoffValue}{ Cutoff value for FC estimates to convert to [-]Inf values. Should never really be needed... } \item{\dots}{ Additional arguments. } } \details{ None } \value{ A data.frame object } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) diff<-diffData(sampleGeneSet) #returns a dataframe of differential expression data from sample CuffGeneSet object. } cummeRbund/man/dimensionality.Rd0000644000175200017520000000413114516004263017767 0ustar00biocbuildbiocbuild\name{Dimensionality Reduction} \alias{MDSplot} \alias{MDSplot,CuffData-method} \alias{MDSplot,CuffFeatureSet-method} \alias{PCAplot} \alias{PCAplot,CuffData-method} \alias{PCAplot,CuffFeatureSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Dimensionality reduction utilities } \description{ Dimensionality reduction plots for feature selection and extraction for cummeRbund } \usage{ \S4method{MDSplot}{CuffData}(object,replicates=FALSE,logMode=TRUE,pseudocount=1.0) \S4method{PCAplot}{CuffData}(object,x="PC1", y="PC2",replicates=FALSE,pseudocount=1.0,scale=TRUE,showPoints = TRUE,...) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ The output of class CuffData from which to draw expression estimates. (e.g. genes(cuff)) } \item{x}{ For PCAplot, indicates which principal component is to be presented on the x-axis (e.g. "PC1","PC2","PC3", etc) } \item{y}{ See x. } \item{pseudocount}{ Value added to FPKM to avoid log transformation issues. } \item{logMode}{ Logical value whether or not to use log-transformed expression estimates (default: TRUE) } \item{replicates}{ A logical value to indicate whether or not individual replicate expression estimates will be used. } \item{scale}{ For PCAplot, a logical value passed directly to prcomp. } \item{showPoints}{ For PCAplot, a logical value whether or not to display individual gene values on final PCA plot. } \item{\dots}{ Additional passthrough arguments (may not be fully implemented yet). } } \details{ These methods attempt to project a matrix of expression estimates across conditions and/or replicates onto a smaller number of dimesions for feature selection, feature extraction, and can also be useful for outlier detection. } \value{ A ggplot2 object. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \examples{ cuff<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object from sample data p<-PCAplot(genes(cuff),x="PC2",y="PC3",replicates=TRUE) m<-MDSplot(genes(cuff),replicates=TRUE) p #Render PCA plot m #Render MDS plot } cummeRbund/man/dispersionPlot.Rd0000644000175200017520000000150014516004263017752 0ustar00biocbuildbiocbuild\name{dispersionPlot} \alias{dispersionPlot} \alias{dispersionPlot,CuffData-method} \alias{dispersionPlot,CuffSet-method} \title{ Mean count vs dispersion plot } \description{ A scatter plot comparing the mean counts against the estimated dispersion for a given level of features from a cuffdiff run. } \usage{ \S4method{dispersionPlot}{CuffData}(object) \S4method{dispersionPlot}{CuffSet}(object) } \arguments{ \item{object}{ An object of class ('CuffData') } } \details{ None } \value{ ggplot object with geom_point layer } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object from sample data genes<-genes(a) #Create CuffData object for all genes d<-dispersionPlot(genes) #Create plot object d #render plot object } cummeRbund/man/distValues.Rd0000644000175200017520000000163214516004263017065 0ustar00biocbuildbiocbuild\name{distValues} \alias{distValues} \alias{distValues,CuffDist-method} \title{ distValues } \description{ Returns a data.frame of distribution-level test values from a CuffDist object (@promoters, @splicing, @relCDS) } \usage{ \S4method{distValues}{CuffDist}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class 'CuffDist' } \item{\dots}{ Additional arguments to distValues } } \details{ None } \value{ Returns a data.frame of distribution-level test values. } \references{ None } \author{ Loyal A. Goff } \note{ None } \seealso{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) # Read cufflinks data and create CuffSet object distValues(a@promoters) # returns data.frame of values from CuffDist object in slot 'promoters' } % Add one or more standard keywords, see file 'KEYWORDS' in the % R documentation directory. cummeRbund/man/exploratory.Rd0000644000175200017520000000340314516004263017330 0ustar00biocbuildbiocbuild\name{Exploratory Analysis} \alias{csNMF} \alias{csNMF,CuffData-method} \alias{csNMF,CuffFeatureSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Methods for Exploratory Analysis in cummeRbund } \description{ Exploratory analysis methods for cummeRbund RNA-Seq data. } \usage{ \S4method{csNMF}{CuffData}(object,k,logMode=T,pseudocount=1,maxiter=1000,replicates=FALSE,fullnames=FALSE) \S4method{csNMF}{CuffFeatureSet}(object,k,logMode=T,pseudocount=1,maxiter=1000,replicates=FALSE,fullnames=FALSE) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ The output of class CuffData or CuffFeatureSet from which to draw expression estimates. (e.g. genes(cuff) or custom feature set via getGenes() or getFeatures() ) } \item{k}{ rank value for factorization } \item{logMode}{ Logical value whether or not to use log-transformed FPKM values. [Default: TRUE] } \item{pseudocount}{ Value added to FPKM to avoid log transformation issues. } \item{maxiter}{ Maximum number of iterations for factorization [Default: 1000] } \item{replicates}{ A logical value to indicate whether or not individual replicate expression estimates will be used. } \item{fullnames}{ Logical passthrough value to fpkmMatrix whether or not to concatenate gene_short_name with tracking_id. [Default: FALSE] } } \details{ csNMF is a convenience method to invoke the nnmf() method from package:NMFN. This performs non-negative matrix factorization on the provided data and can be useful for many downstream applications. } \value{ csNMF returns W, H - decomposed matrices of input FPKM values. (See package:NMFN for details) } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \examples{ data(sampleData) csNMF(sampleGeneSet,4) } cummeRbund/man/expressionBarplot.Rd0000644000175200017520000000310614516004263020463 0ustar00biocbuildbiocbuild\name{expressionBarplot} \alias{expressionBarplot} \alias{expressionBarplot,CuffFeature-method} \alias{expressionBarplot,CuffFeatureSet-method} \title{ Barplot } \description{ A barplot of FPKM values with confidence intervals for a given gene, set of genes, or features of a gene (e.g. isoforms, TSS, CDS, etc). } \usage{ \S4method{expressionBarplot}{CuffFeatureSet}(object, logMode=TRUE, pseudocount=1.0, showErrorbars=TRUE, showStatus=TRUE, replicates=FALSE, ...) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class ('CuffFeatureSet','CuffGeneSet','CuffFeature','CuffGene') } \item{logMode}{ A logical value whether or not to draw y-axis on log10 scale. Default = FALSE. } \item{pseudocount}{ Numerical value added to each FPKM during log-transformation to avoid errors. } \item{showErrorbars}{ A logical value whether or not to draw error bars. Default = TRUE } \item{showStatus}{ A logical value whether or not to draw visual queues for quantification status of a given gene:condition. Default = TRUE } \item{replicates}{ A logical value whether or not to plot individual replicates or aggregate condition values. } \item{\dots}{ Additional arguments. } } \details{ None } \value{ A ggplot2 plot object } \references{ None } \author{ Loyal A. Goff } \note{ Need to implement logMode and features for this plotting method. } \examples{ data(sampleData) PINK1 # sample CuffFeature object expressionBarplot(PINK1) #Barplot of PINK1 FPKM values expressionBarplot(PINK1@isoforms) #Barplot of PINK1 FPKM values faceted by isoforms } cummeRbund/man/expressionPlot.Rd0000644000175200017520000000335514516004263020004 0ustar00biocbuildbiocbuild\name{expressionPlot} \alias{expressionPlot} \alias{expressionPlot,CuffFeature-method} \alias{expressionPlot,CuffFeatureSet-method} \title{ Expression Plot } \description{ A line plot (optionally with confidence intervals) detailing FPKM expression levels across conditions for a given gene(s) or feature(s) } \usage{ \S4method{expressionPlot}{CuffFeature}(object, logMode=FALSE, pseudocount=1.0, drawSummary=FALSE, sumFun=mean_cl_boot, showErrorbars=TRUE, showStatus=TRUE, replicates=FALSE, facet = TRUE,...) } \arguments{ \item{object}{ An object of class ('CuffFeature' or 'CuffGene') } \item{logMode}{ A logical value to draw y-axis (FPKM) on log-10 scale. Default = FALSE. } \item{pseudocount}{ A numeric value added to FPKM to avoid errors on log-10 transformation. } \item{drawSummary}{ A logical valuie. Draws a 'summary' line with mean FPKM values for each condition. } \item{sumFun}{ Function used to determine values for summary line. Default = mean_cl_boot } \item{showErrorbars}{ A logical value whether or not to draw error bars. } \item{showStatus}{ A logical value whether or not to draw visual queues for quantification status of a given gene:condition. Default = TRUE } \item{replicates}{ A logical value whether or not to plot individual replicates or aggregate condition values. } \item{facet}{ A logical value whether or not to facet the plot by feature id (default=TRUE). } \item{\dots}{ Additional arguments } } \details{ None } \value{ A ggplot2 plot object } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) PINK1 # sample CuffFeature object expressionPlot(PINK1) #Line plot of PINK1 FPKM values expressionPlot(PINK1@isoforms) #Line plot of PINK1 FPKM values faceted by isoforms } cummeRbund/man/featureNames.Rd0000644000175200017520000000074414516004263017364 0ustar00biocbuildbiocbuild\name{featureNames} \alias{featureNames,CuffData-method} \title{ Feature names } \description{ Retrive a vector of feature names from a 'CuffData' or 'CuffFeatureSet' object } \usage{ \S4method{featureNames}{CuffData}(object) } \arguments{ \item{object}{ An object of class ('CuffData' or 'CuffFeatureSet') } } \details{ None } \value{ A list of feature names } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) featureNames(sampleGeneSet) } cummeRbund/man/features.Rd0000644000175200017520000000106714516004263016562 0ustar00biocbuildbiocbuild\name{features} \alias{features} \alias{features,CuffGene-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Features } \description{ Returns a data frame of features from a CuffGene object } \usage{ \S4method{features}{CuffGene}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class ('CuffGene') } } \details{ None } \value{ A data.frame of feature-level information } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) features(PINK1) } cummeRbund/man/findGene.Rd0000644000175200017520000000224514516004263016462 0ustar00biocbuildbiocbuild\name{findGene} \alias{findGene} \alias{findGene,CuffSet-method} \title{ findGene } \description{ A helper function to retrieve the gene_ids given a 'lookup' value (e.g. gene_short_name, isoform_id, etc). Utility to search for gene_id and gene_short_name given a single 'query' string (e.g. query='pink1' will return all genes with 'pink1' (case-insensitive) in the gene_short_name field. } \usage{ \S4method{findGene}{CuffSet}(object, query) } \arguments{ \item{object}{ An object of class 'CuffSet' (Primary 'pointer' object for Cufflinks data). } \item{query}{ A character string for which you would like to retrieve corresponding gene_id values. } } \details{ None. } \value{ Returns a data.frame of gene_id and gene_short_name values corresponding to genes from which 'query' matches } \references{ None. } \author{ Loyal A. Goff } \note{ Right now, this does not return an error if it cannot find a gene. (this is probably a bad thing...) } \examples{ cuff<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create master CuffSet object myQuery<-'pink1' findGene(cuff,myQuery) # Retrieve gene_id values for any genes matching 'pink1' } cummeRbund/man/findSimilar.Rd0000644000175200017520000000273414516004263017207 0ustar00biocbuildbiocbuild\name{findSimilar} \alias{findSimilar} \alias{findSimilar,CuffSet-method} \title{ findSimilar } \description{ Returns a CuffGeneSet containing n genes with the most similar expression profiles to gene/profile x. } \usage{ \S4method{findSimilar}{CuffSet}(object, x, n,distThresh,returnGeneSet=TRUE,...) } \arguments{ \item{object}{ A object of class 'CuffSet' } \item{x}{ A 'gene_id' or 'gene_short_name' from which to look up an expression profile OR a vector of expression values to compare all genes (vector must have same length and order of 'samples') } \item{n}{ Number of similar genes to return } \item{distThresh}{ A thresholding value on which to filter results based on JS-distance (e.g. A distThresh of 1.0 will return all genes, 0.0 will return those genes with 'perfect identity' to the gene of interest.) } \item{returnGeneSet}{ A logical value whether to return a CuffGeneSet object [default] or a distance-ranked data frame of similar genes. The latter is useful if you want to explore the returned list based on distances. } \item{\dots}{ Additional arguments to fpkmMatrix call within findSimilar (e.g. fullnames=T) } } \details{ By default, returns a CuffGeneSet object with n similar genes. This may change in the future. } \value{ A CuffGeneSet object of n most similar genes to x. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) mySimilarGenes<-findSimilar(a,"PINK1",10) }cummeRbund/man/fpkm.Rd0000644000175200017520000000137314516004263015701 0ustar00biocbuildbiocbuild\name{fpkm-methods} \docType{methods} \alias{fpkm} \alias{fpkm-methods} \alias{fpkm,CuffData-method} \alias{fpkm,CuffFeature-method} \alias{fpkm,CuffFeatureSet-method} \title{ Retrieve FPKM values } \description{ Returns a data.frame from @FPKM slot } \section{Methods}{ \describe{ \item{\code{signature(object = "CuffData")}}{ %% ~~describe this method here~~ } \item{\code{signature(object = "CuffFeature")}}{ %% ~~describe this method here~~ } \item{\code{signature(object = "CuffFeatureSet")}}{ %% ~~describe this method here~~ } }} \details{ Returns a data.frame of FPKM values. } \value{ A data.frame of FPKM-level values for a set of features. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) fpkm(PINK1) }cummeRbund/man/fpkmMatrix.Rd0000644000175200017520000000233514516004263017065 0ustar00biocbuildbiocbuild\name{fpkmMatrix} \alias{fpkmMatrix} \alias{fpkmMatrix,CuffData-method} \alias{fpkmMatrix,CuffFeatureSet-method} \alias{repFpkmMatrix} \alias{repFpkmMatrix,CuffData-method} \alias{repFpkmMatrix,CuffFeatureSet-method} \alias{repFpkmMatrix,CuffFeature-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ fpkmMatrix } \description{ Retrieve FPKM values as gene by condition (fpkmMatrix) or gene by replicate (repFpkmMatrix) matrix } \usage{ \S4method{fpkmMatrix}{CuffData}(object,fullnames=FALSE,sampleIdList) \S4method{repFpkmMatrix}{CuffData}(object,fullnames=FALSE,repIdList) } \arguments{ \item{object}{ An object of class ('CuffData','CuffFeatureSet','CuffGeneSet','CuffGene',or 'CuffFeature') } \item{fullnames}{ A logical value whether or not to concatenate gene_short_name and tracking_id values (easier to read labels) } \item{sampleIdList}{ A vector of sample names to subset the resulting matrix. } \item{repIdList}{ A vector of sample names to subset the resulting matrix. } } \details{ None. } \value{ A feature x condition matrix of FPKM values. } \references{ None. } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) fpkmMatrix(sampleGeneSet) repFpkmMatrix(sampleGeneSet) } cummeRbund/man/getFeatures.Rd0000644000175200017520000000267714516004263017232 0ustar00biocbuildbiocbuild\name{getFeatures} \alias{getFeatures} \alias{getFeatures,CuffSet-method} \title{ getFeatures } \description{ Primary accessor from a CuffSet object to retrieve all related information for >1 (MANY) given FEATURES, indexed by tracking id. } \usage{ \S4method{getFeatures}{CuffSet}(object, featureIdList, sampleIdList=NULL,level='isoforms') } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class 'CuffSet' (Primary 'pointer' object for Cufflinks data). } \item{featureIdList}{ A vector of 'isoform_id', 'TSS_group_id', or 'CDS_id' to identify which features for which you would like to retrieve all information. } \item{sampleIdList}{ A vector of sample names used to subset or re-order samples in returned object } \item{level}{ Feature level to be queried for significance (must be one of c('isoforms','TSS','CDS') } } \details{ None. } \value{ Returns a CuffFeatureSet object containing all related information for a given set of tracking_id values } \references{ None. } \author{ Loyal A. Goff } \note{ Right now, this does not return an error if it cannot find a gene. (this is probably a bad thing...) } \examples{ cuff<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create master CuffSet object sample.isoform.ids<-sample(featureNames(isoforms(cuff)),10) myGene<-getFeatures(cuff,sample.isoform.ids) # Retrieve all information for a set of 10 sampled features. }cummeRbund/man/getGene.Rd0000644000175200017520000000214514516004263016320 0ustar00biocbuildbiocbuild\name{getGene} \alias{getGene} \alias{getGene,CuffSet-method} \title{ getGene } \description{ Primary accessor from a CuffSet object to retrive all related information for 1 (one) given gene, indexed by gene_id or gene_short_name. } \usage{ \S4method{getGene}{CuffSet}(object, geneId, sampleIdList=NULL) } \arguments{ \item{object}{ An object of class 'CuffSet' (Primary 'pointer' object for Cufflinks data). } \item{geneId}{ A character string to identify which gene for which you would like to retrieve all information. } \item{sampleIdList}{ A vector of sample names used to subset or re-order samples in returned object } } \details{ None. } \value{ Returns a CuffGene object containing all related information for a given gene_id or gene_short_name } \references{ None. } \author{ Loyal A. Goff } \note{ Right now, this does not return an error if it cannot find a gene. (this is probably a bad thing...) } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create master CuffSet object myGene<-getGene(a,"PINK1") # Retrieve all information for gene "PINK1" } cummeRbund/man/getGeneId.Rd0000644000175200017520000000221414516004263016572 0ustar00biocbuildbiocbuild\name{getGeneId} \alias{getGeneId} \alias{getGeneId,CuffSet-method} \title{ getGene } \description{ A helper function to retrieve the gene_ids for a given list of feature ids (e.g. isoform_ids, tss_group_ids, or CDS_ids). This should not be called directly by the user } \usage{ \S4method{getGeneId}{CuffSet}(object, idList) } \arguments{ \item{object}{ An object of class 'CuffSet' (Primary 'pointer' object for Cufflinks data). } \item{idList}{ A character string to identify the identifiers for which you would like to retrieve corresponding gene_id values. } } \details{ None. } \value{ Returns a vector of gene_id values corresponding to genes from which idList are sub-features. } \references{ None. } \author{ Loyal A. Goff } \note{ Right now, this does not return an error if it cannot find a gene. (this is probably a bad thing...) } \examples{ cuff<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create master CuffSet object sampleFeatureIds<-sample(featureNames(isoforms(cuff)),10) correspondingGeneIds<-getGeneId(cuff,sampleFeatureIds) # Retrieve gene_id values for parent genes of sampleFeatureIds. } cummeRbund/man/getGenes.Rd0000644000175200017520000000240214516004263016477 0ustar00biocbuildbiocbuild\name{getGenes} \alias{getGenes} \alias{getGenes,CuffSet-method} \title{ getGenes } \description{ Primary accessor from a CuffSet object to retrive all related information for >1 (MANY) given genes, indexed by gene_id or gene_short_name. } \usage{ \S4method{getGenes}{CuffSet}(object, geneIdList, sampleIdList=NULL) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class 'CuffSet' (Primary 'pointer' object for Cufflinks data). } \item{geneIdList}{ A vector of gene_ids or gene_short_namesto identify which genes for which you would like to retrieve all information. } \item{sampleIdList}{ A vector of sample names used to subset or re-order samples in returned object } } \details{ None. } \value{ Returns a CuffGeneSet object containing all related information for a given set of gene_id or gene_short_name values } \references{ None. } \author{ Loyal A. Goff } \note{ Right now, this does not return an error if it cannot find a gene. (this is probably a bad thing...) } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data and create master CuffSet object data(sampleData) sampleIDs myGene<-getGenes(a,sampleIDs) # Retrieve all information for a set of 20 'sample' genes. }cummeRbund/man/getLevels.Rd0000644000175200017520000000117114516004263016672 0ustar00biocbuildbiocbuild\name{getLevels} \alias{getLevels} \alias{getLevels,CuffSet-method} \alias{getLevels,CuffData-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ getLevels } \description{ Returns a list of samples as levels. This should not be called directly by user. } \usage{ \S4method{getLevels}{CuffData}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class 'CuffData' or 'CuffFeatureSet' or 'CuffFeature' } } \details{ For internal usage only. } \value{ A vector of sample names as factors. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } cummeRbund/man/getRepLevels.Rd0000644000175200017520000000120014516004263017332 0ustar00biocbuildbiocbuild\name{getRepLevels} \alias{getRepLevels} \alias{getRepLevels,CuffSet-method} \alias{getRepLevels,CuffData-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ getRepLevels } \description{ Returns a list of replicate samples as levels. This should not be called directly by user. } \usage{ \S4method{getRepLevels}{CuffData}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class 'CuffSet' or 'CuffData' } } \details{ For internal usage only. } \value{ A vector of replicate names as factors. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } cummeRbund/man/getSig.Rd0000644000175200017520000000404414516004263016164 0ustar00biocbuildbiocbuild\name{getSig} \alias{getSig} \alias{getSig,CuffSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ getSig } \description{ Returns the identifiers of significant genes in a vector format. } \usage{ \S4method{getSig}{CuffSet}(object,x,y,alpha=0.05,level='genes',method="BH", useCuffMTC=FALSE) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ A CuffSet object (e.g. cuff) } \item{x}{ Optional argument to restrict significance results to one pairwise comparison. Must be used with a 'y' argument to specificy the other half of the pair. } \item{y}{ See x. } \item{alpha}{ An alpha value by which to filter multiple-testing corrected q-values to determine significance } \item{level}{ Feature level to be queried for significance (must be one of c('genes','isoforms','TSS','CDS') } \item{method}{ Multiple testing method to be used for correction. (default: "BH") } \item{useCuffMTC}{ Logical vector whether or not to use the multiple-testing corrected q-values from the cuffdiff analysis directly, or calculate new q-values from a subset of tests. } } \details{ This is a convenience function to quickly retrieve vectors of identifiers for genes or features that were determined to be significantly regulated between conditions by cuffdiff. This function only returns tracking IDs that correspond to tests with an 'OK' status from cuffdiff, NOTEST values are ignored. By default getSig returns a vector of IDs for all pairwise comparisons together. If you specify an 'x' AND 'y' values as sample names, then only the features that are significant in that particular pairwise comparison are reported, after appropriate multiple testing correction of output p-values. } \value{ A vector of feature IDs. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data in sample directory and creates CuffSet object 'a' mySig<-getSig(a,x='hESC',y='Fibroblasts',alpha=0.05,level='genes') head(mySig) } cummeRbund/man/getSigTable.Rd0000644000175200017520000000326614516004263017141 0ustar00biocbuildbiocbuild\name{getSigTable} \alias{getSigTable} \alias{getSigTable,CuffSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ getSigTable } \description{ Returns the identifiers of significant genes in a test table - like format. } \usage{ \S4method{getSigTable}{CuffSet}(object,alpha=0.05,level='genes') } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ A CuffSet object (e.g. cuff) } \item{alpha}{ An alpha value by which to filter multiple-testing corrected q-values to determine significance } \item{level}{ Feature level to be queried for significance (must be one of c('genes','isoforms','TSS','CDS') } } \details{ This is a convenience function to quickly retrieve lists of identifiers for genes or features that were determined to be significantly regulated between conditions by cuffdiff. This function only returns tracking IDs that correspond to tests with an 'OK' status from cuffdiff, NOTEST values are ignored or reported as NA. By default getSig returns a table of genes x conditions, where the column names represent the pairwise comparisons from the cuffdiff analysis. The values in the table are 1 for features that are significant for this comparison and 0 for genes that are not, any failed tests are reported as .Only includes the features that are significant in at least one comparison. } \value{ A data.frame of pairwise test results. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data in sample directory and creates CuffSet object 'a' mySigTable<-getSigTable(a,alpha=0.05,level='genes') head(mySigTable) } cummeRbund/man/makeprobs.Rd0000644000175200017520000000155414516004263016730 0ustar00biocbuildbiocbuild\name{makeprobs} \alias{makeprobs} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Transform a matrix into probabilities by columns } \description{ This function takes a matrix of expression values (must be greater than 0) and returns a matrix of probabilities by column. This is a required transformation for the Jensen-Shannon distance which is a metric that operates on probabilities. } \usage{ makeprobs(a) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{a}{ A matrix of expression values (values must be greater than 0). } } \details{ To make a matrix of probabilities by row, use t() to transpose prior to calling makeprobs. } \value{ A matrix of expression probabilities by column. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ myMat<-matrix(sample(1:50,50),10) probs<-makeprobs(myMat) } cummeRbund/man/makeprobsvec.Rd0000644000175200017520000000071414516004263017423 0ustar00biocbuildbiocbuild\name{makeprobsvec} \alias{makeprobsvec} \title{ makeprobsvec } \description{ Sums a vector of numerics and divides by the sum } \usage{ makeprobsvec(p) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{p}{ A vector of numerics } } \details{ None } \value{ A vector of probabilities } \references{ None } \author{ Loyal A. Goff } \note{ Should not be called directly by user. } \examples{ p<-sample(1:5000,20) makeprobsvec(p) } cummeRbund/man/readCufflinks.Rd0000644000175200017520000001014614516004263017522 0ustar00biocbuildbiocbuild\name{readCufflinks} \alias{readCufflinks} %- Also NEED an '\alias' for EACH other topic documented here. \title{ readCufflinks } \description{ This initializes the backend SQLite table and provides a DB connection for all downstream data analysis. } \usage{ readCufflinks(dir = getwd(), dbFile = "cuffData.db", gtfFile = NULL, runInfoFile = "run.info", repTableFile = "read_groups.info", geneFPKM = "genes.fpkm_tracking", geneDiff = "gene_exp.diff", geneCount="genes.count_tracking", geneRep="genes.read_group_tracking", isoformFPKM = "isoforms.fpkm_tracking", isoformDiff = "isoform_exp.diff", isoformCount="isoforms.count_tracking", isoformRep="isoforms.read_group_tracking", TSSFPKM = "tss_groups.fpkm_tracking", TSSDiff = "tss_group_exp.diff", TSSCount="tss_groups.count_tracking", TSSRep="tss_groups.read_group_tracking", CDSFPKM = "cds.fpkm_tracking", CDSExpDiff = "cds_exp.diff", CDSCount="cds.count_tracking", CDSRep="cds.read_group_tracking", CDSDiff = "cds.diff", promoterFile = "promoters.diff", splicingFile = "splicing.diff", varModelFile = "var_model.info", driver = "SQLite", genome = NULL, rebuild = FALSE,verbose=FALSE, ...) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{dir}{ Directory in which all CuffDiff output files can be located. Defaults to current working directory. } \item{dbFile}{ Name of backend database. Default is 'cuffData.db' } \item{gtfFile}{ Path to .gtf file used in cuffdiff analysis. This file will be parsed to retrieve transcript model information. } \item{runInfoFile}{ run.info file } \item{repTableFile}{ read_groups.info file } \item{geneFPKM}{ genes.fpkm_tracking file } \item{geneDiff}{ gene_exp.diff file } \item{geneCount}{ genes.count_tracking file } \item{geneRep}{ genes.read_group_tracking file } \item{isoformFPKM}{ isoforms.fpkm_tracking file } \item{isoformDiff}{ isoform_exp.diff file } \item{isoformCount}{ isoforms.count_tracking file } \item{isoformRep}{ isoform.read_group_tracking file } \item{TSSFPKM}{ tss_groups.fpkm_tracking file } \item{TSSDiff}{ tss_group_exp.diff file } \item{TSSCount}{ tss_groups.count_tracking file } \item{TSSRep}{ tss_groups.read_group_tracking file } \item{CDSFPKM}{ cds.fpkm_tracking file } \item{CDSExpDiff}{ cds_exp.diff file } \item{CDSCount}{ cds.count_tracking file } \item{CDSRep}{ cds.read_group_tracking file } \item{CDSDiff}{ cds.diff file (distribution tests on CDS) } \item{promoterFile}{ promoters.diff file (distribution tests on promoters) } \item{splicingFile}{ splicing.diff (distribution tests on isoforms) } \item{varModelFile}{ varModel.info (emitted in cuffdiff >= v2.1) } \item{driver}{ Driver for backend database. (Currently only "SQLite" is supported). } \item{genome}{ A character string indicating to which genome build the .gtf annotations belong (e.g. 'hg19' or 'mm9') } \item{rebuild}{ A logical argument to rebuild database backend. } \item{verbose}{ A logical argument for super verbose reporting (As if it wasn't enough already!) } \item{\dots}{ Additional arguments to readCufflinks } } \details{ This is the initialization function for the cummeRbund package. It creates the SQLite backend database, populates the data, and provides a connection object for all future interactions with the dataset. Once the initial build is complete, this function will default to using the database for all future sessions. IMPORTANT: - Each R session should begin with a call to readCufflinks to re-open the connection to the database. - Should any connectivity issues to the database arise, another call to readCufflinks should create a new connection object and repair any issue. - The database can always be rebuild (using rebuild=TRUE) from the original CuffDiff output files. } \value{ A CuffSet object. A 'pointer' class that allows interaction with cufflinks/cuffdiff data via a SQLite database backend. } \references{ None. } \author{ Loyal A. Goff } \note{ None. } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Read cufflinks data in sample directory and creates CuffSet object 'a' } cummeRbund/man/repFpkm.Rd0000644000175200017520000000153314516004263016346 0ustar00biocbuildbiocbuild\name{repFpkm-methods} \docType{methods} \alias{repFpkm} \alias{repFpkm-methods} \alias{repFpkm,CuffData-method} \alias{repFpkm,CuffFeature-method} \alias{repFpkm,CuffFeatureSet-method} \title{ Retrieve FPKM values } \description{ Returns a data.frame from @repFpkm slot } \section{Methods}{ \describe{ \item{\code{signature(object = "CuffData")}}{ %% ~~describe this method here~~ } \item{\code{signature(object = "CuffFeature")}}{ %% ~~describe this method here~~ } \item{\code{signature(object = "CuffFeatureSet")}}{ %% ~~describe this method here~~ } }} \details{ Returns a data.frame of replicate FPKM values and associated statistics. } \value{ A data.frame of replicate-level FPKM values and associated statistics for a set of features. } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ data(sampleData) repFpkm(PINK1) }cummeRbund/man/replicates.Rd0000644000175200017520000000161414516004263017075 0ustar00biocbuildbiocbuild\name{replicates} \alias{replicates} \alias{replicates,CuffSet-method} \alias{replicates,CuffData-method} \alias{replicates,CuffFeatureSet-method} \alias{replicates,CuffFeature-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Get replicate sample list from CuffData object } \description{ Returns a list of replicate names from a CuffData or CuffFeatureSet object } \usage{ \S4method{replicates}{CuffData}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class ('CuffSet','CuffData') } } \details{ None } \value{ A list of replicate sample names } \references{ None } \author{ Loyal A. Goff } \note{ None } %% ~Make other sections like Warning with \section{Warning }{....} ~ \seealso{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object replicates(a@genes) } cummeRbund/man/runInfo.Rd0000644000175200017520000000137414516004263016365 0ustar00biocbuildbiocbuild\name{runInfo} \alias{runInfo} \alias{runInfo,CuffSet-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Retrieve run parameters and information from a CuffSet object } \description{ Returns a data.frame of cuffdiff run parameters and information } \usage{ \S4method{runInfo}{CuffSet}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class ('CuffSet') } } \details{ None } \value{ A data.frame of run parameters } \references{ None } \author{ Loyal A. Goff } \note{ None } %% ~Make other sections like Warning with \section{Warning }{....} ~ \seealso{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object runInfo(a) } cummeRbund/man/sampleGeneSet.Rd0000644000175200017520000000102214516004263017467 0ustar00biocbuildbiocbuild\name{sampleGeneSet} \alias{sampleGeneSet} \docType{data} \title{ sampleGeneSet } \description{ A sample CuffGeneSet data set for 20 genes. } \usage{data(sampleData)} \format{ sampleGeneSet is a CuffGeneSet (extends CuffFeatureSet) object containing all sample gene-, isoform-, TSS-, and CDS-level data for 20 different genes. These data were derived from a toy set of hESC-vs-iPSC-vs-Fibroblast RNA-Seq expression data. } \details{ None } \source{ None } \references{ None } \examples{ data(sampleData) } \keyword{datasets} cummeRbund/man/sampleIDs.Rd0000644000175200017520000000047714516004263016631 0ustar00biocbuildbiocbuild\name{sampleIDs} \alias{sampleIDs} \docType{data} \title{ sampleIDs } \description{ A vector of gene_ids used to create 'sampleGeneSet' example } \usage{data(sampleData)} \format{ The format is: chr "sampleIDs" } \details{ None } \source{ None } \references{ None } \examples{ data(sampleData) } \keyword{datasets} cummeRbund/man/samples.Rd0000644000175200017520000000145114516004263016405 0ustar00biocbuildbiocbuild\name{samples} \alias{samples} \alias{samples,CuffSet-method} \alias{samples,CuffData-method} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Get sample list from CuffData object } \description{ Returns a list of sample names from a CuffData or CuffFeatureSet object } \usage{ \S4method{samples}{CuffData}(object) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class ('CuffData','CuffFeatureSet','CuffFeature') } } \details{ None } \value{ A list of sample names } \references{ None } \author{ Loyal A. Goff } \note{ None } %% ~Make other sections like Warning with \section{Warning }{....} ~ \seealso{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object samples(a@genes) } cummeRbund/man/shannon.entropy.Rd0000644000175200017520000000114614516004263020105 0ustar00biocbuildbiocbuild\name{shannon.entropy} \alias{shannon.entropy} %- Also NEED an '\alias' for EACH other topic documented here. \title{ Shannon entropy } \description{ Calculates the Shannon entropy for a probability distribution } \usage{ shannon.entropy(p) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{p}{ A vector of probabilities (must sum to ~1) } } \details{ None } \value{ Returns a numeric value for the Shannon entropy of the supplied probability distribution } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ x<-sample(1:500,50) p<-x/sum(x) shannon.entropy(p) } cummeRbund/man/sigMatrix.Rd0000644000175200017520000000237214516004263016713 0ustar00biocbuildbiocbuild\name{sigMatrix} \alias{sigMatrix} \alias{sigMatrix,CuffSet-method} \title{ sigMatrix } \description{ Returns a ggplot2 plot object representing a matrix of significant features. This is a useful synopsis of all significant pairwise comparisons within the dataset. } \usage{ \S4method{sigMatrix}{CuffSet}(object,alpha=0.05,level='genes',orderByDist=FALSE) } %- maybe also 'usage' for other objects documented here. \arguments{ \item{object}{ An object of class CuffSet. } \item{alpha}{ An alpha value by which to filter multiple-testing corrected q-values to determine significance } \item{level}{ Feature level to be queried for significance (must be one of c('genes','isoforms','TSS','CDS') } \item{orderByDist}{ Logical. If TRUE then samples are re-ordered based on JS-distance from one another (fairly useless unless you have a specific need for this). } } \details{ Creates a matrix plot to illustrate the number of significant features of type 'level' at a given alpha from a cuffdiff run. } \value{ A ggplot2 plot object } \references{ None } \author{ Loyal A. Goff } \note{ None } \examples{ a<-readCufflinks(system.file("extdata", package="cummeRbund")) #Create CuffSet object from sample data d<-sigMatrix(a) #Create csDensity plot d #Render plot } cummeRbund/vignettes/0000755000175200017520000000000014516027267015717 5ustar00biocbuildbiocbuildcummeRbund/vignettes/ENCODE_SCV.pdf0000644000175200017520000006755414516004263020072 0ustar00biocbuildbiocbuild%PDF-1.4 %âãÏÓ\r 1 0 obj << /CreationDate (D:20120917131218) /ModDate (D:20120917131218) /Title (R Graphics Output) /Producer (R 2.15.0) /Creator (R) >> endobj 2 0 obj << /Type /Catalog /Pages 3 0 R >> endobj 7 0 obj << /Type /Page /Parent 3 0 R /Contents 8 0 R /Resources 4 0 R >> endobj 8 0 obj << /Length 24201 /Filter /FlateDecode >> stream xœÍ}K³e·mõ¼Å~øšïÇT*Y.;J%iŤR)—#'år;N4Èßÿb-<}ÜêVlÉ·ÌsÏconraXãË/^âËï^þûÍ?œÿ½„×ôŸÚ›ûÏÿ|óòÏ/xóÓoÿñËÏ^~ó훸^ /þßoÃ?þöÉŸß~þwòj{ùß7ÿò¯/áåßßÄ—_¬ÿýîMÜ?÷Õ›ýŸŸ<ÿíÏüEî -ý5…—<_gz©±¼–õö_ÛøÈKýàç{î$¼Î!3rþ}ÿNÂÃèwÇX_G~y÷¦¶õ½6þý›·xCªíµ¦óŒÏòÜÿ±7`|ÞPsó¼cyC¬ñ5%Üà;ñ>yCŽéµL{†î ¥ç×Þì º7„õ[ãÅÿ+S^K>S£×Yª|·]¦ÏmÄÑ^ãp3¥c7©½Žæ&BÇç ¥õ×ZÝ/èXÞÐÃkv:r7‘r|ÕþŽ¡Ÿ§™_ã™H Ýj-¯ùL$†î ?ýòmªýå?¾•ÅÔóš«Òö¿©ï¥¨×”F}mrkÑ×µÖŒ¸>?ÖsIkm¬ÿŽ×\^R¯Mîo–×Ô^RZŸíkC™Kq¿,ã5“ë˺&ù²¸žrH/qÖ×®ãþ:ËšðñÚåëbÊ2±qä×¼¿/Í×>^b:ß1¯®Ô‹\ë—u—ëûÖ-ô°ÇkÞ×÷­‹ûó5¿–ºÆY&GÆS¾8®ÉÉû󭾦ù"/—ýù¾–i\ã.OAÆý5æ5n²ªÖx]XXß·æxî÷¯ ŸëûÖÏì×| ù¾õýò÷´æcÍb,S~FÆíu=¹Ì$÷ŸÖ|¬yŒkEƲÇãu=ªXÖ÷Éõ¥Td©Êmf¹ž”×c[ß·vßïÏí5¯ï[cÏW*é5­ïËØ¨©Œ×¸¾o½-îß_Ö÷­iLûûÚ†Œ˜ñ|Òš5Q1g\ÿš±æ3¯¯Í{ÜeƵJƒÜoZó± KÓØ¿?æÞ@ièâKëA/H‰©ë÷çeŵBÚã."®ÛÜÏ?Çüšäû²–±^_²æ3®ŸÉ{©žyX+gšFP”À,Ž(ÏÎ&yñþf<ƒµóöÇ#ZßPóy‚ ÌS:x û8ÏÙ7½ ]k¸Ñ«g,ðÌgq­áÆF¬½5Ô¯Ò¥¹PŸ¼®Ü5Ü {ÁÁžg¬û5ÜËÛbý»Ÿ*vÍÈaSÍ…9åì¹e÷6¤aKŠá)gÇ.œÑ ªzý\žg¿/ÞRêƒ9°-æÔÍF0 x ›°#­ñ¶Œ«”NÌB–{=`·Æ{ý —1ÜÜ€`*À`*›§9°•¯õ`,›!8°^›aG‚y8ì×e†îŒ€OsÆbÕ6Þ4& KqÆf-û01š±Z`¼1[oÓû±KU3aÚ6õËe,zrÆtýlõÆvmÊœ1^ÆjVg¬eGgÌKPãIc¿ns¯X’‚ù&YXÓ²×;ÉÄ2ÞqÈF-JjIFÖ×n´ YY?»ç‹df­×=_$;k7ëß• Ém†}?J–âZŽ{ûK­Ç·w˜–ÌžÌxغ¹½…ÀÒ*Ö=8Ü‚†½tþS\ˆ/߯ç¤ï‰/¤Ž¾e}wñL„+hzûd‚€V^ýÐÅA&öw› hnrœÔî&oÝŒœÜ^ÀÌ0ù }7tñá´¢–‹oíé™`çÃ_s[R.ŽšÀ¹x& Wàâ[‹g[B.ΨÊ\±x×e(SÅâ^ÏK7^rs¬=·¡‰›'ƒ qs-&vm¾…QÛrÛæœÊl¹y×f*ÁmîeÂfq›?Ue>‡õµÑƒÇbZÛ$\Öf¯ÃσìÁia¢2K€—0©æÀM˜Òpà·˜2'€ã£é™ XÏ#À…à+–Ü3Áµ[ԼȞ .pT&¸À³{&¨fë0A22AY¿ó˜ë½ÞÈ×X™#˜ x:ýØ4ÿ½^ÈïLpì™àš– –d‚b|ê1·²­À ·5^¶«Ïc«×Py›Zò Ú;¿Ìàl‡Ì®AŠã€.øÅz|MéÆfk6sQn²{Q>¸™ËÜ×j¼f ³c=˰ë5+'¢cZ,`OøÔnÏlk}öàbk”n¦¶Öܶàqº%å­aÑø‡÷ˆÇº¹{"œÏ÷#$fÙʉs«8˜×~ÜVMq0§£¦8(Œ7f¹Bg$d¬8©8˜—‘œsâûóÚg›¤åZ»óˆóÚŠsŠƒ™ë8˜×em”íé=â´fV_q0 N·ƒƒ-ˆ“yì:éi‘× ¦N’¢8(𡸥8˜QÖ¿+&áÑéà Àz”ŠƒiÙêpP,_w$&5P\à ÀY¨Ó²Ñá`jX£ÀÁÔ’’oà ÁÖÊÛö>¦ŠpPbiÓyÄò3Ýá ÄS²ÃÁ´öà&aÀA±²£L à ðÅIÅA ÈGbÓZÑq\1ÓÊy“Øzp0­õ¶× p0ÑNÓZ†{ÿSŠ òŠƒ)à¦â <¶cÀÁ‰«ŠƒI‚‘áà DŒÔ£T”e ­âàfEåà`ŠØnÀÁ$¸îœ–$ÓèP–YpP(©‘¦…ËŠ» †IÀ(4Lë1Í|àPÆúýЇ‰Nq/'ãâ Q¾?8L”ñt (×·yP1­ý»y`qß_=¸˜ÄÃe¾¶dLëÐ(ó¿÷°QžÏpX)¤8º÷Ç RN»‚'Ð_Ó´ïŸz5^=øŠ=ü€ÆçAƒ“Ä‚lÃzæS"|±žùŽm¨`„býóި߇Ç‚xurYãMÒ!é딞ÁK§FfmõÝ¡Y—¥ß»½Æj{a×Þéú€Ýïàä<мaÝöô¦‘°ßÁ;yxÉòé§s—ã ¯«;Î~˜žÎcŽ‹l–O¼36žà#ñ&À©$­ý¦ß¼ × <“ˆ•Ç»¸æàa|ÀËÅ#·µ%žFˆ·kvÇÆc×ë²öïÏS¿" ‚‡Å9͇W'ö"#"I{B|¥½ïíÑZ6oi¯d[9^/cµ°wDŽöPü¼áìe¡ý‡=-N%ìí2ó19{\±ži¯+#ò°çË^©ý†½_ÛDýðµÿ†úI›/ìt€ó«’~ñ ±ßÕùebÿ£:É›¯ŽÏ¤Yè$o¾“ÖzÛö|(M$˜A˜SÃ?ô+…ÚÊ÷Ãí\ÿÉÎi^ïÞ«T-"à"%tšë3§ù‘ŠÓÌLÉ~VÆ S¿~,Ãý/\?ŽwŸÅ)ç>2#»ä…ëíÝóÂÈy/Œ°Kä… ^“›ç²Ú>áüÕ=§ ’ÏQHñtÏyáHôë` ’ÌuÒ›ò®£7Ûnp-œí.x#<ÌgJd]]ëxá~¬n¯í]ðHÖiöû¤¶Ë?–ÈÆ1î³ ×ƒûpÙ©æüãT‘ùá>^û$ú}.ð—¬iÒ} œX¼lã:qDöau8SÒCŒ×§Ö¾.ø'—Õ]p0-ÿ_ypP2/Î?œRœŽ®ÅW\¦D¦aºà¥à f&€Ó)'*ޝeµí:q>ÒŸ/”i/ÇNn'gG„‡ÌrìŒð”î2%«ªó…ifvlíÔæx¡Øáíàdfvr-›Ë?ß2:;»ìš:¦°Ã8J;=¦>_Úñµ,õï°ó<š<` ¢Fž°ìêæMäËÚñ òŒ5Þ~yÈï`yʺíæ3%k¼×/yÎú¾\]ørm7ç4‹íÇiÞNÅt `-x8ïȪq8à¸IQ>à(¤JÓ²L#Gó<ì <,0:L#óz<„“fÁðeNŸ¥‘À™iäzG¶køž4òžl—FÞNŽ¥‘‡^¥‘"ýL#ɱ4r@ðÁá‹ÁÒÈõG 6êß™FŽ—Ó,Ó|YҺ連›sšwpñ &¤­™÷1ª‡/·${Q¬µ$|Ǽ3OŒumIüÁ¤?’ü¸:Ë'R;P½€| ×â—–'xNÌ7ÄKNžXó%ÌE$ EŠL¨XŽH|99œ‰ Ú–'È{Sä2ÿ¡†ùŠd4MEü“"æ7(Â)·b0`}˜ˆ'«16‘O†Ë Ô 2ÙÈ aÂ÷3H(`•8JPkúäñ7$LHv3Hh" ÅïôÁüæÎ a$X!H("—rÀQ’J’$Œk0H©ˆCPü('¢‘d‚-‚„q  Ū;9µÜvuü0™AB&3$$xX2&ªßeÉš€äÀq‚äç *8ÎðuÉ"/§žHÎY² â‚£È3´SÊ4h pœ('° a…œ“AB BD䃄.y,ãæåÔ³0™Œ !ųGypà8!® 8Šú%;p\ãâÔ¶‘ à8!™#8N• ŽŠN‚ã©uÉãð<®Îÿ“äÛNþXòb Kƒ4[òxªãÆä1µ%t´äqÕùµä1X&“DzŸŠËžtýLå¶Ü÷ɸ¹dµ‘9‚5Eó5ö¢ê…(ŸW¯˜_&‹’QKc&3’ùLg¬/&duÉc *3yœÌfò˜n8“Çñ&LN[ò8êõZò˜cì'ysû­O¹×XÅ!د=]b¹þ=ßÜïëþu?:ÉðB’FÕáI§Øx#Ž„W\âÈ܈wyÈ@‹dPnË%%è®É[Éa.²’M‰Ÿø¸ãH¬Š*Af%¤àð\œŒ• OˆH–'‚ø$Óâ’mjëHÆ'㨠ë"P¯Ç^m<öö,@8O{GòC{(Ë‹­’@´§ÉqÚÛ€¸$í±eç̾/£…ö>P> âœýýà WôIÇØ‘ßHXoä# xò•L¾>“™œß‘Ú7+*t¢Á—–s×=ŸªãòE—¯¸¿d¬AB ªÖ¡8‘ëH æUè6n§ù‘:§¹íRã…Rb:Ý™q)^%.´ƒ¤ó>•ô¸OIâû$ºå0O‘2Σ8©ÑÍsyà…™e}xN<…ÏQ’Ñ=ç„x3×Áz®É¯“8®üˆ¬ƒà“Ç–ìÆ:Þäש8™®Ì.1yÎu!Šá>ˆˆHrŸ¬±&o±"DMä…¢8òBUµ³O…‡Ÿ<—“ /kdŸ\Éã€û!/”}çE*ù&òB Öy§yÒ)ŽIrßçG& yˆƒÂ›ŠÃIÁ%'*Üêg'“³ÀáùÀ Ä÷Äqÿç™,¥:ÐN.»¢ÁíéÅÕvÔDLù åʸ¹HïNvz;'Á1o󰓃";ØÑñ Òbr”vX¾¿8;=˜`ò8«¸Á’ÇLæ2y\‰gò¢Y—<Ö07“ÇMŸ¯%x-“Ç<Éãñ<žà‰LÏ;yÌ‚+ò¨‰üyÖd™x˜ˆE¼ÓÂ*Ùãž BˆÙEp%¢ÙÓ,1L/UÈ”eRA?×TØO(H©À·² (ô'«TðO^?þ“eʨ˜ãŠ€‹t8¥˜lûäœæàp?9sdB*f¦cL4GFDÉéÉJŽñ*P¥ætJ9©ÐiÎi–çŸ\rYÖgsN³ˆV§Ç“Å:ñ†ââ‘Ud¯ÖþhN #ûGàÀ»ëÕeXäk4q ¼LúO—T² ¼•JÄàðx9eª¤^g–-ÏK¸‚¤‚?Á)-7ž92-ø™½=aEíMC…íQË™|‡ÂzÛ³Ü Ö‚½û0\¦9wìØKy¬Ã)UÅÞD'ÖÊ¥·°ÇbŸ‚ë²ÇΞËûƒs†äû§ ¢ç…=+´‚„¬àj¬%Í\™òæfÇiÎ= ‚îÓ—)˖ض”¹ð̧N³ñÂã4Ë^,GT˜zN¦Y®L[y!UIà…•@ä…ŒpÉÂú«H.\qÊt¹³ä’)ÓÏó`¯<‡Þ|N”òð9Ø>çõþá*ñ²ÞÅY'•N\G|ŠnÍŒL7Ö¡³âZÆìÁ:žå^ç¸Ï}0‘‰ã>¬´Ã>¨ìà>£r‰ûp(¨±O;‚ÜÇ=³ý€îóõˆ7O'4$ ˆk_ëß#ÕÀ±{‡¤ÒÁ)®…géýÇ Êñ‰s¥ÓIV,(ç'NVðG×mÄàp¶‡ˆÃäEÄé ¥q|ýgx^˜±¯i2’´¸F;’É#agr¼*„W¡o†Ú©íXB%í\‚B;(·œLPÐÐŽ&Ü?y!“kä…‘MMÀ #*SÈ #ƒëà…"êsŠk±£ú{à…’ sÁwy,Ýçwe«Ë4gV\“†x)®…h°ÓaLMqͲÊÓ¸+xNdD’ŠëŠï;Šëê”§[AÝ8nù¥¸F¦Ì×”µPq À>»‚srv£._vÕ”áô[q½–åðEö2Î Ž»×P;à¸eTWã®z9Í{ìœf'×ÏJÆÕ9™[¦ådÌ‘í_L†ÓÙ°2œ®àn2ôh0Êþ¬qWPcw»q×p.xC7J׸Ë] “ª§qWsŠëΉ²Æ]È8³qWu¾ò%9»T–n»Š \ŒÌä?wéYã®è¢"$‹®q—ó‘GCHÅw¥»q—:ÌhÜ5.»=UhÜ–pwé>6ŵ¯ÞŸá*F¦ü4î‚Ô»²+‚˜t³Oã.Çv&‚"§qWr>ñd¾Áw—ž˜,£ä/@%súvEW:·%fWß®¤¶É$‡À6“$f@)YD–Ô$Ðt[ß®‚€+¥×`˜ôºÁPz I¯m$™¿Oéu„›Òë„€-¥×å*Œ XÑVEd‹hËØô¶ÎJ¬a #K;)½f‹ØRVGÐÖJ6Ðe÷ÄÖhV¶zÙ¦êJ#‰,m}†jŠ\ 3 Oéu€Néu†£EéuS¬6é5$&½F)©I¯3Tn”^¶²R.ÔÑ:ˆÒë1ôyQzå¢Ñp…Ò먩4ʇ™Ž*˜xžE&çóYä}K‡óA5ÏÃJ"çK—ºP0Ö9ö;KãJ­·Z¢úyPRzu]›ôšJ¯¡V2é5Ö¹I¯Óݬu!]vYäÍÑ<çcU›I¯ãU‚,’ýxIü;J–YPQ:ΔLr¯GÓý:§e%܇,Q`i?Kªæ(½F"À¤×™ûÒkTQ9éµwˆe_ _e·öݼ¤×óje ûT1”^³µ¥×”~³E¤éVeÇ–c¬²c .VÙA½eUvlÆÊ*;Â?«ì€ Æù£”^Ï»Yk@–Ïµè ¾Eèw9 dÚµè ^­¨¤ô­˜\‹®à«ìpÃI¯}`xK›}•]@ Ð¤×PU¸]>‹<Ñ”ŠuPhtZtyÂ7QáÈ «!¡µèÊΞáœ]ª*CeWa>Dë¾2ÂëÖ¢k£[t¡Ò‰-ºcb‹.xYlÑ D‹.¦YÉ6¡ÄFÛÐßeÜ@IZtA Ä]pGnß7ïÞçMÖÒ{-ºvRƃ±'ª¬ÇÕ´º#¢JÙOG+‚£ ª.*jMøRUÕ›©ŽLU­jšd}!UM#/»­ÀÅp}&EÝ¢¾'UQ¿5M@ÑÕ4 Jâà-P œ¤T»ÄÁÕ,qpÑÖéTcÒr&;•µ|mð¾o‡ê˜8Ø¡–  Áž×#Ë¥EoU؈«ÀÁ†}Ml…¥kŠƒ a‰ƒ¿láJPX©q°"¡F¬(í'ÖÊ¢<ÅÁŠçE”¯ç“5±u¡â`E q°‚+Õ6ÀÁŠq°F–¤(²$‰8(-™¢ÃÁ®”ØÕáUÖ“8XÆÝR¨ DŠ8Xà› ž?q°P­,à—ÄÁRnß·ÀÒ÷-ù î’(_‚R¸ƒïËjvú¾ê$ú¾¢t HW‡‡2¾ª3Ô]ô}3ô}åó¾Ã_m\Z+À÷-(Z¥ï[âÝŠaµ!|ß’îjã‚@>}ß‚¨µäªlÕ°Ç"Rw¾ï„<ß6¡0GsÄY~LG½<ÔÓ4d÷éè»/E€ƒh¥Ù,ïeé6!,íÎpUYú]î‡%Ùö«t¼ÑñEi9ÀÁJÏJÛYšŽ¾³VºŽÍnfŸˆÁæàbMáêc-ãê~ ,Å×ͰH[ñÒ³ÄÍÍ”³ÃºÙØ$™›Q¢ê¾5@¢„›Y0ÃoöTïþ\r…—X'€Á$ 8·ì?Ñ `”¸%XQÚI0“.FN³•N=³I´Ë\nç8—«*Yl`ÉŒs»¤2¾$Ö¹³-èÓBcPؔƢDªÔ˜öÍ…±)Xo4F¥]ê&Çè¹Î.[,à¼S@§†Æ²"IcÚ¬YmCp€Æ¸µ«o’ô§ë¾ž´#0Lcß)‰†S4Õdê4 öƒSE©&®ÉÀ>œ2éåKÂ$ó$3R’äûs±õÉPBk ’¥ü ±.¨çתP Sbu·SõÜôá›hàÍä/ª•nçø‘úlñ>ÝÀœã ;NR˜n‰5z ðB!6R„À}®éì®>[úÂM—Uéú¸Ha¸%Ö‘}aA Œ2I!q˜ÏQ‚ZNE($¯:R($¯øºäÑYï®ëˆÙY®³®Ò;y¹ú N‡*„븣N“ë¼!@Í} ëØ;ÇìÛÈ}Ä:lî³Üá>\¤»yRXÛM ­¿öyEiq@HVs8Q#ö)p¤ÀhgÖ×h¿àô÷öαt7÷ë ‚cN×ÉÖ4˜àÑÜÍŒH†Q8†Áfÿ“Mo£¯?‘ªÏO4u5plWSëÈ6ä§ïÏ5( '8¢i§c¾›ûJ¨Ž8ÖÈÀÙ-ó˜é¡ÒcFSó˜Ù¼Ÿà8áq‘í#86Ö­Ñc¶&Öð˜ÑÄÀoY…ÊAÙd&Ë`íe‘IcÈ:x Èi´wâaó(áF¦¬yt“M–2°‘yÞ\QÖbZk;¯._²˜¢@êλ‹>•¼6^õ,SRL^–C–ãÎÛË>´)G"ùF‹¹0%o¹Þ† C&b²¢»ÑŽL2o9¢°Þ2RBæ-34ËF“(D3o™…‹ô–ñ|Ì[‹²F—^HÃ[† hÞrfjY yC÷qú¥÷8‘Q`hšD¢ÔRñ<Éqi«¥p0{YÛ¨‘Ù]d}*yøí¼ËþÞy˜Ãw¿ŠåÊL$ôád—TøTTô!Ôö[ÐS X”㓚ß ò¨8zËÞ2¢cê˜Q³Á”‰âDi÷Qr¥\]ó·7›¤”Ì[Fwp‹ú»ñBFÍŸE +RŒ*"GiQG¤\TrøJf#HÕôɉ'û¨hñɦu>QUŠ2êJÜfT–©ðµE3IDuéÝ3ê‹T¾‹ 'O½ÙU޾ ™ç–š|5vŒZÛ[æ9¦õ$ˆˆŠCgQsC\TýnØúpî'Oﲨ=pÕ¢ú[Կݧvˆô@å‚hØJžÂ†­íJ,ï±ïâe \Ù° ­a+¤'vî'jíÜOÔ›·Œ(º÷–#t6Pìk[:oY‰Òéâ5¿·Ì¾ðDb‡Ýõb”P’ÓÙŒ÷Ë[.è¦@o™FˆàØ`¤è-£K•Çæ¼åݵ$xp¬!áxEFJpìôî Ž…#4²<*€F¸!L#]P˜BpÌyŸx~™ßâp]v…';ô<8fhŸ ŽñÖÙ¨‘ÄàÔO#9(À4pD~ÒÀ1SŸpD~ÎÀ1Ò;8†Û[ÎèÝa$óeàH]Á±Þ:›ŒÖðŽlQHpŒ··œ!Ã0’:y¬)ÀÞ¹£!À‘Ý"8†p,®€q뚢G¬?G0—òš¾ëPb! ÁÏÓÀ‘]Žl)È”H°KÙ,á-CìR~¾€Ô¥cÇèC‰ì.nàXY€l)Ëê»FIa‹oq*$8òh‚c½º8G ;pœ>%q"»#ôˆŽSÁÙB‰ùf„Ó}(rB÷qëf ­?»YWD&Ñͺ_Ju0ª|РĆ]Úͺðv³öí»¬Pøt³öÊ$*ä¡[ŠP1[7ko fºQju襰Á©¦‚“H­U¹•Xåê…Îl;U\í,¡ñª”|i7köC7ëzµ§›0ŠÔV÷뤧ÙïnÖ8‡Úê Œ ¶@íDí®-é¼´s(F2m]EÇjïÚulÜøN]ÅlÔXCÓdktN4m`¸;ÐD<>Ó"âgÚC›6‘éjËÕ!Ç‚Ó>úcûv}‰×X§p§‘SB”ÚËòÞñ©js¨Ýìxÿ9~U 0ë}ëÓ–÷Jåüpü+µ—Ôž2"Mm*j·z%Ÿ¹ãgõØFÖ;Q“vê¡‚×XW¢¬ž iq«·êw„ÝoÖk!¢KÎѱ´z/ïKÇ8ñ8#8ÆèžeŽ1: šcÜ¡õ¥cŒ#ýMdéB Êä6§µ–úÉvjSytŒßç~Þ1Þµ(‡ûÁ79™’áÒÈPà p4é÷«¸Z:†úf4»sTöó4xì1ãÈh€¸´îvL¬Ãc€#"óçܘÎg€¤@SÍJ¼:¾Iš¶{îWÛíWt´ëúXWÇŽz¬«Ã±Aî$“K[XXKÁÓCYöÁUWGÇ™uuÖ™ uu<¶‰0X-@†ÎO@£&œ¶pó´÷}s8”ipuuÍãXB§5WW—]ó…íXzÇ8±åÔÕE׌f;Ž>`=L_)³½àp^¸Mtv€šp  —,ÀšÙÌÂN2ñ§*lM¸ç~‘vˆ^‡iuuá²û {ß©ËêàN€¹= £Ï”#îØZÎÄ7mb͘,@ŽÀÐëÕŒ&Úq¡ À›=°ÀϸÞà¿:ud¾\‚ ^r»„“JN{ëyÉõp®ooíšÃì„ÖÙ¡®‘]{ë«ckÀÉ;o]̰,väÿ}rlüË/ÞhEÞWëNw5üÞçrU žjÚ}eÿç›—·oþáå¿íŸ}­î÷ßùé·ÿøåg/¿9õ.ç_ñÃú³uu/_ÿöEçüqNïYÄ×ï^þßzño^¾þÝ›/¾Þ¿ò1µ–„~:}ê§¥<~-ýtùÔO—¶÷•~ºñÓœ'> ¢Ïß>™¢÷ŸIgòò»ó\¶*¹lFúO©€Ÿ¾Å_%‡ýÃówé0šýÃówÙ ìëÐ÷~ìþ–[CŒfoÝwMVHÉÕ¨ögíïÒøb÷ñÒ¿sh¯uUÈ¿shÿ ¬f=d3í:Á½&>a=i›‡óÙOXÉÊ›Ã𳟰ŽkÝ*íóÙ÷Vñÿ}秇Þã¤M¤õÈ*ùáß?½è?ñÙ¦~ö¿>á³C·Œ}ö?ž}vÜúÉ©~»0Eùd|þ|Ÿÿì4âÏþìïùÕÇ<ëê?y|LßëѸ_ø‰ûa=¬^tœIaùógWúâaˇõ'?¼§õ'g®ãÎÙçÐøÑô¡Åz¼eõ ü¿rË%ívWÒ5j9½hìMæ–}ûí÷œÆü¡­%\fíš3íÓ·¿~÷Çßóoøõ»ožØŠ»‘'È;öïžÿ„¡¿ŒŠ^ZŒÚ|ï¦ýÏî‹ê31÷‘ºËòÉ¿Ëtêì~àû~ûìš¿åc án% i}êÝKц†ÿÞq”e.ËÜJÂO›ËÇCŠÝ\>ÿ¾§sùì¨ã›Ë°›Ëœ¹Ôñ?—Ré—?q.ŸiúÁï{:—ÏŽËú¨¹,íg.1þñçROdþ´¹|v.οïé\>ë¢þqsÙv¸âÌ¥Žü¹,»ôû{ÍåÕ.ùƒß÷¡¹¼šë}Ü\ÖÝ—÷Ì¥Žü¹ÔÜý÷[—¾‹Ö¿ïƒëÒ÷eø¸¹Tµü™K¨çô¹”6CŸj{žUeðûžÎå³2ž›Ë¸kãÏ\êøGŸKéŸ>Õö<ÓëðûžÛñ'"¯šË¬Ù\büãÏ¥ ,>e.Ÿ«9>ø}Oæòy^àãærlÿåÌ¥Žý\þ#Eysç]›->ÂÏÿéW_|þgqî>ø‹e-‘®ÿßýüoöüàØm¥ö-~óÇ/ßóìþ¿Ø*ý×ÿüâí1§ewçÓ9ýâ—?ÀæÝßsúö«¯~€Œ;_)?øËÚ~€g(ù… «æË¯b}ü¿ÙwNEWêßþú»Bßñ¿—Ú›ýþ?þ³°ëŸ_þð€æ÷ßöÝÐŒßþÉóëùì½Ëoª™ü‰OºþÕó0ÁðóïwÃ8~¤ïúÿwoâ® äXâ¾xƒTúŠïkïÀ î-ý1¹·à÷–š·Bó¼/È[zÚ’½ÝwÖ†ÔÏÛ7cl…߀¡{C e£4ßÁ±{‹“ˆïDÏùW¦jŸeS…kÞe_Ý]3^ðw.½ðŠ¿s}Á½¥h¦õ¼/ì·”vbùï8ôwú æ¿ãнa¶y¢ùï8ôS³‹­Îäq|OT> ZÙUÑĬˬ‰ºƒkoz̘hvî¾µ¢ª´Jh=¨V «.«õ¦Z”¬¶‘T+€&ˆm=ß §7nÍM“ž¹³1M Fʺž@³O¯ÛÍ×%)«Ùýþ®j`Éé‰f"Ð+[á§„§Éb‰ýèz®ª@Ub/Qµ8…©—®:Qh`zͪÀÑνNÕ àôήêxѤèïõ Å èŸÕ{3­Àþ>U•mËn¥7µ[ÔÜgQ­ú»-ª©Zô%¡©N÷3bRhPmÀˆCµh1¤–·«nsÿ}­ %Ò[ 6òF=Ñìë%ªV ¡z£t-ÖÁ©jCÊ+Ñšc¾Nj´âB:ü«V`¯‡Ñ£jpêÔè]µ‰g¼gÕ ª§j®Põ9fÕ~lCµ3DÕ @ 0CW­úøL=±Ât‹SÕæ‘ ÍTT+€ù9¨VG]ÏÜT+y$}R­@`?þ¡š5œn:5£yÐÑlAû±A7[Ób1ÌÏ”c´¿Ûžï)ÕZ ·sýsdÕ Õ&LDk·­‘šk>pvEsT±@äñÊzÆG´ºã³Êx&@ÐÉÝùr}!íÆ&sR·$¥ZUÆã½{×XµÐAº ãä¾²dúu3ûlÓ9­`hïÞ áùïÝ;Ù‹3ôÄŠCm¤M¥føU­FQÉ@`g 9L5(Ö™MEÜÆ}Z¸ªÐô# • dHÈwsQ.&÷BãIÎøDC…4¿R2œÝýfc›\Ô鹩WÝqŒ8o«gž€¨÷ÝÙC óÒ+çEç­£çµê°tÞEž1Üs‘N¾Ý=·\|®|î#±º.ŒÁ‚!¬œ^ƒ\Zr"\pkoà¬Í5œné(±²G×E‡…?ÐÊûb øÛf ! vÕ@Y6ÝD¯*ìIi—Ï–h…=Q /’®zð`âKÀÅÄq@“‰ÊF‚M#î=‚U xÌN‰!ØU ETX´ ˜F l¬‚ãÈΩ눆×s6Ï$ØS4Nc z¬âŒE‚@“ÆD³™Çذ?‘ô—ˆÎX¥ã c–pú]†Æ0ãGKžÂCcšQBc›!*§1Ψt¥±.hJGc^PYIcϦq$àJ²À$‹Nm°%ÙhèóE2Ò£Î7ÉJ‡šdF¼~g=p§#€ ‰¾ä(±²2(¹R2Åf¥$[ s$c [’µ„#EÆDd”ãÔ *2J¦Q2îÓ|êAÆÝ¯dL&E·+L€Œr¶Z E°^ãAFéw7H¬ò2î¿;"ŸW‚¥-㽂€Œ2Îù ãþ»ó¦e¼ ãî·×2ÊX½eEÆÝÙ>d”±"—"£œÎ^7-u³dܬÒAF9o}:‚˜J”Œ2V§È¸ÿeÜ2ÊX½[EF+ƒWd”qpü75ûd”ñ¾_ £´BÜUŒ@FGǽè÷ïá £,xbŸE4¦ fl”.×:VpL<> è(-¿6Á9”¢ œ:¥()-.à*LJ¥ú™ÀIyáÊDM3‘RÂlÓ»ÔòÞ¡X¹qÁåîo6ZÊ h ®p¹OÓ /å-|`Ê 8†ZsŸãê½jyÍB3÷ Ѧ¼Ð/7›>–9Ⓡ3òKC £‹Ÿ ™Ç_ãÂB¥)Á¥Dšíæ"OäíG¶=áÅÂG‰)÷¨ûIŽƒïÀcH¬ãƒJ‰.1¥œ)•üÃ^‹—Žå°H¹6Ýä‚IìÛÁ%•,^‚E'ùZ–M\·9‘èºÎx²\÷¹h…÷E.©HìÆ}•5å¾Ë8v’û2£ñ=÷­8^~_çI†¤û¾ äD\(¨#n4$®4ô'î4þ$.t nÉñÏÉáZAÅq¯tvlU\,hùDܤ#H\-ˆrw ¢ÔÄåŠ 5â¶t+¯×+ºÃ÷+<Ú…ŠJ»AT¡]©dà°;Ò-ÝÛ%v  ÝªèÅG»&•‘Î#ñ^•´‹ÕÒ´›µ(“£]­hI»«ûáØåŠci·+*ôh×+ºÐîWoL^PÁqÉ¿’W4Tl‘wˆ]ô¼¤#bIÞ"mÿ¼¦£¥yO’±ySàWõx{¤Y x¬1Uz´óE^×FôˆºJ#Q?ô5z"]5W=jÑ ¿q"–Ç_`¼"¶‡ãO&Á;(ˆçtï3&‰¼…1ɈÃŒŽÄCpuÆÎÉâ‘XcõOlÜO´ƒ™ð‰wìxc’ð‘¸bºUrE òL²á@s®È†þ\±<\+šÝ&¹â3sÔÑÈ<±cò ÜQ ±\î¸Á±#”æŽm¨y䎦ÓÝŽo`ÞD„F!“ ØñD”y…úöA™žIÖI„b¡¿­"ÀJÄ«p3‰ˆ5ˆDÌŠÖ²DÔŠC‰¸Œ‘+j0‰ØÍ£ˆèçañ‰Á"Tt¥Å¨<ö ¥F6sU‹C„¤Eb.-VAlœ­ ¦”OÎÎ":Ö°˜ÂȪ³¨…MÎ`q%Oç™dIFÕdKPÀ¨—À“«`öy¤ƒƒ<È@ØÊÈEæ1ݤ™Ç  dc 0Á #9Ù. 4HŽŒµl< ÔTŠÂF¶R#ëc‰°6ëDJ—²±@%}‰'q‘I&´ƒ0&÷ºýïgRwCMˆš»Úe³›L’ˆ[dþ¨`·-²Á™„]²È$N³È$ü‹L"€k‘ÉÉ€rgå»ú×ÌfGÄ™ìZ)k‘É¢«Ö²Ùñ²Ã»KQ?¨)‘Køã“•ïjW™Í†´Èä¸ô9Ëf£Ç©e³3¬³Ù‘:f³Éƒ™œŒD&V¾ïue‘ÉTd6]š,›–}–ÍF‡ËfD>™œŒDfV¾™då»Ëf7Çw× çGž’dÙl,rF&zL32™Ð@‘É„Ss™Lˆ/02™Â•ž²ì¸e³q ‘e³x5³ÙèøaÙlúˈLFœVÇlvÄ)ÌfKW¯qPsoLçGìHl<¨¹[™–ƒš;2ëPÓN[c6[\W6;‚[6›ÍUO6{ÞIKy~ž¢¦¼£¬‰Ï QX‹* J{"ŵSºåå Œw~?¢ÄÃÆŒ"woó\ÔY£Ð‘}Ü¥N¦Ð(vb”QîL¯QðBwQr4,eMCb¯jQNÞË9&:S0xOñ‡…öÕ«FààôÀ`¬L³Ú }!«È¢åÀ&,'ؼå,ÐÃÄr8·Ñr°t–a¤Œ94#µÔ6ø·¥¶RÍLmOuËÙÝù–Óe±œ޾°œPÒ3µ].{瀺Cö•Km‡+µˆ-‡ôâ©Î²ðloKm£¿˜¥¶3ø:SÛ5SÛýò°Å²Œä,£™ÊÔvV„q©mï¯ìóa}ÎPÎ÷ÊÎrD€\j;xË_ ‹²Ô6#åLmÃr‘YSÚßÇÔ6 ˆÌD Òa.rÞó°¥épò̧£¹'SÛæ!+s’Twõ™€Ô>™Wç´œqºuˆ ©2;QšîïóKÈDÜö³‚F~¢äÛÃ.P®Wĉ€vE“JG$ã‘mrÉúzqEìHKöC¼abÄàŒ+Ò¦˜ é0®åœ=1dË,‹] \$Wd.„+‡©X›ÊCrEt rYì˜ÝŠ,è¸è²Ø7WÄ2®Èƒ¸#p¸‹e±ÑIβØPY;?d±3² ój;QeËb£û›e±ÑöÚ²ØlLÍ,6ž·Ëb+¢,¶rUrÅ€ÜÐÉbÏ ñp^!"T–ÅnÌj#‹]xÌbƒÛ›ò13wåc‚òÊGpãŠÈºWD(³LCÓ¢LQY¹<ËbwxìT>væf |lˆñRùXÁuòQ›ŒQùXÀuòQ# Gù¨1i*³©Ñ |L\‘:‘ÃqdÃáŠñV>îÔ¼ßï–g^Cw´Š¦}L>SÃqMû8Lë¨ÚÇÁ4´ìEÙÒ„>—lj62Qe[ì·H66- lmV:ÍÊæìU°½Ynz(›MEüÞ§~VòLázÜmŸ]$2 ª8™ÌiGZ ä´RHÀÉÌNªÀIiÖÛÁIg—Ó–Ïï+Nfgœ”¦bÙ)Äå÷£‹gŠà€“r†âŽâdŽTp+NæU œÌL 8)ãàbßYö‘SˆgœÌt€“rÀÛt8™Î}NÊXqTqRšªu‡“2F{ãänÒNʸºH¤Œ“ó©eœÚ'S‘ œtã“ûýΧÞã~pRÆéTœÜ¿ç"‘{ìr+g¬8¹?ï˜ãþþqpr_cž2î'e\]$2³ûpRŠ7¦SûÈx¯?àd6ÜQœÌGݳq2S6 œÌ¹ऌ}n,›ú=—ìpR4Õád’ãW|nn"fÃHä„]a$r¢0#‘'Ž39;csˆDÎsT´F"'b»‰œ&4F$r6¢"‘r@ë•æœZ"D"g#Ö"9Û­þÙ/ •òÜ_D"yb¸E"åJ½bzß‹÷©å…;1<;‘È9¨NG$Ò š‘ȉ(—E"'…JŒDš‚/Ôã—ëG*¤¿ö¥µÞ@½#è×…ÕAù8.½N†%psÒÀ´ùÛo‰ tL`îÌm•sŠInÝÄûúÚà“Ãâ¡ö({ä¬ãa÷Äs$±z¦#Rvïd'F2mÑIaNô˲Óƺí8á›ëº3¶…uß©âþ°ÔÜ7ƒì«-3ƒÚdÄü”³oeì+?Ð*ëd §=‘Ã%âM´-AcÛ°È£S“=ºéÒÔ¨ÆX=ÌþhtgA NôÔaÔ;;cvÒèǺ:•’  «›…9íÁÎð¤A”¯QYP);ƒœd«Oê8AÇú`e%[ÇTFé:¤‘¾ÞL.©´åÔF;t+Oýï«M–álÖjtjÊ*DéWœÌCÔlýö¿;Î %jö©W@ÔˆÛ5…wyÔìˆT5;ü)¢f§jv¬j¢¦Ì·«¶‘¿«jJÕ£Ó†Éõ§’q÷þw·ŠlEMmowPSžAv¨IâIÔìþ¸¢f‡†šþw‡\•þ7«2éwÇHÿ»ãÜ_úßë~‡CÍÜ#‹èÔÿn8i‡þwÃýÐÿnôoá7V»Àÿf?ýï ^Lÿ»"çKÿ{mEmøßµP ©þw…€—þ·(m\µM®ˆ·Ðÿ.8·–þwÁ9Èô¿K¿â”YÎ9pqÊÌ“Œèð*úߥ\ÚQ‰ÓkNþwAœ–þwA!ýoÑ–ºœv.à}ô¿×8;%P.PÂ5eÜjÊ8»œvf\¨)ãàü˜=öâ]y˜¢¦¼P¼³$/ šû=jÊM¯)Ï&»jÊ´tš2LroÔ”|ùM¦Ѝ)¡EMyöÉG+·,Ñ+rÍ7jf|EÔÌǰ5se‚¨¹Ûôû˜en”å5óªbf³í#íöP,/ ïï8_ò¶&¡^\º”ÓzM¹Îì%õÙN9ãñX$›ÂXoá¾ÔìYòB÷þwfêÒe´ vìt¦±¢Åx°`b§Û%%/d¿è¢¥Ù±,å;\ž{³gçgžFÃuqÌ)÷ÅçŸ1ö•½ûδ(Ø—ÕôÜ·ù,îk9<ÃÇÝ"òQÄ…85_EÜHñàJB)q'!]@\J(ž&n%°;âZjÄAŽ4®*ÄqÌ73â~ÄÕŒAÜóæŠ¹³ˆû\•dΈw×ECïüoÙñÑÕɆoÎÿÕüìJ!Û…Ý)þ<ìRañ7ìV…üŽv­‚}ÒîUÄíiEáéò{²Ïsvv•ÇâÒîVtò ]^ãæãæçuÓ®‹óÞR½;·ÐL·¯ ’WT(8É;*3îà%µxä-5£X¼¦&d˜Á{ÖßÕ?/ªÞfC'ò*¢y—c{^V×àm•ï¯Ëàä}%_ÅÜr8Èø“þ÷Õ*•Ÿ/roy‚ÁùßÛ{&Y‘Yá¯Ýº»£NÍ;îPâØŒLT7bÆZ»™dc&3Þò¥)ßãâžX3æ¨O´á b>ñ†3í¸"èäŠiT?bE5¨ü¹âZGû¬ÈÖ¯Œwæ¹C\Ñk¬™'¬ø¹wDàÜ1 àrG5ÖMcÇIõœk¯ +¦»ˆ™¬(QËõö¿eEFµ^íd7§)Gc’ÐÚ‘D3í2Þ‚(Õe¼7ÃñJf; EDiÇà39%°÷"jFï"îBDÕX‘s»ªeG$Ï$3˜,?£Êƒ!ƒFÐbdÜ/-Jf„‡ôÒ"e7Z,A|ç˸8y—Œ“g’‰uXÌtG´e<œÿ½Ç®|{/&™©Œz²N<0ûë…«„;³‡Q‡4™¹È8Æ×臈f}&G^€†'ºÉÉF¶@ƒ²•’ƒ(åDgT*[³-éDå3ßòx‘daË•ÊCPºÌ¯IúÖƒÅÑå …¹!aBâ˜;»½=ËûÖÊÔ µqÕtKeÏ‹nÈç¿wAäÕ!-êì9MùU{ᯘ¦¼±‰ÈéæìPœ¨ª·iì&ÁiTޱCZ¹uBƒºvHCeuB´Ø4åìfÁiì~Ð"ëêŸSS~ç¿·æÜñѨNÈ:¨A'Tá ™¦§•™¦¼ßÝ.¤ÐñÑ%©òÒЄ…:!ž¾fšrÈ…MSÞY«M9ô ¦)GüÅ:¤á¸Pê„2BOÔ ÉþòÝ..MùƒN(õ[Y¹xh¼4åä‘Ô”Ã72M9Nï2M9º‹˜¦§qQ'$º&—ÿÞ§³]šrÌ¿iʵušrŒMS]M÷Vn>hÊ}ÔRtMÁwH‹‰5ÞДóú¨)G”ÛtB§NhÜþ÷>Ô£¦(•Xx%+©*w§¬¬•uB¨_:šòLW™šrCìþÐ)mrΡ)‡†žšr¦¢¡)gÜšrÒhÊÙšr”æRS^‘U†¦¼]"½Ù¯ŒÂ‘˜SS®?t4åùRÆ»wâz¶Å)g¶BÏ+œ¦)¯}xèñRS>PCM9ªÈM!‰óvMAÉj*,óUã¸ÛŸ]íÒÀÿMSÛošr(¯LS>¯Èë>o×kÊû&Qaš/>¾«ƒ.…*Γ5M9B0¦)Gu™)`±JM!‹Dˆ)h‘\1M9ø³)pÙ^ ݬÏÃ)x½rMª»²‹¬‹åí^S^¡„r bUSaŒjS ·[¡Ìî+¦`fuÎÕyT@gµ¤¦Æ¹™NA=]Ÿ0i,Ñ}µ^@À4åȸviS=jhÊ'ØÔ”ß¶ø'Ûr>Ïpû4¬þpÇ”WDÿÓ”wh©)G'-Ó”\ÁÑ”wÏ%£|iÊQæ:£©€\UÊV=•qEhÒí‰Ñãeýa~xâU¬?ÄÑá®þÐÇlääÝ»›.c4äŠèb\1°J+%2¦)‡ÚÕêï˜Tä|ÛŽ‚÷cšrh)MSÎ~9¬?¤GÎúCp[ãŠìdFD@†ÝÝMSÞt¾LS^‘Ë¡¦¼@³CM9NØ6®˜Ð@’\ýr ç•áÞˆæ5ÿMSŽŽ'¦)G„À4åV¥ My†NM9ëù¨)¬ÒWÄósšrýûÑ”'ÏåÀ`§•ÜÌÌsÅ^ašòrÅœ·röîÄæúÿìå¯nº@8ÚáG3=™FFi˜ðÒ±NˆÒ²Æ@=JÏPf¥i… Î &?ÅÙ*&Oty!&O¤®“GþÄäyQZ7É[Qz7ذ ¥yV·Ò½Îï·il`Ëi—ˆq ©‚5Hãõ³Aùv¦Ÿ­C€»µ°“¡I€à̸F©9€ìE7²¨ ×>š¾ÑG…æ”Ît¥m- Š6ÙÖ¢ôK”%âêÌB´U ¢®µ®›odÂäEat&)ËLžCTưEgŠÒ(EkÒñÓ‹Ú$/½%´¸£(Ñù‡(ñz!âÑÜ”E(Šã*ÐN”\QD§HN¸N ·s”*Åx7H“â‚”öðÓK€”¸”QôF P€ü— €x%@¡]I¡Ù‹*V8%@l M P€£@ 8BΙ–"¯ìBÒ@qäœlF¬)’)_t3‘¦#@Nˆ- ­0 lñH€ßÁäLWÒ.ÏCRÚëgzêéq¦‡ÙV gz ­cÎô°Î\p¦E˜zÝŒNE6œéÑn²¼Ð|ŽT^¨Wöéõgz4¶×€3=šµûRgš ©Í™^œéa­ºàLŸ ƒ3=ú‚Ü-}‡ƒLy¡zÌ”úåL¶ñæ Åjtð‘»嗮ÕÀFmú³eéqaZA»ôjRqÜ\-œ Ü~­|”˜ Åïi^t %SMr 4x -ґǃj‰ùoðK^H>P¹_ðbòDí”o+™|J6‘Jprd¿”àähç;h N¶t7Jpx•àäÄ+JprºÅä2Aѧ¦S~è‡fižãOªËÙ <Þ½*ÅX·Ëퟅ·8gæÅ>V±C?>ü „Ǥé1ZmS(­®bî`µRx ›îA±+‹=Ê0(2ÀÃóö¿Ó鹇£§K*¦‡bÆrS—Ø®‹ëZdñÙ­ûÑ÷…°M×,Fƾñ °Ó拹#Z¦s_RTÅ}›pOÜ× M=¸ï¥£K\;®.±!þ—O|›NL.ãé'wU¸•Úå¦N)¤â^"N)Ó#næ@\q5ã(ânFt‡¸œË]:™qL%qÂ8â~†t•v!³4vCp/9»RØðv§ !6íRIWª{ã°·kÒ>×{ íåhKg"OíftØ”GÄÁÙ •Ö œÞ ÛAJyÑ.:Ã;c;i&BÙn탭5Û?³]5Û­vÖ^L¾‹£µ¸ ÊïÆ¯ûýÞÿîéJuù4(÷ÒêÝÀÜ{«E€Ì‹0ñKo—ïgƒr4c2ÿ»"±L19øêCƒò&éÅäe§.ÿ>”æ‡IBÜ`L2Ý©îñÐ>mmFpL¯Íظ[¾21נ܉6ós ïdÜ\[ ¹Þé™äàQ9稛éÚí'ìÄä2ãúw2ÉpÉ"eÅ5¿b3AlPކˆÆ$ÑÜZöw¬P¶ôG[kùφ‰çH€æwäÚAš©áŽ…Cb;å¶ã!†'"¶b”J[¥˜?®ˆ#å)žI²LϘd¼Ž•±—En&æ"’‘|û‹<è+¢JË#nnW«ÝÝ:Ûµ„Tñ7=¡ˆø™m€`2â;´9éõÑ¢d´›°#1ØÊ—i‚iÂb™X-±ø/¡ø1Ýçgîöƒ¾=ŠX '‹”qpbòÝÛûßbâÚÕ(µä¹$ÉR;8¹$2?³MâC1w <ôƒUZFPDNzsÇAJÇSXì˜UžÓbiwžäb݈xÖKcâž§ÁT^:˜d,,“ŒåN©§©p·•IžÎº`’ñA¹c\bòÆ.ûÚªÞÿÖÎÿf fÅ9·DÍŠ]CÔ,h†EÔ4P35ÙFÕÄäÅTÔ ùö¿C¼Š¢„ÅNç †]„˜¼ÕŽ˜¼:;ºC—@(ÝbòÚ/;-’3m‚BÉO¥¤ ±h먂" „5¥¤«ÏB8 Ð „Ê%BVÑBlCK$v&ÂA,&& ™@(¹ü÷–z1yÂópM'=jF6¤7É#[bPY™‡@Š %üBáŽZJTÖ „xÌ’I:òl”|â÷LŠ>P&ÍW1÷èø7åøuX7%·±}e¸…fF÷`¤;Fv®ÛÙèú`»u®¾?´«ïÖãMN·åøC÷€q 2ÈryÆvà©$zÆ69ÎØ¾;œ†hzÆöÝMfÜÍfFºè‹À‡Sކ©t³§ vù¨D"á42®/ d°ý¡"ŒtsŽôDžø4q>!àk¢•=ÐÇuÛñÚ¬ôáñÚ ~<¬|[Ô‡®"{¯îäÀ9ÜÑDýX};âÔ:ëAŽÓ¬9À“Æ#2ÅD½xxèA~Ÿ9´+{¼ñ’£æœK°O¯ÎøQoNã˜ÐÙÅzÓ8²y|8^»0®Æ9«#šTVM—Ä>•ZÔ‹7V`C= cdêbT8õq¸ÔÉ85ËÔËc:usòzqõîÕÑÞ¥äù vî4RlV©±š©³ÑÁÍÔÛèõk./:4[J=ñ½ý>ôIì¹{n;:ˆŠ «-Äy'V[H¹#¯x>œ¤M'™wÜÔüºÚÂá*²…î¡Cf”é’S[¨IjÒAœWëj UnÈ'ÚÙetNœÑAè٭ ^a™­ÿöt°Ô«G€¬¸ë$më’ÏÍÞA¬€`…'kƒ"Œæ*0ºKbŸ“±¹#'év,œz«i"°f®‚¤úÚÂÄsþˆ(¨¶ •vÉ!7¢¸Þ>ûðé-bEâî"¢âÝNmx…|¥c¬ Íè`¸NùbÃ8@9ûµèÙf`B\ #1ËU|4Ñ?•¥I ŸEáh0iàÝR—I?6¨ºiö&Ùj¡ñ¦É8‘M(hns)°ÆÝh¡Zë£uÔ:°~7òL᲎¬ßÅ×£ßj¹1˜GÚ°¢BžR|Ö…2îm¾M }ÎaL“@ª@ÜØº«ÛÓnãÁzæh·ñ`gvi·ñx×[K½‰O­LÔ/¼uAŲl¢ÿWðp‡þ÷Í¿üëKxù÷7ñåoâ> ø«7MJ"ÂBJÙU:@†—šö±RÿóÍËÛ7ÿðòßö¿Ï¾V?|ÈýôÛüò³—ßœŠó¯8ä?ýÙZÎ/_ÿöEèü£ãÙX7üõ»—ÿ·éo^¾þÝ›/¾Þ¿óQÏzò»~¼|òÇKݨ£oü8ï–3ª7úùÛ'7úþÔ™Ú—ßéÛAºÍÞqº1–‡wd­€µwdVÄÚ;ŠÞlï(<Ìù~Hþž[`í•lÈwÇ´*÷}»°{7¾áß9´¿Ï¶QŒçÐþÅ Hû¼ÁÆöŽ¿Äú+YEtÚ àãWÏUÃæg?aá „î¸?û «6ns݇ß[³ÿ÷Ýš~y‡–qÄ-‚•þýÓ«~þÙºkšÎgÿëS>«»Ç>ûÏ>;îîáÐóKã–·È'ãóüügûÖ žŸýÙßÿò«ÿøÔp>þòø˜¾×£q¿ð÷ÃUû '­,ŸûüÙ¥~×§wëYùô¯þä§÷Äþd¸Ï&= ¢ñ³éCë€ôx×Jàý¿r×sn­¼´8Z¼½uï“–Yúí÷œÉüÁí%dY“š7Õûùö×ïþøûoþí¿~÷ÍëðqwòƒÇþáóЃíÚbTyýÞRûß5ŸÝWÕæbîKÛÿ.$Wõá/üí³«~üšï¶ëGv©}MûH¹wŽÜ:m¼ð{Ç/~œù”–Ù=~â|>+íçóù>Ïg§Sä|†-ró©/ü̧†ÿ>m>Ÿ8ûá/|:ŸÏÎ"û¸ù,zÀ™O¼ðW0Ÿ-h¹Ì§Ìç³Ã†>ü…OçóY§ùœÏ¶ón>õ…¿‚ù,; ñ½æójýá/üÐ|^?r>ë.»wó©/üÌgªª$ÿ>ëÓ7ûð~p}ú>9Ÿy« Ý|ê ó†–¿}Ê|>«ÿð>ÏgÅ@9ŸqŸ+äæS_øñçSÀáSíÑ3}ÿ‡¿ð¹}"îú¸ùÌsŒqæ/üÌgÏZ[òñóù\¯ñá/|2ŸÏãü9Ÿ#íƒQÎ|ê ~>ÿŒ±…ÒÖ7W=E‰ŸÿÓ¯¾øüÏâ~ø'ËÜõò“÷ó¿ýÙñ‹¢ÔÞÏ¿ùã—ïy€‰Ÿl•®î~ñö™Ö²Å:­_üò‡øÅ¼ p÷´¾ýê«âãNYÈ/þ²¶â9fmÈ/~ùUL£âGûn:¥ëõoý]‹þïÍÿO¬·Ôendstream endobj 3 0 obj << /Type /Pages /Kids [ 7 0 R ] /Count 1 /MediaBox [0 0 1152 576] >> endobj 4 0 obj << /ProcSet [/PDF /Text] /Font <> /ExtGState << /GS1 12 0 R /GS257 13 0 R /GS258 14 0 R >> /ColorSpace << /sRGB 5 0 R >> >> endobj 5 0 obj [/ICCBased 6 0 R] endobj 6 0 obj << /Alternate /DeviceRGB /N 3 /Length 2596 /Filter /FlateDecode >> stream xœ–wTSهϽ7½P’Š”ÐkhRH ½H‘.*1 JÀ"6DTpDQ‘¦2(à€£C‘±"Š…Q±ëDÔqp–Id­ß¼yïÍ›ß÷~kŸ½ÏÝgï}ÖºüƒÂLX € ¡Xáçň‹g` ðlàp³³BøF™|ØŒl™ø½º ùû*Ó?ŒÁÿŸ”¹Y"1P˜ŒçòøÙ\É8=Wœ%·Oɘ¶4MÎ0JÎ"Y‚2V“sò,[|ö™e9ó2„<ËsÎâeðäÜ'ã9¾Œ‘`çø¹2¾&cƒtI†@Æoä±|N6(’Ü.æsSdl-c’(2‚-ãyàHÉ_ðÒ/XÌÏËÅÎÌZ.$§ˆ&\S†“‹áÏÏMç‹ÅÌ07#â1Ø™YárfÏüYym²";Ø8980m-m¾(Ô]ü›’÷v–^„îDøÃöW~™ °¦eµÙú‡mi]ëP»ý‡Í`/в¾u}qº|^RÄâ,g+«ÜÜ\KŸk)/èïúŸC_|ÏR¾Ýïåaxó“8’t1C^7nfz¦DÄÈÎâpù 柇øþuü$¾ˆ/”ED˦L L–µ[Ȉ™B†@øŸšøÃþ¤Ù¹–‰ÚøЖX¥!@~(* {d+Ðï} ÆGù͋љ˜ûÏ‚þ}W¸LþÈ$ŽcGD2¸QÎìšüZ4 E@ê@èÀ¶À¸àA(ˆq`1à‚D €µ ”‚­`'¨u 4ƒ6ptcà48.Ë`ÜR0ž€)ð Ì@„…ÈR‡t CȲ…XäCP”%CBH@ë R¨ª†ê¡fè[è(tº C· Qhúz#0 ¦ÁZ°l³`O8Ž„ÁÉð28.‚·À•p|î„O×àX ?§€:¢‹0ÂFB‘x$ !«¤i@Ú¤¹ŠH‘§È[EE1PL” Ê…⢖¡V¡6£ªQP¨>ÔUÔ(j õMFk¢ÍÑÎèt,:‹.FW ›Ðè³èô8úƒ¡cŒ1ŽL&³³³ÓŽ9…ÆŒa¦±X¬:ÖëŠ År°bl1¶ {{{;Ž}ƒ#âtp¶8_\¡8áú"ãEy‹.,ÖXœ¾øøÅ%œ%Gщ1‰-‰ï9¡œÎôÒ€¥µK§¸lî.îžoo’ïÊ/çO$¹&•'=JvMÞž<™âžR‘òTÀT ž§ú§Ö¥¾N MÛŸö)=&½=—‘˜qTH¦ û2µ3ó2‡³Ì³Š³¤Ëœ—í\6% 5eCÙ‹²»Å4ÙÏÔ€ÄD²^2šã–S“ó&7:÷Hžrž0o`¹ÙòMË'ò}ó¿^ZÁ]Ñ[ [°¶`t¥çÊúUЪ¥«zWë¯.Z=¾Æo͵„µik(´.,/|¹.f]O‘VÑš¢±õ~ë[‹ŠEÅ76¸l¨ÛˆÚ(Ø8¸iMKx%K­K+Jßoæn¾ø•ÍW•_}Ú’´e°Ì¡lÏVÌVáÖëÛÜ·(W.Ï/Û²½scGÉŽ—;—ì¼PaWQ·‹°K²KZ\Ù]ePµµê}uJõHWM{­fí¦Ú×»y»¯ìñØÓV§UWZ÷n¯`ïÍz¿úΣ†Š}˜}9û6F7öÍúº¹I£©´éÃ~á~éˆ}ÍŽÍÍ-š-e­p«¤uò`ÂÁËßxÓÝÆl«o§·—‡$‡›øíõÃA‡{°Ž´}gø]mµ£¤ê\Þ9Õ•Ò%íŽë>x´·Ç¥§ã{Ëï÷Ó=Vs\åx٠‰¢ŸN柜>•uêééäÓc½Kz=s­/¼oðlÐÙóç|Ïé÷ì?yÞõü± ÎŽ^d]ìºäp©sÀ~ ãû:;‡‡º/;]îž7|âŠû•ÓW½¯ž»píÒÈü‘áëQ×oÞH¸!½É»ùèVú­ç·snÏÜYs}·äžÒ½Šûš÷~4ý±]ê =>ê=:ð`Áƒ;cܱ'?eÿô~¼è!ùaÅ„ÎDó#ÛGÇ&}'/?^øxüIÖ“™§Å?+ÿ\ûÌäÙw¿xü20;5þ\ôüÓ¯›_¨¿ØÿÒîeïtØôýW¯f^—¼Qsà-ëmÿ»˜w3¹ï±ï+?˜~èùôñî§ŒOŸ~÷„óûendstream endobj 9 0 obj << /Type /Encoding /BaseEncoding /WinAnsiEncoding /Differences [ 45/minus 96/quoteleft 144/dotlessi /grave /acute /circumflex /tilde /macron /breve /dotaccent /dieresis /.notdef /ring /cedilla /.notdef /hungarumlaut /ogonek /caron /space] >> endobj 10 0 obj << /Type /Font /Subtype /Type1 /Name /F2 /BaseFont /Helvetica /Encoding 9 0 R >> endobj 11 0 obj << /Type /Font /Subtype /Type1 /Name /F3 /BaseFont /Helvetica-Bold /Encoding 9 0 R >> endobj 12 0 obj << /Type /ExtGState /CA 1.000 >> endobj 13 0 obj << /Type /ExtGState /ca 0.400 >> endobj 14 0 obj << /Type /ExtGState /ca 1.000 >> endobj xref 0 15 0000000000 65535 f 0000000021 00000 n 0000000164 00000 n 0000024567 00000 n 0000024651 00000 n 0000024814 00000 n 0000024847 00000 n 0000000213 00000 n 0000000293 00000 n 0000027542 00000 n 0000027799 00000 n 0000027896 00000 n 0000027998 00000 n 0000028047 00000 n 0000028096 00000 n trailer << /Size 15 /Info 1 0 R /Root 2 0 R >> startxref 28145 %%EOF cummeRbund/vignettes/cuffData_schema.pdf0000644000175200017520000257523014516004263021454 0ustar00biocbuildbiocbuild%PDF-1.3 %Äåòåë§ó ÐÄÆ 4 0 obj << /Length 5 0 R /Filter /FlateDecode >> stream x̽ÝÎä8’¦yîWñÝ@D}rwù°˜ƒn ö´]À ö ;«s ‹Èrj€¹ýy^£)Q¤$÷ЗÙÝÈŠCN‘f$Íìµþþñß>~ÿøü¸?ÎßïçóÇoÃ0Ü¿ß/¹åGnùöùýósøøÁëù¯ÿø>þ Ÿö–~túŸÿ‘Ú¾·ÛããüåŸÿ1|üòÏïÏÇçåyæ/áyû|ð—ûíq;ß?þñKzëŸÿUÿÿþõŸÛ`½Ó>Èñã—ß>žß/ãùãrÿ>œÇó'C{œ?Î×áûu¼0„bbô5Úÿœìo|åùýóþq¿Žß÷'sÕ¤Çknø‘è÷ ~|ܟߟÃãã~¹~¿^™û)õ¯»üÕ†û©)ýÓ_?nßÏ—+âÿý¯Ãùûõréññ}¼_Oý©Ìò¯¿~ü_ŸÐ—ÿ˜Îç…ÿ®ü7òßÿîþüàÏ'ÿýÿý»·ýâþí¿œþúÿü׿қþŸ!|~ÒkÔÎw˜rþ¸Þ`‰­‚Ôpº^¿ŸÇÇÇp~~\¯×ó÷3ü.çïš—?þò1ˆN·!X3‹h}½§èáAY Ñ<¦ïÓ¡7<Æï—ÏFôNFþùäß­ÿ½Üò÷ý‘}ÈÞ@‡‹†4ÇSôà$‰þã1 ˆç$ûÁR¨š~;¥E8²Øï¶Ú¯ÏO[þ£ýÅøs‡?é¿ü9ÕüÉô{“?ÁÑ7ÑïEþŒl¥óCüñS7Ä’jÑÇ6é_þåßþ×ÿúÿù?tDüå_´jËy29‡F+¿–ÃÄöTl²ÇçpóMf˜Åãrf“ ß/gÎ,Ûeçõ]¦§v‰]¤]ûù±Ê–ûð…ù1rìÀÙß>þÕN+<†ïÛýã»ø#è%Øþ?i—p‚ïÞ%·Û÷ÏËð1Þ¾#€†ÏïçÏKˆÎÅ“ŒíÃù‚:?aÄçñu¾,ŽŽáúÖQ|¹¦£wuÑŒ×ï‡çýÝóœÛkf¸ˆ%¼”׌·LÖ Ce©Ï–LþÙ¯§´ˆc£,˜Ï¹qÞž·ç“ãùzKÖ$’<˜0ßNLEî b°žÿ=&¼c—ŒcÁãb²$¸$}lèdIkË6„‰th6®ŸOçÇ÷ š;öû 1 ¼åùø>pb±g¿³õŸlt‰ÄçpõÇIaÔNªôï&…ë†çð}d¯ùÃó¢}sŠîÓcþ>=F Gæm¸«Ë•6Êy< þ = ôŨâ9 w ¶xu8anwI¥2ÆeKZa "±ê¤…ì:™œ¿¼%»–rþ"Á{ù¸!@¯Ÿ·!É®‰ —jü7?³ãì–<ûõ¿|$Uyýø:ai ˆ“Ç™Åõ‰ê×9±ó.¿¡Fa@Ù‰y^?¼ÅrÿþyMƒ±VŒV~:”ßÕRþÚ¥ÔšF´8è‘òwiÒ·›Ô¬ Úðĵü°·?¡Üµ~FÂØó)<„e¡ƒ,ÖBÒùƃgˆ Êö_Š2é,è&RW¤§œ9Cœi<£¿äg½EÎè5ç{ˆºß9µ^ÆèðD=Ñ,Q‚G–ËIÞžäõÂQUQ³Q,ÔDź° %³¥Ù2á³Ø»C1»bw!o°R&8’fJ™©g/if~nÊ@ÇžfJo®t34³5ÝŒŸÊƼa|c^Ž_¥›Ý¤Á뜭ºJÖÎNL:$úí‚0¼ˆÝqÔÞ.·ïׇ™C±¯/ðé"9W4ÿ°€õòóÖ¡KÝÁ…*ÊBÕ¥Û«"TÇUG„f)›¥Á–E膴‡ yh©ÍEè…ÈøO_L ½>±¦V‰DÐu•ú!ã)%HW¶¬…+œçxd,²Ûp³dÒ“Ò#Ìÿ¼‚‚• SjA{Jï¨åö}M‰–á3­¦åaßÈÏ6)ZÑ‚ÌFhˆúó ßhyž¿>A|å)KÉó‘ù³ªþ”^  ŸMiðÙFN‹ø‚?¦A}`Ë­Ò¸mQÏ›ö+DfÑ­ÚIuÏùë-NbnÛœÊ|érЉnrŠâ<<Åç¢Á—X—Js)(´|k^ºÓÜ «5"tÖçç }V‡ Ãú¨(I'y (q8³`×5"a¯ÒõàAçðâd&'Ù“ ¨7ÞæÔÉòÔߢEÄg!KyósT„Züì×ÓœLd2´ÙÕ³{Ϙ¢W Ïf÷Ö ‡ÈcrTJ£€ )‘6ì0õHí"§“ðàÛÿ*ù‡ª"x5Î2th†Í ÿòƒ™ÿÿÐÚº}žO àÚG:ô‹h½dùöf~ôqË äÐQR¿ŸFE¾rÖWÄñ öË¢{…šhypôü5ÑH2¥Eͦj*X¶ÁÚ~Žw¡þýZ+zW­Cã¿£*Ë É ým-ÈO )Wº·¨zP­+AX¨(A Åù+” +b[ ”¼^ˬ³4ÝÞ†“ ÅÊÛÛ[&Û›¡ Ž›nïü³_™ngÕ3G im޼ÄSCYó#º„¼2±Oò³V|>(c™7×òþqÇÂýŸè¤wø‘4jƵ‰€í2!90͋¢@sÆkÁ9Rõ3ã4”—щXR]‡âžšàc2¸§ùFŒI+Jè9 žƒ’É hgqPº¡ e/þ[éÅEô -Tà.4J‰}cs•Ï}+®GøSQø¼A‹Ïô¬ðŨ!©{ÑO5z÷GÿøD×®€Ü˜,®F‹­xc"ó??˜m0Œþ"Í2t=.ºž70*×õJƒëzÑ…Fñ…xLƒÊºž{¢Äd*îõníÕôrÇ+ì 5o“=Åï´k²'Ó~Áž‡ôÍÅ© „úyA˜²¼¦p—»µ$Õ·´»,hedÚaÕÕîî¨-è/~X¼Ë4:©%ÒèB°Ê…¬¶[7–ùˆÔKú[ZB ¼VED‹öFÒñîg@4а‰ˆ—0ƒ+oè{ßRK°èÑÕ¯·?K-‰ï¬–Ü&X¢‰5¡ßùzëû_A ³š|ÿäx¸³ j¸IëJp“Ö˜þ”º,%N! úSíM…Ušv¹’ÎÙwÖÐRî®òôÆ0ÁéÈ'Â~ïáth\Bî€Z34 צß"Ü Á5^14jÂupºAI|«R߀&Á3bÿ6TW$è}ï¾%8°­¹š Ó¯ÉF䦹2®û3(RŽ.[::²¦Ñ-:ÆòòHXÏšœÍwr=æÜ:³ˆ;²ˆ¡rfEK9³nŒt䜜Yñ’ά¬_¶çzåÛy¹u!´l³(ÙFçØ2ÐÀ@w™ ÚRj÷÷ÚVéªmÄZ?ãh;ã"éŒãsâ aRkô… æN¨Ø@]Sb,Üöús­çZšè±IAAP;¨úKGÂ’M:RW:Å®g(àÍ”¬J 5qÈjèå\U à–‹1•ôXþ¼°öÓÒL Ú¨4š/w¼Ä¤7`Q±˜*P)·`EÉ7ÊXÇËóBʪãú°¬þ…X9p‚KiùÑl‘ E†¯õr:ZŒ³H_)Ïiê5½qF()L½vZNgÙ¿8ÒΆúÊùž¢ÉbdñŒRë£X:oPšfœ{ ŠÄWò³L½Î©hºmjÃÞÊîÕnm‰÷–¶™hÕçºL rçI.˜–Ùºƒi™¦ Óû¥°>ÓI³lqÂLˆÅr0bù&¨4¾ßrM‡«5^ó¨]âx0ØtðJ‘(,N8\Vx“Ùe©³Æ'gئù-›"côaü-£„‚?øÁŽa§^hØ~,W`9WÛr…žVÅw<¤Ò=$yÌpLS Ú Øå€‰b`¦s¶©F™»ÓDäÏ‹Cž±C¸kþh`Qž><õ÷Ñ¿_«qE‡E€ï÷Ÿ‘]À;ÖŒ£ãK‡1A˜Œ’ùÏɼ î;Æt‘0C•gu¬k¥«ú‡H"|ûýû5 'dÛRßå:<_ ó2m.¼¾àý½,<Ìþëýv­G-­LZZhgæo—@T“¶Æ¦­‰z:ƒˆÕ>óŸ-˜=þwt˜ÏgNf¢òšS5ÿÀr%ðóö¨­dsuhªZ(LÏÉQÓ$*oÆ/¹Bx[Ó<trà4 iÀ#¿Ü‚GÂþÓ5ö‚tuI^9O,7Û7orXB0ÿØ,…æÌû0È{kçàpç\©äÍBk7,1ú+gÎÚfûžqä˼JS·ˆ’ò?Ét0³tÓtpå<ÞM.µÓu· 6NÔËçƒ#ÆHt¬qj±4¨g€5 ż³yj±%®[Œlü„Q„V<žqË`Õ¢¤Å; öÎXM%‹¶ô»ãbK\?…bÿ[Ö+CÁ~Y7¥=™%SÅÞ —×Õø<2‘¡6:v—Øx&ÓÔ7xó¸Þ? èBÜD”ÎãÆÿYÆÒ$S©kÚJ¥$î_1ýgüKDÜbøÀØ+¦ô™@£:S‰Oq°úùŠïiA²X ¨Vb´°°ES 2*¹ÁÐ6ŸÊªA{U¼ïÜMnø»7¢‹B2û•¯6¡ Ìó (>:2úê9‡"©CCG§ <û{¡½Ÿœ„#å jwÁÐK±Ð©á„#Ä’ÀF¦Ï¤/hr«Ž1?où{Á¦˜žxÊÍ[´ ù•}âEÉãß(Ïiôêo\É5yò¦ú°ßàí«ZÈÒa —_¹^q­ÂÕG<ÿƒ÷泉7hH³'N|!?¦!üϦģÿWM¬õÃLÝùÇè97¼Ä)8›X¹à”Qù%Naæ§.ÀÙOvâ<¬Eƒ/±6•Nuà*ë寎vµí¯Úƽ)ä¿0 ,ÂÑýEú(›&{t´·®ÈŽ­ÛCäz–áÆrÁ˜|ŸK?Ë¡#WA$–‡Ã-@%ZĢ˯çÅL:‹ßÕ-a= ½¢Â Ù1]Æ+N7P.j|–|ôg©§:xü2}.R’Öít:|ÎZyó”E€ÉÜÃ=˜ò{Ëý`àëí‚å|!Í‹°’¦Î·6Y†ÕáÞ™` âH×g&Ó©¬S{bªˆhRn |–_ÇOò>ñÖ ? þ_{C û‰í癫MÚ)æLѨF;W"ýÛÄ3øä§M…L<Ó‘²Ü2ˆŒ8Bçµ5™‰Ùz² ¥GG›[ Óä¸%1we’¥½oÀ=–px1?P!›Kñ 'Smõv½.¨ÙÚ»fg……-jeÃ*ib”öFõþ¸ú8jJþl Ç‚|#BÛ•íÛ¤è1N¦(‘Ëçc™C®uljh›Yn;a_ÛÒ—q*]xÕœ­A1‡íÆ‹ôçûý¹ØåÓÖkÅ|iÊ ªépó|ÑÙŒ?PÑ©ôm…h7'”¢&×£%÷ŸÍH\17Ïc˜ŸÍ-…æ¬ ÀQ“7Ê›€¶ÁÛâæøùˆ´XÜö·ÌîÐ4q'Ý ØPv”LW¢Ù2ã]Þ¢  Ç#HQŸ#|Âw¬m‚¾®@óBÔcÑn°´ÒÊÑvEæ‚™4醸q(Z²dcåC‹ÄXÿŽíu·°ºÅ®Àš!çYÀOeJ‘o«ð\Wü ÏŒ34•š2ɶM½¹´æìøàà ¥ÊðÀÐΛJFCú•Lãœ"¿1ÙOìÍ mNÔÆÐyfgšd¬£u¦áIQYˆ4òéÏt%Úüþx‚$Mø'ƒ0¥c‡†Ÿ–O2Ã,Ûkøa;&Ëð§ ?ì{3übL¶\ó¨’u¸Q`ûԬؑ`ÌD9X–­˜›Îkº§+¹HÎ)QÉZ0ÇäfÆ£Ä*T—«ce¸{6rTÅ3K|O fðÌÙª…m)HUéªñ«3›TQÜñ•üìãP¯öÆé†‘¤¸õ‘~Óh†#09å঱Ç8üÙÌÎ4úxCÁ²%Í8Þ ŠÜü+þœG&cÖiæ£O|·mXô/ÅeTŸ[0Åÿ"ÓŒ¼36¦±j냛L!À ߫țÈà-†êÌ Ó'ÖÜy}é‡k®™­µa¯¼òêY,øe]ÁÊ Ã^¢^Gë‹¡š”S"A³ÍbØBN,?[N¸»rÖ¯%+ ÚXõÊX2Ïp?©‹$rÕ¿ZT!A–õLü5Gm±’ *»ZqN_5l‰¢/¶ñ1WT¡MŒa*T‰Tà-=ò|Fâ| ¹t‚ ñün“l[‘,$S¨n#ÈÐ$·ŒT™KZV®*›$_5¥˜ªÐ€\ §)°E.Pxzß— Îwί™ú¸xQFœ1ˆ…¶%…øèQpmƒö0«|Ÿ5Ã-TÊ)PϨø¦î;Ô90Rn£ççDßaJ?m.•EÁî¾PÇf±â15Î ³—tæ´§k^¹:üÿ"ý].ª ºõ¨O¢y¶Œ§ËA¡-ù˜€”7 ¼šc`M§gÎyA„íémAOyz,`ÀöôŽK ÷PÞ€¶ î±-¯_ R[Ø‘Ûêü]†¢µmÚý«hI9 }5™ßÙÖHaÔ‡1ÿo(àä}~ß÷¨ âÃßñû¢dg¡L ,©Äóæ§ÉR(VfazêOÌϱ–ÏF)¢9ZŠl&êj&—ã sãÙén†Åa'EMÛSµù„¤,xªÓ@ëKG¨kùÚ2иõ¯\>c]%;xÅ5AÇ17¢ç æÒ5¦dÚØ‰Hma^Óhê=cïŠÆÙ~o!ù²%ψ&ågÝpü (ÜÄ÷Y©¿W4îÐ|ÃôÐbpc$§0pÂh¨L•hÓƒÜâdÀ„ö\™L1EÅôˆSclé­ýñоóìko›Ú”»¢±–d Ì÷naR¹!EŠÉÏ{¾31o»œ¼DEú3¢X€oÑ‚ ÑhÁ"±<(ëƒÒ°#•JyŒVžÓÔkzã®ï¤ˆ^ËéN/‚§Tp@_¹3å¥Ç8âÙ<ÃŒ=ž ˜>cV›s3^pBDÿù1 ¿ðœrâå¼)XÙ[Ó\ú¬ðœÓ¼gηÜ0eSfÛdØm±)3a“M§íõÁ1„[Øi²hðåµ$S™&û¥äzÜ­=åtÍ"ª­GÄ$5Ípu)PÉWI(èhm=¢Ý•6€i~>ˆCš€Ø‚Vɦ”Ÿٱ+EK(íEéÞI¶Î^%›4kl—Qê„õκW ñ¼Añ¾P’›´E¶—ì›)¹ !›yO!7Ž;8gi*‹ÚÚ`Ø GêeÊxŒYä SïSþ?©ÜRËõw…L7+¢ +ß2ÔYW œ'%ºíäD§8–¡(z$Â,"Pº³‹=°œÝ–³#TԵͻ~xÍ{Ë_C3/Z ) 9¤S S`c·âs¡ Ê1µÆâ)Û‡¤,+•×ëgG£¨»8P šÙÑÚéUTÖ…E¨‡:#ääyOeCK¤œ¾Ïœ]‰‚cj5– N$ñ³Ë-à‹ µÞ„ªb €’=séžjv}íô½-€:Ã^*[œÇäÁ'šÇØOÎŽhE24ç¾ÂøÖìP~vk[I¦hà ‡“²ÈÆÖŸÚÔvp;>wHg=T­9žÝ"Ýb¹)J ä’¡L ý(ÿ37ìVoáp‹é†ÃHiJÔ¸)¬y^Ñ*Åÿô×Óò> x$õž?ÐU.c¦t±rŽáˆQ9ô˜ ¡<ÎC@Ü¡^ƒ¢;ðsº ã Å‚a ª%c0 ˜ü#Â?V18ŒtŽhD0QTƒZlš5ËTGd†´k3ñ|ÉÙot:ÆÁèïüërôíŒAÒÊÌ×f_î¶‘=Ñ…ôJv(©#vjSÇÏ!ö-è¾ðûI“!¿Æ<šãˆl#2‹\^O­‰.œi3Úôm¥:¡Z0E÷j!“D :-üþ,’Äxv‘d2o“Ø (lë$n|P÷h‘œ'¹Š«{›…v[ {Â$ëóÃoŽGyò¶yb<5IæqI«EidÔ£ÜAYépj~4¯ åñ…Åð$°beâüƈx"ôy¨b“€w$–8[ÂkUGr«šZ•ÖŸM ˜˜‚¦Sn¦ØEä1%dÕcoL ¬9?LîÁuðß‚«I{ªcªVåo$’_8U”d†³ÀSË•¸¤¤§³‚„ÉhSJ ‚‡Â¨÷D¢ø3Îr»¬PP´àkj´@(K‡²^ˆ€"ò8%=Ók½F ‡ âr­…B|—ÙwþÔW¼‚yé‘>cì©.— 6ÛÓÅ{bp‰Eºäç4(u™2ñcàæÓ˜· „ןÛäW™bâ_á—%II•x_ðÇWEp'ñKµ@¢åŒG‹8^×I³lq.÷‰U™{ É\ý³'E¹e©ˆDö‘ƒDQ#Gq‹ª¸Ä÷"+Zç™u)èRÎÕ6Ï¡Zße|O LÄ8ä¦ $«ÕðzK¢ddÕœQòí¡$*ÁŽbÛ•ëªà_þ4ÎGçuÕø Ⱦ»x`&_ MžuT+ZLŸq¡iÕâ#D‚‰YÛÍ C ¼"*«[ÀEñ ‘ÑaÚÒÃ'Ò.ÆPËÍ ¸N es’DuÃ0 f4²ªw+ð?/s¤*ŠÅ#´BJ=&.ò“ìæŒ²Ž)µÆ¬”ët Ê–…¹bÃ8d—NþÕq*à…X… ÑQ (ˆy·!÷ê© ød¦EÌÆ"d°)Ú•(¿X„ùw[ì&W¸7Œxj€ª Ô.•5%Õ -iin²¼)•c>ZyóÕ¸±ª€ ”­c©W•´="Û¶_´LUµ‡ˆƒY‰‚´š|κ\„Cqò&!õ§JÁ,¬YyX¶ÊC ZXoZhDÚ Ð™›Qš©f³Ë³¯ %À_m%]+9·Æ‹é|Få88QT°‹¨U”9Å}Ç39ô¾¥£…tøF EnùW'TsÈ_¨5£¯”ç4õšÞ¸Þì®ñn %,"Ù/º~‡¯\A"T:?ÆÏÈ_}´°Oç-ën3νEâ+ùÙG¦^çT4“Ú [Pö°üïús]¦e&Å$ƒE™i™­;˜–ÐaêMfiJ*Á-òz……EKfB¬X†¾ æê aïÈçÚß„G0šJDPýf¸än8ˆÑÉë'œI="R-IBuÊ@ßšÒäÂÑN¥aÄ`á5Z· OñÖ$®U‡ ›<0mù»…JÓ€~¦U ä®Èe>_¹ çBUE€p3i„Ǩ4œiÏA Io ÛAãR,UåãŠz®8þÄj•õs%b;h¼ŒóùödíV$3dDrùk‚ÆE®3·™|h~¡Q¢ l_ÁEŠ…D\±Vx¿MÂcB¬ ‘@—1ŠJĹëòèekLL­ã±å·Ú´³Ðê´O•{…bj˜ëÒT £ï”{oaØ…°õ²ÈN*©i²¥´D¤økŽRå´›–óÛòÙžqh†ZÿÙLª¾˜°n¸S)˜¦¿ ߣÅÉìö êQiñQƒÈ‚´æÂVlVÎaIòÎÏ]EÜ.*FI¤˜ÝÝúþ¤²¨Ûªÿó¢`–dzî^m‘ívLt®J„¦•†žÃ…‹°#š-ó³­Ù„P®kò[š.þZ  |¤Õ¡hNÓ„ŸÎ-ÓTQpû›5Þ§c'·’3:…X!†¿î7b6§Ž‡S ݤÝfðQ€€3X‰ðT^ÆÜéÜÕ~àLþ¹™oî>ÞqŠŽûÿÞ3üì`gS¨r@û(ÁÜ>}_8J(Ô}¹éšÃê(oÇH€ïZzE ÂRœWg—›—?×(úvQdÇÜ ŠÂÕÌXfÃJHË®u{Ö‡ÿ»Ù¹ ôã(-õ†­›äƒ.2BûÏ(Z¢Lû/y>AæÅ‚ÒßÎpæ)"^C þ«·³À,)¶u5Nw¥`)}¦ÿb¹Å‡ô§@ü^F÷_©kw¥'ºå]±.8¯Ú¹ºì€í „Ψ&7Á£(Úx" ð¶uz´J.¢ûnÑ€qTMŒÔ©:…0Iåp\›òç¬Láw“[þ^Úr×[Nö;ç$j £áK,±…"gÙ†6kWÅé‘/\9a»+PÚ¿…$¢ ~-Z ‰Xõ$|䩨‚ }d•ç.‚¹’ù GÆ›*‹³û‰>CÊøYÑ Ä z Õ­•²ÚäôÀ ,ZÕÜM_˜4ø ¬ÛôÃ`†hŸæM0(7Q2Ä.à¢A_²Ú@øz!NÅÔð‹?ž¤çÓô9M7Z‚ñ‰xŽ©Ç žÏÛ ëˆ‡åºžu-ßÁ²ëÜâôÜDZ`Ç Ç‚Í™Î=Ž©.Zpu/ˆGia–-±Ú¤júbY ÛJñv¨÷j#_‰‚¤Þ¹×fCHLI iÓéOYLüaâDâKêä%6\†ý4Õ§n[CÒ_qÌ«Ny‡ËÑøÄa¢˜WôP•”‡¶t²äMiHUTá1Ö(þQ#ßü—t?óÊr+»úâÕxÎS8ˆBƒÎÊ»¸.bµEÑ©uh™Ú­ýdhðbŽ1{ £xª.Œ ÿù0j©ÿDñÄSt®[ņwÆÌÁE»¢¤÷ŠG»ÐNéÿŸ¸7jk ºØbû÷¬ˆF‘ÝRÒù>L™üÁ¤m÷,ld#!gGÂýÛ„? Oüiø£Ðíb¼.¥¦ôJØFU¯-ý)•Š}G9Wnc c¡ZÇà}eJí±ß¸FUR£-òN{%LÚ÷ v„½E} É¢o¯úû1—3•éawq Âv0j:=Ë£ÕÑÛž^p¯gâæéÉž4P|™ÝN²Xï@|oS£µbÎ2b¤¢IŠLp9’aäb¦{2®BÚܤ™Xõ¢Ö0ÞÛ×Ê^QU¯iÜ…Åï—ÿ1Å=]2,ÅeMqϪAÓº@±„òÚ´?Ÿèü*#«°\)Í_<éK¶45ÃIUˆp“ (ȲZÙB朡8×$«½Ét*—Õ —;®ç²:½†”ß2L•S òð¤ÚZnLlîU¬5§e˜mk–¦–¡Úf2gc©éöéþhè,äzÎäêªP% »‡+»¹:ÜGå1B¨Š)…˜k´l˜ü*%úïoRãŽþ@ʧ iÁœ9º¨v1­jÉ!Kó"] ³+»‚·¶,ž›Q¦W¦&7h¸ê=›)YRôÍfÊVTìöm›)¬(i²õ`Ý {åþw?ìsTMJˆ€)ôUû®aæN"xÔ“AB‚iƒä;ðaqI:rìy¹1KhÂCGm<ÿòAiœ…èCþ B£“ÜÃß9±%Yý<¦äÇ4 lƒôïwbUd‡Cî^±+@—':·Ü9ÅT”>†Ï Ó- ³Ñ’&ï1îé+ü"‘+Æ¥^çS«¶àiEKüJFðÆâ>U]÷ù”Γ îd~eŽîàW¿Í/,á` 2N—жN—e‹/µ¥¸NÁ\ï$¤·§¹” Àm;øÂb…³Tf’Zd®JO@wùÒ:vðWÔ#{(+Ê£]>fD%wÉŠÒÔAj“kY+R,=‹sMè±ôõOŠiœjº±wß¡gmsÙp‚án!¨¤t_¾ …EêcLcª+“u*„ÍÇQ ¤lãÞ)[gªÂ[†Κõ^Ñ£3õtÀ¥¨ÃÛý h©§$Ê OØ0šÆUIþ 3häªîjoag!b^í„›D¨ÕîCYoMÖê2â¡­Û9Íô]Sƒw0URâßNšµ‡0#Yß'™I”/§ns¡õ¬·hF€7yPm†Ó;eÙnFÈ]Ä‚hlã Éª{7oÄÀªfbsÆÇÜ)•·Ÿj9rø·ÌYªrÃq åmÅÌ;¡í=üÓG—bbîOL¨jô#ÌÞâ'ÅùœMõq×]l€åì¶b^òìäò%á¨É;‡~ïʼS`y–ÑåX  Dat„CßÌx"~ ^_ 3r"‡ÝiUg lluÕçÀ4|,5¥½JWgúP¸öúë8ܽpKpæqLLX¦ºîb¯›!¬Õ± ƒRñ÷Øÿj{¨ û›Œf­5ò8&$,f‰Ê· õ®_­Ð™ÝÀ–w€<ø š³ë«©ïìol©'ÇÉü0|Mê“N.­îÉ)Ö™Ý6ïÒéÅŠ¡`eÅâGí9l£qpIù} g3!)†¶_…JId†Ö3vTñq®b GòñÔ{|&Ï7ö8ÈáçŸòÐÓú( ¡ý-!‡áî\­ÒÆÓØÎûðü@ùlÝ.FÖŽ1zàÐi¢¢RŠ_>À¸)HŒÑ´ôKÇ„!\AÅÑŠ ã Ùˆ‘JE³ ÝìÉ¿ùÕ–žŽÉöÅÞ†RPUï-k웽P™ˆÚ_:Et8ú ´ßëy(nHö°ò{c²¾é²é=´!DÿÛxЃ5"8%‹(êØÄMX1ÓŠì8)H ¯æŸI«S½MN-€Û$¿ÊM ¿÷B>Dž‘y§*D¹×É£œ jÐ/ÌŸIžÓKäÙ®_–É£,Š¬â­“‡³ ísQ€|mU¿¶»wÕßFÀùÊxmdʦ1-È£M?ætcgγ]ìJm›Š@w]ïçúápžIˆ‹œÿIðÌ@8uÇЄ=Pð5ˆš¸ð‘d<2“+³öAÔU°®gZát¹|uÃ7±®P%Ÿk³ð,"Wu»,ùìàåxcù›F¯{‹¢EÁò•ÿÍxŸà¦º-~Vh¡ôù<º=j½d))#ÈîŠ-hkM‰@s,re!j^g¯ Ъ³FJ i%]˜ ÄöXòÉ‘™c Ö’1Ù[Ž‘I%?…£ ’õãÙøwÆó-4ض.鮟,Äko ÛG0m,„Ÿ‰f7ÇÞHÓ葬ìÏíü")ÎiÅ)ôá“=QAJ=”Ñpa꯭°ä¸±2|½ïï!—ŒQŠÜ¨ló ‡oŽêC•o‘KµŒH¢XK^5‘*Èe+N¤Í3d6Ù`ÝU·c…¿uÇÀJ.à¿V,ÿmJ+PîŸÔËk“ñ L4Vê=)O_^–S"óHf’ýÇJŒ@:#›«›v“Œ–¾ÕFÒ+Ÿþ'çÜ&ä¼¥ÒüjRYm¾iŸÇäåM«¢Fãó¾´Wü|3ËžÕggB)5fö¹ñÓ«ÑÇR“1Ÿ§¯’3­F]âÛæjDnsþ<‚—W#5ZJåÒ"62D\÷UÎ$`!AêW`§RÄ´Z=Ç8]TDªzïi¶fL²ˆìøÂV2ǃŽ˜¨ ;Rdñàt¶›Ö¡Œ«ýP&5™Ðƒ…)N ˜™-N–¬èá¿ÊE¶¹ã‰M¯®¸È†|S"Í‘^kÆehå¾PîªüdÅ/Uéjpå,ŠV£ãK£N¾“b¢n+Hp‚6kÊ:DQµ}ºÉ˜]çƒ4Q…K]qJY !«ÚJà U[õ€qBÕŽ–¬jk¬œb3UÛ_ÚZi–£’ÇT$ZׯU ÌÀŒ% mé²”ã<þ=f¼‰D V€£Š#ñ•&ÜTÿÊh ¬Ž2å,Ù‹´…Ä›*{@AÖ÷mR„’5™+®õŒ%}¹.¥È«CªŠ{†ªDTðË«e‚Ä ¿1TÞU¬úÌzy¨r®ê$pA)jï²B“RPöj7Jbç¿}¯lòœ­†¼È¥XŒá,§pvXK¯ã,1²©/ÃÛvÃgéx"]ØQp<8/x*ßG&ƒJ“hW4æGæhœ›cOV¦›&B½ãYin ß°ÔSA õn4¡Ÿê’Oÿ!A¶¸¾\Jõ ûÒ¤! F]Ç;˜‚ O=÷ZNÜxcî&^ñ/Qýn2o(Éeèªö ¤ž4æ- >sl¡ôN¦Œ'?§±©Ó91 Mm/|V®Ë» y™£j)Á¨Â»ÌÞ]¼›p¡Ã;Ë~ Nÿ(©Yu-[œ<’1j#™ïˆJ;R£È„Ê© Åâ[¡¿MD¼zmr-éœÓŸÒ\ùCÂÐĽLO9¤ëÉ =S¶âð‰¾zÁüUY…P7uÕ°;¨þm0¶ÂÖ‰¦ öå!5ï”Q©úì¨ü ŒV ùü—¦TÔìCnÅ¢_ÆÐÖ1ŸPÅLj›îŠ—º-äEù>†·µÙ8j=fbŠÛ±Z³ êá4Ò)EÝNR<3wIŠzZœ÷¦®i|y`1èz|HŠ©4SyA¤ú5Eø×h£C±ûî2iLO›,Û4S’jIZv°ñÉa±±,I T=µé²ô¦é²dÀ U˜¯ËôÞý”,iq[Ö;Ú«¶˜q[Z:¬¶,Â7ìú ÌÑ4l\,FAÎÂ'WƤcCýKwæ¢í9B‘P–¢ù‚s-ÉÊF˜ºTÖ¡’¬­ÃZŠqéÀþO$HCêë‹Á¥¶½?Ó^ ‰ ‹ØÔ$m/ôÍüß±ž@”2ÏT¼ýbÚVnaÿ*RIÛšKÌ­^8È•>+íVåÃy4MF‘ùÓd–-¬#n»ò_1g KÈM¼ÁÇaý¦&’Iý:›ü–7¡ÊLš˜²4ا0Ã’^BCM4HIsˆÉok±J¬Ò“D×´ã ‹Yw|§<‡Æ-NJ‡yAÞ•¤ Îññ}œ ®¬q.øéÝã\ÒœsØ)T…6j¦Árßpq@(³༳R¥¢á1¢BC광㶸À(0]S…D3Ô"£•,@Í3ÿÍòþ½H§Ð: …V©ª”ißÎçÅ€Ö÷Öé/ÿüᕽEáj!.Àê-ýK&šN#&h.±XËInÕLRùÂØLVÁ¤íIãQ)Ü£ÈñìË,oædÓä\¡åGÕ>Yý`bmOš@2¬M2}©y'rÃÚчÐW)1LïÔ?à¾ÈLùD|~ Ä*VØ0Š¾Ô¹˜s–BR"C ¥j@¦J»n‡ê†]bÈ­u XÿÝr9„a” ÉTÎ?4tµ¤yÙ BU|[ 4Xl©& êe%0.Ñ•Û2bÓ7 Í*Äâÿ¼^Ð…¯`ú½„ýú=†4|&ë£\V,J²Z(½ Œ“ê{'„TõÜÖ°ÃHlE0Dƒ©â¦ìG‹©Ó–¤ˆ«òwùl'“">4iHcQÇþµçÒÒ<­›¦o¡QáŠ%¾Å݈i%$k$žÕsšÅ)š4fŸXiйG‹ÓæãÎÒ҇ʳ OùÞ‰z™žIm­i¼GÉßy”Ô]—ÌØ;ßg_Ò%gì+|ØÃ>ÒˆÐPá¾<¼º…&®÷)VËÒ÷‹–šþ–Î5ÈcÊ•£‹ótMÓw…a­îÿðo¡híÁ=€ÜÉ!T‰ëÄtîK¨Æl%fÛ⇓!šl*m›·˜˜¢|ý¬™ý´‰ry纒ò±[IѥߔÛW™Ž¨Ê§úÇa¢ Âè,1ŽŸÓÿ@*¡<o][ÿéCô/Z‰~:ˆ)êqvg9Z£»”þ©ë²g î®”ÿo~¢A퀒YœDƒÄ‹6T½ŸûXü[d#=õy‡ïõ²“JŒÆøõÿ±Ý 'GT"“³g²ž¥á?ƒ°J‹ÇCË—mJ¿[4aN+Ǫíëg[G&pKÉt7ÜŸÙ©]Oý˜<ö˜ºÊ•¿8VdÞh;È"ðmñÞÌ··vù‡£^f;‚›PŒ¹4cü†º"C }šôñ´ö›Œ¶`7nõX ‚W*cJ° ƒ·,Ä䂦 Œ¶Þœ³ïmN ÜÒU—†¥`Þ‡FÌú•Ä–E,ï‡þ]KÄÿÝ,dy-x'‚ÕÞ¢‰ã®L«ÿÔdëpLgl‚ŸO®ÈªwÿþÙÈpôCÕÿ‰êJS.nBû›™%;KºÖ¾g!“Q$ûEÞKb¬¿ä.\…$6£bÝåoÍáÎ`#`ößL]C“Õ0ÑÖ¼e¢¬I± L×LWKoír*ÞnµV;鮕ðÛë+°gÀa‹ŠþÖŽq¨ÅvŽÖÖ¯[‡$§ê,%Gšã øÆv¡û"3˜É7Kiþ=º3f´ªÆÜ)éB‚/¦rc†%«ˆ›7ñ«¡b<5ãf„‚0¢}¤G"5ÑIUv7XŽ+ÝP.®:$êla‘ësÙH7CY!O{-rŒëd´¯YäÙl{²c‘«Æ{%!XdH_2Ü÷;UuªÜ ºçÜm zOÁ{Ä ”ìæ/gn6…Jã¾û x#ì¢Ø:°ôà˜îmúºÿÇ]ùeVƒƒ‹9ìB„hùñ‘[°.¡pÌÈB“mÈÝ)\&w çä¬{ÞªPª`^¦M:9>Ÿ3ÖâH{š}®ÿLÃäåïÓ̵[D±9—ÒŸ‹sæe„KØœ"DýZšßÌcKÃIUªñl_™° mêFŠ q_§?þBÕ[1„Ϧ‡tË(ÿOþ†Êäªüµ÷þ}uèÿ†®ŽÕcÕr*-êšZx,^U|HÓWßy þüK··üˆ–SüF->U'H3àE°ŒF'QÎ62zÏ\Öó&vÀ0‹M°}™Á¢çhxSÁ‡>§‚—™Êi%ÄcÍ©[QU¬  “cÑà?‘ÔŽwòz}ÂJÖ@ów\¬5t…›X;uFTžàî¦PñQr_±ƒ†_ê úõS¯D½âjáÈ$‰ó-ë3:Ð 7DøÎFÐå¿ÙrTâI´@zäŒr‰52†m+gù»:v°³]b¿xï·¯ Â%8ÐÊZ [,/<›œCÒ=¾ ÃN5Õ/È…þ8çÞp ê(@¾âÕGÉ鸑LGä42‚Fê„«´IÓu‚£šBÂ_šZsØQ$Øu)*¼€õ$j §\A™=4êRc:6gʦ¬ÙÁÄÃí…mPÏà:‰8©Ô®ú†µ6U‡M•‘*­Oê¸ s^|Á—_–bJ­\æ®^$¦¯D\„º ¬mæ¨÷ÓpWY‰„‹bI, då,,7\Œ‚«›P0O;”Œ¦Í¨ˆ‘w÷1ÔdÜqìˆäÕú3à',”zýí‰`zá ÔuŒd6/«Þ±sµK ÔŽemµW‹Tün;x$—NyD0rwVÈ1¨`^!væ5®ó‘º˜*Ç®rF&±Óó0âóÆ-lèeKšð)Þ z`ÏÛˆùÙGF¯ ­ó6gÞZß›¶4€ß©þë;>ÖdYžc0(³ òSEÝ%Û,ƒ…-– RUzU…¸1®e‹/·>©jÍÉÜJv®bb#§1*6뱊®ä1ÔjÒ›æÍ —¶ô€·BºÚiYhàæÒ#,íBGKWnœ­ì\SÎe)Ê5NªÙ9ªño²¯[ˆ7ÄgPÐÑ¿ Y¯7*à™@å˼^‹Ç”$)4äP"ß¡© ˆv.îPJ‘ÚÆßôG#Šô¾ìI”a„“øÔ™Òžªm  L %“j ‹ ³Ýä±f Pð“wÞH>¦xfšgâ>ÓÉT³ìŒ¤Ìõwÿ¤Veµì[ó“!'»Õ–ùÒº öõî$Èó#éX{~ÇÄ"•ù©`–$R¿’QúÝ hGä÷ߨÇ8¤*¦œ)ƒ8•`ïZ‰¡œñÞ*ñ +QW9qÃ.·iKÊEl_b%Þˆ¸B$|Í1ÐÜrù‡A- FÁí EnË5'ld*·ãW›6¢éÝ rÑv˜ù"¤k“IžHd(†?%F¦6Û+¹º U%w“ëdU«)Îø¦ YÆ+å¶~qßtvÉ+$Ff«.Æ–l•°BLø­Í2í6ä s*•«¦Æ%–xÊ2^ëæŠš%o)NÚþYoàV]f$vxr—½|\¬p9hUÍ8žåPML´`S4Ztç;ŠHêkºîg½}%?û0Ôkz£TÅí¶œpgÎIZû _2{;ÆÏÉM«ÑGKrÓNZð”ùŒó;NøHTôÝèTY^ú3´¦\ÕŸ_T$Óhì[Ìwå#¶ç| ¬SÖ ‡(µÐömÎÓ–M‹7/"Òóþzݾ¥ty&Ïøúo=–¾—:W—½*ÓCÿi²îN/¶ÁrzÛÎIŸž,«q]‰là‹#P¹2?Ö ŽßÅP„®_|힢F*¶`§±,Ž»Q§ %׫„.³PÕÎò?&ƒ­ÐOöø}y3©mw¡˜¾õÍ ­Ž̳½N0ëˆ23}ìÀt˜ïÇ®Ìð+Ñ95Œe¨£T8mq™±“íޙߌ•·¹Ì”ŽÄ#6é™!WûCÞ;¹ÑvPøÕq¿àî½<=4!²;Ëô¨Ðׄ®81TU®fŸ-O4r‹«ØÎß…¬èO‹KÕ.éuŒt'AÚR>žz«ï•îÚêøS¹PPqéNCÀ‹v?Á«¥‰Ü :K_$'§ÅÚb®åú+޵¥¼Ð}Àr”HÄÀý÷è˜(¢WÈË»PvÈAGUJN˜+Š UÚb1s¢¥˜9¬”ñ©™ãoíHÉ1c^E®D½¹R àDg‡¢Î y,´}ÑÙûz®á0þý²~³5A$Äu£÷Æb¡ù–aÆç*Ð¥p6«ýF}ý2ÓTõ HU+µ¾€f#- ØÙ€P¸úXê ¶ð²ÑåHQ« Žr(è(¹t×9T s¸-~°¸Ff_^¯ÃDz‹Û—çeràiybÛ%M{ƒ*ÛˆÞ›õo‘@G5ZšùKùûçcÝ0ÕNy¢Fê'§&Im>+ˆiµ*W¼ah¨Ž*Àeäüù‚ßzF©cÌQË„H‚sþ4"iPZÂ`µtI°…HưìäŒ%Ør7Ê|Ff†&7-¢—Qæ;®>ÈB÷gU©ÑÔÄÚ}Xü×)\7)Œ+âø0øtz¤öyý¨|jDµ¥åàþ0lÚz=ÅSú¦zJÿ X¡0õÕi>VÝè;ªs^(WïŸNOS•ÂC¼A>¥EƒæåÿSNŸâÑGƒÏjF"ñlÞ²‘éó’ƒdö©&7N‰¢1¥Ÿà†"|”›„³×ÜKÚÔóA-Ò/ H¦Y¬¢ijgPH¦§sÏb\ºFôgƒtÃËA¡rª‰¹*WjUiƒtTAn]«,4ŽÊŠ[M[m¢91³Óe¥Ë¡ÆYUnn1dGØu“Þºf+8ZcW¶¤ÖÒâwK€˜˜Š]¤3ƒF T;pVQj¬¾ãÛ¡vð›ÊÉSëÕ§Iˆ!'Þ̸P¶Êùª¬LÃB~ÈZÇdà¥WòWî#W]™óÙ3É…75ú]Q°±äòϤ­Ò¯Þƒ5ˆ6§³Š¨`y5ÒDË:=B¥¿á:y(åI>†Ð#zë’Õ˜båòºô–ɺÔ];+—×eünÓé.a¡tÀ;Ã)AÛŠìžúÛÓ¥YÎmßunlA0±iLÂ\Å`I$_¶¶‹&ÿ·æžcÓÅ„¶»£§¦Œ²Ã¹È™B˜Ó)Û”Q§¦ŒÊGòBFeÊÁâçz ðd®ÎMïµ-\'¦FâT«€8ÛÑáO:âð¥`«Õº:J+-ÄüÔŠô‰áª³…ÜmC<‹‰iÜÑ"..[lª„˧^‚p%_á¸?!•ªpidê5µ8ñLá˜5…ŽØÓ”_XÆ~ö1TŽhhq*ϯÃ)œôA¥ ëZœÂIºÊ©BÄÐ6FᢡKôTQ8á_þ…´·¤èBõà4BŠò5H X9Øg ˆÀ/Ç5  ÚEuï€Q8¥úWe V”Â[JÄ&ÅÔœ;ºZ‚!DÊœ7ˆT»^OêMiü¦rÔ¿ZDA³{Ç+iQÖ„91¶…´7lFøL²@¿Dãä£Jþǽ7†w5\ªÌHˆ]¾«¼r· kAÆŸöHg2ÞžH*êŸ7qX-³¯ ‚V"©ßæß_°ñ]xfDÍ‘rÓ]MÂcÖE cK¬6g1£©ï"‡ä;Zi­Áß)gν+X—ä@ ©Í™ïžk9 úc·™óÑä)šOwº;ÓñŽ0ç±Ë@·ÊÞ–Å®,JXñ!ŠA“IV®$¸,_·xmkø¿›%¬ÌÞù‰ºÖ2-ž\ú¤ä1 à6[É ÎbâŠâ <¸8þ(kóNÙ¨”gguÅÑ÷Ö°+€¬HKw{ãî'«¯Û?®Y-Iá™=ÂåvGLOvÆ$ |âs›*mŠó½[õ PÚ¢%+m«l§©Òæ/%kØŒÀ®KKåSû¸sŒ¥Q ©-%«š ¨×n`‡äˆMívÏ2·tãpTÅ\|,½±L˜Ö7K¹æ~=Š£,¨°âõêL²^…p‡!§vÇ“})…|,Kñ‘ p7Ü<{Q³P} «›â8$€*,=7¾9ÒJ‹Á§Ý¦6›“1¾bjgs<¬ÅŽ©-ïX H'ÃÉ ßŸè~ а Ù+À¾¾ ¶„äÚ…H,ò§ý-Yè;kV“• ïÞc 8L õ †v¥pŽP–~Ñj~§D-ŽVê"Èâ‰=Ñ¥ÛÑBü­·\HNâîN€‘–è-ÝŒª¸fR<½›ÒBêë¢ëÍJk„´P Q— 4_¦yèºLZ¯R#Õ©=\¿Æ¥ ê:.uE›ÊzAÌ m"Ÿ6·È|‡– LÏ\Â+X8Ýy¯±ã™ÔW\¬…GøjÙp§ÂÑþþvó—Ùm±úJyNã WcT ‚‚èµ×rR@­ðÙÑ¿¢@cUàqÄ3¹Ê§}´ÀÃy löçw‚"ñ•òœFF¯™fiô’2ÞÆ ¹AY øYÔUºmý¹iËŒiAî<É`QfZfë¦eèîÞÓ”í,Â¥Œ¥fYÐNšeKfB¬X†ˆä.ÅîìáREc¯¡åµ®„¤Þ¤S]¾ÇZ]„ ™H’§t^¶z#7ù KºñX'½t¢«èDe»*Ž”MÂÍ]ÌP‹óÕî-Zà,[f˜œ¢Lõ;:_x‘ÇÊP;ͦKÄÙ \XÅI|, ˜NO!ÓîÑeúáiü[DÐy çù¶ª×Œ$CèÄ×k™½§¸-â\ÔÈ®lÜЕ+8á6±¶=‚`9±º{a©7*™ö…Ý'[Áþ›BÒ7ᤠŠq¿ÏC·­ôÆ ÛÌ(ÏŸ{ªåê–bNx27°}×ô;†+ôC¼€P/ì+ ã}d7KîISæ =D›4oA««qIPRŒ·ÆRór¹’÷ÑidTjØWm{Õ๟†­ =IàJÆ…þm!¢§[$Û4ƒ®¯î`Ý7eŠ^CMÇ]{O·Ö ‰ÝÛÀ9n{BŒ^Ùø†Iø[äN£!E¯/›ÙkÖ^o ¼¶öÀ(~×^{Ä„•µ‡Æ¬ˆÔl¨= þc°¨ Qícæµ£óï/œ] oª0{U9Ê\«:» ÇÎ|ì9.«ÆÙ¹ï{ÍÖÌ÷’Wk`^; Ì+&Ñà,*VqÇõœŽ©ô—yH˜åMMòÌ`nÇ÷îÏçŠøÉ/âš#–še'ÊD´€†Ÿ‹(Õ˜Ü[ ³/×ú&lºòV¥O)ŽÅ·TEJÅp¬6.tFá[¡û)öÓpìУ¥èŒ,gØLgô·v\fò˜‹Ýpiya‰<òthù²œC4 ÿ¢uLÞ†¬ÆŒž^ÍØÎÇ“ÑiãAY'uséíœnµbš—dˆ:V%Áì[í$íZ’‘ +ܼ‰#£#|»U6ršS[n*T&£j•‰3[O¶–ܾ8J¹È.ø$ScOh½ºc-,ìiË‹ö4x²¸ö4 òE{32vqŒÌ ¡Êúß>Óv†€)q(ñµJ¶x(¼Ï©@5ü‘à”LZZ”y"‡.*‹@Ò—À9Þñ ¦¦è%JùE H]jÉ¿Q Æi¼sS^ B@h”¾Ržm*iío…ê¤ÐãµÌÔ«øÊâ:1*ý3' iñÄéR=¥ê͘ýMõ#é±<Û(„T3&VmëÔŸc5ç͔ɓ Rgeâï`Ð)ˆÝa Ô`¡HÌ'²úbª[[Z^}bÕò¿áºæÞ¯ƒu(ÉÂâUMÂ5‹[è (Âi*ÛKö«ü}/ÔW¥/ÕDQq ²äÚBï&„³3'¿C‚®@TeD \QR7„h°é ;’Eç¿3¡WÓê ©”¨"6©T,Rj¡ïÖGþºmZ„iIÆ ¡Ú?Ü}AØÊ{|¡«Ý³°ë‰JïÔ©¨bvMÛó¬¤Ð ÅùFE¥[š=þñð”IÑ]/!ÿ&ºi7lÓkd²çÞ÷éSë»ÐŸ¿oã%ªàª •Qû'D›†ÇÔˆ)4äâL<Ëèly¡ÝFœA(A½uAÆžíµ|KW2¶ç´'ÇxÛþ.s’_åÉõÕºˆ0­S©dƒËkªsç={ãF¶—ÇP§oFÖòêsâL¦Ì4üÁáµ]ÜšŸlG³³Úó þu«‹Çüе9^ šß½Ÿ¬ÉŒ0Îó0¶>G‚“jþ û”½¨ý«},ÃŽ·?“`c—s¡,µíq¼µ·qVŽŠZ&U7íƒ÷ã.²Ä'à‚XŽwnñfëË4)x\’P޵Kñ¢¥kiÞ-'_†ìÒµyÑì[ˆ":ZŠˆ¶‹V$Rhªßí°K¥SßU…™êm\lƒ¡\-±®¥¥5¦e§ãBËPG‡–ís·ÿ¶ÝÊÍÊ@"¨Þ$1_ MÑ\ÆK¬Òãq^Dн2Þ®XdJ%9û÷ÖQnÆQ%)èJá\\¯eÏs²å~½¾xeqˆÿˆ ¬·PŠ“3±/àþöÅ©c_˜¥’”èb÷°Âò8’-41WÝw¾·?a,¦t †ê‰ýâ†W%¥ÂŒŠ†1Tia«XÅ'J¤ð/*ÞŠS]Vëöœô¨I¡Å*Ú¾S5$€sÐßË›MË•WéþÌ?§!Ðezƒðõ‰ÑçJ å{ˆ‰Τà±4e<†Ïr¤§‘G‹Ìüe‹M––ÔKC·só~‘È#S¯sêÔ¨Ú85q¤ë–ªªkvviiñ‹nó ò[hÈn~ÁŸ¿0Ž"zÈhGEe*ËçrƒN¿Y%‚Zô÷3Ž×|ŵ¹HE*[¦@x®ˆ¢©µ(ÀëðZâ`tŠûÑUYY‹›H)Á`ºÅ‚{!È¡`„Y›RE‹¸¥ÚÓ\ ÇÄóÙ¤Ç\"›«–fÕ|‘WSÞaÀ©¯"tí•b(ÍÏGÄaD¼q~‹‚œâ.Õ€:”òÞâð©œ[ƪœÄ~¢µÜž ~Õíì¼ÅQ‚„.ÄkÖg]wz± –ÓÛŠÎÓSÚ1Çl›{ÅÓ÷¬(Âç2œÆaùƾºR8båŠ"ÍEÆRd"¾NÊtºtÌÄTThYÛïÀ¾îÁò¬fb#„ð¹COI²"@9 ¶ÕHú¶ooR\:aÎýþ[®®m/’Ç1¹m! ðµ“Jº¼¹ÄðC¶tk/t¦·{‹V@ }gz}¥ô-.×÷BÖ}E™p?Áî¨?ª©ÙÜâÜ Ì"=ì€V6ÂiPk‹¶8ÑÍý-´MÚ¢PaµU(ÜAbý!h&ÆSŸ¨»Å: ŠÄN€m§`h Çöª%¶’J§Èàf­s÷9UbtO¬LaØŸš ÎU1Sæƒ% à*¹kzy±nŽHpº²J•ÄvG›i¹ÂX2XáfÁpË™Ë N^vo(ö #VvàÔ|É?"ýÀÖ&QgºªÚJô»ãØQÍãmìN71êêpKT¡„´A×é`6!Ég‹ &ÚÀ_¥ƒmÔ_7hÁ°?qæÇXjž,ôucCôù{´û7µÙä¹ÌËnˆóóƒà˜ÿ 䈱ì"ÇŽ áèÕ æPa*mïZòU·êô}kEøÑ ýàd“5 5 PŸÉDz ‡fRÌå0=G_+«‚Ó‘ªäP΂ð€ŠÌ ˆO1F ÞrðO‡cdvvæ±TPãf $1àÒTý<2!e[d‰X[ÉXQò¥ƒ\Ý‹W]ˆTY/èIÖæ<á’Q))ž©7#Að~´»l¹Zœ{¼CMeP4ÅmûWò³ƒ^ý+QhªB@¯½–Ó©¥ÁwÿÊUg˜Nà40Ä‹ÄjS5RoÀeT5P4ÓjzÆAŒø@yNƒR—©†eP<õ6ò°‚¨‡ÀÇ -«?7i™ó+(§ÜÉüÊÝÁ¯Lû¿ˆ½ îXî"®+7HC²^Õ’3!©LÖæ ²È1e{FWCnäaÝÈ&µ Ÿ6!..jÖ D>%\§'¥…XK©UÛ5N¸m}àŽù/Ó€ªUvUFÚ©äØòÊ(Åt™ÐK’r…¿(85ˆGiÿièq{ò½úÕ²À8çeÂ5`ã\©OY¯çÆ-Æ_Œ9±âûµøÙßq0)r 5ÛŠYP¶‹îÿB,k,ï«b‹Ñeñ8}²¢Új[VÝv«òwa«HÄ'…§¬ÇµßÍàtâ¯U›*W2•§ñî¹+„Õåëña×"æ˜ZT¤-V ƒåê;Sý—¿ÛJ=¶ ™Ï[æüõTÿ=µÄË*ŒíÙTfî\I1Ô«©I³½±dzä•Ï[P*2V·*DÊD7ZZ›}O´´u] <>–[Là!F“X}[àqH›ÀC„šÈÌ‹Ú%jy®^‘˺é IsoۭĤõ ±³\~C‰aêJ'J·~Ý0ES ±üœ*}þyÇùšêØ«"ûˆ»#ž%½Ðo9n£EÚÆ²…DÉž©ªˆ§ÍJçÖGÊs½úöK¯½¢½±¿ÐY¦õ‘¸G;†ÏÒ8Òà£E‚vÖÂVMóÍ9üå‘fõôJCO‚ÙÚ ZPõ@-fþ9i1Ñ2eX:Ï0Ø“–Yºƒa™ø†I‰ –rÄÉI+JúÀ–-N— ­¯Ñª£ÄôE/)1hü„¾¡+àª!{z5nÚ"Bå ¡‹“q‡âBR³ˆp…¸ŒC^NåFÑãÁ” :¡”P® Á¬AlQ:š>jÒE®8/ü¥i‚¹»»™Þ!z  ÅZ!–ɲY5¡¿Àß­KQ¨Mƽ¿–4»ô.’àd"–FxbbC­÷=Veimû»e¹Î”¨X7áH,¥†ïö€°i#A潯£ykASN(i?}OŽ–¡r ® ’þmªõƒŠ_qª¡š?(ûTS-‚n¨Í'åUÉÊDŠ<ò¦¬WÃ1ÁÄe^¨¶„×-6OvÚ(9C’øcÐÎ/˜Ž¤v±!nOyOòt X7y÷<& ¸Ì=èzEÖH4SúÜîRIíÒ\2Râ°m'ûê»ØIºPP±j3“ÎY'÷™I š†è~ä'Òì2NÜO½nœXÄ( ÇŠG’ßA5'cÞYȘqìê¥.6¶5BÆŠÑPuÅóTÈįvÜrd1o7E«nùd»¦  ÐO÷·„I1G"¼ x©K"0N`mÓ”1E±’h"=eXxá_s÷„ÏãoŽC>¥Ç¯GŒ£ÞGŤjî{a[ÜClWžXoxb¬…&,³u%e]Wj7Ë-¯©Ý\/Iü2ÍBí¶™;ÕnåQÆ.%Æ3!dºÜ)Ya3L≻vhB“o:~.c1µ¥ Û+æ,÷ý¥2e7ÊzbC–Å›³ UuTAÞºuøFÞŽ“x–nNŽ2ºV´hZK~G-2ÿéÍ{‰-­L3}¥<Û8 `Lš%õv,ŸF}ô[°ˆ8Nâ+*[<Ú•midñ |ôÑ[-iÆñNPä.»ëvË4‹‘©×9ÍF¨ÚÚAÅœî¯ßXV.3 ¼È´ÌÓ„½Æ4 Ë`ÑMðBªŸÈpZ´ðå´äúĪô|ïD9Ô‘Å‚@ÉŽ íúÝ [Ý VžôPJ3töK× ”XúΛɪ8ØØs£ÒpŽDìÝ)NÀ0h±Ÿ’w’å×ñ‰U&¥ U6q耲¿…‰ZbŒ½ ?5aŽ1º\ŽBä×òrù©\ü £ —-Îw¢Áüûµ,ÚctIž¡ *Ë(ùÅ¡`ÄŽlÓkÕôÒ¥”èÙõx£•E=(úA†¼tmYa¡gk=º}$ú"‡ËsöVtd7Õïáþ›ö÷'Eq6uw<«&¦òˆmݽï”xÍî ºlZ/¬Õ(óõá)¬øQAo::Úó4Àç§£°²Ž7P™ø“ÒMuX„Ù^Zžì¨õa :‡X#¦‹*\¸ÒQ-$kiŸm™&]P êÕÛs?&D8Ï$aåq/mP‹78bw÷wü’Eéã¨÷èŽâJwƒ”y¥:·ÝämT¢CϼöüqÛMÚ Ä ÔÇËàZJ7Òƒ$zô§Üùí¥pL¼q^ Ô1O_D#Z½>Lin, ƒ!$®MLÂÇ×je½AIm•Aº+gZ´ip$ãG:°Ò»ÛÁÌ·¯Ï¸ z&VÌn‹Ë9ßÅjKöÙ>¸Âuc™€”TSjËKhÈ;Õpïšsú "(¹ÇPE¹£U*>±º£ év^C4B?󆢞1T™XSí,ÿèW¹:®cYaZvR¬G ¦®´ØÝ5aÊl(¬Ú) ‹X]­þÍB+u2øJr@Wûp$í÷ŽÉÙÊT±Í7ùäK¥á¥èò¡„f¤Š<¾WËÌ.ò…䉡ԜšªÃ&jÂ$ÉáLÄ—.‚EäpžÔŦnX€a ‡aÏ/Ô§øUدþ•l>/ êh±=37ÿ÷{ÓQAì![(çQ þJŽß „„ðlU®çó&Ú²}ÕáQCÍßî ÔUò}åûz¬‡×ÏíC¾œßµÂ¥W–r-?>r ×%ã¼Æ§”3Þ%V÷sÁ’ÜOnù{iË}o…h´ZBìcÔ³Ø;’2ìá,lÿýÒ…®é ÒKe—HëháÓS3žø*D– É µª¿¥G.J4ŸÁ蔬=Lâë¥aÍ¢öÇ_)85aE¼ðcÙrâ&RÝÌ–;á™’œ%þòœ† ^ý ]'¦š ê65–M\:–’Ñy'}èÌdT€*.~É3ð¸sŠwÔ’&-‰@ñ•xJ#£Ç ùèîï³DÚa^þé‡è×ßâãÌ´q^‰ßäÓ ë^7/@:#FõèK«C›9…©‹âõRè5…i#5›Yiuù&èB…\žN¨º« Y=³ í¿7A¨'ƒ.GÃ+„‡ÓBò‡6ƒÅ¼°Ë,Œ=ÚrÑdKȰݢD<®Zÿ´C©>þ;$­‹i€¥’Ëj15çFEOÎ$Ëî€T¦&‰tú{œc2DRuÂ÷d$19βj7>åx»áЋ1ÔÂ?÷%ƒ…o{ Ó– nG‡Ê†hÙ4MŽ3ïQñ”¥P¥÷ñ@é¯ÍEíÓMŠM(˜g½MEîgÂEÔÃvù¹'é€ü6„£<(Ò²ÒäÅè‘ì•0ŠB2–‘tËšd¬¡àia¹ÅªÅ¦ÇöB«É¶A2*bF,Û«5†¹r`„íP•Ju⢉ú<Ï+d“| ;¤Zi«dÓ?6÷ç›dëŒáE²áZ  HgµõãÁÞÛ b{ÜË‚UZQ_ <•€€à ËP7„¶7Ø1¨`^)7¢ãñ’?j 5G¦Èž@?ys±R^¬ð$)\„4¢±Ú³ëcwo1¹!óa“Ò]ìåì¶äIÌŽ0;Ù¨÷ù1@^áž*¬}^@ÞÅ岎C“»’¿±ˆµÇ—óóhøn”'ÑÀ¥S*hÕáß1©ýe~¸÷[q$¶§¶æó Ø¥=Ïm>’ôŽ)8`q–БŠÃ1¹ýež VÊî_ìB¶›éO/Mv£Õïð1íB*'™ÁÜ܇Ԝé‰ñ÷ö!®S¥÷×òè ²ûó>DMée÷cQj~?íW*üCM!¿qŠÚšdïýAéý¦¡ÉæP €Æ³ ·Æš^?öS*‹Õ˜R0vø$šØtÄ­¦÷»ÝJÝgeõ·ow°ô~ƒjÉ:[Ú!˜©Ržn$Ñ’Ýÿ%tO×k¹§³›Ü?“Ùv0P5¼ß’U-³-š&f›ŠEEŠýS3ÛRy¡*AZ]ÇÙÔKt8BmK-4a±YGZ8©Ì1½À³Á¶úžã¨œö¡¶\G¹‰VKO¹Ó—©à|#ંÉnÇÌ3¬È’8QƒÚ ©Hy«þÑ£þ3ãª÷á‚@Ûiï….P¿€®táR:‚aWc¡ ë2®›SŠ#—&OÍaSM“R%âã¿þuíl¢´ ó ‹ûrE± 2à»,°tôò(†ü)8VuQÖèãªI1Ù7[á"ìà³ÔÙ*›+.âË +!Ÿ:ì2LklAz9e5%x8¬0C•ã À‚õ&×QE‡yãiÀư(–æcµBšÛÇÍ”Nq ëÍõ¾jDOÆú•¬b5eí¤Z£"U´¤â±< >Ž'â´Un–¤Jüâíög0ðÔÝÖê-’V w¿ârIïœÐÆ©uÍÍÜT©ìÞòœÆ¡^ý p7¡êÝG•­¹Ò!Ž}øÀ.å¢!*ÖûУI"¯nbi¤ —ž‚"bß*$ÒÐÔmP,=ñ5µ(“B×ëÏõY É“\°,˜ºƒe…m–§›y„{ûvVÂWë²Å 3%wKŠXîΫM—=]UµQ`@  ­¦üñj^¸« íÓÏ£uÖ&^)2:ø&F}2]jd3ÊRS•÷9Xx[ªZMÆ&b`ÈüÓðAÖ«Ÿ¶u"Õz–Q8+ò5ʰ”Ð25$6 pAmøIâZÔñ0³%áAþ’4„Ze;áã÷Ve"EÌÓnYôr‚Oä¥mÛ’}®Pl;ƳP ‡Ô¢Rœé1¦¼B²P„… Û¹R‰âÞÃNl“~ˆCTP!~›nýÎWlðB7¾I]´×è&¢ GáÏìgžóØXž×u¿B·Î^¥q“º€°M·c0ÄL·›.@úóòÚXœh(ºX2çµÕ‡ú1¸b™3:zë’¤.nÊ2yâLÇ”&Ð ÝaÑfé1°b™z÷ã²¼˜¢;½ØK¸m NŒéI­z€5çw>N,óã®O¢=k©ò°0'娨‹µrØžà1xb™ ‡#~áßúB\ØtˆJý64.¦jOô`±LTÅÍI‰pÃy¥òÉÞMâŠPî©?o %%ê´nïþ`8ϵӻÙûLÔëÀpáŠBëfoSV„Ò)`B^ŽÌéÏKê Ç`5Ý+ããY({úî60lŠ‹jØ>>¹ê» [èòJ²d1lT_îP"4û*nYà°Ò˜›(´fC‚éÊ‚ù<ù§X"+% üôNæþú8IÇÑæ't^Â8mþ‰é¡á™š£ª87 Ü‹.¥)éùÑ41=ˆŒ4šé¦‡¿·F÷P@{Ô#­°’)º5eLy½Ù;zî"Áü[¾-²C\Èh€ÝqäØ u•ƒ·¡ÆI*W&h#%â¤3ˆ è(A¨µäûÃi‘†Qo³)v`¾™è åÖ‰ €›_¨¡q$ æhfcg,„ š À™ÆRÓaG.;z/öŠòòÙA*p[î€dö °x’›!2¦¤­íÁ€,P&”¦Át¾ê·ö X‚ëJäÁi¬mÖ63ÑbgUQ;/sœT‚3㿵c»\¹*tL÷9p(åùÈ8­'BòÌ—î÷LE-‰G _ð¡+þï༩á4iÀsCü£7<9Úà¿TÿùѾF˜Ôîþ9-Z&ï¨ë;Ïþ ï;ÊŸ‰qŸ(îg_' †Zädí¶g’üf>@ve`· ¼>º´¶úꈆB2Ýéü Þè•HMØFÁƒ@<¼ø$©tư•{P  ÀUå®Ûd3€ÊäMu±‰r4VL9÷;°2ÿùÃ++ ¡{»Ríñ²iÿ<˜YÈÖËd£‚í'6C›lÇ_eµqjP&gQÁη¯p}¨:[”`·PIªÃëF{'Ò[ëD¥{Ÿ¤©Õ뤋ôÅÖzé{PúïJv~¦6?9º€2?ߊ~¼ˆ;ëN/¶Àrz[ñŸ1=3Tq]4×+¦û±ì#è´Èf©¯)ùþ s ¨}hb³ØîE×ËÓ௟Ž,ü#&Žâ9Kþi/~M|+…ÔI  ²b0ˆhóñ¬Ìó ö|,é/€1ó:EŸâfœÎüú:ä{Ç J×6/ÎÕ/€1óüÐRºÛð˜$Â>”|”E/®^¶¡‰ !‡ ŠiúÙ@’Â[5žúTAò*òF…œT-m.ˆ©×ÕøÖ°lÈеyéUJ%v}ïõUÝ|¥„a…Œ^³À:ÄDÍ´’LÂZuuLÌ;›1Ãl¸1"î–á¥05¢¥˜¬ 3mÝDñ·v˜¨ŒLí,˦V2 o5ËÊ3 ­"–œŸ’–q¨µÈR4 ¯ÞzþÕ°<¥‡[ÉÞÞxt"Xï'ó+`¦ÈªH‰J°Yùi‚g™,D¯7Ss¦XædÖÁ¼þÙǬ%ÆSïº\Hkt¥ y~o¨Ópjåä“—œ  ªà!PJϼù‡RÅdz›*Û°o¦ k¦¤ÓY£eb#n ÇOÛ‰–Ìn¢eQ‹#òœ¾’Á rl Ç› eì)¯>ÍÞâLÙ¦ÓTÐ1s ‹ô˜ògP,yBu:1e•Å,âäJwHñ‰9*C™þ‡SUá¥b¥Õƒ°0Ý3€Å t2Z~|äÎöÏ„|(}€Ê0ì³¹›Üò÷Ò¦RÖõVuгœ€ ê*ÒôÈ:ó‘ÿ¬ÅÄ2´36Ľ[v.zŽàçßâŒ}lVUæFqSÉÅ߬è 'ü{Fd0â¢Zðq¡¨Èñø 1šT¢ŸÿûFˆàÙÉßàH“Îöá½çÇôu:ôçÔF4Cü^ÃiÐ}ðç’>`g¼b cH:óõÌ2ðQG ·ˆë6Íx#ˆß(Ï6*u9£šD±72!‹™­>–YDLcßÇ"¦*_9ž«Åb‹AÔcƒ™¾¬¦Å¢bžNÕÕwšÞ ªt&~ïŒÉ(*n²Hs0í‹FXQJ‚%+WGs­2€C7#Õ«ôÉŠ¾fùkìrŠIUˆÀkÚÀØÏJ½,ÖþúÌÎÿ覬Cg KÇÑ JÄmrƒXæ‰áoÙ zå¢8¬C‹ñÚM+ÞÊ’³2»öe‡È™TõGÁ$í ÁW&Œrs¹’ [ÍXƹ6‘‰6fjÑŠ2Ðß8¢‘nª—Op‘ pyRQX÷? Í–y¡³U—v¦æ ±Ný}.rJoY½&­U>O)`ØšW›O}ˆ²¨ Ûie>|ôñI nÍ'­B)úoðE÷¡Å‘ž×™Cß¿ü–b@¢:Ìò´×i¤eÆŠx;KjÔ¿óoüg'îu7€Š 8b:e›7¦¸Ö¨ûټɑáÛúÒœü¤ >m§d0ï½§Z3q“å ËŒµä>&Å ¬Gü*Yë@’Ö&©_–(/Ì—0%,¿úŸ”ÃôµÛÄwÅÞ„ÕA€-ߎE=8€í¦ Éæv+ŽpT1–6agæÒKûtb*¨T½$­Ÿ7Z×n&ìŽb=Ë C¹ËW¥*ñ¤Å]E±†Â¯PaÅ»ÿ–Í4Á½Ü±*SØ E«ªŠ±ìªÒf¿K0†…¸W ÃCì/жüßZšÛݘÙfò2žl™¿iw›•ðƒ°³ßµ»cTF<.è>´*±þf0BQœ_†OÈŸW0kÒÛ«8•#¨Ž°ˆÇ®è¿pí*Ò¥Á~T Њ3›”SÔß0"Y°ê??Ú·9¢+Ã|³gë.ýžSÛ ]qvIcV]lføEH• ¥GŒþU…PÖ¬9x6üòg¿ž*±Éòê™cE["Iu¼W°Ù8²ï€$wªk±¨HVD'¿B“$2B‡†fˆèß±öï2H+ƒ÷Eû|ÿƒ›ã$ š!ÈGhç… ª¿sÿ\äM›ö íOÚÓÞ mUÙÀGeµ$à b_Þe£«Ûzœ~EÙ-S¤Æx¥¦q­°ûÔÖ8½Ï—´ iˆ³Äá8tƲ#¨òŠbC ×ʶ´WGß&-›dÛÖɤ»Á.ôã%é´D>mý=ì—ŒÈüB£;âåU ee̘Ãûª¥‰|£r…Ô\DtS£.mIÚ—bŒQľB©¼(Çû_ÍD™ÎAÓóUÕ&/¦x†¿á£à±$›ŸÁ«”¦lþ® <@@‡ŽrJZŽû î›:‰¼ -e¿N’F¤ñf¤±ÄØöi‘Îë¤ó°eÙh§ÿöñß?H"6W%µXÿ/¾„¿µ í.Ñt¡RyN%mÈ øaŽóx hžJ˜ùñ¡“ñ¿o|» ‡Z3ÉeÇe{ŠIÃ.Aè’n¯n)gs•%•ÞHÝva¯è£†8t¦?÷†øù·!E ó¿}¬i_BøSf¯•»ûF‡ä4Ÿ¢eïïå¶²Š#Þ]¦&(gty‰‘XtÅ ¬«qó¤T#84(«‘Ï’“åžfÔïMW^ëOîÿ¦ža4šï7u¾CSÊ"ø¡&¸´¯9sgVm2z¿§oW"|Óé7éÄÛ‚–hçŽÍXA´§ùuîïÙ;CnáÔ’±ùû§ç F§Ji„ïðbP°:kÃyÁ¸¢åÂyºR…LáL uÕ0޵2>[Ü8øm HZ…u2Ù­ ‹8|Êž‚ª‚L~/(Û`OÕqaOé¤bOb±u5åy`ƒRó,€L+ùßbk¿æåXé×t—ÞbŒ+(®­;_‡Q|I \Ù•Ä$‰•°lÚ…Uë_#«K=‹V>¾QÄÎO }JÙmßFÈ"ÙǦQø°J¼Ùî±V‰¸ûð¶è¤CVâÖ¸öÄ+ž$ʶV-¸hØõsÞN¦4I~ösú Ûúõ³‹¸m9™ [¼á†#A$¸åû“ ‹†w‹0!Œ XÀya7~~S 7:FnŠé7X`§ê┹JÁX‘ +T†’b¾ X„È1sîÜùç±/òÏ­á-á#H~yg«*5œ ½1$¯3xË Ú‡/#SêYüë½4m1 u1c@éb×3(‚Oè^Äσùçï3‘…Ô¾éæ…b´r(¼}15œ¦#ƒbç¥e&1>%y}Ç¡¬“Ý-ƒoú¤ (M—Ø~Þ½ÊsȾÄFšÎïO¶ûL’‡>s©¥ôÐ䂃)Õ†Ô• ×±Ff RC°»µìû=o» ?M:x_;†”OQo]1µlh›øyl ™ ¹aÆ„Æ)bÒõ†¦gÇŽEWcjé¡k)PúíH‘Näà fë Ú¡¼dØÑo õ›;‰A§ó©£Éêâ¶Ç‘O>déëv-1ˆÕߓͯb-¬¯Sþ½·¤ß¿flŒ-raÈó!?ƒ·Àrfd+؈JŽk´¨Z3Lò/›ô¦hlƒŠvÆÂ‹P¿ék\ Ð@Ÿ“ðm öG¡˜°gTNßxCó÷÷‚2Û£þy·Ö…º¥Åï®è±9tËž|o‰7£]ˆ¾ë-1‚†ð×ÂË@4O©ëO’ˆ¦–W™cGŠŠŽA.þ~·^•j¦ÜþhÁFó¹€Q°ÊÆÉ f†bÕ:iÄÁÁâÿ·;ß”CAM¨Ò”X¢)¥RpX*mi¼žò[A–ínA¤"ÐmêƒnSSæMgÙ»ñ–w kFª´´ùÆA#Æ–Á¥õ;†Qó4Ì¿S´™Õ /]QRFÓζ"df ì»ô£_ò;|n”^ éGÔ!~ðÚÖ'Äý+Û›ËY!Ý¿qvŸ¢î§–‰€7±8_ÕÊKËìàl1JK ˆµ-ºð__‘Y1áÿüê…å­5þÏ»Íü/}xSé£É4ä„,±(,ȶVâ|H5w¼i³­ˆ‘hælô6'g1]&{o\6$C¶çw88ÀcŒlöŒº?y™é§Ìt*“¦ >("cx Ñ=Ö‚‰ë-ì=ñl¢²ä–]›ž+ÏèÀvxlz}åŠÊ:e:›ó}ÿž/½ž[tºoË_dŠÊu_´´Ótšnh-Zt߸V4½ —ŸVuÒ„Û\ü윪!ýèTx‡q(°·ô²hð/µ÷91*+xßHìÖCQè$‰ä2-¼Þ‚ mV¦ÊÜ ×ˆö–/[ç¼¢$äEþ¦¯J#<é#Z:ß £0é%ñNÙ^È_Á¡ùJvxŸ˜:©tPMz°–ÒCs‹üN…•²¡X¿â¾¤r¤–Ý¿O>U‰ˆÔèf¸Yí| úÓˆrsÆçˆ´AÉòµ„“Ô"RyË Ç é¾ä–]篲Ap¨¤b?""gŒ‰–B„R¨ÎÀ†Æ‡è"µ”.:|@S–ÁVø0çÌîß>¤áê2€é”©eƇ”ä1åC´ìãƒ\F—9à±Bpö3"õ1cDéc''p…s´'NHb©æªÚíÝñû '¬ƒŸâÄS» ?ѨÔß»$éÈR½¼VDË€Öh¦A>©¢a#PÇmG}Ó7Qlù•ÔOŽ>)Á| sOéåñRYŸË-"ÉP:¥œ×[¯Ñ…7•>Ú{3nÀ+{ΰ %†wr&ýž·3v¹ƒÔ”Fðš²èœÁºLH¶¾„h|ð²=ï´XÍŠ¸CD>¡òG L™hºø7^*4ìð!wZø»¨øÐ°¸$t*ÏÎ#Ù‰’žjQÆ©!ưþ{–+Ë”Âù¿â÷ÞðˆÜì§Qþ¤,ƒJ-¨ªÀKœÉ*j&µ°|ÙÒàÌŠ5ý§#qs  ¾qO¬ qDqpùÛÚó ñìïe\”‹@SqN'Ñ12Lú¡:NHM°¶lµõÈ‹Y¯Þà”@óP\k´Ä(h«>¢ƒàOéàMY¯*f‰z«æ I ² ŠÒêSC€íÙO7qÓl%<éDdËû ´$‰~G‹TSL¸Õ…VtêBzvBDf]L½$¿»ËÎø7å1 OV]AÀ› ÖØçÊ?G3¶¨‰üskx 8Á»’"ÔÈ]9§h‘¨¶ÆÝtÑõèEÜtè8‘FJú‘»›æ“>‚èÞGáCð­±PÅ6çV€Üø¾ˆ†b6PROm—iù÷AõòûÔ’¾ïâà´/†@Õ©YÍò/`àƒ&(e:Z~œr ÎÞdFn Íwd™Ø©Ã'RÝuI|KrÈõ`†•Js\ø[AÄ3s¯)‚¤Yä.RSÞ?>\Y­Š ñü&¸äjHˆo‰1lv€SÌ ’xvT«%qò5Áœ9 xro 'hêe<Þ`^^]þ#'2GE&±HF—ÙêŒA·Èoe*v‘º3Sˆº>öqBbF”c_:›2vÈò¯c?įß?„´Ò•Â?BzS¼mIFZ°\1`@·©Ú›£!: y["²6¹þú˜‚F‹9MSZ«ùµ Év¿ÄyI€Y¿Ñ‰·E'½õc 7oΔÓDÒŽÙ÷û¼~‡ôß§ “~ÿÚö{[þ8ÊZ|BOW©QGÜÀ8Sà ÒA¬@7@ûJGœW´ËIÓûæ-1ÝÞNð0ãP,Í•4éÁZ¢‡ÁS@S,{`¾©·±ó×± Ò¯ÙEY*¼YæÄFL𲂼LÆnzF¾ûó ¤–D¸K!“‰¤>Ýqà˜jº“Ô“œÔÞC&þ±„]•#f³%؆A{~ ±º"8ÿ:h¿Î¤^€÷§Ú:¼O—å!ÂÀе§œo•œ{TJŸ©ÅêÄ×[¥É«(ËË ¿ÇÍSn›h Òm÷€K™p?TšÜƒµd]¿çVa«¡´„ÌÑDܺEžlšÄvhbNûï X‘;xÏ$V¿‰~8«[ž)ž¦,@ÿa±LY-hD§Mèg[ÿAqt@ÄÀóœØr=Lº&”.RKacK8“ût‚Kd²ªÚÿ½öp¸_3¤/ -Ù#ŠTŠ–BÂ6wK‰“Ó‚·Z&­ÕmDØžB–¦§(UÊÚµs ÷ótX¥ŸÏ+ÿýû#XàÁ«rŠ'yÔ)¶sÊ‚hÙÅ¡¿ò×gŠ+dVˆ–Ú„ ¦´t·Xé#¸0éc'’Ö=aÜ1ý3Îù`¿Ÿñ!wð>#P&€vÀõñQz8+Né(Þ 1á©"KRê'œˆƒ]6…7¾ô µ¡¾ñM–$Ök9AU¥)œ'&}à*4mcÒGjrJr`6O%e­SYcº!8T@nvªPùçE…ŠßÀ•)V܇d ÓÝ[¦œHWSNX‹ꛜ ùÑ€›Bw6>Åtç¶m 1é%˜1í%sÃ÷V‡è G(ßÏÞP¦Òñ†Íš~_Ø‘;xŸ²¦ˆ1ϱ=SqÍ.’¼ûD`»Nt˜ªeÉ)¹e×¥…‰f›Î¾!—<-=®€ârX´¥Æ¤Ï„±ë„µÄz°– w›|Q>°\OEv_¹µqŸÜ¶7™•„¤Gx¡`Üoƒ”ÉïX(­ƒÄ§Ëƒ÷ÞAÑëhÉ$<{ÁQ,Çoi!eÌÒ<Øi0[akË–`éeئ®ÕÊDj¶ÀOlpËMå¹iƒãrE(¬0˜ ‘‚‚ãï‡wtœ0pôVa]²pé$µE'–¨óÑÅà"ò’3G÷% +D(æ:žo£¥¿Ü €¾'”N“ׯà<žÓ(-Bް*¢ƒêÑ?0ãöNxþ¬Š»Lé‚-šrå”$}6Z~PˆÂ[PÉ”Q¶ò%·LUñDKçÌ”Ý*ÔÁá}úFN-§’àˆ æ©Šqå¦àIOÂyœƒÐFYƒ“>¼‰®êl„Ù!©‘pI.±2´ `Àæö5U£ü¼¨Ýö{:t­; ü—,¢çˆ{Å$I¤¹Á*4RŒ µ€?¦²SŽËF¢±ËܲÉÛãò—“Bøí†ýå^TpC죩±s†¦>NßnÌZ\¹o*}tQÅHGì$ÁVʶ¨Žá”]è÷D*Ðyòsµ„´ Œœ¸PÝpv5'•´Þ'o€ ©ô^;±¥v¤#/7ìbRh±2 ¨ÐCǬ*9HÎEK!^›©Ñß} ¥k(¿oŸ÷D‘ @»À’drZÀÎß; ŸÓÞñQ=/‰ø¸ÀÓ«aåOV8n†S´àO-R¦ââ¶âoª•TZv±àÂ*S5ÖoOõÄ!8J±ä¦B„6¼Ó·§ÇUMûð¦ÒG›ˆ%‰ƒ‡ YNG;’4ô¦Í-÷té›ÂBfI^Ú ÙøQ}¨tßßH䔕CK- ,ZJ"Yèy¥e7"ÐR 6áu¸ÀPºÑñ•È¥¶`öFnû$¿Wè»ä‘N»iÏè’ƒO{Im¥—6—€Á” 2ZùèÀ;¥Fú}–œv,ñÞk$ ZFB#XBSÐf´À o¡²·€à‰ðކ){ú0Ñ6  ÔRÜá«ÄÞ©)M© Rã­‰½äƯpUï6ÀÍIxsF“ŸXÕŠ8ÞLôIjè3Ö,$,éçEœÇïß㋺U¡L¯”§ÁNQ9oPuj SÏʧqòªHˆ?~¬àôÉ¥÷-F Rî>[… «•€¤‚žýM^ä.#> tZ6(éþrtÝ&ù 4âI5oèÿÚÔªük¶öÙ/Þ±i‘’1ˆb0\ªX …XyJ<0µ*‹Z—¹˜Z¶Ñkìe…þrscB/QØ/'’¥ä1ÃÝ zàÁß ¡ŒÌôK~,/Ý+çÏÐc­)ÏËà@“5ùÉn.Ú…8KuX=Ð$Ã_Êï³b/xï@ÓsopkDÁoY ¬8ÜGV8Zd¨{ ‹Mäv:…{Sæ¹¹ze›‰byõ¸šPó¤ÉòlŽ8èŒdˆo ï<6Î#†kMkssÕ¹<1ÝE®%:>¬ù²@j8m““m÷ü{kyç0‹™!‰›òÉòèPªJ´€¼¼EUuDw°oà1,}-Z¶ykäŸV.¿Ø45z‰eüç©ÑKA|ù[E*í1¯³¨<5fÆ¡ÙMMåµ`M—Ž8g¹ÃÌ„ðß8i9Øuå÷ÅaÐql䟨ÙÚ¢×Íáÿs¢DƒÌzk8ȵ £˜õ¥¥€sèdÈñ¢ulxsí%Ô§ êO~lEÙHó7¿xÙ8U½è[Óο‹!Ï»Tïý2\ЄS”oɶ“>l™üŒm³£}òžæS¹5;'¯îÜøïñ“úÎ!Ÿ*? ³s¶áKÄð•káóvÉ"Æbú,>2™-èƒTU,øÈܰºk$@ÎE9ç`„Hñ×4 ø]Ýóh|EþÎÚ¤äg‰ÈOð–ò„®HÁžH33’(uḬå¦ßgFÎ%~ï¬eúýv̬#Ö™zÖ ¡¥æŠ>³Àóé Ò2©AøÉ‚ºó^É-ÓI¾ð²ÀáKx‡®m2’fE¡º±(¾5ÑÝí^ÑòSó´”GÌçe#À)N `<‰y9bô‹ìXÝ*¦ýÁ¶þû¢dòÞÛ*z® ¥)_è$Ï»éâ'(ÔàŸ™—ôyf»”ê”=,«ÇÆ­~VˆM‹Ñ¤Ô9¦b21oÊU7¬ž¿T–f; ó§r‰ÒÑôT„·Ä#:–‡æƒÿ2-¾‡PeÃm°[ò¯ÍŽH)Vé×_*¾'ÆâD®Š®P¼Ñ¢4*bÜòb¢mË>Rõw|O.¸Žm ZÒQBÉL?æð¦kTô˜_Dɘ‰¯„@™‘ÚJ­žÉ¡*P¨gæ‡x[7Œ,ê¹Ç…Åmˉ¸<•©šÎ 8ʉD­û¢PޏÈñÊMã¦EGˆ™? ë“ò€÷¶‰ij( œ¶'±ÅÂ"ѹâ-a7Ê ƒ]Ž)·l£)O˜U–ƒ7™¬ Å6å©9^‹ñ–§fñ³©É-Sc€¥œOÍè:2'bòÃŽ—°1zëM“õÑ=óÜ’Ÿ>afÜó"nmÓÕë×¥kÅ©³z`çþIĹ¢P»¸\ú¨ë®@ÄŒ[&áܼɸô,¦‹EÓìß ¶]cäwðHÙÐ*°ÅëjÝÔû²j·T+ï¤êžÒí©§³Lk½…­Ü#¯è µ¨9é£T;’õiâºp…ù7Žx èÓuRöøô1¿Ÿ'F ‡¦gÐ.´È³ƒ_ÊßAJŒ]çˆÏIÁ«ãÑ’4|Ý¢¡%æqAØnTNDþœ:&%?^Òb³6 H›ÍJÍsz½¬æá:g^™+ƒ0 sŠ 1•ÉëΕ.]œ+î…Çâ‚™ûض‹e`MP¨‰„ÚK××ýåßOðn£[ËUw­öju=a´2:o(Qî9&í59±u½îËÔ•ÁqzK£ýú?ýzòeE/ÃEqÔÊѲ{×gvÞç7ÎÀ‹æÍ¢ÊÞbS’¼ÕÙ+Ѷ¤ü|(¿k5½]³ý2.ªïÎLå,˜$9ò„K›Bv ®A0ÒŸqOæ´<£UðyðûIÄzð;UQ {\ŒYÆå•u¨r«"úC,žLgv=L»:Ö´2ÃÄ]Zöã©$¾êy¼?Ð6¸áOsÊp4µ·ØÝ!ÙÊÇ¢T‘Æ#1 *žº»ƒÐÙì¿‘B²çÅÑ€ÓML™\ür ×-©¹F³8 œm\µ‡©wmv|ìòö‚pßñҢǡMlý£Yl<19ÉÖ¢´²ãáDö¥/}yƒ'À£g;>¹­¡ž‰¿MZÁ-ÿný2Çmø·R¥Z’)À>k¹¤Št}ZñUÚ¶h. ¼XT¥Yë#…ܵ¤pQ¥äƒ/ƶËd%é.F½Íª¿–ED%s 0ލ¢ê ¦ ÞUôú1Ýçx³KE'ÿ(h„ÃCå£åØiÁGŽ[>¾ã8ËßxÞ =5bò’êÐS‡-pzä2¢žý-°™ „ÉýðÏ<Õ;ï ‚i4¥ÁF ÒòG¸,Òè’•ë3-’™ðlQÏšvF³'¯ÍT›_ÄÙÌ”6åÖ™b +3u`ñÏÌS½ŸMƒÏn+%ÆÒAF·÷nÊ®‘'-d [3PŽ-2’†××ÒüŸÝ|nߌŒ¦µäÐBºÈ<ÔÔÁÉk‰¥7¾#×8; ñëoÑB¢5QµâèªNR‰ªùY‹ SFr‰.ªu©Êh2Bowm`d·%K±ˆ'œDxqU¸Á¤à’„+d#ëß§òÅÒ]«M‰`Ò–b1þÇÓÃý/ÿëÇÿó­/¼ãX X“Yzà¦hI‡…µàߺtj‹’Yînjø¿EŽÅ!}%GÞsÒ{t›yâäeVO56Ñ‚ÊS0]M²ÖE–ø12ï€s“Gëloœ•â4üý5Ì ¯Ãç‰9:‰¶À;xzŠ›5 rì±Ø;Xh›¶öóB ã‚£WÁŠ •º#?² ÉSÀòRBâé;è*œ5º×P$å…â1êé?Ä^ÅPTâ×d‹{‹–¦oqº*rnºÅóÏ~e¸ƒuo©IQDz牙ûà ¢€ÌˆEÈŸµæ°HÛÉ–y_¢–íKáJÚtZðaô+qÇ |ئC“ o¼=‹Fç©Øc–s> 9¼Æ!l­ÀB:#,È?TùF°¡ÒìƒÜ&°Ú™¡SƒM?7‘b°ééNd÷f¦µ˜Ð<3묘ý92B‚T‡`Ñ”,áDo+¢ÁŸ».|ðÅ7åÐ!{6KWGÀ±x€5žîýåÄ1´(CG|Ñb½M"ãW˜a¼"B 3žñÃ@|Dê [¦aLbip|ë 1IñŸ3ï~ŒÔàÝž@™,Å­D˜ëÓ#¯Êêô,_žp.êJh¹;=YöÍôû”.·vAÔŸÁ”å5…xNvÜ5B.àìýâQl \G•»Â`‰`]hÖ7½]¸áu•*(Å‚çZ{8´@¸±Šˆ–¢î”m!ócªâK??~=T¤ ù/ˆK˜©{¸g`¢èîyo¹!¤”ÁG ôB|;“xÿÎÀ„+%`§S±¡9 ¿Ì;Rêqçµ§#Ø}«›ð›VÙljŒžS{ÓM0Þeß‘.F¢÷¡ãÓ¡“ÿö×~2»T*L^Y’åUL¨/¹1Qýž•ò"äéQ÷úsÀصèw*©—,ÞVA8hJ RK[¸_Ñ ÷­Ç4˜Ë«jwЫñlxÁ»Û± WúE†¸KdB݉¼Ã_ÿßóšTÿ’2 ôJú)º}¼ôizÙ>õ–rlé¦×Tӯاùg«¾ÖÀ–Šmæ–ä†~7ª=cv%ûˆ¨¯´gÄÕâ²è9Þû¶Ôâþa±Ÿp½)˜tÐÏà…ÍKòE Ô"“½;¨{ÉXVš,hbý¹ôäM°l)…ø ´Ž”S/ –­`PJ+0(s<šÁcÎáZ0_fp,ŽÏ±,ƒQS‹eÙ‚·<ó'n?DJ¹KJ%•é+wnSq:U®”×AE†âó†”B££…ÅN‹Ü)2~Óí—9`ëUo)Ÿ­t!i´¨Tbªv1l9œdãX;aê-‘uýˆĮ̈÷>Z˜Òy‹è½4âü”H¼%öžé©œÉ"jáb Â –x6GjÛÉÕkfZõºá¤…¸ó cŠò¤åiÝ0iyJì²ÏvÒ¸"9¦HuŠî“0]4mK+¬ o‚ƒŒÝ˜Ô›`Üœ¨Ür™ïþWs¯¸|Y-J ¬@¯)RQpÁiB™7SÐDî/á 1/°¸QItW2†ˆ®QFÕ$²Û^ D!¡2B7¬À¡º Hó»6Ì ÇàW©TíòÄŠÔ¸MºÇ„ãܦ„4á0Ûø+Í\Ÿ¶¢ñç)ª].oœ}$e¾O{À˜_'™ædãËH(‚~÷P0h_'2q³_‡ñ èÁyO ïèý’ïy‘_ŒŠ¤ªp’ˆr´jÝÍ9ðe_dàtnƒþ„Ó…×Ù4ÛåÆwóØ1ˆd3Ì-þþ ¿€áåHTd…»Ûu=±íã*(bÃþ¿Ü±KkóG!rŠ.t“ù£è -;AYA;þ°å‰˜Nü÷ù7þä?Ûº«@ºè¡òÃdZþÖßf ;Œ—ˆêÄ}ÞÚ‡¥fÒ1¾]ÇI=<'äÉ7õV0eÇq》¾Ý Ò:6ŽkkÄ1âó«9=M ¸ìºxcŽ?Äã.ÓmÔÝ“çÙ¾SŒ³hæÖš×  åûG åÍ>áÚOyŒCu›‡Å±Ë‰ÌWi§w\,PEØj8€™ÜoÕ¢ŒT‹®Á•q‚cSQ1d7TP’T"++µŒ*ekCÔY• 5ž6ÚÒï€fëÑ&ÙH[ÂEŽðIS"ERiç´_†óÞ“y2øfÀ¼çsÏ$†Ü7ýç k,R(¥ßÆo›æ&fÍ&M¶ÚÒc ÿ/MʇºbrÙ4@q äÊžÑarªä1.ñ‘ÙçV‰Þ¢5•[@Ûº Ãß¹òѳøüÃ;›+Êøh& i´Ñà²PA½!´N}ü8dY¥~k:«¦íÆÙ*¯Õ<97ôfŠœÅ­3•çE2íÎs¹6SgاåˆD·š_bC)ÕjtKI‹Êk«Ìj¨~rw¬Âðœ6OÑÙ!µø‚ &  -pÆ‹•|BI/Ì|кÂN×È\´Á-™„7ZdE´hϤ*XvYG$MÔ¿kM0bŸ÷0ÁÐB@mÒàpÁ™x@N±[NŽÒ¸üi€ ðAþÎE„ODö9WUä8ëþïC `‰ƒXµõXqg´é™@<Â!úe‹©ß.ª:4'K ~¨±ô rÉb@kIMíÆ˜Jr’¨à6-['úŽ,ÚeKEÃ쿌ºÀã'ÆŠÓ]C9ùžÙá'.áêéí ¥§P0n¯mþXgf¨¸½gƉŒ¡¾h #fq-n"ÐLJõ¥^wyf^'³¢bþg®àé/Æ}b®³8W·Ë¥goûš] qjkKœ!Ú°„›º"JÕe]¼µ(SˆT,nVç‹"åd¥&6;•ýíØÓ}hˆ,Rœò”³¹4+T+ÑÙ~ÖžFZË{ùõá ßa2Ÿ)V­j¸ÝDÌÅöV ÷¬Ëî\áR³:Ê´X¶šX-æÒ1E»®Ðx¤Ä麖TP»7)æOLÛW¸¸<"44Aï×f-úAlœ¬F¦=Àa÷Šfþ{•B¥Le͈¥lš4ãkÃg"7¼·`|W-ßb•z¿:ÑmÅ Ç[ògjß8ܰ•ä‘×3Òo:-GŠ·D‰¼è‡Æ/½oÈ„Mã™¶¤GKHäæo ™E?ôT—™÷>Íë¼mŲ)¢ z]3i,þ'ÍÄ;›Æ2iÐiêcV' ˆÐœ†oƒ·33ÌXX•M<²^—˜jß/bµXÜ2¶iEÁ5¾t½ 0o9dýÈ·âC2,»£å4ç*'%´)*]kVÜ©7°ì•v#2™î~rÓƒäUÿª5õIÄ kè£Æ1]®*(‰y‡°8©Ï8¹ €dÚ¹ØÑÖWQÕÇ áD¦:HuP6Øú'Ê1©\Êᩌi:.ëöƒ4–™BM;r¦¼åT“Ѥ…åpÙd'9Æ¿I™ XòƒlWšÅ¿hXI^Ð3DŸŒÞ/Î{^4¨Tdê¡;8‘s¾b-Bc˜¾îËÊË‚±ç³37¿ˆU¯Yäz™¹}¥|ÄÐ?G€ÛúVZç€ÊVb‡ssسYÆacË9UaV“ÎþøÖXyVtséU¯~ö—ý>,M¼aç5¸µ3>ó+‹Sè/æOé4üo®!ø˜ÇÇ2Á§=ß8\cIoŒ·5þ…ÛÌkѪhMj;GbÛ]Æ’ÚÕ&9ð×þÖæßþ÷êöNÇá ïlmtŒHJž˜ã2pø»vhÖú ‡3Îï8,ÁÅD‰Y$Ž¢"*%½‡ª@(•¢´H¢Ž·’mMkYÞ\©St´ MÐÐL;Ç7ÌSigâ0HxÍ\[ª¾£R¯­iHm£rµ˜|méO©‘æ;|åüëj»¨°¨oDî¥k"Ö´¾RÙ#¿^í»í §V³1 ™iBU’Ñ ÿQ!Âv å È_‹Ám’dPˆ1Ù9a;Tˆòí;öÆÀ!EV©l°™+ „!&Û¨X Ñb 1ú–¾å±Œës/ËY;ÏÞfÙÉ(Ÿš–›"zqQ=H¥¾2Þ»…øä†æ$·/eMâVy êc¤º£„‘÷.7\´`JtZ0L,—Ç~ErS­Jñ7‹¤*ŸSôÔô»Þ“B F-‡;OKe7#ð–;#Qzuô#>›£˜¾ÇgÕÈÕXòg¬kóuFƒ "žŸ?¦.qiø\ršËySL%ÕoŠr°bŒ¯¦ZŠ'™?™ó-7L§)OÃÊ4ɾ[›¦< «ÓĽ!©f*¥n]&Mƒ/¯VH eš±&€F¹¦ç>E Г­Â略’?46"­^ätºÉ ”$à£ÿÞ50qœº#°·¤ý`°± ì? ·ã»*‹Lµg¢Q½¢D´hÊÈi–‘Ç`t—«„©j©“ß±äJ¾½gÿa”®ã¶ôU ¬àÞ‰+ðñÎm8 p”Œd T}‰ÎäN$ÙLÞ‡Zo°1HO¾;…‚¦™±1ë2[7&²Ìd[¢tH{~7¢Êvdecêã|²F³m€¡¯øï'Î;¢µú}ðz Ä/Üç 2S0Š C.Q•aÉY=’Û+ ¾ÈMw½=MšðÙâ†àƒýJ<Ò¾rôáU¹ ]ß5î`N÷•îEW›ó¥5õ’‘3]g‡¹[jWpäéÒ$å¨ÜgÌû䈖µ‚™uÞcÈÙ“±®¿ûÙ”÷Fmå\3hYaŠý&­ (=šeÑî;¥à½['ý —È)Û"oƒvxk|D à êtfÏè–/SHeö€äEC—2¨™J’†f¦Š´fTômæáŠ•­“1´ÑŒ²X9) û9SHõ…Ô—æÔáY¹ŠÝÒI) Kãò|ñÑì»<Ý<_ÉD+ž?FTÇ€ÖY_&Jä£ü¾Ðœá[+„Ý‚aøPJÄÒ35øÈ‰#Í>ÞÖMÉùÌ•hæÃcíí<‹àš IõÊ;9aÐÛìƒá­Ï^:ÈPlCïˆÖ"f‘î·ÉA Gvløo‹SªE›Vð‘¿k“ëOml;¾Õ®Å¬ ­ƒ@›Q]›_‡@|f±Ÿ®+¨,ØèO#î¤æÖ!¢o”º‚^³!è·žn¸”nCâü %Z……˜‰o ÉŠ H‡ C•[+9‚® býBްUÀÏèb× !³9Ã’¡Fc2K(>@ìß‘¹É§ÞPŒ:JÁß™-“DDÈ"‡ÁÎ1"&P‚òFÍ®Y¢´ì@déØÁ¡õçKÎ~£Ï U·¼¤`âN˜&£®Ì #{kòÌè{jà‘mƒöpö'„0¸`Ãb_òçÔ)=2Ä•:nþyÛž¤xý:yš£Ýù*CLóWæËòÚ%^˜¯²*bvÒ|©°E´œðnA&J¸Þ³¶Ågy,¬ÚèØBNV„n§°×Õ #íG2%zšâ:ÂJ¶Bß ÃAg1BçjËaÅëxæÄût¹ø™(K1N¹Œ -â »DN(›*Ñ'Pž¢?¢E3Å2ÓE_ æO“àüwBüÌÝ0#Óû• «“kÅE+¹éóqm°V­@B)˜B@fëV ßYN°Ò¦>~r@Ej͹×9¡TOò«dÍÇlt‚ ˆ¦žª6G^èèU Å=´º@/ÔÜWò,•Õ² Î!Ùâ¶Y+p«>ý#•aýTü þS¥F¥›.SPs^…,V˜¯B.?Sqk†«0µ(Œ6V!M!°Dþ5¿[‹n7Í¢læ ýê%Ç/ÁTËiÄp£ÅhN¹«h63‚,1ÃtEºÐHÉÇ µÏ}©W•žIœ‚ÛÇv<‹@5hˆ?˜eÚï€kòIëš‘г7©©?UfuÍ’ÈÝ2mzÐ"¦Fë4OÙf@vhÝLÔL±Í&?¿B Ž8 ÏÜÏsao#§ÜBŽ/Æó Ð up Â³ÝŽ}Î)<>ÿàˆH[:Z~ë¶P €¢Ìþ|ª¹çÏ”MÑ[ÊçÔ=5}㵿º¿FO´)qfAž¹ENo¹ÀE¨"|ô,>³s½÷ÑÂ>·X¼8?%$oÉŸ½gzê\ЦqRr Én­Mkçéhî팪^7œ´wdLQž´<­&-OÀ`Ò8yŠð𨪴ěDsiZB0aÅ2ô]Pœ±7l¨ {ØŠCôN¼÷m½Z‘/:ùStbxŠ Çä†#ŽUKPÙ-¸P£YÔœ9Û)žK‡8,ÚF WÑ*Ñ¢Ù±AÏœ÷còòW¿ë‚š-QÑ(ìD’« šWyeº5÷øgdŸq«=‚$Þ‡Zýl5–OÈÓ †Û XŸ¦£^gc]Ygë^þ"3Žh.xƹÿóã/ÿª#zÝËoëLj»›š 4z;ÖaW]K^'n»2Ñ}¿¯í#É Z±‰ &‹®êËp?`‘!Zè|}¶”††åØËàÐ> W€öLU8vzL™ªJâ ©‰­'[¾?¬±{î½¥a×žÖ #»stÉ¢ÒB`pæóžcpo䫞ðk)JUŸ;ÐK˜–Ñ¢Ù¶–ºL‹ÒC-œ83Ÿ‰PnàÃ_p>´N@œEË]qȤ?ëé'Þ¢E•[ð½û/¹KQòPï—^§®Ókÿ¨ô±Ll¬þ9ÁÍ)öüò9™$dQ¥~' âKm+9ŸâØOúÑ¥“¹ÊrñÅÌ,ÌÕtöæsu1¯Î•. tú8äR·Ðµ5IU(êø^ Dði¬ 8…ÑãÛkrI:ÒÀbáÝ7cv)ŠfµÍnbºKt€æÓ*³\»iZ§˜./B]iÐ>ca*›ƒ—H§Iõ«&+Ô½AIp·^ QºÅi. øJŠ?‘¡ï}¨!Ð,¯ P¨`]à¦R1]À†['u·`ù™‚ß>¡?*,oQà‚fw¶ ¿OaÍ2–'™À’¼‰À¹‹®Ð³â \nœÐº]´/·1þJÄ®j^¦µÖ¡Ò;grÞžå.ÔÛŽç×"™ðÝZ0À ¤2ýqîSôŒS¡­PøM š`¼Û'Føó÷\Ž oï±ãîÆä#¾÷é3õ{Dqå¡+Qžbʉ–œÜ ŸƒùkC_Ý"€ØèE½As€fÿ€vº³/TY`tœìE ø¶ õù¦küªãD¬¾%A¼kñA)&Ka_£¾—¥îC¢8´"r›<s:(ÌHC“'‹]ºZ;C§Í–‡ÿ»¼rNð(?õ†Ñ«R•Tº"J + 3>îö7 mAsÐthdzéo'¦æ)#NÄnp¢Â7Œ%ÔîU?ݱ‚uô™þ‹B>Ó—‰ÖåCŸño)­í®t–âcÞûBØr?×û·ãœ@(7q¥nü’D}Càà ¶þ¿[t`œVc5q¤ ¡P®ŸŠàqPåŸ3¦Â•¤Ô‚)¤Ê?Y 4‹IªDñ‰åÜ$‰/9Ûz÷â4HŠeòJ"/5¹xÉ€ÔÄ"'Öeûrß ø†'nó°û.ÍäèÅÜ÷ìÉ`«=ª½)ÆFÇ‘>óç1Ç-uû£ ju`Üyê#.ö‹Ž¹úç6ð{­“ù«éˆ½§Š[.¶Z?©ò•˜¨°›Â`åesƒË*YÅnoŽ V:·É`ÍæèÐ`Ͷ}ôÉÖwîUÚ¬›î.O›šÎ™’ÖT~X ŠzæðTa¹D¸"ÿÜÂíwibQF¤»\ЧԳ'NŠX«ôAÂ,*«šç-„þöZT»(~Ä'Øêâoˆ†Ü {¬}‡²„`QÃÚž;j:PéÂî=âIö&eÌC3—¾DÆ£þÇçßêÏŒ/ 7¾âˆWÄç蘞8¡æÔÛH:±îæ5¬_·6c>ÂfÆ¿&4I¶ÃÞŒ1ƒiMÔ3¦¢^>«T÷a.ˆ›‘h“`Ú–ËDT1ù}Ÿ!î¢uû¯òu|†Ü §P<ŠÊs¯óýÙ–²Œ` :!…ô§lþ°“N§œÎ %¨žºå %tÁƒ¬jÛi§Vzñ ©¯ðL ’•-'€SûÈnÃò&ÛB1ªšÅ"Ågò›ÿ²ç=<Ž‹¯wG%½Ž÷ð) –Jò“#pi-#A™#G1à”Fܶè¨E á©z&ª['À‘«’èäKþ¸lè'f†Ê|sÓ%6¦ÏLE€Þ#ÀêÜ"<¥­ÂÁ×¶’³å&Wa(ÓÓRìZŠú7-OÙˆzî]Y•ÕMt/Äàý<³$ó|‡{B#F[é-æD`B]c{ÓTcÓ]®žkìô5ÓØ)i ^¢|î°7¼ Çz’ß(N6 ‘<rW“Ý1ý7 › ¯”0_L÷2¼A_ºx¤#‰ñ÷W¥qD£h]ê)ö"Ž!m$)œA¤W0‰ÐMÀÄ%ÌÉ>Kö⢙±r& ƒÃh1t™šÜ®áþÛ¯šNà}3°Æ’õ»}ÝtŠ~ ÏÖuƒ`=F/N{%2[‹xS(-w[jò  :ÖõçGi!º+ªQdÏÃõ‘Rx:а¤âójš[-¿u[°l võïØ’¬~>¦—䩘™éßïUÈǼ5d·vàáö‚;§˜ «G§â3ÝôŽG Ýì´¤ÁÆwB÷ô–,œè—ž: &µj‹9Ñ<:ýµ¨ã¿…ÓãP=z<_!é<Ș<_yF7ÌWˆ¿?_Ä1еºòM²u¹´-¾Ô:’úøy˜Ð’‘ö—?ãGA—%ƒ®vÊ?€ VôIE)¤åpz¢L)foH?TæðwÓz(Šžj W»ù5l‰Jñ’ÇEÈt¡v¹ÖµbšÒgMÞ}},rý“RE+U$Óå¡ï´6ò¸²ZAª€À‚µô+o¬a&º[:xùò”‰Õ®–¤@0‰’œHÑZ%½`"?PÊ’¶NUEàõÍ»quÞW tŸÎ¸kDÔ ®GÚJjëbCtËÅ#ä²\¹qƒË²û}ØXŠMܨøì´"B™×ä˜ÔzKj2Z[×¼€Næ2¾Kë ß¾Bëwa&³±ã,ËŒð<ƒ¥6æ²ÞÉäîôÙŽð@Ëëõ‚cgj‰ñß6öä½³«nDlªè_wwú²!žwï’åÔNa£Ê˜Ðß|Ê;‹Ci‹=²Ãø&t #VÿζÐdtö¾5£T™?â©Ï¼]/ö@;¼µÐ”<<¹&I“éÏžÑDûÍž"¡³ª.gc0&òUj[à¡JmëO¦Ñ˜#fÖØ#©t©ý{PŠY‹©"—=¥¾Ô¢6Zò „¿|ÚïXÈq«sÜß>LyñÂ`Q›ýn±<Ò02¦CРȨõU¢ú5ìq2qE*ö‡¹OS ìÃ|_›ª"–$èìõÁðÖ¸¶¼ ä¦À'ÑÞ°¾³Ç1¼žœ)Í%QßPH+†Çš¡æâ€*…vãÛm=¸&úޜж8¥X´gÅ$ŠêaoëÏìçw†q,¤XŠñþÔû|¦×ÇólŸÃ"Þñ*…:­B ÚßæߢÏ: ©;Áˆw|[Ø"±û•´ú1‘:²,ªø-4â›jvÄLë– ¬ª&¨²W1g¼!Û3‚V$ð›èPþͯ¶ôú¤©1T„À‹Ä:Çxw4Âh磌B#Z޾í÷ú,­â°i%²äAúy€ ,è÷iÑX².„–Z熬Q‹`-â~c÷'±;’9]‚I›óÏ”Uô©Þ‰v2Höµóp&§±&–)ÍμSö ÞËâQ"ŃógŠ'úô’xÖ‹oiõ˜xùŸqÞ²x8›€iøIíf¥GJ¿¶»Òsììÿ{ì„~ŸØixpdÓ¦>5âÑŽ¦_æcgÌqaãUcm›ŠÈlÝSçú€±~%v«â6ñ8ÙùOÂmÛ©Ó8º&Âày js5,© "ß4¤¼¨èÍùÅ”m¢«‰b1½àq”Üæ˜ÐŽäõÞ¡Aؤ âœ"‚Ð4M|†ýÄq!/_´ r:-x÷•Éžž¹œH8¥Àè-å³åȈRM_Àö[è†-‡+7$Éåcf/½6«8ºŸÅ-§ÎG‹XÕY ‰j>`‚:ÒSB ñ–ò9õìÇDdÖyMªÉ \˜`·ø­xýÚ„…¨óczò„å)Ý0ay>ú_ÓsF+`Z‚ô¥Õ¶¤L¨‰ ,S‚êÑÕÀ–‘…ÿ]­«îÉéÆ=c—?%c]M +·d–Ñ‚2òÿêÖj"3K>Ørµ-J+êºTÒ°áÎqÍò3v¾î-,Åľ²–éïİ[ó³BF;»N‰ë%cI9,`on˜ís\‹ËUÂñZFnàè ú1á˘¢Å¤'°:I@ÜÕŒ&óe;Q„Y~ætŽPÏhÔ‰L.'ËL¦R¡« >&›ñ„˪Ù]>YŠ—Q»jÚV³rÈáÈP™€»Š„»Œ£ÜÊ]O°“¡‘ÖœB!>Ù•D/d8œ{66ö”Æ„•‘½‹¼dR¢Eu‡)jÜ%4àjG{ô-y©) ¼äe“¬B^fúKv¬=#ieˆ­îÕ k nØÖòÑCÒæ ž;ó'õÞr܉u§º:OJ¬×ä¶Ñ#¢Jdäò‡ý‡ÜÔn² Ø»¸oWåxfñ[mõ¡Yûœ“³n•7„åÒ¾åW“Ò`õ¾Ý'H/ï[å¹>ïmÚ—Ÿqfà³þì¼ãàJ# Ĭ¿½Ö£÷¥–cŽz}Uži=ªhW³ÖãN°>ˆìÁmµóû'óWþ šL€™x„ÆŸ'G$=Úàté;TžNÑ\ﳫ­ ÷ dU³uÁe&rÕ(¤Â˜&²4Ç-„ÇdÏ Œè.J¬UTSE–.†\ÞÉ0 ö2x×åÞ›JkÆ:Mxgy µ˜KÙX¦ãbŒÚƒìFQ]p ´Æ¸3æ}˜[¥k’psGKÆÜê+Ù sû—6\š IÕ-+Ò¬ûÄ*£b¹R‰¶vYËq$ÿ*bÙʰ™«ð–jû–Ü%pJoŒ¶þlB¨·rn¡õ¦¨¢$2Ž×$k‡+$©¤ÈšÌÕï–»zÂx<_ZEòjW§€qKWU-&óbI"qȯtUõú8ŽêCëå®Öö;`S—¯”òƒ²{P£è^+ù ‹&=‡«q0r.+cŒËaÆÅˆ‚D1½Î¸DÏÌ2Î}³Þn&ÒÒñDºX¤˜ñtàØ9¹GS* •ÕHåðJ €#ó Ìe¨«/€e)[ñY9p˜ ºá>šÞiRø4õ*ý[„ÞâWÈ)ahö¦ICêŒßÁ"äÐГG-.n1Ç_ñ7‘ÍŠžôÆSôô1ðª}…¸Òy 4†‹(}'KÆß“?§¾é¡sajz½ ñ…€w£Ôê×AçÌæ.Dο§t»˜¨2wyz7ÍÝdsg©‘1Sð@ªo+‰º€ÚÏDdôÚDæ;¢FpokÔHŠ#¨$¨ø,^Æ=4¦ñ¶qk{•Ž?~YíBª¤êr¤.Pý»›ˆÖÆh+šØ B²A©É&Oé–ª2ìW¼´BËç¿4 P‹sL¾Ã~=WMëÄewÁc]+—?ˆ|C¤¼k‡{Ǭ5’™¤käâäsŠÊ“J¼Œéé`SUçKØ4ïŒݳ?I$6t”Öë*ñ'Þ î†E±ÿî*þ_¯[yD¿ˆMI¹%§Ùiǧq½U5yõ¯¬.²Ulº.½iº.é°Âæ 3}oBåL†ät»‘£_£SÅ{‰èCôü[ Ë—uȶ;¬3tpû$€$ò@è™? 8ZGËè2ݬn. ï‹Å7ÇI¬¹ÇÕîá6Ý¿)…€™‹:)0M\jù'R¥¡÷uŒE碻¦IW=Ži¯ˆØÆî5 ”@¥]¡Ãƽ.jO˜JhªA~6¼•[Ø¿ŠZÒ¶Öåªz ¥× ßúGÃ2ŠÂÈ_0,Ó¶°¶¹¶ÉŘ©Û 4½DBðï‡=75‘eê÷²äoy`fÒ„‚À˜¥Á^…!– ©7Ñ @“Æ-ÒàÖb¥D…“NOwš¤Ç„X̾ã=åsêž:%Lšµ±Ìw„Iõ£óË\¨[g.feiæb¾³¼G3—’Ï– uMš©³b?ç-±ð:Ò ¤±?h¨Ò»‰,:C÷Z/ÜÓ¨·ô×8Ru ÈqnOd}­¿g&hËÑ'NHljÝúGߌÉÈäc¶ég´ØtQ,_œ<[Ó**JàÉ¿ÖCE×-î¡M¨H•Ì *ª2÷ç¡"L~œ·ÑZƒ¾†ŠpòQŒŸ£Ý'§B•8Gî¢W\º(M—@÷|S‡QZÕ–Y¦¥KPÿ¦eÚ¥›×´ž•2{T$#½ͧÿ‚jÞ)?ûËåúî’e ‘ñÆQå·ãPîC›ˆúÐÅê¹êhê—ù[$êeXIÞOTè÷ØA¬b…öébÌE„…£rA§ßá‹ÒEÁÒDn²«Ã*[ïv«¢ôÓd¨PEá`fæÿ–LÍ@!ൄ¾¬Sß‚F޵Ð0áß‹yfEô/Áܹ$ ¸¥Ç[a¾| â*ÏÈO†ê” 5|¿Žñ1¦™g²0ÌeÉÒoµP?Z-'ø{'¤TEÉÅØ°-IyE3DƒÁqÃÿÑbècÚ’À¸ŠW—Ÿq[t2+âE“†Ô=Ø¿Cyº´t Pë¦é·È§´K ½‹ $XRJHJ|Ö“Ó(Ѥ>ûÀJSŒ=Z\6w––^T>[÷” ž¤—å™ k-ã-@ãQR?ºt`6}LçûÓg›ØEêÏ)ó°eúHg VCµýr÷ê:˜f},±Z—¾—iT§ÆC‡ÂgÀuå7í\Ÿ¹T)îˆGPêFNÆÁ€¾ä)TÖ„é]ý[®æ³Å€x'‹„4Qå´wÿð8‹åÇ\Pʶq°~¸¢Éö ºùƒþöswþÓ® °Å¯¾ ¤èk*Æ«GTÅ]¾ ‰ÇšrFÁgm [C²ÐÂ`–èÇ×,‘Js…ÕçnŽ>þóô/šI~:ˆ!*ê~G ŽeèlFýZügÈ}Mn¨» ìû¯ÍpbqFL/h"T½ŸÇ|ü[b#eõygÞëe'H þ†ö¤²GªD'gÿd=J£(¾œ@Èy“·žGÛ™ YðÅQo°ˆk±èBÿ®agȈ\J®»áÍ®íjè·}²ÛcèÐg"å›cEǯFü呯o óïF½Ì6Ä8Œ)úÏ1~C·Êèž&(¡ð¢Éh †ãÿƽ-Ÿ ºJ!¦²Å°:fð 19¢yFÛhL»Ù÷6&Xî3é«­†a)˜fÑØø»Y¿ÒزˆÝ¶Íáÿn²´߉˜µ·d@‡ ã¸õÑjCõ§uŸpÎØ >ŸÜóTïþý²‘™ Ø•®'¶+ ¹„±Ùß’÷®ÅÏÇÔ¾g!“a$ûEL­¿¥>îBXwù\sä3ÜÆ—ý7ƒkà0Y ´æ-°&`A · ÌKßJ&²±OH²ë›3{E?§ðí¤¿VÊos “ÔAàXívŒíÚAÚYZ[¿®’œÀÙQìY<Óv¡sõÎRW~ vÆŒV5™;•^ÈHðE¸,(YE\ Ù„±þY‚ŠþÔ7“!Ù‡£·é÷;©D3€å¼Rûr÷Ò.±gE®×e#Ý e>mµÈ1®“Ѿd‘g³=ìÉENÝúò §,<$÷/î[¯T4уzØ­tÎMYŽ·ä]]â¨Ä)vÑïùøiI5¨²²ò¸P Ь* Ê€‹‹ý㪴ÂÎ=xmú÷ßz œÃ”õo¨¬+%›þ|ÿï×íß1ÓƒõÄq‹MQD8{©ä*;埔~{Ëoݪ'Ds„Ù¶¤;UôŒ§Î…§“rÞÄA¹…`ÙÂ&æû#Wf*ä¼2Sð`YJeêz3+!¦Áߟgê@øˆê-!RGÓà?iåê•|{a<èÛEœÉMÈ=×DM§à½ÔΠ†RèïÏKtÙƒ¥Aüˆt¶õ“ýB<&ô¿rþÉrl‘u¬Øa‚–¥¼³3t'ÁO´’"¢Ñsö)ßU=£Ûæ„o×$iâæXÌzšÁEá¡D­Yéô]{…Çú7'€© øùÝ«òÝ>dn}>ÞXÜLGg>ÎfïÀõðAŒ_6|‹aÈ8~jÀk(EˆE¨BJRÿafc÷ëé_&EÝ ¬´°Y/ºD¯òù“eÊ+5‘csŠf£ (þß}…‡+¼Z Ï| ‚`‚yÇ$@¡)D3t$dHÑ-BòSWjÀSXª·V"n+Ý Õ7½ŒhÚq%ÆÚnŠ8åü Ó&ÁE‰!Ífn"†ÇÝûP‹qõœWέ?##5×ëoK`Í g .¸#ó¶-ÎÆÎ¬µÝú=îÜ+Y^Š'²Žã¸¿Bîû0Uù¬² ñÔ5ûmx°„#öà"éJ<Šªj'?uwÑ#ë]µ˜.ªÄØjS_5kâPœ_Ù)Yî -?4ѧVú4@À»>ø@M±àŒè^M–»°aØv°Úܱ ù-ÉEX’ÄŽ—ˆaO±Ï!0 ÷RÊÑ—2S½ÅÔR°úªTw¡Âæwº~‘_]r½cxÜ€PÜyݲˆÐ~_Í–»`cquŽ8"ýÓ˜»f|é9”„4 àÔŒŸ¦Â"Ð*•²‹ã™¿§>£J§W«Ï€í¥+¡c³ i6ìŒM¤W`ý0u4a„ hP-;™\‡£KÙ˜ðÏ/™\{öôl㬛\Ñ3[=¹oÉdĨØt™]Ú6È,ú€ÛKÓ;5¡¸`fô’ }¥|³‚ÄÉRôüÜ"ƒˆ}ˆ:‘-}TZÄãAÅw°/¼·†P5RGËo½V<áù;7ü³ä–T4š—øÇÜ š¾À•U<œØk:n!i‹È„÷,ÛKNè$vzîF|ƼñÎG ºmI>ÄwBvo_þì=ã©• mZçm{ÚÒõëXßñ²î”å1Æå)Cü6©’n;‰ý)c {SFÌFLj¨«j%Â~µ-¾ÜÆ¢ªI´ëz·r¦wB’¯ÔyÅ¿ÆÉ«z¹äDÏ®æt,l¾rÝ{luð¢ÚEìt• pVWñ†âÔ=È?™üëòby‹æêý†²VX˜„ÕüeS‹j%8rÀ@Ô¥ù¯g:‰‡PS0u[Öñû í›B¹¦ ÷¡Æå-Îô®ßÁvÃÍ*p„êNWu®»âÒß=ŒÅ"GK—G+GV—YŠrj¹9š5;GJUV¤þMJVîDLÉõ¥9vt|D±×ñµQW¦JÑ2ÛO\»Ü_þûdU•å/{üÞÞ¢iÛ]KÞ·¾™¡þ÷lž2®7®D÷ª¬ˆ™éŠès¯è‡$2Ã/p¯5•!‡¶¸Têd»¿Icå} 3e¤ñÆÈõ½mÚð5•±¾á‚¸<<ü#d²õ§ï¹WèˆOß'†ªÕÓgËSÚEHR,³2‹Ôwön'íNvåV½?õVߪݵÕñ§ré +±Fº‰"Ÿ»xCœT'áEòDºQ°-‚§¤LàX«½E\žŒšP9b¨ø>Ë,&A͉ ¥ú$ÐWJ_È ç¿3…K9è¨J sE´J¥+fN´3GŸš9þ­ i"f̫Ԓ¤W"W <¢èìP”Ù'sE+Ð}_Ÿ»ôÝ2l$s†Å@Ý”A_,$6Â2üö»E ˆ¨«IFñ÷2Ó¥þŠHŸR§f“éLìP‘/ËѬ¤Ê@Û¢P ïK½Á“‡Gn µªX«T ‚åŠR+âP•Æã­uøýâð¾lÇúoYxZžØvI¯ˆC¥[;Ñ{S£þ­áÇwþŸõòÄ ¦K†ÔŸZ$‰+_ëIAL‹·ëp ††ê{„åAÀ¯—¢Ò+8JcÎZ&FžóËŒ¤Qi‰ƒ ÖÒ5Á#ݲ“3:–hËÍ,³ë ÈÐDò¦Eô2Ë|c§ó¨2£`!äý³*§è®dbí>R„V¸nR4טñbøéô‘ë»êÊñEU[Zîã¦í©‡ø”Þ©'¥…¬Pþ‘ž5h€>VEã;êá|íH!uuúd1U)<ÄäSj4.ÿ÷rzø!>zoðYÍD¤9›·¬dú¼ä ™½ª;‡$ÑÒfC>ÊMA âÙëÙKy\¤çjÒ/H–Y¬¢ijg@=X¦YYD×®•:lñ ÚœûÏHò%æª\ùT RÉíAmŠ¡LmÀAgÁ!25fÐi!ÖÕ¿bã¨æP®hš 'Fv¸“4«ªdÀ8+ÍÕˆì»Ñ[X×ìqG«ïÊàÓZj~×Ä@ÔM¢[ œU”ÚC…”ï¸$¨iÛXcS]"}ð ±²Uà?µêRýÁÔ’”>H?­Ç$ݯ\ÄdÎgÏnN“ßõ¹Ç’WÈ ·é‹£a ‚ætV,¯FhY§{@úu Jy’!pÄh]²S¬\^—Þ2Y—ºÆcåòºŒß­:Ý¥,”x§;%È`Љ!ÈàÀÝø>ùrœ1òƒe` œö87ì\ÝË«ÃÀ¦1 sˆ;öõ*ÎqlºšÐv·sôÐÕQv0E®r&¦ÂtÊvuÔ¡«£ò‘Ü訬B9Xü\ÚU™ë³…KàÄÔHœ¢ŠMÑáO:ÄgM¢¢øpKù74‹m‹ •pùô”ĺ’·ð ÜŸˆJ•¡Ô3=5µ¸ð pÌš#޲xTOþoÁREô³—9¢¡7Sy|ƒ™ÂIRšL]o¦p’.ÎÔ¥ ch#õ°iÊ; ž[LË;Z´vWß`=P”hÑ#Å%a ’½^ögã¼f"È"µcy#* @ÏWµV”¾Ÿî›Cv›y©CU˜óMÕÙ.—ƒž¦4~ƒõ¯š(hÞ7’Õ+ikâœè[£í'Çú·!H>ª·ÜG}xqàReDbìò}Ú•»…‰@Œ_NòÌb¼=ÑT”ån("V™-³ŽGÚ–– þMZ–á¾­Â2D4RSÌßßLã»"$ðdDŒr[-Â}N¤2FT …2›bká$›âGkë®tÌ‹7W+×@r$):÷ÃqÖõlÊ´ E«CÅ“¿edA.$8‡óÿJQC /ºh#ƒíyÁ:2~îòh‘ŽPD7Ô͉,`i¢„Ø, E¦nþŠŒ`Œ–©&òŸ%·Á°&ÐÝ!PýÉx/á®—ÑØfˆî2Ì“º†îrÏL ¹o :£´i*‹þt}€-?}Zj¤.´¾x¿ ±ÑÆiY~ gf ´@dP²Œ¸ñPYª\"%@éQRWÒg&_¤®Yˆæ:µPê'}G-$Û«À­·ÜÑ›YâszKùœ– Oõoœ)*CT å¼Ek*·°6!£ã-ºEÕ`÷,>®SïѤúx&->âh ‰PèÑÞR>§žñÔ¹mm×m+4!ú@€}ÛÑQ½n8iyb!þ…IËSÔLÚ!Ľ>i'’Ä~ ^ïkÓBßÒT›ÓŒhŠàƒB|Ïm_#xnlÇ %cRu(I¬Í€WÜ•ô Å\$Ðb*ŠEéÎyÜ©ëÎe€¯@û;úLV<Ò³‡i•ãNí`%gK}$ÂÊ ÐÞbH¹EÓDýU¥¨ál$çÁN”ùÏì`«g±‚´á»µïê˜ yxä+¾ÓÛýùg„ê,"«`®)¸~’¾¯5| ˆ¦';c’>¡e§ Mq¾w« -Z2hS_e;MA›)YÃf†7¼_X*Ÿ*ØÇ=Xœ(ZHƒh)¹XíДg\»b»E§v »§Í-]9Õ”uöe `zï,%„7`gŠ£,¨°âåêL²^“„p‡¡§6Ç“}«„¼/­úèy9ïf@³€¾„ÕM qì@–žß2;æ¦öa³©ýfô‚©Íñ°¦¶¼cqP$Z mœÜ·doæOtç…ÁÅì±U3(–«»àAã: ”;ç@/Bægn‘¡I¦®\è×טŠÀL׆ëNáøL’&tÑYŽ|ÿA¶m D•8öïà6ÏŽ]·©·”Ï©<Õ¿qUEÂWxê¨å ÐO1‰W g‰Õ/~Äg²j¡øÔûh!¡tÞ¢LÝ4âüH¼¥|N=ã©Yf©÷:½íP$»_¶nõºá¤…¸ó cŠò¤åiÝ0iytùigÒ”¯ëS„}„MaùºÞ×¶%3V,C”GË (ðfdslYÙüBP‚'oÒþgÂı«šà;<±;ŽóË+QôœdºæÃ0!¨‰V¥Û,&¬,ˆhÍ÷1B-Îö¥·h³lEí¨crËI2Õïxxíï¼|>QÛÿiªö¨2‡DƽšC¹œV«c¢_tÝî¼&Ͻ-µy{@S$‹áP´î¸t-ÿ&æ M]Šù.jà+¥³d”øÛkí²¥ +¹Ì2Pˆy‹»Hö¸…8Z÷]a)ÈôÌRïÔ¸1œ&ªµÿ`vÕ »ˆ‘åÂ?fié;²lLz+ãv”‡îªõAV³µ1 Í ”H.äBµú:® Y­A)»M³c‘S}uýÀ{eãÄ$5­É€ûBJ¯ì5koÔ‡æe>ÖCJ…„z#þÈŠ öä¸ÁUÖ‘ÆŠl.íQ˜ ;ûDâi/ž{Ó5·m¼ðDª…zQáÄ\¿©>»ö‰h)ã…Éy^Ûúfvîû^³}7ahä9JƒFRï˜l»`,ܱ®ñ_›·±~ìS“.‰€, q@ïuô™‘’{¡ó—³9Ÿ+šOþ{‘»RŒÓòèd̘ë=¹‘Þ}$N”½­xÄ—«R`†³W–Â!Š}™ÐQÙ+Õ<©S5sŸöSªç§1®£¥`Fu–3l†ý[¨3yÌöƒi¯Ö/^ZË—å*ñø·P ë´‡˜!t5eͦÛõ3Çd‚Yë$¶~¹ 5TÓ¼$CÕ±* »ŽÈ§Q A¥˜¢éK18Á•ÞhÜ+p8Íþ¬{7U*“^õh«Ì$[KJ¨êRØpH“ÈÔ€ÇÌÿl=:Œµ°°§-/ÚÓXàÉânìiä‹ö4fdìâè™B•õ¿…&1¦íŒSŠK:Ek¢d-Ô„ñœ 鹬šÒK‹r$äz²@ƒÉd¡F‘ŸaPÊT/8D œRjÉ¿Q tÆi|ç¦ ”Àݪ·”ÏÖ_öo¿tRìR‹* RWØßr;ò÷Ô+ý;5J>ñ‰Ó¥ú”F¨oÆèoªtÈËgë…¸€Jb6‰UÛŽa%õëXÍùe³ ÊâÁ…¨óeáo˜ C{0A"ýb %*Œs‰ÕSÝBßÒò «Æ4ãXÌ%GtVBš ‹—Óï„]ã—þ¥WHNSé~Ù¯òLåÄë @5©T½Ce ˆþj‰¹tÓ¹¢¡Nœüb ¢HŠl‚haV Æ]ê¬nq“´ªß™Ò«eõÔ!JT;ÍBpTÔ-ÕàÝúÈ_¶M‹2ÝhgqK „Çû¬vÏÊn¤VtX(Q§¢Ê®õ±å8d©KëvV‘m§ÿ¶4{@v¾‚A§# !»^J<þM˜ºk7éªk“וÁžFïç™s¦j“Í¡Z£Ê¥¸j“ Ó•áiŸj&E†ª€Ó¹´y£G<@Ðh][f{í ¨û2úcÚ’ ûʺ ûúä¾ïj]W¦5`Jܘü{:wÞ³7nĵsÍ õx32ʫΠ–ÊW™3Øð×+×vqo|²ÍÎê/æobóøÀÚìÙ®Ç7æO–tFMçñ1¶>¯„ÑÔóǾµ”í_ícÌaðxÛcÞWö7t9•¡ˆýì÷ã­½ ˆ[íªøZ’JÓ>x?B k|BtQùWü®D¥2LJó–t‰¢¢÷ˆ—Ç‹–.P!Ì´äFL|S}$ƒ—}‹pBEGKQÑv%‘VSíßÚ`— SßU/˜:c\Á‚¡\-±¡¥¥5¦e§ãBËPG‡–í–ŠûKj¶Ü>¹ˆFÕS¹”ák¡«jJ‰ªyû6Ö{¼Îp‰ñ }Ùº¶%ᤎé­Ú·»JmЇ™ØÆÊ5‹Yx户ú|S<¯˜6yg Ç\:›CK³j¾É«)ï°R×qêSbs°RŒ¥ùzAl/âíˆókr2¶ ÔI8zÞ[ì£Êù·f¬Êù÷‰¯I÷”qã}x ÆÑYûÖŒ$t¦ A}Ö ‡› ÞZ’Iždñ'v÷9á;{p yÁb£GÖ†Ó„ þ¨i CuHsånêK-j;qÃý½´ß¡})1ƒåw´ê~<þ».â÷9A›@Ûê"$}Û÷HŒ7 )®G0çþ ÿ-—¬É>YX±Hðµ“ôØÞ±!=i8CÛ[Ja²ÕÃۼŠ+ Ù{0¼1(}g‹‹ÂÀõÝèºï(hí'Øø£êý-¾S؉Њ›¢ j´h‹¬mîo±müÝXaµÅŒ: ·“Zˆš‰þÔÛ|³ZgჩHAÔ=Ý D[8µ-ù°•TäC7k[º¹õ\7šÊÄ‘ñ†ý¡ ó.àâðÁp‘Þ5\^¬›=ˆ6Ýl¯t«;h¦ç ã\à 7 †ûhÌ\VÈpò²{C±_è±òئæKþW’8À$ WõE‰ž§$qhTfȈ³²ãPÆœŽ ­>_pö}}nø·et‡û® Ã~ðLçî8v6^¡£K®UÖO)ýiy-ËÁlBÒ¤š ¦ã°Ã%¾*Û¨¿®È‚nâ̾ÔsÒàu›†xæï=÷Ž’nì¦Hm6y.ó²[êüô 8æŸAÑ—MâØPË\­`¥àSzÓꯊø¸E§ï[+ÂîdèÇLv§F¡ês y_qÈa&`.‡é)žµ°*8)âC¶ß,oª8Ȭ øc”è-'ÿtª1zfggî›Q¥A5®–²Iã]šêt§S&´Œb‹,kµœW/<ÃFé „W"U€ÆKO’µƒ9O¸dÔô‰ÏTF‘Š x?ZÈÕl[.çß¡ú/,šâ¶ý-ù³÷ƒ§ú7.D¡)_ž§ŽZ´–ªÙÞý-a:SÇü#¬6ÕŸô\FUå­úd|#„/(ŸS§ôÈTm1¨9õ6ò°B¨»ÐÇ -«_7i™ÏWH:1f'ÏWžÑ ó•e?˜/b¯bvÎ\¦ ü$ÜMÛ’3©LÖæ âX`îGF×CîäaåZ”6ŒcÔ#(0kF"‹Ÿ’ ®S“ÒB¬jÕv‰nÝ—wÇü—i@}%»Ô!àæ,îö. D)Ž°Ë„^’>*þE¹ª©As”öŸº÷üÖ¿jJa_ð¾,¸NüQ®)wV¨Î}»ßÌE9±âýµúÙÀßq0)r ˜me—c:qßû‡•À¦[ñ¢Øb°,§OVTö÷qpªGÆoÏl©øxÊz\€ýn§)æ–£ÙêÑ]ÈӛƻçõÇ auùúã@|“7Y€©EåÄbÒY.i3èßþ쿜‚¯oWØP­ÍùAÿ-U¯Ë*ŒíÙ3wÊ”?.”?Š>Ô«©I3,™‘x-©É)«úÿ¥¨øH&ŽÔPLJV¦ðP£I­¾­ð8¤Má¡BMeÆ™½®ð¢S:ÃK·L-n1iýc"Cì,Ão€v ¤®0QºŸê†)šZˆå<¨H÷ççkª¸®ÚáW¼ã³´ø–ã6Z„6Ú%{¦§Pï:V:·^R>§nðTÿF„ýòÔQ ÑÞØ_`ˆi½$n|ŽnÄg!ŽÔùh‘¢µXáE7?$Äáï(Uÿ¤xá,¯Ôõ¤˜M†-¤º#Љé‰G—L',DGÓ“',Oé† ËÂL˜@LL)Gœœ´’­wµmq¹LdEm@3v½b@ü„¾pÕ=½7m€ÆyU‹‡»Åɸ¸Ô,!\.ãЗS½Qp<œ*A'”Êuu•5hZ”…Ò)-pz^ø—¦ æîîf7ï‚[P^Kd…Z&ËfÑ„þ·®ï ®1÷þþZÓlÂ-\yÀÉD,øÄ4 >¦žéº¸ÖÃce™¸N€ø#Õíêî& üÛñÝî6mâ"È|ôv·4…oú{r´ •[pQ òïKmTüŠ H hþ @Q-µºÝP+{ÍÁG(€KëFÇGÞ”õjØ'˜¸Œ hKx]³y²S!6²tÐ0?FýGà|ëÄt&uÈ qvÊ{’§pÜŸ»}ŠËÁA— ʰf¢Òàv$µë9pIÈH‰Ã¶cœl«xëjëJÒ…‚ŠUE˜tÎÊ8Y¹‘ÇLUßÕ‘sœD³É8ñe¼lœ=«:‘â‘äwPuÄwV2VÌQ¯®àµ5JÆŠ’QWuñTÉį6ÜÇc1o”áU÷|²CÓDQ¾x¹§û[ʤ˜#"^P¼Ô%§«š‹ƒ¶kʰ¥¯$š§/ü«}žð¹ÿÝ~ȧô8áõˆ~Ôû¨˜TÝ}/ƒZ¥u9õÆ'ÆZXR2[·æ® ÎË2 vs"ñËP4 ì¶–`·ò(c—âöKœ™®!JVEéªÁîEB8ÑÉ‚7ŒŸËXLm)‘Âöß‚9ËÍtžÿÆ„²žØ¥Eñ¦ÀìBÕÇT·îǽ‘·#`Ÿ…ÍÉQkE‹ö§µäï¨Eæ?Oó§Ä–Væ”ÞR>[?Œ`LÈ’z;–O£gŒ[°ˆ8Nâ-*°{µËÅRÏâ3SསµÓ’Fß ‰ÜewÝnYfÑ3=u.E³ª¶~P1§ûëwkկ˓Ƽ8iyBšIôÚ¤aXÆÝD/¤úæI ‡¦…7§%7VsÞ+&R'¢Š$C;ÒµËóê^Ø¢èf¬°Bð„C9(Í`ÐÙ/¬,±ðΛɪ8ØØsW¥-à‰Ø;”/»Öþ3eèÄ0l±Ÿ’w’å×Í«NJ«lêpþ;LÔc¬¸abŒIÁ]·"ÖcŒ³NB.è¯öô©^ü£ —-Îw¢Áüýµ.ÚbtIŸ)GÐÃübP0ü—ëòÚbu9îànVÀhbTõ è…ÔkË œ­õèö‘ä[ zñ÷ì­ènªÞÃM-ý÷O z­bw˜<«'¦òˆ}ì>vJ¼fw…Ü`¶!­kÕ䆜¾£’9em?*êMGGœFø|9L¶ì'jè~Rº©‹0ÛKk“µ>,¡Sçkİ(ž«£ZHVkŸ­Ú †õ U!¢nH½?ö}B„óØIVwkƒZ¼Ác|>Ü#ÜFK¥÷£Þ£Š+Ý Ræ•lžaòöu/&Ç÷^{ þ¸í&4ø×_?þ…¥@`‘'qŒ° Þ¨¥t#=HªGÊß] „ÄqLî· ¨ct$<½‰F´z} ˜ÒØXFCH]‹šã–6S7þïFUìPÍ­­2Hwål"‹¾ ö¢d|ZÁÀJïn¶ƒ™oߟ%põL¬˜Ýk–s¾ßÏU+ë7R•o0ïTÀ½kÎIèoˆ äºcåŽVQó4Õ€¦{dÑ|æ žÑU™XSt–ô«í×±¬0-;ë«:S†‘áo`V‡¦«v‚‚À"VW+G»DËH'ƒ¯¤cèêޤýÞ19G]™â—ú•/1Ðå=2*VB ÍH•x"|¯Ö™‚x¢+õLMáp¡‰º4Ir8ñÅž›GbÛ?obKÙ„U¼ ;R6ÚÄ]ÔŦnX€a ‡aŸ_2¨ñ«¼ý“AÍçÖ ŽÛ3óÞn÷:§£‚ØC¶PΚ2%›B稟¢  +Zâuý„Á#y D ay9P¡Ô »ô³˜ý% &Š}# ×¢äN4ÿW9R™àtæö:£ÇãstAOMß°û—TšR]jJ™×|'½èÄ`T)÷%~|Ä¢å·n‹ úßI޵Pòø”2ÂyâT|šÎYƒ‘#š†þ¢Ö±¸uQÛs[æ)iÃ<&3ן'ÌÏÕy‚ö»^!V\8ö‘Y›‰¢/ìõÿýßÿý÷ÿúO·ÝÉL~dÕ\[~RN¥~ä«s êaÆ}¸Mª"£vÖë³€•þ{“ y\E4J"ÛDÓ2ÚëÔ” å’Ký3-]¶\n²•J»v†“Q­Ú£Cxʺy¿N‡`YCé‘Ri¡§NaI4°% *3Õ\lÙ\CS›¸ùÞ¸úù¢ùò”ÿç†_)úPë L7Óõ»íèPõ -›ò“J¯ûEŠ`¯ÇìYᦧá¢Äf&yÔëRäB<ƒ>¬WA{’•vÆ}@Tă¨Ö¾±°¯TD†Á~%믛 ðHÿ>?À—²˜hŸóJZ,+"ƒ'!tÁ’Žz}ؘ²… KôÅ‘”÷ÔGà>´R›|±GH¾j¥-ŠMÿ([z/± úð¢Ø`¸©K1Xmã°¤÷6(õÎ÷G[7I+êûMÓ§âàQ$»éJÅþÛ‡œÊ+åF6ÎÚGmdä ±"o®–|ó°Þa%‡'¹ÉR&DËÔÝmL!½5¡è Ep5¡ÃÑÅhG·F-ÆèxAîa`Wûœ2”ï@ºNE™=úê\qv½¬ãÐô®´I,bíñv|ë³Ç´q÷‘òÔáNó·O†y^æ^8ƒmF÷>&gŒ/¬ÿþ8×ç‘ÜkÜ&G‚þJC=ïAÖñiRÀgœcN ¿~|oâÁS–y­¾!É<ïC`Ê0É ¶ï>¦fÞœ¢¶>Ù{P–¹!4ÙòG«?¼Õ—@zãDA+u¤˜à Æ»i˜²‹YænR~XÉåýK,ËÜC’ŸÚ}‚•/ðt#—“$óo‰çz:®åbÃaŽ9ó™Ì¶,‰Š²M̶hš˜mªY™æõOÍl[Î7Ct>î* »¸DÇÇ]>þ kšudðg¸ ¶äœÛr5·Ê22§œ Ïö+´~Djp=t›>¤xº£.?Ï0¨ËÞf©Vv¯ Ï”*µÁýÁŠ~Õû°Ðzöu‘ Ò/Üߊ\¸˜ÌÅк]äÂB;¯˜S g’§ô­õ©–I)Vðño]:›¨pC"ìQ÷ÇåÂV+b¸Ë¥ßÖùÙ{yC~eÿp¬ê¾¦«÷«…1UlÝy¨Ú ¿jtb·A}Zk•o …9ɨ Æ^\Øï™ ,‰Dʈ]ñ'<45& xnˆô†'g¢Hü—z~þhï‡#Ì zŽ® 94-“ïèÑw>û+üÙ¹SþùGôû@9{ûoÑÂâË-1ToÉ’°§cž…¨RϘÊÜ’:¯c¾jêçQ3+³¦˜ 5WqÁ2“ê¤t)D—àR2Vwc£>$6!^¹c7ÑKH:—ÿ꪿¥ë¹á—ê Þ‡Zådt;¦3ÉÁ2$»»ÐcÌ.‘­³™EdºZøA¼Ñ+‘šHm›ØÛƒ@<¼ø”ÿôa#+÷€ :’³N€«ª.÷Åf•UA¡©<3QŽÆŠ)çšVæ¿þãøÊJCéÞ.|ElÚÅ›VÛF± úð¢Ønlml†¾Øö!¾ÊjãÔ ZK“¦oçÛ÷¸>Tˆ›-J°[@’êpÇ;r¯¼µNTAöI¶T½Nz¼‰øH¶F^gúT »<ÉEUyÝŸÏ÷Ê~ÔñPy>ß >nâΆË-Ðo-n0†g†*®‹þøöɘ(ã»cbgÝ,øšrÀß 2׈ڇö!6ûÄ\ôp½<þúr>x1qÔpiçO{ÑMfqš9Àk²Gß]¦„ Ÿˆßå°ˆþ<îCƒ•q^ Áž†þ3¯Sð´ ÖéC¾wÌ:¸=¸9W¿ÆÌ㥠·á>Ieúù§ÓÍk|—mhjCÌáÃb>;’¤ðVõ§>Õ_Ð¼Š¼QÕ!•K[`Hb*Æu1¾5,înµyá*%È»¾õ¥‡.`zêÎ BF/YaíKb3­2¸VÝ`ãΦ†HÌ0nôˆ+NøR˜ÑRL uV™¶n¢ø·6˜"(ÐK ,Ë.*™„·šfV–¡–š ÃèO?%^²…Ô<ý}Ø¡L­rì¨?:‘¬ƒÌ”X)q¤ i?}K&ÄBôz75gÊeî!–ã2™÷À?û8õDê]—ë9 <ɇшçw·Bñ~ÑûÅS= §QN>yÉ Z‘ ¥ô,Ñ›¨T¼?›¥²Nûf©°fJ*Ñ.15[¦)pÆ-ñXðiÙ²)7¼_Í–eF-ŽÈSzK&ƒNÎãMز`ö”WŸûflgÊ6ú3¦¢ŽKX¤SòÓâ9×ÈÏ“2€8ªD÷ó#7p¾«^(œåõ@e¤ÎŠÞÙ)þñ1ƒ\¡2™7üÖi€™ãß`‹ Cðfééþ1ÞÎÓ¿s‚@éŠâYhPÅÂËáì/Йc÷Vx—âóÜëhù­Û¢aÆ7BG•r‡‘*Ÿ­WzäLjR ó¦˜Å $æOLQxeЍeÐÎYwŠ>V¦è Ê{L½¤™„Ñ4øšj¥Ã´ÆÃîp¢î¹…uj铚ó<Sq²ª µßˆêJ‡èeH«Ê6ÔQ.®Sǹ8PµEér;ÊÇ7‹ÈÁrÂ=¬“‹÷ÁÑ48Ysñ-æ²ÒúS±!I_[ÑòQµl*Š ªt ¾Ãíï ­) P ’dë=H„“ÿ‚ÓM1èìšjrU®SË’',õWœ*³©”Z[³COØgg2œ‹êêvÍ3ĶG”B Ëô «ujÃÛ2: ­i¯†Û† ư»ºý$èÈi ™úшšå§xbª[¿Râá,¢‘:½ ò ¹bcÅRÙ‡o*’$;ötáx®‹±Ý’Ìð›6š‹ ¬Kuñ;] ¯H•¹À³|ð%SÉ‚M?eE’ñv%Fç;¿fEtƒí§ÅRÑöYs+afCĈˆ ޔޗjP[bGüØ[Ï9§6¥ÕbæVßA¼×狳ʫPÀO1U”®1ã%®Ö¬D3|6|û³_µÚ¼ƵLR@åt6Gö’äN˜o­6ƒÉpAr’ñ+ùIeG†fˆèßP±öï2H%c~ðâ¨ý ßüÁ…ZÒ}Ä´O FƒêÁÜ?›<^CBB {#Ib_¬ú€ÏÄjHÁç¢õLïcI–!Raâz!ÿ¹ì>´¥™Þf‚ 0…IÙ%Š4³Ä…C8 ú²!Èï°!¡€…keDú«cl“–M²ä—EwcºÀÇ­è´$>mý=ì—e¶b3¶ÔÕÙx>H¡¸fÎá}h)E"_aÕäýYIëå¦êœ V%ú4$ż¶¿Têžu•fR© ˜ÎNntÆ!JU?<ð %#Ž”š¼Òl~«¯èô€Í¿ÓÍ|{`JÇ$‡„ t܇tßÄ$òftPÊvL’z ñf¤¾Dß¶¡HŸë„yزl´Ã|üÇÿO#s endstream endobj 5 0 obj 63630 endobj 2 0 obj << /Type /Page /Parent 3 0 R /Resources 6 0 R /Contents 4 0 R /MediaBox [0 0 1117.73 782.7225] >> endobj 6 0 obj << /ProcSet [ /PDF /Text ] /ColorSpace << /Cs1 7 0 R >> /ExtGState << /Gs1 1528 0 R /Gs2 1529 0 R >> /Font << /C1 8 0 R /C2 12 0 R >> /Pattern << /P50 157 0 R /P112 343 0 R /P173 526 0 R /P426 1285 0 R /P425 1282 0 R /P344 1039 0 R /P199 604 0 R /P57 178 0 R /P72 223 0 R /P290 877 0 R /P140 427 0 R /P505 1522 0 R /P118 361 0 R /P422 1273 0 R /P121 370 0 R /P369 1114 0 R /P467 1408 0 R /P82 253 0 R /P262 793 0 R /P167 508 0 R /P395 1192 0 R /P372 1123 0 R /P228 691 0 R /P231 700 0 R /P25 82 0 R /P289 874 0 R /P144 439 0 R /P170 517 0 R /P470 1417 0 R /P473 1426 0 R /P257 778 0 R /P315 952 0 R /P427 1288 0 R /P66 205 0 R /P115 352 0 R /P16 55 0 R /P389 1174 0 R /P341 1030 0 R /P318 961 0 R /P196 595 0 R /P496 1495 0 R /P166 505 0 R /P499 1504 0 R /P357 1078 0 R /P70 217 0 R /P76 235 0 R /P366 1105 0 R /P47 148 0 R /P106 325 0 R /P109 334 0 R /P114 349 0 R /P360 1087 0 R /P363 1096 0 R /P100 307 0 R /P155 472 0 R /P303 916 0 R /P380 1147 0 R /P335 1012 0 R /P190 577 0 R /P263 796 0 R /P466 1405 0 R /P326 985 0 R /P280 847 0 R /P413 1246 0 R /P416 1255 0 R /P219 664 0 R /P222 673 0 R /P102 313 0 R /P283 856 0 R /P383 1156 0 R /P161 490 0 R /P309 934 0 R /P386 1165 0 R /P448 1351 0 R /P491 1480 0 R /P493 1486 0 R /P451 1360 0 R /P454 1369 0 R /P11 40 0 R /P354 1069 0 R /P135 412 0 R /P132 403 0 R /P164 499 0 R /P457 1378 0 R /P146 445 0 R /P462 1393 0 R /P464 1399 0 R /P274 829 0 R /P7 28 0 R /P84 259 0 R /P74 229 0 R /P141 430 0 R /P14 49 0 R /P268 811 0 R /P46 145 0 R /P245 742 0 R /P248 751 0 R /P329 994 0 R /P332 1003 0 R /P187 568 0 R /P406 1225 0 R /P487 1468 0 R /P201 610 0 R /P300 907 0 R /P277 838 0 R /P306 925 0 R /P5 22 0 R /P214 649 0 R /P91 280 0 R /P20 67 0 R /P120 367 0 R /P216 655 0 R /P78 241 0 R /P348 1051 0 R /P225 682 0 R /P377 1138 0 R /P158 481 0 R /P88 271 0 R /P94 289 0 R /P432 1303 0 R /P129 394 0 R /P302 913 0 R /P181 550 0 R /P351 1060 0 R /P172 523 0 R /P271 820 0 R /P126 385 0 R /P213 646 0 R /P56 175 0 R /P207 628 0 R /P210 637 0 R /P111 340 0 R /P42 133 0 R /P291 880 0 R /P242 733 0 R /P323 976 0 R /P445 1342 0 R /P403 1216 0 R /P481 1450 0 R /P484 1459 0 R /P294 889 0 R /P297 898 0 R /P104 319 0 R /P152 463 0 R /P434 1309 0 R /P337 1018 0 R /P236 715 0 R /P123 376 0 R /P68 211 0 R /P374 1129 0 R /P227 688 0 R /P32 103 0 R /P24 79 0 R /P175 532 0 R /P436 1315 0 R /P178 541 0 R /P36 115 0 R /P48 151 0 R /P313 946 0 R /P393 1186 0 R /P346 1045 0 R /P204 619 0 R /P504 1519 0 R /P40 127 0 R /P33 106 0 R /P35 112 0 R /P19 64 0 R /P75 232 0 R /P368 1111 0 R /P371 1120 0 R /P365 1102 0 R /P265 802 0 R /P17 58 0 R /P421 1270 0 R /P441 1330 0 R /P429 1294 0 R /P149 454 0 R /P397 1198 0 R /P62 193 0 R /P230 697 0 R /P73 226 0 R /P233 706 0 R /P147 448 0 R /P143 436 0 R /P192 583 0 R /P423 1276 0 R /P320 967 0 R /P59 184 0 R /P138 421 0 R /P472 1423 0 R /P475 1432 0 R /P39 124 0 R /P1 9 0 R /P117 358 0 R /P314 949 0 R /P317 958 0 R /P259 784 0 R /P347 1048 0 R /P44 139 0 R /P340 1027 0 R /P195 592 0 R /P198 601 0 R /P343 1036 0 R /P498 1501 0 R /P256 775 0 R /P356 1075 0 R /P501 1510 0 R /P408 1231 0 R /P45 142 0 R /P2 13 0 R /P418 1261 0 R /P30 97 0 R /P276 835 0 R /P253 766 0 R /P108 331 0 R /P362 1093 0 R /P103 316 0 R /P288 871 0 R /P169 514 0 R /P452 1363 0 R /P469 1414 0 R /P9 34 0 R /P282 853 0 R /P478 1441 0 R /P412 1243 0 R /P364 1099 0 R /P221 670 0 R /P224 679 0 R /P304 919 0 R /P443 1336 0 R /P381 1150 0 R /P308 931 0 R /P163 496 0 R /P385 1162 0 R /P13 46 0 R /P388 1171 0 R /P409 1234 0 R /P492 1483 0 R /P495 1492 0 R /P399 1204 0 R /P134 409 0 R /P185 562 0 R /P137 418 0 R /P69 214 0 R /P338 1021 0 R /P417 1258 0 R /P461 1390 0 R /P394 1189 0 R /P438 1321 0 R /P350 1057 0 R /P310 937 0 R /P359 1084 0 R /P96 295 0 R /P99 304 0 R /P247 748 0 R /P22 73 0 R /P331 1000 0 R /P334 1009 0 R /P189 574 0 R /P489 1474 0 R /P373 1126 0 R /P279 844 0 R /P12 43 0 R /P480 1447 0 R /P415 1252 0 R /P215 652 0 R /P93 286 0 R /P218 661 0 R /P453 1366 0 R /P249 754 0 R /P83 256 0 R /P157 478 0 R /P97 298 0 R /P160 487 0 R /P382 1153 0 R /P90 277 0 R /P87 268 0 R /P128 391 0 R /P60 187 0 R /P131 400 0 R /P353 1066 0 R /P450 1357 0 R /P456 1375 0 R /P80 247 0 R /P270 817 0 R /P319 964 0 R /P273 826 0 R /P447 1348 0 R /P410 1237 0 R /P212 643 0 R /P238 721 0 R /P34 109 0 R /P241 730 0 R /P244 739 0 R /P328 991 0 R /P460 1387 0 R /P405 1222 0 R /P483 1456 0 R /P486 1465 0 R /P148 451 0 R /P65 202 0 R /P151 460 0 R /P299 904 0 R /P200 607 0 R /P154 469 0 R /P296 895 0 R /P184 559 0 R /P125 382 0 R /P264 799 0 R /P376 1135 0 R /P261 790 0 R /P431 1300 0 R /P28 91 0 R /P177 538 0 R /P180 547 0 R /P85 262 0 R /P305 922 0 R /P503 1516 0 R /P420 1267 0 R /P3 16 0 R /P428 1291 0 R /P203 616 0 R /P206 625 0 R /P186 565 0 R /P209 634 0 R /P506 1525 0 R /P122 373 0 R /P370 1117 0 R /P322 973 0 R /P255 772 0 R /P402 1213 0 R /P391 1180 0 R /P267 808 0 R /P293 886 0 R /P400 1207 0 R /P396 1195 0 R /P53 166 0 R /P239 724 0 R /P325 982 0 R /P433 1306 0 R /P355 1072 0 R /P232 703 0 R /P235 712 0 R /P440 1327 0 R /P145 442 0 R /P67 208 0 R /P275 832 0 R /P474 1429 0 R /P477 1438 0 R /P284 859 0 R /P139 424 0 R /P21 70 0 R /P119 364 0 R /P316 955 0 R /P174 529 0 R /P437 1318 0 R /P226 685 0 R /P258 781 0 R /P165 502 0 R /P43 136 0 R /P342 1033 0 R /P197 598 0 R /P345 1042 0 R /P500 1507 0 R /P37 118 0 R /P367 1108 0 R /P6 25 0 R /P171 520 0 R /P110 337 0 R /P446 1345 0 R /P260 787 0 R /P116 355 0 R /P64 199 0 R /P251 760 0 R /P61 190 0 R /P229 694 0 R /P502 1513 0 R /P51 160 0 R /P142 433 0 R /P168 511 0 R /P26 85 0 R /P287 868 0 R /P468 1411 0 R /P471 1420 0 R /P285 862 0 R /P254 769 0 R /P8 31 0 R /P95 292 0 R /P419 1264 0 R /P223 676 0 R /P77 238 0 R /P31 100 0 R /P387 1168 0 R /P339 1024 0 R /P390 1177 0 R /P194 589 0 R /P127 388 0 R /P494 1489 0 R /P497 1498 0 R /P136 415 0 R /P439 1324 0 R /P71 220 0 R /P463 1396 0 R /P465 1402 0 R /P444 1339 0 R /P252 763 0 R /P107 328 0 R /P358 1081 0 R /P23 76 0 R /P113 346 0 R /P361 1090 0 R /P55 172 0 R /P101 310 0 R /P424 1279 0 R /P156 475 0 R /P18 61 0 R /P193 586 0 R /P237 718 0 R /P336 1015 0 R /P10 37 0 R /P333 1006 0 R /P188 571 0 R /P52 163 0 R /P278 841 0 R /P327 988 0 R /P281 850 0 R /P311 940 0 R /P411 1240 0 R /P414 1249 0 R /P191 580 0 R /P217 658 0 R /P220 667 0 R /P4 19 0 R /P183 556 0 R /P38 121 0 R /P159 484 0 R /P307 928 0 R /P162 493 0 R /P384 1159 0 R /P89 274 0 R /P449 1354 0 R /P130 397 0 R /P54 169 0 R /P133 406 0 R /P458 1381 0 R /P98 301 0 R /P272 823 0 R /P243 736 0 R /P292 883 0 R /P246 745 0 R /P58 181 0 R /P29 94 0 R /P202 613 0 R /P401 1210 0 R /P330 997 0 R /P404 1219 0 R /P407 1228 0 R /P49 154 0 R /P490 1477 0 R /P485 1462 0 R /P488 1471 0 R /P298 901 0 R /P153 466 0 R /P301 910 0 R /P41 130 0 R /P92 283 0 R /P250 757 0 R /P79 244 0 R /P379 1144 0 R /P375 1132 0 R /P378 1141 0 R /P86 265 0 R /P479 1444 0 R /P27 88 0 R /P179 544 0 R /P352 1063 0 R /P182 553 0 R /P455 1372 0 R /P124 379 0 R /P205 622 0 R /P208 631 0 R /P211 640 0 R /P240 727 0 R /P266 805 0 R /P349 1054 0 R /P324 979 0 R /P442 1333 0 R /P459 1384 0 R /P482 1453 0 R /P269 814 0 R /P430 1297 0 R /P295 892 0 R /P150 457 0 R /P435 1312 0 R /P105 322 0 R /P398 1201 0 R /P234 709 0 R /P15 52 0 R /P312 943 0 R /P392 1183 0 R /P321 970 0 R /P476 1435 0 R /P286 865 0 R /P81 250 0 R /P176 535 0 R /P63 196 0 R >> >> endobj 157 0 obj << /Length 158 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 206.3152 450.2884] /Resources 159 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@é@”ž$ endstream endobj 158 0 obj 34 endobj 159 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im1 1530 0 R >> >> endobj 343 0 obj << /Length 344 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 743.324] /Resources 345 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@é@”¦% endstream endobj 344 0 obj 34 endobj 345 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im2 1532 0 R >> >> endobj 526 0 obj << /Length 527 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 166.3216] /Resources 528 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@é@”®& endstream endobj 527 0 obj 34 endobj 528 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im3 1534 0 R >> >> endobj 1285 0 obj << /Length 1286 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 166.3216] /Resources 1287 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@é@”¶' endstream endobj 1286 0 obj 34 endobj 1287 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im4 1536 0 R >> >> endobj 1282 0 obj << /Length 1283 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 177.6576] /Resources 1284 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@é@”¾( endstream endobj 1283 0 obj 34 endobj 1284 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im5 1538 0 R >> >> endobj 1039 0 obj << /Length 1040 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 358.4668] /Resources 1041 0 R >> stream x+TT(BCC „Rɹ úž¹f .ù@é@”Æ) endstream endobj 1040 0 obj 34 endobj 1041 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im6 1540 0 R >> >> endobj 604 0 obj << /Length 605 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 62.0304] /Resources 606 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@é@”Î* endstream endobj 605 0 obj 34 endobj 606 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im7 1542 0 R >> >> endobj 178 0 obj << /Length 179 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 251.6592 149.3176] /Resources 180 0 R >> stream x+TT(BC3 „Rɹ úž¹ .ù@é@•Á5 endstream endobj 179 0 obj 34 endobj 180 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im8 1544 0 R >> >> endobj 223 0 obj << /Length 224 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 806.5564 191.2608] /Resources 225 0 R >> stream x+TT(BC3 „Rɹ úž¹– .ù@é@•É6 endstream endobj 224 0 obj 34 endobj 225 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im9 1546 0 R >> >> endobj 877 0 obj << /Length 878 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 51.012 220.7344] /Resources 879 0 R >> stream x+TT(BC3 „Rɹ úž¹† .ù@ù@‚^ endstream endobj 878 0 obj 35 endobj 879 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im10 1548 0 R >> >> endobj 427 0 obj << /Length 428 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 668.2572 712.15] /Resources 429 0 R >> stream x+TT(BC3 „Rɹ úž¹†† .ù@ù@Š_ endstream endobj 428 0 obj 35 endobj 429 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im11 1550 0 R >> >> endobj 1522 0 obj << /Length 1523 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 708.7492] /Resources 1524 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@ù@œV endstream endobj 1523 0 obj 35 endobj 1524 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im12 1552 0 R >> >> endobj 361 0 obj << /Length 362 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 675.308] /Resources 363 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@ù@œ¥W endstream endobj 362 0 obj 35 endobj 363 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im13 1554 0 R >> >> endobj 1273 0 obj << /Length 1274 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 202.3134] /Resources 1275 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@ù@œ­X endstream endobj 1274 0 obj 35 endobj 1275 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im14 1556 0 R >> >> endobj 370 0 obj << /Length 371 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 582.3528] /Resources 372 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@ù@œµY endstream endobj 371 0 obj 35 endobj 372 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im15 1558 0 R >> >> endobj 1114 0 obj << /Length 1115 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 697.98] /Resources 1116 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@ù@œ½Z endstream endobj 1115 0 obj 35 endobj 1116 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im16 1560 0 R >> >> endobj 1408 0 obj << /Length 1409 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 729.154] /Resources 1410 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@ù@œÅ[ endstream endobj 1409 0 obj 35 endobj 1410 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im17 1562 0 R >> >> endobj 253 0 obj << /Length 254 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 80.168] /Resources 255 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@ù@œÍ\ endstream endobj 254 0 obj 35 endobj 255 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im18 1564 0 R >> >> endobj 793 0 obj << /Length 794 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 615.2272] /Resources 795 0 R >> stream x+TT(BCC „Rɹ úž¹†– .ù@ù@œÕ] endstream endobj 794 0 obj 35 endobj 795 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im19 1566 0 R >> >> endobj 508 0 obj << /Length 509 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 224.1352] /Resources 510 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@ù@œ–U endstream endobj 509 0 obj 35 endobj 510 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im20 1568 0 R >> >> endobj 1192 0 obj << /Length 1193 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 690.0448] /Resources 1194 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@ù@œžV endstream endobj 1193 0 obj 35 endobj 1194 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im21 1570 0 R >> >> endobj 1123 0 obj << /Length 1124 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 580.97 604.458] /Resources 1125 0 R >> stream x+TT(BC3 „Rɹ úž¹FF .ù@ù@›a endstream endobj 1124 0 obj 35 endobj 1125 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im22 1572 0 R >> >> endobj 691 0 obj << /Length 692 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 713.8504] /Resources 693 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@ù@œ®X endstream endobj 692 0 obj 35 endobj 693 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im23 1574 0 R >> >> endobj 700 0 obj << /Length 701 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 680.6926] /Resources 702 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@ù@œ¶Y endstream endobj 701 0 obj 35 endobj 702 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im24 1576 0 R >> >> endobj 82 0 obj << /Length 83 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 428.1832] /Resources 84 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@ù@œ¾Z endstream endobj 83 0 obj 35 endobj 84 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im25 1578 0 R >> >> endobj 874 0 obj << /Length 875 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 219.034] /Resources 876 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@ù@œÆ[ endstream endobj 875 0 obj 35 endobj 876 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im26 1580 0 R >> >> endobj 439 0 obj << /Length 440 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 669.0732] /Resources 441 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@ù@œÎ\ endstream endobj 440 0 obj 35 endobj 441 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im27 1582 0 R >> >> endobj 517 0 obj << /Length 518 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 191.2608] /Resources 519 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@ù@œÖ] endstream endobj 518 0 obj 35 endobj 519 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im28 1584 0 R >> >> endobj 1417 0 obj << /Length 1418 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 695.146] /Resources 1419 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@ù@œÞ^ endstream endobj 1418 0 obj 35 endobj 1419 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im29 1586 0 R >> >> endobj 1426 0 obj << /Length 1427 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 662.555] /Resources 1428 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@ù@œŸV endstream endobj 1427 0 obj 35 endobj 1428 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im30 1588 0 R >> >> endobj 778 0 obj << /Length 779 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 130.364 665.389] /Resources 780 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@ù@œ§W endstream endobj 779 0 obj 35 endobj 780 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im31 1590 0 R >> >> endobj 952 0 obj << /Length 953 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 94.6214] /Resources 954 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@ù@œ¯X endstream endobj 953 0 obj 35 endobj 954 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im32 1592 0 R >> >> endobj 1288 0 obj << /Length 1289 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 154.9856] /Resources 1290 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@ù@œ·Y endstream endobj 1289 0 obj 35 endobj 1290 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im33 1594 0 R >> >> endobj 205 0 obj << /Length 206 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 273.4468] /Resources 207 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@ù@œ¿Z endstream endobj 206 0 obj 35 endobj 207 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im34 1596 0 R >> >> endobj 352 0 obj << /Length 353 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 709.316] /Resources 354 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@ù@œÇ[ endstream endobj 353 0 obj 35 endobj 354 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im35 1598 0 R >> >> endobj 55 0 obj << /Length 56 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 582.3528] /Resources 57 0 R >> stream x+TT(BCC „Rɹ úž¹Æf .ù@ù@œÏ\ endstream endobj 56 0 obj 35 endobj 57 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im36 1600 0 R >> >> endobj 1174 0 obj << /Length 1175 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 505.268] /Resources 1176 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@ù@œ×] endstream endobj 1175 0 obj 35 endobj 1176 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im37 1602 0 R >> >> endobj 1030 0 obj << /Length 1031 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 392.4748] /Resources 1032 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@ù@œß^ endstream endobj 1031 0 obj 35 endobj 1032 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im38 1604 0 R >> >> endobj 961 0 obj << /Length 962 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 917.0824 284.216] /Resources 963 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ– .ù@ù@Üi endstream endobj 962 0 obj 35 endobj 963 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im39 1606 0 R >> >> endobj 595 0 obj << /Length 596 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 95.755] /Resources 597 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@ù@œ¨W endstream endobj 596 0 obj 35 endobj 597 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im40 1608 0 R >> >> endobj 1495 0 obj << /Length 1496 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 676.4416] /Resources 1497 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@ù@œ°X endstream endobj 1496 0 obj 35 endobj 1497 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im41 1610 0 R >> >> endobj 505 0 obj << /Length 506 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 235.4712] /Resources 507 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@ù@œ¸Y endstream endobj 506 0 obj 35 endobj 507 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im42 1612 0 R >> >> endobj 1504 0 obj << /Length 1505 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 645.2676] /Resources 1506 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@ù@œÀZ endstream endobj 1505 0 obj 35 endobj 1506 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im43 1614 0 R >> >> endobj 1078 0 obj << /Length 1079 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 125.512] /Resources 1080 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@ù@œÈ[ endstream endobj 1079 0 obj 35 endobj 1080 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im44 1616 0 R >> >> endobj 217 0 obj << /Length 218 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 228.953] /Resources 219 0 R >> stream x+TT(BCC „Rɹ úž¹&¦ .ù@ù@œÐ\ endstream endobj 218 0 obj 35 endobj 219 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im45 1618 0 R >> >> endobj 235 0 obj << /Length 236 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 146.4836] /Resources 237 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@ù@œØ] endstream endobj 236 0 obj 35 endobj 237 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im46 1620 0 R >> >> endobj 1105 0 obj << /Length 1106 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 731.988] /Resources 1107 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@ù@œà^ endstream endobj 1106 0 obj 35 endobj 1107 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im47 1622 0 R >> >> endobj 148 0 obj << /Length 149 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 109.6416] /Resources 150 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@ù@œè_ endstream endobj 149 0 obj 35 endobj 150 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im48 1624 0 R >> >> endobj 325 0 obj << /Length 326 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 103.6902] /Resources 327 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@ù@œð` endstream endobj 326 0 obj 35 endobj 327 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im49 1626 0 R >> >> endobj 334 0 obj << /Length 335 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 70.5324] /Resources 336 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@ù@œ±X endstream endobj 335 0 obj 35 endobj 336 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im50 1628 0 R >> >> endobj 349 0 obj << /Length 350 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 720.652] /Resources 351 0 R >> stream x+TT(BCC „Rɹ úž¹¦† .ù@ù@œ¹Y endstream endobj 350 0 obj 35 endobj 351 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im51 1630 0 R >> >> endobj 1087 0 obj << /Length 1088 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 92.921] /Resources 1089 0 R >> stream x+TT(BCC „Rɹ úž¹¦F .ù@ù@œÁZ endstream endobj 1088 0 obj 35 endobj 1089 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im52 1632 0 R >> >> endobj 1096 0 obj << /Length 1097 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 59.1964] /Resources 1098 0 R >> stream x+TT(BCC „Rɹ úž¹¦Æ .ù@ù@œÉ[ endstream endobj 1097 0 obj 35 endobj 1098 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im53 1634 0 R >> >> endobj 307 0 obj << /Length 308 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 342.0296] /Resources 309 0 R >> stream x+TT(BCC „Rɹ úž¹¦& .ù@ù@œÑ\ endstream endobj 308 0 obj 35 endobj 309 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im54 1636 0 R >> >> endobj 472 0 obj << /Length 473 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 451.7396 382.8392] /Resources 474 0 R >> stream x+TT(BC3 „Rɹ úž¹¦¦ .ù@ù@Îg endstream endobj 473 0 obj 35 endobj 474 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im55 1638 0 R >> >> endobj 916 0 obj << /Length 917 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 206.3152 450.2884] /Resources 918 0 R >> stream x+TT(BCC „Rɹ úž¹¦f .ù@ù@œá^ endstream endobj 917 0 obj 35 endobj 918 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im56 1640 0 R >> >> endobj 1147 0 obj << /Length 1148 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 605.5916] /Resources 1149 0 R >> stream x+TT(BCC „Rɹ úž¹¦æ .ù@ù@œé_ endstream endobj 1148 0 obj 35 endobj 1149 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im57 1642 0 R >> >> endobj 1012 0 obj << /Length 1013 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 80.168] /Resources 1014 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@ù@œñ` endstream endobj 1013 0 obj 35 endobj 1014 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im58 1644 0 R >> >> endobj 577 0 obj << /Length 578 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 266.6452] /Resources 579 0 R >> stream x+TT(BCC „Rɹ úž¹¦– .ù@ù@œùa endstream endobj 578 0 obj 35 endobj 579 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im59 1646 0 R >> >> endobj 796 0 obj << /Length 797 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 17.004 725.1864] /Resources 798 0 R >> stream x+TT(BC3 „Rɹ úž¹f .ù@ù@¯c endstream endobj 797 0 obj 35 endobj 798 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im60 1648 0 R >> >> endobj 1405 0 obj << /Length 1406 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 1030.442 739.9232] /Resources 1407 0 R >> stream x+TT(BC3 „Rɹ úž¹f† .ù@ù@·d endstream endobj 1406 0 obj 35 endobj 1407 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im61 1650 0 R >> >> endobj 985 0 obj << /Length 986 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 180.4916] /Resources 987 0 R >> stream x+TT(BCC „Rɹ úž¹fF .ù@ù@œÊ[ endstream endobj 986 0 obj 35 endobj 987 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im62 1652 0 R >> >> endobj 847 0 obj << /Length 848 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 405.5112] /Resources 849 0 R >> stream x+TT(BCC „Rɹ úž¹fÆ .ù@ù@œÒ\ endstream endobj 848 0 obj 35 endobj 849 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im63 1654 0 R >> >> endobj 1246 0 obj << /Length 1247 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 326.726] /Resources 1248 0 R >> stream x+TT(BCC „Rɹ úž¹f& .ù@ù@œÚ] endstream endobj 1247 0 obj 35 endobj 1248 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im64 1656 0 R >> >> endobj 1255 0 obj << /Length 1256 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 292.718] /Resources 1257 0 R >> stream x+TT(BCC „Rɹ úž¹f¦ .ù@ù@œâ^ endstream endobj 1256 0 obj 35 endobj 1257 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im65 1658 0 R >> >> endobj 664 0 obj << /Length 665 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 673.3242] /Resources 666 0 R >> stream x+TT(BCC „Rɹ úž¹ff .ù@ù@œê_ endstream endobj 665 0 obj 35 endobj 666 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im66 1660 0 R >> >> endobj 673 0 obj << /Length 674 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 640.7332] /Resources 675 0 R >> stream x+TT(BCC „Rɹ úž¹fæ .ù@ù@œò` endstream endobj 674 0 obj 35 endobj 675 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im67 1662 0 R >> >> endobj 313 0 obj << /Length 314 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 999.8352 147.6172] /Resources 315 0 R >> stream x+TT(BC3 „Rɹ úž¹f .ù@ù@ïk endstream endobj 314 0 obj 35 endobj 315 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im68 1664 0 R >> >> endobj 856 0 obj << /Length 857 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 154.1696 285.3496] /Resources 858 0 R >> stream x+TT(BC3 „Rɹ úž¹f– .ù@ù@÷l endstream endobj 857 0 obj 35 endobj 858 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im69 1666 0 R >> >> endobj 1156 0 obj << /Length 1157 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 571.5836] /Resources 1158 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@ù@œÃZ endstream endobj 1157 0 obj 35 endobj 1158 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im70 1668 0 R >> >> endobj 490 0 obj << /Length 491 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 315.39] /Resources 492 0 R >> stream x+TT(BCC „Rɹ úž¹æ† .ù@ù@œË[ endstream endobj 491 0 obj 35 endobj 492 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im71 1670 0 R >> >> endobj 934 0 obj << /Length 935 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 326.1592] /Resources 936 0 R >> stream x+TT(BCC „Rɹ úž¹æF .ù@ù@œÓ\ endstream endobj 935 0 obj 35 endobj 936 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im72 1672 0 R >> >> endobj 1165 0 obj << /Length 1166 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 538.7092] /Resources 1167 0 R >> stream x+TT(BCC „Rɹ úž¹æÆ .ù@ù@œÛ] endstream endobj 1166 0 obj 35 endobj 1167 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im73 1674 0 R >> >> endobj 1351 0 obj << /Length 1352 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 106.5242] /Resources 1353 0 R >> stream x+TT(BCC „Rɹ úž¹æ& .ù@ù@œã^ endstream endobj 1352 0 obj 35 endobj 1353 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im74 1676 0 R >> >> endobj 1480 0 obj << /Length 1481 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 732.8382] /Resources 1482 0 R >> stream x+TT(BCC „Rɹ úž¹æ¦ .ù@ù@œë_ endstream endobj 1481 0 obj 35 endobj 1482 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im75 1678 0 R >> >> endobj 1486 0 obj << /Length 1487 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 710.4496] /Resources 1488 0 R >> stream x+TT(BCC „Rɹ úž¹æf .ù@ù@œó` endstream endobj 1487 0 obj 35 endobj 1488 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im76 1680 0 R >> >> endobj 1360 0 obj << /Length 1361 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 73.3664] /Resources 1362 0 R >> stream x+TT(BCC „Rɹ úž¹ææ .ù@ù@œûa endstream endobj 1361 0 obj 35 endobj 1362 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im77 1682 0 R >> >> endobj 1369 0 obj << /Length 1370 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 748.4252] /Resources 1371 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@ù@b endstream endobj 1370 0 obj 35 endobj 1371 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im78 1684 0 R >> >> endobj 40 0 obj << /Length 41 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 714.4172] /Resources 42 0 R >> stream x+TT(BCC „Rɹ úž¹æ– .ù@ù@ c endstream endobj 41 0 obj 35 endobj 42 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im79 1686 0 R >> >> endobj 1069 0 obj << /Length 1070 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 331.2604] /Resources 1071 0 R >> stream x+TT(BCC „Rɹ úž¹ .ù@ù@œÌ[ endstream endobj 1070 0 obj 35 endobj 1071 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im80 1688 0 R >> >> endobj 412 0 obj << /Length 413 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 516.604] /Resources 414 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@ù@œÔ\ endstream endobj 413 0 obj 35 endobj 414 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im81 1690 0 R >> >> endobj 403 0 obj << /Length 404 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 549.7618] /Resources 405 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@ù@œÜ] endstream endobj 404 0 obj 35 endobj 405 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im82 1692 0 R >> >> endobj 499 0 obj << /Length 500 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 554.8972 257.5764] /Resources 501 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ .ù@ù@Ùh endstream endobj 500 0 obj 35 endobj 501 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im83 1694 0 R >> >> endobj 1378 0 obj << /Length 1379 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 714.4172] /Resources 1380 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@ù@œì_ endstream endobj 1379 0 obj 35 endobj 1380 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im84 1696 0 R >> >> endobj 445 0 obj << /Length 446 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 689.2288 580.6524] /Resources 447 0 R >> stream x+TT(BC3 „Rɹ úž¹¦ .ù@ù@éj endstream endobj 446 0 obj 35 endobj 447 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im85 1698 0 R >> >> endobj 1393 0 obj << /Length 1394 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 659.721] /Resources 1395 0 R >> stream x+TT(BCC „Rɹ úž¹f .ù@ù@œüa endstream endobj 1394 0 obj 35 endobj 1395 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im86 1700 0 R >> >> endobj 1399 0 obj << /Length 1400 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 637.3324] /Resources 1401 0 R >> stream x+TT(BCC „Rɹ úž¹æ .ù@ù@b endstream endobj 1400 0 obj 35 endobj 1401 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im87 1702 0 R >> >> endobj 829 0 obj << /Length 830 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 527.6566] /Resources 831 0 R >> stream x+TT(BCC „Rɹ úž¹ .ù@ù@ c endstream endobj 830 0 obj 35 endobj 831 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im88 1704 0 R >> >> endobj 28 0 obj << /Length 29 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 17.004 637.3324] /Resources 30 0 R >> stream x+TT(BC3 „Rɹ úž¹– .ù@ù@ž n endstream endobj 29 0 obj 35 endobj 30 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im89 1706 0 R >> >> endobj 259 0 obj << /Length 260 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 799.7548 437.252] /Resources 261 0 R >> stream x+TT(BC3 „Rɹ úž¹– .ù@ù@Êf endstream endobj 260 0 obj 35 endobj 261 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im90 1708 0 R >> >> endobj 229 0 obj << /Length 230 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 169.1556] /Resources 231 0 R >> stream x+TT(BCC „Rɹ úž¹–† .ù@ù@œÝ] endstream endobj 230 0 obj 35 endobj 231 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im91 1710 0 R >> >> endobj 430 0 obj << /Length 431 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 701.3808] /Resources 432 0 R >> stream x+TT(BCC „Rɹ úž¹–F .ù@ù@œå^ endstream endobj 431 0 obj 35 endobj 432 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im92 1712 0 R >> >> endobj 49 0 obj << /Length 50 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 115.6272 603.3244] /Resources 51 0 R >> stream x+TT(BC3 „Rɹ úž¹–Æ .ù@ù@âi endstream endobj 50 0 obj 35 endobj 51 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im93 1714 0 R >> >> endobj 811 0 obj << /Length 812 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 593.122] /Resources 813 0 R >> stream x+TT(BCC „Rɹ úž¹–& .ù@ù@œõ` endstream endobj 812 0 obj 35 endobj 813 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im94 1716 0 R >> >> endobj 145 0 obj << /Length 146 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 120.9776] /Resources 147 0 R >> stream x+TT(BCC „Rɹ úž¹–¦ .ù@ù@œýa endstream endobj 146 0 obj 35 endobj 147 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im95 1718 0 R >> >> endobj 742 0 obj << /Length 743 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 655.47] /Resources 744 0 R >> stream x+TT(BCC „Rɹ úž¹–f .ù@ù@b endstream endobj 743 0 obj 35 endobj 744 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im96 1720 0 R >> >> endobj 751 0 obj << /Length 752 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 623.1624] /Resources 753 0 R >> stream x+TT(BCC „Rɹ úž¹–æ .ù@ù@ c endstream endobj 752 0 obj 35 endobj 753 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im97 1722 0 R >> >> endobj 994 0 obj << /Length 995 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 146.4836] /Resources 996 0 R >> stream x+TT(BCC „Rɹ úž¹– .ù@ù@d endstream endobj 995 0 obj 35 endobj 996 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im98 1724 0 R >> >> endobj 1003 0 obj << /Length 1004 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 113.6092] /Resources 1005 0 R >> stream x+TT(BCC „Rɹ úž¹–– .ù@ù@e endstream endobj 1004 0 obj 35 endobj 1005 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im99 1726 0 R >> >> endobj 568 0 obj << /Length 569 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 298.386] /Resources 570 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¤¬„ endstream endobj 569 0 obj 36 endobj 570 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im100 1728 0 R >> >> endobj 1225 0 obj << /Length 1226 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 503.5676] /Resources 1227 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤´… endstream endobj 1226 0 obj 36 endobj 1227 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im101 1730 0 R >> >> endobj 1468 0 obj << /Length 1469 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 648.1016] /Resources 1470 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@¤¼† endstream endobj 1469 0 obj 36 endobj 1470 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im102 1732 0 R >> >> endobj 610 0 obj << /Length 611 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 748.4252] /Resources 612 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¤Ä‡ endstream endobj 611 0 obj 36 endobj 612 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im103 1734 0 R >> >> endobj 907 0 obj << /Length 908 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 109.6416] /Resources 909 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¤Ìˆ endstream endobj 908 0 obj 36 endobj 909 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im104 1736 0 R >> >> endobj 838 0 obj << /Length 839 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 439.5192] /Resources 840 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¤Ô‰ endstream endobj 839 0 obj 36 endobj 840 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im105 1738 0 R >> >> endobj 925 0 obj << /Length 926 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 357.9] /Resources 927 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@¤ÜŠ endstream endobj 926 0 obj 36 endobj 927 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im106 1740 0 R >> >> endobj 22 0 obj << /Length 23 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 130.364 654.3364] /Resources 24 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¤ä‹ endstream endobj 23 0 obj 36 endobj 24 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im107 1742 0 R >> >> endobj 649 0 obj << /Length 650 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 729.154] /Resources 651 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¤ìŒ endstream endobj 650 0 obj 36 endobj 651 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im108 1744 0 R >> >> endobj 280 0 obj << /Length 281 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 358.4668] /Resources 282 0 R >> stream x+TT(BCC „Rɹ úž¹†– .ù@¤ô endstream endobj 281 0 obj 36 endobj 282 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im109 1746 0 R >> >> endobj 67 0 obj << /Length 68 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 538.4258] /Resources 69 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤µ… endstream endobj 68 0 obj 36 endobj 69 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im110 1748 0 R >> >> endobj 367 0 obj << /Length 368 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 593.6888] /Resources 369 0 R >> stream x+TT(BCC „Rɹ úž¹†@žK>PA ¤½† endstream endobj 368 0 obj 35 endobj 369 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im111 1750 0 R >> >> endobj 655 0 obj << /Length 656 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 706.482] /Resources 657 0 R >> stream x+TT(BCC „Rɹ úž¹††F .ù@¤Å‡ endstream endobj 656 0 obj 36 endobj 657 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im112 1752 0 R >> >> endobj 241 0 obj << /Length 242 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 124.6618] /Resources 243 0 R >> stream x+TT(BCC „Rɹ úž¹††Æ .ù@¤Íˆ endstream endobj 242 0 obj 36 endobj 243 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im113 1754 0 R >> >> endobj 1051 0 obj << /Length 1052 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 997.0012 436.6852] /Resources 1053 0 R >> stream x+TT(BCC „Rɹ úž¹††& .ù@¤Õ‰ endstream endobj 1052 0 obj 36 endobj 1053 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im114 1756 0 R >> >> endobj 682 0 obj << /Length 683 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 819.5928 747.2916] /Resources 684 0 R >> stream x+TT(BC3 „Rɹ úž¹††¦ .ù@¥Ü” endstream endobj 683 0 obj 36 endobj 684 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im115 1758 0 R >> >> endobj 1138 0 obj << /Length 1139 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 549.195] /Resources 1140 0 R >> stream x+TT(BCC „Rɹ úž¹††f .ù@¤å‹ endstream endobj 1139 0 obj 36 endobj 1140 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im116 1760 0 R >> >> endobj 481 0 obj << /Length 482 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 349.398] /Resources 483 0 R >> stream x+TT(BCC „Rɹ úž¹††æ .ù@¤íŒ endstream endobj 482 0 obj 36 endobj 483 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im117 1762 0 R >> >> endobj 271 0 obj << /Length 272 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 392.4748] /Resources 273 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤õ endstream endobj 272 0 obj 36 endobj 273 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im118 1764 0 R >> >> endobj 289 0 obj << /Length 290 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 998.1348 447.4544] /Resources 291 0 R >> stream x+TT(BC3 „Rɹ úž¹††– .ù@¥ü˜ endstream endobj 290 0 obj 36 endobj 291 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im119 1766 0 R >> >> endobj 1303 0 obj << /Length 1304 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 99.7226] /Resources 1305 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@¤¾† endstream endobj 1304 0 obj 36 endobj 1305 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im120 1768 0 R >> >> endobj 394 0 obj << /Length 395 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 582.9196] /Resources 396 0 R >> stream x+TT(BCC „Rɹ úž¹†F† .ù@¤Æ‡ endstream endobj 395 0 obj 36 endobj 396 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im121 1770 0 R >> >> endobj 913 0 obj << /Length 914 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 207.4488 461.0576] /Resources 915 0 R >> stream x+TT(BC3 „Rɹ úž¹†FF .ù@¥Í’ endstream endobj 914 0 obj 36 endobj 915 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im122 1772 0 R >> >> endobj 550 0 obj << /Length 551 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 77.334] /Resources 552 0 R >> stream x+TT(BCC „Rɹ úž¹†FÆ .ù@¤Ö‰ endstream endobj 551 0 obj 36 endobj 552 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im123 1774 0 R >> >> endobj 1060 0 obj << /Length 1061 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 363.0012] /Resources 1062 0 R >> stream x+TT(BCC „Rɹ úž¹†F& .ù@¤ÞŠ endstream endobj 1061 0 obj 36 endobj 1062 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im124 1776 0 R >> >> endobj 523 0 obj << /Length 524 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 177.6576] /Resources 525 0 R >> stream x+TT(BCC „Rɹ úž¹†F¦ .ù@¤æ‹ endstream endobj 524 0 obj 36 endobj 525 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im125 1778 0 R >> >> endobj 820 0 obj << /Length 821 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 559.9642] /Resources 822 0 R >> stream x+TT(BCC „Rɹ úž¹†Ff .ù@¤îŒ endstream endobj 821 0 obj 36 endobj 822 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im126 1780 0 R >> >> endobj 385 0 obj << /Length 386 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 473.278 616.3608] /Resources 387 0 R >> stream x+TT(BC3 „Rɹ úž¹†Fæ .ù@¥õ— endstream endobj 386 0 obj 36 endobj 387 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im127 1782 0 R >> >> endobj 646 0 obj << /Length 647 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 1030.442 739.9232] /Resources 648 0 R >> stream x+TT(BC3 „Rɹ úž¹†F .ù@¥ý˜ endstream endobj 647 0 obj 36 endobj 648 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im128 1784 0 R >> >> endobj 175 0 obj << /Length 176 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 326.1592] /Resources 177 0 R >> stream x+TT(BCC „Rɹ úž¹†F– .ù@¥ endstream endobj 176 0 obj 36 endobj 177 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im129 1786 0 R >> >> endobj 628 0 obj << /Length 629 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 681.2594] /Resources 630 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¤Ç‡ endstream endobj 629 0 obj 36 endobj 630 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im130 1788 0 R >> >> endobj 637 0 obj << /Length 638 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 648.6684] /Resources 639 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ† .ù@¤Ïˆ endstream endobj 638 0 obj 36 endobj 639 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im131 1790 0 R >> >> endobj 340 0 obj << /Length 341 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 472.7112 754.0932] /Resources 342 0 R >> stream x+TT(BC3 „Rɹ úž¹†ÆF .ù@¥Ö“ endstream endobj 341 0 obj 36 endobj 342 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im132 1792 0 R >> >> endobj 133 0 obj << /Length 134 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 164.9046] /Resources 135 0 R >> stream x+TT(BCC „Rɹ úž¹†ÆÆ .ù@¤ßŠ endstream endobj 134 0 obj 36 endobj 135 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im133 1794 0 R >> >> endobj 880 0 obj << /Length 881 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 209.9652] /Resources 882 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ& .ù@¤ç‹ endstream endobj 881 0 obj 36 endobj 882 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im134 1796 0 R >> >> endobj 733 0 obj << /Length 734 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 687.7776] /Resources 735 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ¦ .ù@¤ïŒ endstream endobj 734 0 obj 36 endobj 735 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im135 1798 0 R >> >> endobj 976 0 obj << /Length 977 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 228.953] /Resources 978 0 R >> stream x+TT(BCC „Rɹ úž¹†Æf .ù@¤÷ endstream endobj 977 0 obj 36 endobj 978 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im136 1800 0 R >> >> endobj 1342 0 obj << /Length 1343 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 139.682] /Resources 1344 0 R >> stream x+TT(BCC „Rɹ úž¹†Ææ .ù@¤ÿŽ endstream endobj 1343 0 obj 36 endobj 1344 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im137 1802 0 R >> >> endobj 1216 0 obj << /Length 1217 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 536.7254] /Resources 1218 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¥ endstream endobj 1217 0 obj 36 endobj 1218 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im138 1804 0 R >> >> endobj 1450 0 obj << /Length 1451 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 713.8504] /Resources 1452 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ– .ù@¥ endstream endobj 1451 0 obj 36 endobj 1452 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im139 1806 0 R >> >> endobj 1459 0 obj << /Length 1460 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 680.6926] /Resources 1461 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¤Ðˆ endstream endobj 1460 0 obj 36 endobj 1461 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im140 1808 0 R >> >> endobj 889 0 obj << /Length 890 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 175.9572] /Resources 891 0 R >> stream x+TT(BCC „Rɹ úž¹†&† .ù@¤Ø‰ endstream endobj 890 0 obj 36 endobj 891 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im141 1810 0 R >> >> endobj 898 0 obj << /Length 899 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 143.0828] /Resources 900 0 R >> stream x+TT(BCC „Rɹ úž¹†&F .ù@¤àŠ endstream endobj 899 0 obj 36 endobj 900 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im142 1812 0 R >> >> endobj 319 0 obj << /Length 320 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 125.512] /Resources 321 0 R >> stream x+TT(BCC „Rɹ úž¹†&Æ .ù@¤è‹ endstream endobj 320 0 obj 36 endobj 321 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im143 1814 0 R >> >> endobj 463 0 obj << /Length 464 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 514.9036] /Resources 465 0 R >> stream x+TT(BCC „Rɹ úž¹†&& .ù@¤ðŒ endstream endobj 464 0 obj 36 endobj 465 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im144 1816 0 R >> >> endobj 1309 0 obj << /Length 1310 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 77.334] /Resources 1311 0 R >> stream x+TT(BCC „Rɹ úž¹†&¦ .ù@¤ø endstream endobj 1310 0 obj 36 endobj 1311 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im145 1818 0 R >> >> endobj 1018 0 obj << /Length 1019 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 799.7548 437.252] /Resources 1020 0 R >> stream x+TT(BC3 „Rɹ úž¹†&f .ù@¥ÿ˜ endstream endobj 1019 0 obj 36 endobj 1020 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im146 1820 0 R >> >> endobj 715 0 obj << /Length 716 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 625.4296] /Resources 717 0 R >> stream x+TT(BCC „Rɹ úž¹†&æ .ù@¥ endstream endobj 716 0 obj 36 endobj 717 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im147 1822 0 R >> >> endobj 376 0 obj << /Length 377 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 559.9642] /Resources 378 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¥ endstream endobj 377 0 obj 36 endobj 378 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im148 1824 0 R >> >> endobj 211 0 obj << /Length 212 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 250.7748] /Resources 213 0 R >> stream x+TT(BCC „Rɹ úž¹†&– .ù@¥‘ endstream endobj 212 0 obj 36 endobj 213 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im149 1826 0 R >> >> endobj 1129 0 obj << /Length 1130 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 582.3528] /Resources 1131 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¤Ù‰ endstream endobj 1130 0 obj 36 endobj 1131 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im150 1828 0 R >> >> endobj 688 0 obj << /Length 689 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 725.1864] /Resources 690 0 R >> stream x+TT(BCC „Rɹ úž¹†¦† .ù@¤áŠ endstream endobj 689 0 obj 36 endobj 690 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im151 1830 0 R >> >> endobj 103 0 obj << /Length 104 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 263.2444] /Resources 105 0 R >> stream x+TT(BCC „Rɹ úž¹†¦F .ù@¤é‹ endstream endobj 104 0 obj 36 endobj 105 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im152 1832 0 R >> >> endobj 79 0 obj << /Length 80 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 439.5192] /Resources 81 0 R >> stream x+TT(BCC „Rɹ úž¹†¦Æ .ù@¤ñŒ endstream endobj 80 0 obj 36 endobj 81 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im153 1834 0 R >> >> endobj 532 0 obj << /Length 533 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 143.6496] /Resources 534 0 R >> stream x+TT(BCC „Rɹ úž¹†¦& .ù@¤ù endstream endobj 533 0 obj 36 endobj 534 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im154 1836 0 R >> >> endobj 1315 0 obj << /Length 1316 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 668.2572 386.24] /Resources 1317 0 R >> stream x+TT(BC3 „Rɹ úž¹†¦¦ .ù@¦˜ endstream endobj 1316 0 obj 36 endobj 1317 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im155 1838 0 R >> >> endobj 541 0 obj << /Length 542 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 110.7752] /Resources 543 0 R >> stream x+TT(BCC „Rɹ úž¹†¦f .ù@¥  endstream endobj 542 0 obj 36 endobj 543 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im156 1840 0 R >> >> endobj 115 0 obj << /Length 116 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 219.034] /Resources 117 0 R >> stream x+TT(BCC „Rɹ úž¹†¦æ .ù@¥ endstream endobj 116 0 obj 36 endobj 117 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im157 1842 0 R >> >> endobj 151 0 obj << /Length 152 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 98.3056] /Resources 153 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¥‘ endstream endobj 152 0 obj 36 endobj 153 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im158 1844 0 R >> >> endobj 946 0 obj << /Length 947 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 116.1598] /Resources 948 0 R >> stream x+TT(BCC „Rɹ úž¹†¦– .ù@¥!’ endstream endobj 947 0 obj 36 endobj 948 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im159 1846 0 R >> >> endobj 1186 0 obj << /Length 1187 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 668.2572 712.15] /Resources 1188 0 R >> stream x+TT(BC3 „Rɹ úž¹†f .ù@¥á” endstream endobj 1187 0 obj 36 endobj 1188 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im160 1848 0 R >> >> endobj 1045 0 obj << /Length 1046 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 335.7948] /Resources 1047 0 R >> stream x+TT(BCC „Rɹ úž¹†f† .ù@¤ê‹ endstream endobj 1046 0 obj 36 endobj 1047 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im161 1850 0 R >> >> endobj 619 0 obj << /Length 620 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 714.4172] /Resources 621 0 R >> stream x+TT(BCC „Rɹ úž¹†fF .ù@¤òŒ endstream endobj 620 0 obj 36 endobj 621 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im162 1852 0 R >> >> endobj 1519 0 obj << /Length 1520 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 719.8018] /Resources 1521 0 R >> stream x+TT(BCC „Rɹ úž¹†fÆ .ù@¤ú endstream endobj 1520 0 obj 36 endobj 1521 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im163 1854 0 R >> >> endobj 127 0 obj << /Length 128 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 187.2932] /Resources 129 0 R >> stream x+TT(BCC „Rɹ úž¹†f& .ù@¥Ž endstream endobj 128 0 obj 36 endobj 129 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im164 1856 0 R >> >> endobj 106 0 obj << /Length 107 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 251.9084] /Resources 108 0 R >> stream x+TT(BCC „Rɹ úž¹†f¦ .ù@¥  endstream endobj 107 0 obj 36 endobj 108 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im165 1858 0 R >> >> endobj 112 0 obj << /Length 113 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 230.0866] /Resources 114 0 R >> stream x+TT(BCC „Rɹ úž¹†ff .ù@¥ endstream endobj 113 0 obj 36 endobj 114 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im166 1860 0 R >> >> endobj 64 0 obj << /Length 65 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 549.195] /Resources 66 0 R >> stream x+TT(BCC „Rɹ úž¹†fæ .ù@¥‘ endstream endobj 65 0 obj 36 endobj 66 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im167 1862 0 R >> >> endobj 232 0 obj << /Length 233 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 157.8196] /Resources 234 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@¥"’ endstream endobj 233 0 obj 36 endobj 234 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im168 1864 0 R >> >> endobj 1111 0 obj << /Length 1112 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 709.316] /Resources 1113 0 R >> stream x+TT(BCC „Rɹ úž¹†f– .ù@¥*“ endstream endobj 1112 0 obj 36 endobj 1113 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im169 1866 0 R >> >> endobj 1120 0 obj << /Length 1121 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 675.308] /Resources 1122 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¤ë‹ endstream endobj 1121 0 obj 36 endobj 1122 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im170 1868 0 R >> >> endobj 1102 0 obj << /Length 1103 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 743.324] /Resources 1104 0 R >> stream x+TT(BCC „Rɹ úž¹†æ† .ù@¤óŒ endstream endobj 1103 0 obj 36 endobj 1104 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im171 1870 0 R >> >> endobj 802 0 obj << /Length 803 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 703.0812] /Resources 804 0 R >> stream x+TT(BCC „Rɹ úž¹†æF .ù@¤û endstream endobj 803 0 obj 36 endobj 804 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im172 1872 0 R >> >> endobj 58 0 obj << /Length 59 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 571.0168] /Resources 60 0 R >> stream x+TT(BCC „Rɹ úž¹†æÆ .ù@¥Ž endstream endobj 59 0 obj 36 endobj 60 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im173 1874 0 R >> >> endobj 1270 0 obj << /Length 1271 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 213.0826] /Resources 1272 0 R >> stream x+TT(BCC „Rɹ úž¹†æ& .ù@¥  endstream endobj 1271 0 obj 36 endobj 1272 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im174 1876 0 R >> >> endobj 1330 0 obj << /Length 1331 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 287.6168] /Resources 1332 0 R >> stream x+TT(BCC „Rɹ úž¹†æ¦ .ù@¥ endstream endobj 1331 0 obj 36 endobj 1332 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im175 1878 0 R >> >> endobj 1294 0 obj << /Length 1295 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 132.597] /Resources 1296 0 R >> stream x+TT(BCC „Rɹ úž¹†æf .ù@¥‘ endstream endobj 1295 0 obj 36 endobj 1296 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im176 1880 0 R >> >> endobj 454 0 obj << /Length 455 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 547.4946] /Resources 456 0 R >> stream x+TT(BCC „Rɹ úž¹†ææ .ù@¥#’ endstream endobj 455 0 obj 36 endobj 456 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im177 1882 0 R >> >> endobj 1198 0 obj << /Length 1199 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 669.0732] /Resources 1200 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¥+“ endstream endobj 1199 0 obj 36 endobj 1200 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im178 1884 0 R >> >> endobj 193 0 obj << /Length 194 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 94.6214] /Resources 195 0 R >> stream x+TT(BCC „Rɹ úž¹†æ– .ù@¥3” endstream endobj 194 0 obj 36 endobj 195 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im179 1886 0 R >> >> endobj 697 0 obj << /Length 698 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 691.4618] /Resources 699 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¤ôŒ endstream endobj 698 0 obj 36 endobj 699 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im180 1888 0 R >> >> endobj 226 0 obj << /Length 227 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 180.4916] /Resources 228 0 R >> stream x+TT(BCC „Rɹ úž¹†† .ù@¤ü endstream endobj 227 0 obj 36 endobj 228 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im181 1890 0 R >> >> endobj 706 0 obj << /Length 707 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 659.1542] /Resources 708 0 R >> stream x+TT(BCC „Rɹ úž¹†F .ù@¥Ž endstream endobj 707 0 obj 36 endobj 708 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im182 1892 0 R >> >> endobj 448 0 obj << /Length 449 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 569.8832] /Resources 450 0 R >> stream x+TT(BCC „Rɹ úž¹†Æ .ù@¥  endstream endobj 449 0 obj 36 endobj 450 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im183 1894 0 R >> >> endobj 436 0 obj << /Length 437 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 679.2756] /Resources 438 0 R >> stream x+TT(BCC „Rɹ úž¹†& .ù@¥ endstream endobj 437 0 obj 36 endobj 438 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im184 1896 0 R >> >> endobj 583 0 obj << /Length 584 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 139.682] /Resources 585 0 R >> stream x+TT(BCC „Rɹ úž¹†¦ .ù@¥‘ endstream endobj 584 0 obj 36 endobj 585 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im185 1898 0 R >> >> endobj 1276 0 obj << /Length 1277 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 191.2608] /Resources 1278 0 R >> stream x+TT(BCC „Rɹ úž¹†f .ù@¥$’ endstream endobj 1277 0 obj 36 endobj 1278 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im186 1900 0 R >> >> endobj 967 0 obj << /Length 968 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 262.1108] /Resources 969 0 R >> stream x+TT(BCC „Rɹ úž¹†æ .ù@¥,“ endstream endobj 968 0 obj 36 endobj 969 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im187 1902 0 R >> >> endobj 184 0 obj << /Length 185 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 127.2124] /Resources 186 0 R >> stream x+TT(BCC „Rɹ úž¹† .ù@¥4” endstream endobj 185 0 obj 36 endobj 186 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im188 1904 0 R >> >> endobj 421 0 obj << /Length 422 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 662.5892 767.1296] /Resources 423 0 R >> stream x+TT(BC3 „Rɹ úž¹†– .ù@¦;Ÿ endstream endobj 422 0 obj 36 endobj 423 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im189 1906 0 R >> >> endobj 1423 0 obj << /Length 1424 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 673.3242] /Resources 1425 0 R >> stream x+TT(BCC „Rɹ úž¹†– .ù@¤ý endstream endobj 1424 0 obj 36 endobj 1425 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im190 1908 0 R >> >> endobj 1432 0 obj << /Length 1433 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 640.7332] /Resources 1434 0 R >> stream x+TT(BCC „Rɹ úž¹†–† .ù@¥Ž endstream endobj 1433 0 obj 36 endobj 1434 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im191 1910 0 R >> >> endobj 124 0 obj << /Length 125 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 198.6292] /Resources 126 0 R >> stream x+TT(BCC „Rɹ úž¹†–F .ù@¥  endstream endobj 125 0 obj 36 endobj 126 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im192 1912 0 R >> >> endobj 9 0 obj << /Length 10 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 130.9308 729.7208] /Resources 11 0 R >> stream x+TT(BC3 „Rɹ úž¹†–Æ .ù@¦š endstream endobj 10 0 obj 36 endobj 11 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im193 1914 0 R >> >> endobj 358 0 obj << /Length 359 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 686.644] /Resources 360 0 R >> stream x+TT(BCC „Rɹ úž¹†–& .ù@¥‘ endstream endobj 359 0 obj 36 endobj 360 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im194 1916 0 R >> >> endobj 949 0 obj << /Length 950 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 105.3906] /Resources 951 0 R >> stream x+TT(BCC „Rɹ úž¹†–¦ .ù@¥%’ endstream endobj 950 0 obj 36 endobj 951 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im195 1918 0 R >> >> endobj 958 0 obj << /Length 959 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 72.2328] /Resources 960 0 R >> stream x+TT(BCC „Rɹ úž¹†–f .ù@¥-“ endstream endobj 959 0 obj 36 endobj 960 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im196 1920 0 R >> >> endobj 784 0 obj << /Length 785 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 130.364 643.5672] /Resources 786 0 R >> stream x+TT(BCC „Rɹ úž¹†–æ .ù@¥5” endstream endobj 785 0 obj 36 endobj 786 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im197 1922 0 R >> >> endobj 1048 0 obj << /Length 1049 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 998.1348 447.4544] /Resources 1050 0 R >> stream x+TT(BC3 „Rɹ úž¹†– .ù@¦<Ÿ endstream endobj 1049 0 obj 36 endobj 1050 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im198 1924 0 R >> >> endobj 139 0 obj << /Length 140 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 143.0828] /Resources 141 0 R >> stream x+TT(BCC „Rɹ úž¹†–– .ù@¥E– endstream endobj 140 0 obj 36 endobj 141 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im199 1926 0 R >> >> endobj 1027 0 obj << /Length 1028 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 403.8108] /Resources 1029 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@¤¶… endstream endobj 1028 0 obj 36 endobj 1029 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im200 1928 0 R >> >> endobj 592 0 obj << /Length 593 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 106.5242] /Resources 594 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¤¾† endstream endobj 593 0 obj 36 endobj 594 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im201 1930 0 R >> >> endobj 601 0 obj << /Length 602 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 73.3664] /Resources 603 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¤Æ‡ endstream endobj 602 0 obj 36 endobj 603 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im202 1932 0 R >> >> endobj 1036 0 obj << /Length 1037 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 369.8028] /Resources 1038 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¤Îˆ endstream endobj 1037 0 obj 36 endobj 1038 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im203 1934 0 R >> >> endobj 1501 0 obj << /Length 1502 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 655.47] /Resources 1503 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@¤Ö‰ endstream endobj 1502 0 obj 36 endobj 1503 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im204 1936 0 R >> >> endobj 775 0 obj << /Length 776 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 131.4976 675.8748] /Resources 777 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦ .ù@¥Ý” endstream endobj 776 0 obj 36 endobj 777 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im205 1938 0 R >> >> endobj 1075 0 obj << /Length 1076 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 136.848] /Resources 1077 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¤æ‹ endstream endobj 1076 0 obj 36 endobj 1077 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im206 1940 0 R >> >> endobj 1510 0 obj << /Length 1511 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 623.1624] /Resources 1512 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@¤îŒ endstream endobj 1511 0 obj 36 endobj 1512 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im207 1942 0 R >> >> endobj 1231 0 obj << /Length 1232 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 451.7396 382.8392] /Resources 1233 0 R >> stream x+TT(BC3 „Rɹ úž¹F .ù@¥õ— endstream endobj 1232 0 obj 36 endobj 1233 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im208 1944 0 R >> >> endobj 142 0 obj << /Length 143 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 132.0302] /Resources 144 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¤þŽ endstream endobj 143 0 obj 36 endobj 144 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im209 1946 0 R >> >> endobj 13 0 obj << /Length 14 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 129.7972 719.235] /Resources 15 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¤¿† endstream endobj 14 0 obj 36 endobj 15 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im210 1948 0 R >> >> endobj 1261 0 obj << /Length 1262 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 246.8072] /Resources 1263 0 R >> stream x+TT(BCC „Rɹ úž¹F@žK>PA ¤Ç‡ endstream endobj 1262 0 obj 35 endobj 1263 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im211 1950 0 R >> >> endobj 97 0 obj << /Length 98 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 154.1696 285.3496] /Resources 99 0 R >> stream x+TT(BC3 „Rɹ úž¹F†F .ù@¥Î’ endstream endobj 98 0 obj 36 endobj 99 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im212 1952 0 R >> >> endobj 835 0 obj << /Length 836 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 450.8552] /Resources 837 0 R >> stream x+TT(BCC „Rɹ úž¹F†Æ .ù@¤×‰ endstream endobj 836 0 obj 36 endobj 837 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im213 1954 0 R >> >> endobj 766 0 obj << /Length 767 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 697.4132] /Resources 768 0 R >> stream x+TT(BCC „Rɹ úž¹F†& .ù@¤ßŠ endstream endobj 767 0 obj 36 endobj 768 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im214 1956 0 R >> >> endobj 331 0 obj << /Length 332 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 81.8684] /Resources 333 0 R >> stream x+TT(BCC „Rɹ úž¹F†¦ .ù@¤ç‹ endstream endobj 332 0 obj 36 endobj 333 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im215 1958 0 R >> >> endobj 1093 0 obj << /Length 1094 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 70.5324] /Resources 1095 0 R >> stream x+TT(BCC „Rɹ úž¹F†f .ù@¤ïŒ endstream endobj 1094 0 obj 36 endobj 1095 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im216 1960 0 R >> >> endobj 316 0 obj << /Length 317 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 136.848] /Resources 318 0 R >> stream x+TT(BCC „Rɹ úž¹F†æ .ù@¤÷ endstream endobj 317 0 obj 36 endobj 318 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im217 1962 0 R >> >> endobj 871 0 obj << /Length 872 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 230.0866] /Resources 873 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¤ÿŽ endstream endobj 872 0 obj 36 endobj 873 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im218 1964 0 R >> >> endobj 514 0 obj << /Length 515 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 202.3134] /Resources 516 0 R >> stream x+TT(BCC „Rɹ úž¹F†– .ù@¥ endstream endobj 515 0 obj 36 endobj 516 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im219 1966 0 R >> >> endobj 1363 0 obj << /Length 1364 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 62.0304] /Resources 1365 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¤È‡ endstream endobj 1364 0 obj 36 endobj 1365 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im220 1968 0 R >> >> endobj 1414 0 obj << /Length 1415 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 706.482] /Resources 1416 0 R >> stream x+TT(BCC „Rɹ úž¹FF† .ù@¤Ðˆ endstream endobj 1415 0 obj 36 endobj 1416 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im221 1970 0 R >> >> endobj 34 0 obj << /Length 35 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 615.2272] /Resources 36 0 R >> stream x+TT(BCC „Rɹ úž¹FFF .ù@¤Ø‰ endstream endobj 35 0 obj 36 endobj 36 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im222 1972 0 R >> >> endobj 853 0 obj << /Length 854 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 382.8392] /Resources 855 0 R >> stream x+TT(BCC „Rɹ úž¹FFÆ .ù@¤àŠ endstream endobj 854 0 obj 36 endobj 855 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im223 1974 0 R >> >> endobj 1441 0 obj << /Length 1442 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 819.5928 747.2916] /Resources 1443 0 R >> stream x+TT(BC3 „Rɹ úž¹FF& .ù@¥ç• endstream endobj 1442 0 obj 36 endobj 1443 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im224 1976 0 R >> >> endobj 1243 0 obj << /Length 1244 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 338.062] /Resources 1245 0 R >> stream x+TT(BCC „Rɹ úž¹FF¦ .ù@¤ðŒ endstream endobj 1244 0 obj 36 endobj 1245 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im225 1978 0 R >> >> endobj 1099 0 obj << /Length 1100 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 472.7112 754.0932] /Resources 1101 0 R >> stream x+TT(BC3 „Rɹ úž¹FFf .ù@¥÷— endstream endobj 1100 0 obj 36 endobj 1101 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im226 1980 0 R >> >> endobj 670 0 obj << /Length 671 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 651.7858] /Resources 672 0 R >> stream x+TT(BCC „Rɹ úž¹FFæ .ù@¥Ž endstream endobj 671 0 obj 36 endobj 672 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im227 1982 0 R >> >> endobj 679 0 obj << /Length 680 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 618.0612] /Resources 681 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¥ endstream endobj 680 0 obj 36 endobj 681 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im228 1984 0 R >> >> endobj 919 0 obj << /Length 920 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 248.2584 380.0052] /Resources 921 0 R >> stream x+TT(BC3 „Rɹ úž¹FF– .ù@¦š endstream endobj 920 0 obj 36 endobj 921 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im229 1986 0 R >> >> endobj 1336 0 obj << /Length 1337 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 266.6452] /Resources 1338 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¤Ñˆ endstream endobj 1337 0 obj 36 endobj 1338 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im230 1988 0 R >> >> endobj 1150 0 obj << /Length 1151 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 594.2556] /Resources 1152 0 R >> stream x+TT(BCC „Rɹ úž¹FƆ .ù@¤Ù‰ endstream endobj 1151 0 obj 36 endobj 1152 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im231 1990 0 R >> >> endobj 931 0 obj << /Length 932 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 336.9284] /Resources 933 0 R >> stream x+TT(BCC „Rɹ úž¹FÆF .ù@¤áŠ endstream endobj 932 0 obj 36 endobj 933 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im232 1992 0 R >> >> endobj 496 0 obj << /Length 497 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 292.718] /Resources 498 0 R >> stream x+TT(BCC „Rɹ úž¹FÆÆ .ù@¤é‹ endstream endobj 497 0 obj 36 endobj 498 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im233 1994 0 R >> >> endobj 1162 0 obj << /Length 1163 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 549.7618] /Resources 1164 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ& .ù@¤ñŒ endstream endobj 1163 0 obj 36 endobj 1164 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im234 1996 0 R >> >> endobj 46 0 obj << /Length 47 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 691.7452] /Resources 48 0 R >> stream x+TT(BCC „Rɹ úž¹FƦ .ù@¤ù endstream endobj 47 0 obj 36 endobj 48 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im235 1998 0 R >> >> endobj 1171 0 obj << /Length 1172 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 516.604] /Resources 1173 0 R >> stream x+TT(BCC „Rɹ úž¹FÆf .ù@¥Ž endstream endobj 1172 0 obj 36 endobj 1173 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im236 2000 0 R >> >> endobj 1234 0 obj << /Length 1235 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 372.07] /Resources 1236 0 R >> stream x+TT(BCC „Rɹ úž¹FÆæ .ù@¥  endstream endobj 1235 0 obj 36 endobj 1236 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im237 2002 0 R >> >> endobj 1483 0 obj << /Length 1484 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 721.7856] /Resources 1485 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¥ endstream endobj 1484 0 obj 36 endobj 1485 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im238 2004 0 R >> >> endobj 1492 0 obj << /Length 1493 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 687.7776] /Resources 1494 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ– .ù@¥‘ endstream endobj 1493 0 obj 36 endobj 1494 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im239 2006 0 R >> >> endobj 1204 0 obj << /Length 1205 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 689.2288 580.6524] /Resources 1206 0 R >> stream x+TT(BC3 „Rɹ úž¹F& .ù@¥Ù“ endstream endobj 1205 0 obj 36 endobj 1206 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im240 2008 0 R >> >> endobj 409 0 obj << /Length 410 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 527.6566] /Resources 411 0 R >> stream x+TT(BCC „Rɹ úž¹F&† .ù@¤âŠ endstream endobj 410 0 obj 36 endobj 411 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im241 2010 0 R >> >> endobj 562 0 obj << /Length 563 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 663.156 320.4912] /Resources 564 0 R >> stream x+TT(BC3 „Rɹ úž¹F&F .ù@¥é• endstream endobj 563 0 obj 36 endobj 564 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im242 2012 0 R >> >> endobj 418 0 obj << /Length 419 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 493.932] /Resources 420 0 R >> stream x+TT(BCC „Rɹ úž¹F&Æ .ù@¤òŒ endstream endobj 419 0 obj 36 endobj 420 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im243 2014 0 R >> >> endobj 214 0 obj << /Length 215 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 239.7222] /Resources 216 0 R >> stream x+TT(BCC „Rɹ úž¹F&& .ù@¤ú endstream endobj 215 0 obj 36 endobj 216 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im244 2016 0 R >> >> endobj 1021 0 obj << /Length 1022 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 426.4828] /Resources 1023 0 R >> stream x+TT(BCC „Rɹ úž¹F&¦ .ù@¥Ž endstream endobj 1022 0 obj 36 endobj 1023 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im245 2018 0 R >> >> endobj 1258 0 obj << /Length 1259 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 554.8972 257.5764] /Resources 1260 0 R >> stream x+TT(BC3 „Rɹ úž¹F&f .ù@¦ ™ endstream endobj 1259 0 obj 36 endobj 1260 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im246 2020 0 R >> >> endobj 1390 0 obj << /Length 1391 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 670.4902] /Resources 1392 0 R >> stream x+TT(BCC „Rɹ úž¹F&æ .ù@¥ endstream endobj 1391 0 obj 36 endobj 1392 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im247 2022 0 R >> >> endobj 1189 0 obj << /Length 1190 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 701.3808] /Resources 1191 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@¥‘ endstream endobj 1190 0 obj 36 endobj 1191 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im248 2024 0 R >> >> endobj 1321 0 obj << /Length 1322 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 663.156 320.4912] /Resources 1323 0 R >> stream x+TT(BC3 „Rɹ úž¹F&– .ù@¦!œ endstream endobj 1322 0 obj 36 endobj 1323 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im249 2026 0 R >> >> endobj 1057 0 obj << /Length 1058 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 374.3372] /Resources 1059 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@¤ãŠ endstream endobj 1058 0 obj 36 endobj 1059 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im250 2028 0 R >> >> endobj 937 0 obj << /Length 938 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 251.6592 149.3176] /Resources 939 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦† .ù@¥ê• endstream endobj 938 0 obj 36 endobj 939 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im251 2030 0 R >> >> endobj 1084 0 obj << /Length 1085 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 103.6902] /Resources 1086 0 R >> stream x+TT(BCC „Rɹ úž¹F¦F .ù@¤óŒ endstream endobj 1085 0 obj 36 endobj 1086 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im252 2032 0 R >> >> endobj 295 0 obj << /Length 296 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 997.0012 385.1064] /Resources 297 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦Æ .ù@¥ú— endstream endobj 296 0 obj 36 endobj 297 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im253 2034 0 R >> >> endobj 304 0 obj << /Length 305 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 352.232] /Resources 306 0 R >> stream x+TT(BCC „Rɹ úž¹F¦& .ù@¥Ž endstream endobj 305 0 obj 36 endobj 306 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im254 2036 0 R >> >> endobj 748 0 obj << /Length 749 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 634.4984] /Resources 750 0 R >> stream x+TT(BCC „Rɹ úž¹F¦¦ .ù@¥  endstream endobj 749 0 obj 36 endobj 750 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im255 2038 0 R >> >> endobj 73 0 obj << /Length 74 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 51.5788 461.6244] /Resources 75 0 R >> stream x+TT(BC3 „Rɹ úž¹F¦f .ù@¦š endstream endobj 74 0 obj 36 endobj 75 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im256 2040 0 R >> >> endobj 1000 0 obj << /Length 1001 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 124.6618] /Resources 1002 0 R >> stream x+TT(BCC „Rɹ úž¹F¦æ .ù@¥‘ endstream endobj 1001 0 obj 36 endobj 1002 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im257 2042 0 R >> >> endobj 1009 0 obj << /Length 1010 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 91.504] /Resources 1011 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@¥#’ endstream endobj 1010 0 obj 36 endobj 1011 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im258 2044 0 R >> >> endobj 574 0 obj << /Length 575 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 277.4144] /Resources 576 0 R >> stream x+TT(BCC „Rɹ úž¹F¦– .ù@¥+“ endstream endobj 575 0 obj 36 endobj 576 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im259 2046 0 R >> >> endobj 1474 0 obj << /Length 1475 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 625.4296] /Resources 1476 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¤ì‹ endstream endobj 1475 0 obj 36 endobj 1476 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im260 2048 0 R >> >> endobj 1126 0 obj << /Length 1127 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 593.6888] /Resources 1128 0 R >> stream x+TT(BCC „Rɹ úž¹Ff† .ù@¤ôŒ endstream endobj 1127 0 obj 36 endobj 1128 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im261 2050 0 R >> >> endobj 844 0 obj << /Length 845 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 416.8472] /Resources 846 0 R >> stream x+TT(BCC „Rɹ úž¹FfF .ù@¤ü endstream endobj 845 0 obj 36 endobj 846 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im262 2052 0 R >> >> endobj 43 0 obj << /Length 44 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 703.0812] /Resources 45 0 R >> stream x+TT(BCC „Rɹ úž¹FfÆ .ù@¥Ž endstream endobj 44 0 obj 36 endobj 45 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im263 2054 0 R >> >> endobj 1447 0 obj << /Length 1448 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 725.1864] /Resources 1449 0 R >> stream x+TT(BCC „Rɹ úž¹Ff& .ù@¥  endstream endobj 1448 0 obj 36 endobj 1449 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im264 2056 0 R >> >> endobj 1252 0 obj << /Length 1253 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 304.054] /Resources 1254 0 R >> stream x+TT(BCC „Rɹ úž¹Ff¦ .ù@¥ endstream endobj 1253 0 obj 36 endobj 1254 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im265 2058 0 R >> >> endobj 652 0 obj << /Length 653 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 717.818] /Resources 654 0 R >> stream x+TT(BCC „Rɹ úž¹Fff .ù@¥‘ endstream endobj 653 0 obj 36 endobj 654 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im266 2060 0 R >> >> endobj 286 0 obj << /Length 287 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 335.7948] /Resources 288 0 R >> stream x+TT(BCC „Rɹ úž¹Ffæ .ù@¥$’ endstream endobj 287 0 obj 36 endobj 288 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im267 2062 0 R >> >> endobj 661 0 obj << /Length 662 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 684.0934] /Resources 663 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¥,“ endstream endobj 662 0 obj 36 endobj 663 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im268 2064 0 R >> >> endobj 1366 0 obj << /Length 1367 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 921.6168 759.1944] /Resources 1368 0 R >> stream x+TT(BC3 „Rɹ úž¹Ff– .ù@¦3ž endstream endobj 1367 0 obj 36 endobj 1368 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im269 2066 0 R >> >> endobj 754 0 obj << /Length 755 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 353.1164 741.6236] /Resources 756 0 R >> stream x+TT(BC3 „Rɹ úž¹Fæ .ù@¥ô– endstream endobj 755 0 obj 36 endobj 756 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im270 2068 0 R >> >> endobj 256 0 obj << /Length 257 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 68.832] /Resources 258 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ† .ù@¤ý endstream endobj 257 0 obj 36 endobj 258 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im271 2070 0 R >> >> endobj 478 0 obj << /Length 479 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 360.734] /Resources 480 0 R >> stream x+TT(BCC „Rɹ úž¹FæF .ù@¥Ž endstream endobj 479 0 obj 36 endobj 480 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im272 2072 0 R >> >> endobj 298 0 obj << /Length 299 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 374.3372] /Resources 300 0 R >> stream x+TT(BCC „Rɹ úž¹FæÆ .ù@¥  endstream endobj 299 0 obj 36 endobj 300 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im273 2074 0 R >> >> endobj 487 0 obj << /Length 488 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 326.726] /Resources 489 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ& .ù@¥ endstream endobj 488 0 obj 36 endobj 489 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im274 2076 0 R >> >> endobj 1153 0 obj << /Length 1154 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 582.9196] /Resources 1155 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ¦ .ù@¥‘ endstream endobj 1154 0 obj 36 endobj 1155 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im275 2078 0 R >> >> endobj 277 0 obj << /Length 278 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 369.8028] /Resources 279 0 R >> stream x+TT(BCC „Rɹ úž¹Fæf .ù@¥%’ endstream endobj 278 0 obj 36 endobj 279 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im276 2080 0 R >> >> endobj 268 0 obj << /Length 269 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 403.8108] /Resources 270 0 R >> stream x+TT(BCC „Rɹ úž¹Fææ .ù@¥-“ endstream endobj 269 0 obj 36 endobj 270 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im277 2082 0 R >> >> endobj 391 0 obj << /Length 392 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 594.2556] /Resources 393 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@¥5” endstream endobj 392 0 obj 36 endobj 393 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im278 2084 0 R >> >> endobj 187 0 obj << /Length 188 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 116.1598] /Resources 189 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ– .ù@¥=• endstream endobj 188 0 obj 36 endobj 189 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im279 2086 0 R >> >> endobj 400 0 obj << /Length 401 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 560.531] /Resources 402 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@¤þ endstream endobj 401 0 obj 36 endobj 402 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im280 2088 0 R >> >> endobj 1066 0 obj << /Length 1067 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 342.0296] /Resources 1068 0 R >> stream x+TT(BCC „Rɹ úž¹F† .ù@¥Ž endstream endobj 1067 0 obj 36 endobj 1068 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im281 2090 0 R >> >> endobj 1357 0 obj << /Length 1358 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 84.7024] /Resources 1359 0 R >> stream x+TT(BCC „Rɹ úž¹FF .ù@¥ endstream endobj 1358 0 obj 36 endobj 1359 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im282 2092 0 R >> >> endobj 1375 0 obj << /Length 1376 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 725.7532] /Resources 1377 0 R >> stream x+TT(BCC „Rɹ úž¹FÆ .ù@¥ endstream endobj 1376 0 obj 36 endobj 1377 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im283 2094 0 R >> >> endobj 247 0 obj << /Length 248 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 102.5566] /Resources 249 0 R >> stream x+TT(BCC „Rɹ úž¹F& .ù@¥‘ endstream endobj 248 0 obj 36 endobj 249 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im284 2096 0 R >> >> endobj 817 0 obj << /Length 818 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 571.0168] /Resources 819 0 R >> stream x+TT(BCC „Rɹ úž¹F¦ .ù@¥&’ endstream endobj 818 0 obj 36 endobj 819 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im285 2098 0 R >> >> endobj 964 0 obj << /Length 965 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 273.4468] /Resources 966 0 R >> stream x+TT(BCC „Rɹ úž¹Ff .ù@¥.“ endstream endobj 965 0 obj 36 endobj 966 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im286 2100 0 R >> >> endobj 826 0 obj << /Length 827 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 538.4258] /Resources 828 0 R >> stream x+TT(BCC „Rɹ úž¹Fæ .ù@¥6” endstream endobj 827 0 obj 36 endobj 828 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im287 2102 0 R >> >> endobj 1348 0 obj << /Length 1349 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 117.2934] /Resources 1350 0 R >> stream x+TT(BCC „Rɹ úž¹F .ù@¥>• endstream endobj 1349 0 obj 36 endobj 1350 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im288 2104 0 R >> >> endobj 1237 0 obj << /Length 1238 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 360.734] /Resources 1239 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¥F– endstream endobj 1238 0 obj 36 endobj 1239 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im289 2106 0 R >> >> endobj 643 0 obj << /Length 644 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 625.9964] /Resources 645 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¥Ž endstream endobj 644 0 obj 36 endobj 645 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im290 2108 0 R >> >> endobj 721 0 obj << /Length 722 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 732.8382] /Resources 723 0 R >> stream x+TT(BCC „Rɹ úž¹F–† .ù@¥ endstream endobj 722 0 obj 36 endobj 723 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im291 2110 0 R >> >> endobj 109 0 obj << /Length 110 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 240.8558] /Resources 111 0 R >> stream x+TT(BCC „Rɹ úž¹F–F .ù@¥ endstream endobj 110 0 obj 36 endobj 111 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im292 2112 0 R >> >> endobj 730 0 obj << /Length 731 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 699.1136] /Resources 732 0 R >> stream x+TT(BCC „Rɹ úž¹F–Æ .ù@¥‘ endstream endobj 731 0 obj 36 endobj 732 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im293 2114 0 R >> >> endobj 739 0 obj << /Length 740 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 665.6724] /Resources 741 0 R >> stream x+TT(BCC „Rɹ úž¹F–& .ù@¥'’ endstream endobj 740 0 obj 36 endobj 741 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im294 2116 0 R >> >> endobj 991 0 obj << /Length 992 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 157.8196] /Resources 993 0 R >> stream x+TT(BCC „Rɹ úž¹F–¦ .ù@¥/“ endstream endobj 992 0 obj 36 endobj 993 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im295 2118 0 R >> >> endobj 1387 0 obj << /Length 1388 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 681.2594] /Resources 1389 0 R >> stream x+TT(BCC „Rɹ úž¹F–f .ù@¥7” endstream endobj 1388 0 obj 36 endobj 1389 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im296 2120 0 R >> >> endobj 1222 0 obj << /Length 1223 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 514.9036] /Resources 1224 0 R >> stream x+TT(BCC „Rɹ úž¹F–æ .ù@¥?• endstream endobj 1223 0 obj 36 endobj 1224 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im297 2122 0 R >> >> endobj 1456 0 obj << /Length 1457 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 691.4618] /Resources 1458 0 R >> stream x+TT(BCC „Rɹ úž¹F– .ù@¥G– endstream endobj 1457 0 obj 36 endobj 1458 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im298 2124 0 R >> >> endobj 1465 0 obj << /Length 1466 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 659.1542] /Resources 1467 0 R >> stream x+TT(BCC „Rɹ úž¹F–– .ù@¥O— endstream endobj 1466 0 obj 36 endobj 1467 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im299 2126 0 R >> >> endobj 451 0 obj << /Length 452 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 558.5472] /Resources 453 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¤À† endstream endobj 452 0 obj 36 endobj 453 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im300 2128 0 R >> >> endobj 202 0 obj << /Length 203 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 917.0824 284.216] /Resources 204 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ† .ù@¥Ç‘ endstream endobj 203 0 obj 36 endobj 204 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im301 2130 0 R >> >> endobj 460 0 obj << /Length 461 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 525.9562] /Resources 462 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@¤Ðˆ endstream endobj 461 0 obj 36 endobj 462 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im302 2132 0 R >> >> endobj 904 0 obj << /Length 905 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 120.9776] /Resources 906 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¤Ø‰ endstream endobj 905 0 obj 36 endobj 906 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im303 2134 0 R >> >> endobj 607 0 obj << /Length 608 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 921.6168 759.1944] /Resources 609 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ& .ù@¥ß” endstream endobj 608 0 obj 36 endobj 609 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im304 2136 0 R >> >> endobj 469 0 obj << /Length 470 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 492.2316] /Resources 471 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¤è‹ endstream endobj 470 0 obj 36 endobj 471 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im305 2138 0 R >> >> endobj 895 0 obj << /Length 896 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 154.1354] /Resources 897 0 R >> stream x+TT(BCC „Rɹ úž¹Æf .ù@¤ðŒ endstream endobj 896 0 obj 36 endobj 897 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im306 2140 0 R >> >> endobj 559 0 obj << /Length 560 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 375.4708] /Resources 561 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@¤ø endstream endobj 560 0 obj 36 endobj 561 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im307 2142 0 R >> >> endobj 382 0 obj << /Length 383 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 538.1424] /Resources 384 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¥Ž endstream endobj 383 0 obj 36 endobj 384 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im308 2144 0 R >> >> endobj 799 0 obj << /Length 800 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 714.4172] /Resources 801 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥ endstream endobj 800 0 obj 36 endobj 801 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im309 2146 0 R >> >> endobj 1135 0 obj << /Length 1136 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 559.9642] /Resources 1137 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@¤É‡ endstream endobj 1136 0 obj 36 endobj 1137 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im310 2148 0 R >> >> endobj 790 0 obj << /Length 791 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 626.5632] /Resources 792 0 R >> stream x+TT(BCC „Rɹ úž¹Æ@žK>PA ¤Ñˆ endstream endobj 791 0 obj 35 endobj 792 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im311 2150 0 R >> >> endobj 1300 0 obj << /Length 1301 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 110.7752] /Resources 1302 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†F .ù@¤Ù‰ endstream endobj 1301 0 obj 36 endobj 1302 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im312 2152 0 R >> >> endobj 91 0 obj << /Length 92 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 394.1752] /Resources 93 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†Æ .ù@¤áŠ endstream endobj 92 0 obj 36 endobj 93 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im313 2154 0 R >> >> endobj 538 0 obj << /Length 539 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 121.8278] /Resources 540 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†& .ù@¤é‹ endstream endobj 539 0 obj 36 endobj 540 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im314 2156 0 R >> >> endobj 547 0 obj << /Length 548 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 88.67] /Resources 549 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†¦ .ù@¤ñŒ endstream endobj 548 0 obj 36 endobj 549 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im315 2158 0 R >> >> endobj 262 0 obj << /Length 263 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 426.4828] /Resources 264 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†f .ù@¤ù endstream endobj 263 0 obj 36 endobj 264 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im316 2160 0 R >> >> endobj 922 0 obj << /Length 923 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 369.236] /Resources 924 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†æ .ù@¥Ž endstream endobj 923 0 obj 36 endobj 924 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im317 2162 0 R >> >> endobj 1516 0 obj << /Length 1517 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 730.8544] /Resources 1518 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@¥  endstream endobj 1517 0 obj 36 endobj 1518 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im318 2164 0 R >> >> endobj 1267 0 obj << /Length 1268 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 224.1352] /Resources 1269 0 R >> stream x+TT(BCC „Rɹ úž¹Æ†– .ù@¥ endstream endobj 1268 0 obj 36 endobj 1269 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im319 2166 0 R >> >> endobj 16 0 obj << /Length 17 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 131.4976 675.8748] /Resources 18 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆF .ù@¥Ñ’ endstream endobj 17 0 obj 36 endobj 18 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im320 2168 0 R >> >> endobj 1291 0 obj << /Length 1292 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 143.6496] /Resources 1293 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF† .ù@¤Ú‰ endstream endobj 1292 0 obj 36 endobj 1293 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im321 2170 0 R >> >> endobj 616 0 obj << /Length 617 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 725.7532] /Resources 618 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFF .ù@¤âŠ endstream endobj 617 0 obj 36 endobj 618 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im322 2172 0 R >> >> endobj 625 0 obj << /Length 626 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 692.0286] /Resources 627 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFÆ .ù@¤ê‹ endstream endobj 626 0 obj 36 endobj 627 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im323 2174 0 R >> >> endobj 565 0 obj << /Length 566 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 309.722] /Resources 567 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF& .ù@¤òŒ endstream endobj 566 0 obj 36 endobj 567 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im324 2176 0 R >> >> endobj 634 0 obj << /Length 635 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 659.721] /Resources 636 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF¦ .ù@¤ú endstream endobj 635 0 obj 36 endobj 636 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im325 2178 0 R >> >> endobj 1525 0 obj << /Length 1526 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 697.4132] /Resources 1527 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFf .ù@¥Ž endstream endobj 1526 0 obj 36 endobj 1527 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im326 2180 0 R >> >> endobj 373 0 obj << /Length 374 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 571.0168] /Resources 375 0 R >> stream x+TT(BCC „Rɹ úž¹ÆFæ .ù@¥  endstream endobj 374 0 obj 36 endobj 375 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im327 2182 0 R >> >> endobj 1117 0 obj << /Length 1118 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 686.644] /Resources 1119 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@¥ endstream endobj 1118 0 obj 36 endobj 1119 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im328 2184 0 R >> >> endobj 973 0 obj << /Length 974 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 239.7222] /Resources 975 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF– .ù@¥‘ endstream endobj 974 0 obj 36 endobj 975 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im329 2186 0 R >> >> endobj 772 0 obj << /Length 773 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 129.7972 719.235] /Resources 774 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¤Û‰ endstream endobj 773 0 obj 36 endobj 774 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im330 2188 0 R >> >> endobj 1213 0 obj << /Length 1214 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 547.4946] /Resources 1215 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ† .ù@¤ãŠ endstream endobj 1214 0 obj 36 endobj 1215 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im331 2190 0 R >> >> endobj 1180 0 obj << /Length 1181 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 662.5892 767.1296] /Resources 1182 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆÆF .ù@¥ê• endstream endobj 1181 0 obj 36 endobj 1182 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im332 2192 0 R >> >> endobj 808 0 obj << /Length 809 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 115.6272 603.3244] /Resources 810 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆÆÆ .ù@¥ò– endstream endobj 809 0 obj 36 endobj 810 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im333 2194 0 R >> >> endobj 886 0 obj << /Length 887 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 187.2932] /Resources 888 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ& .ù@¤û endstream endobj 887 0 obj 36 endobj 888 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im334 2196 0 R >> >> endobj 1207 0 obj << /Length 1208 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 569.8832] /Resources 1209 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ¦ .ù@¥Ž endstream endobj 1208 0 obj 36 endobj 1209 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im335 2198 0 R >> >> endobj 1195 0 obj << /Length 1196 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 679.2756] /Resources 1197 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆf .ù@¥  endstream endobj 1196 0 obj 36 endobj 1197 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im336 2200 0 R >> >> endobj 166 0 obj << /Length 167 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 357.9] /Resources 168 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆæ .ù@¥ endstream endobj 167 0 obj 36 endobj 168 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im337 2202 0 R >> >> endobj 724 0 obj << /Length 725 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 721.7856] /Resources 726 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¥‘ endstream endobj 725 0 obj 36 endobj 726 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im338 2204 0 R >> >> endobj 982 0 obj << /Length 983 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 806.5564 191.2608] /Resources 984 0 R >> stream x+TT(BC3 „Rɹ úž¹ÆÆ– .ù@¦"œ endstream endobj 983 0 obj 36 endobj 984 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im339 2206 0 R >> >> endobj 1306 0 obj << /Length 1307 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 88.67] /Resources 1308 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@¤äŠ endstream endobj 1307 0 obj 36 endobj 1308 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im340 2208 0 R >> >> endobj 1072 0 obj << /Length 1073 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 999.8352 147.6172] /Resources 1074 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ&† .ù@¥ë• endstream endobj 1073 0 obj 36 endobj 1074 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im341 2210 0 R >> >> endobj 703 0 obj << /Length 704 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 669.9234] /Resources 705 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&F .ù@¤ôŒ endstream endobj 704 0 obj 36 endobj 705 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im342 2212 0 R >> >> endobj 712 0 obj << /Length 713 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 636.7656] /Resources 714 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&Æ .ù@¤ü endstream endobj 713 0 obj 36 endobj 714 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im343 2214 0 R >> >> endobj 1327 0 obj << /Length 1328 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 298.386] /Resources 1329 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&& .ù@¥Ž endstream endobj 1328 0 obj 36 endobj 1329 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im344 2216 0 R >> >> endobj 442 0 obj << /Length 443 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 658.304] /Resources 444 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&¦ .ù@¥  endstream endobj 443 0 obj 36 endobj 444 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im345 2218 0 R >> >> endobj 208 0 obj << /Length 209 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 262.1108] /Resources 210 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&f .ù@¥ endstream endobj 209 0 obj 36 endobj 210 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im346 2220 0 R >> >> endobj 832 0 obj << /Length 833 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 51.5788 461.6244] /Resources 834 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ&æ .ù@¦› endstream endobj 833 0 obj 36 endobj 834 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im347 2222 0 R >> >> endobj 1429 0 obj << /Length 1430 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 651.7858] /Resources 1431 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@¥$’ endstream endobj 1430 0 obj 36 endobj 1431 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im348 2224 0 R >> >> endobj 1438 0 obj << /Length 1439 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 618.0612] /Resources 1440 0 R >> stream x+TT(BCC „Rɹ úž¹Æ&– .ù@¥,“ endstream endobj 1439 0 obj 36 endobj 1440 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im349 2226 0 R >> >> endobj 859 0 obj << /Length 860 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 274.5804] /Resources 861 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¤í‹ endstream endobj 860 0 obj 36 endobj 861 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im350 2228 0 R >> >> endobj 424 0 obj << /Length 425 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 661.4556 756.3604] /Resources 426 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦† .ù@¤õŒ endstream endobj 425 0 obj 36 endobj 426 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im351 2230 0 R >> >> endobj 70 0 obj << /Length 71 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 527.6566] /Resources 72 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦F .ù@¤ý endstream endobj 71 0 obj 36 endobj 72 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im352 2232 0 R >> >> endobj 364 0 obj << /Length 365 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 580.97 604.458] /Resources 366 0 R >> stream x+TT(BC3 „Rɹ úž¹Æ¦Æ .ù@¦˜ endstream endobj 365 0 obj 36 endobj 366 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im353 2234 0 R >> >> endobj 955 0 obj << /Length 956 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 83.5688] /Resources 957 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦& .ù@¥  endstream endobj 956 0 obj 36 endobj 957 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im354 2236 0 R >> >> endobj 529 0 obj << /Length 530 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 154.9856] /Resources 531 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦¦ .ù@¥ endstream endobj 530 0 obj 36 endobj 531 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im355 2238 0 R >> >> endobj 1318 0 obj << /Length 1319 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 375.4708] /Resources 1320 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦f .ù@¥‘ endstream endobj 1319 0 obj 36 endobj 1320 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im356 2240 0 R >> >> endobj 685 0 obj << /Length 686 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 736.5224] /Resources 687 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦æ .ù@¥%’ endstream endobj 686 0 obj 36 endobj 687 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im357 2242 0 R >> >> endobj 781 0 obj << /Length 782 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 130.364 654.3364] /Resources 783 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¥-“ endstream endobj 782 0 obj 36 endobj 783 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im358 2244 0 R >> >> endobj 502 0 obj << /Length 503 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 246.8072] /Resources 504 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦– .ù@¥5” endstream endobj 503 0 obj 36 endobj 504 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im359 2246 0 R >> >> endobj 136 0 obj << /Length 137 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 154.1354] /Resources 138 0 R >> stream x+TT(BCC „Rɹ úž¹Æf .ù@¤öŒ endstream endobj 137 0 obj 36 endobj 138 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im360 2248 0 R >> >> endobj 1033 0 obj << /Length 1034 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 381.1388] /Resources 1035 0 R >> stream x+TT(BCC „Rɹ úž¹Æf† .ù@¤þ endstream endobj 1034 0 obj 36 endobj 1035 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im361 2250 0 R >> >> endobj 598 0 obj << /Length 599 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 84.7024] /Resources 600 0 R >> stream x+TT(BCC „Rɹ úž¹ÆfF .ù@¥Ž endstream endobj 599 0 obj 36 endobj 600 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im362 2252 0 R >> >> endobj 1042 0 obj << /Length 1043 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 347.1308] /Resources 1044 0 R >> stream x+TT(BCC „Rɹ úž¹ÆfÆ .ù@¥ endstream endobj 1043 0 obj 36 endobj 1044 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im363 2254 0 R >> >> endobj 1507 0 obj << /Length 1508 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 634.4984] /Resources 1509 0 R >> stream x+TT(BCC „Rɹ úž¹Æf& .ù@¥ endstream endobj 1508 0 obj 36 endobj 1509 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im364 2256 0 R >> >> endobj 118 0 obj << /Length 119 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 51.012 220.7344] /Resources 120 0 R >> stream x+TT(BC3 „Rɹ úž¹Æf¦ .ù@¦› endstream endobj 119 0 obj 36 endobj 120 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im365 2258 0 R >> >> endobj 1108 0 obj << /Length 1109 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 720.652] /Resources 1110 0 R >> stream x+TT(BCC „Rɹ úž¹Æff .ù@¥&’ endstream endobj 1109 0 obj 36 endobj 1110 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im366 2260 0 R >> >> endobj 25 0 obj << /Length 26 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 130.364 643.5672] /Resources 27 0 R >> stream x+TT(BCC „Rɹ úž¹Æfæ .ù@¥.“ endstream endobj 26 0 obj 36 endobj 27 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im367 2262 0 R >> >> endobj 520 0 obj << /Length 521 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 455.1404 188.4268] /Resources 522 0 R >> stream x+TT(BC3 „Rɹ úž¹Æf .ù@¦5ž endstream endobj 521 0 obj 36 endobj 522 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im368 2264 0 R >> >> endobj 337 0 obj << /Length 338 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 59.1964] /Resources 339 0 R >> stream x+TT(BCC „Rɹ úž¹Æf– .ù@¥>• endstream endobj 338 0 obj 36 endobj 339 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im369 2266 0 R >> >> endobj 1345 0 obj << /Length 1346 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 128.346] /Resources 1347 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@¤ÿ endstream endobj 1346 0 obj 36 endobj 1347 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im370 2268 0 R >> >> endobj 787 0 obj << /Length 788 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 17.004 637.3324] /Resources 789 0 R >> stream x+TT(BC3 „Rɹ úž¹Ææ† .ù@¦˜ endstream endobj 788 0 obj 36 endobj 789 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im371 2270 0 R >> >> endobj 355 0 obj << /Length 356 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 697.98] /Resources 357 0 R >> stream x+TT(BCC „Rɹ úž¹ÆæF .ù@¥ endstream endobj 356 0 obj 36 endobj 357 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im372 2272 0 R >> >> endobj 199 0 obj << /Length 200 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 72.2328] /Resources 201 0 R >> stream x+TT(BCC „Rɹ úž¹ÆæÆ .ù@¥ endstream endobj 200 0 obj 36 endobj 201 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im373 2274 0 R >> >> endobj 760 0 obj << /Length 761 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 719.8018] /Resources 762 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ& .ù@¥‘ endstream endobj 761 0 obj 36 endobj 762 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im374 2276 0 R >> >> endobj 190 0 obj << /Length 191 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 105.3906] /Resources 192 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ¦ .ù@¥'’ endstream endobj 191 0 obj 36 endobj 192 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im375 2278 0 R >> >> endobj 694 0 obj << /Length 695 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 702.5144] /Resources 696 0 R >> stream x+TT(BCC „Rɹ úž¹Ææf .ù@¥/“ endstream endobj 695 0 obj 36 endobj 696 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im376 2280 0 R >> >> endobj 1513 0 obj << /Length 1514 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 353.1164 741.6236] /Resources 1515 0 R >> stream x+TT(BC3 „Rɹ úž¹Æææ .ù@¦6ž endstream endobj 1514 0 obj 36 endobj 1515 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im377 2282 0 R >> >> endobj 160 0 obj << /Length 161 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 248.2584 380.0052] /Resources 162 0 R >> stream x+TT(BC3 „Rɹ úž¹Ææ .ù@¦>Ÿ endstream endobj 161 0 obj 36 endobj 162 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im378 2284 0 R >> >> endobj 433 0 obj << /Length 434 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 690.0448] /Resources 435 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ– .ù@¥G– endstream endobj 434 0 obj 36 endobj 435 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im379 2286 0 R >> >> endobj 511 0 obj << /Length 512 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 213.0826] /Resources 513 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¥Ž endstream endobj 512 0 obj 36 endobj 513 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im380 2288 0 R >> >> endobj 85 0 obj << /Length 86 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 416.8472] /Resources 87 0 R >> stream x+TT(BCC „Rɹ úž¹Æ† .ù@¥ endstream endobj 86 0 obj 36 endobj 87 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im381 2290 0 R >> >> endobj 868 0 obj << /Length 869 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 240.8558] /Resources 870 0 R >> stream x+TT(BCC „Rɹ úž¹ÆF .ù@¥ endstream endobj 869 0 obj 36 endobj 870 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im382 2292 0 R >> >> endobj 1411 0 obj << /Length 1412 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 717.818] /Resources 1413 0 R >> stream x+TT(BCC „Rɹ úž¹ÆÆ .ù@¥ ‘ endstream endobj 1412 0 obj 36 endobj 1413 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im383 2294 0 R >> >> endobj 1420 0 obj << /Length 1421 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 684.0934] /Resources 1422 0 R >> stream x+TT(BCC „Rɹ úž¹Æ& .ù@¥(’ endstream endobj 1421 0 obj 36 endobj 1422 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im384 2296 0 R >> >> endobj 862 0 obj << /Length 863 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 263.2444] /Resources 864 0 R >> stream x+TT(BCC „Rɹ úž¹Æ¦ .ù@¥0“ endstream endobj 863 0 obj 36 endobj 864 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im385 2298 0 R >> >> endobj 769 0 obj << /Length 770 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 130.9308 729.7208] /Resources 771 0 R >> stream x+TT(BC3 „Rɹ úž¹Æf .ù@¦7ž endstream endobj 770 0 obj 36 endobj 771 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im386 2300 0 R >> >> endobj 31 0 obj << /Length 32 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 626.5632] /Resources 33 0 R >> stream x+TT(BCC „Rɹ úž¹Ææ .ù@¥@• endstream endobj 32 0 obj 36 endobj 33 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im387 2302 0 R >> >> endobj 292 0 obj << /Length 293 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 997.0012 436.6852] /Resources 294 0 R >> stream x+TT(BCC „Rɹ úž¹Æ .ù@¥H– endstream endobj 293 0 obj 36 endobj 294 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im388 2304 0 R >> >> endobj 1264 0 obj << /Length 1265 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 553.7636 235.4712] /Resources 1266 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥P— endstream endobj 1265 0 obj 36 endobj 1266 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im389 2306 0 R >> >> endobj 676 0 obj << /Length 677 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 629.3972] /Resources 678 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥ endstream endobj 677 0 obj 36 endobj 678 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im390 2308 0 R >> >> endobj 238 0 obj << /Length 239 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 135.431] /Resources 240 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–† .ù@¥ endstream endobj 239 0 obj 36 endobj 240 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im391 2310 0 R >> >> endobj 100 0 obj << /Length 101 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 274.5804] /Resources 102 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–F .ù@¥!‘ endstream endobj 101 0 obj 36 endobj 102 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im392 2312 0 R >> >> endobj 1168 0 obj << /Length 1169 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 527.6566] /Resources 1170 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–Æ .ù@¥)’ endstream endobj 1169 0 obj 36 endobj 1170 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im393 2314 0 R >> >> endobj 1024 0 obj << /Length 1025 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 415.1468] /Resources 1026 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–& .ù@¥1“ endstream endobj 1025 0 obj 36 endobj 1026 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im394 2316 0 R >> >> endobj 1177 0 obj << /Length 1178 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 493.932] /Resources 1179 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–¦ .ù@¥9” endstream endobj 1178 0 obj 36 endobj 1179 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im395 2318 0 R >> >> endobj 589 0 obj << /Length 590 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 117.2934] /Resources 591 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–f .ù@¥A• endstream endobj 590 0 obj 36 endobj 591 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im396 2320 0 R >> >> endobj 388 0 obj << /Length 389 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 605.5916] /Resources 390 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–æ .ù@¥I– endstream endobj 389 0 obj 36 endobj 390 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im397 2322 0 R >> >> endobj 1489 0 obj << /Length 1490 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 699.1136] /Resources 1491 0 R >> stream x+TT(BCC „Rɹ úž¹Æ– .ù@¥Q— endstream endobj 1490 0 obj 36 endobj 1491 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im398 2324 0 R >> >> endobj 1498 0 obj << /Length 1499 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 665.6724] /Resources 1500 0 R >> stream x+TT(BCC „Rɹ úž¹Æ–– .ù@¥Y˜ endstream endobj 1499 0 obj 36 endobj 1500 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im399 2326 0 R >> >> endobj 415 0 obj << /Length 416 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 505.268] /Resources 417 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¤Ê‡ endstream endobj 416 0 obj 36 endobj 417 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im400 2328 0 R >> >> endobj 1324 0 obj << /Length 1325 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 309.722] /Resources 1326 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@¤Òˆ endstream endobj 1325 0 obj 36 endobj 1326 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im401 2330 0 R >> >> endobj 220 0 obj << /Length 221 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 217.9004] /Resources 222 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@¤Ú‰ endstream endobj 221 0 obj 36 endobj 222 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im402 2332 0 R >> >> endobj 1396 0 obj << /Length 1397 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 648.6684] /Resources 1398 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@¤âŠ endstream endobj 1397 0 obj 36 endobj 1398 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im403 2334 0 R >> >> endobj 1402 0 obj << /Length 1403 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 625.9964] /Resources 1404 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¤ê‹ endstream endobj 1403 0 obj 36 endobj 1404 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im404 2336 0 R >> >> endobj 1339 0 obj << /Length 1340 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 655.7876 150.4512] /Resources 1341 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦ .ù@¥ñ– endstream endobj 1340 0 obj 36 endobj 1341 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im405 2338 0 R >> >> endobj 763 0 obj << /Length 764 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 708.7492] /Resources 765 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¤ú endstream endobj 764 0 obj 36 endobj 765 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im406 2340 0 R >> >> endobj 328 0 obj << /Length 329 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 92.921] /Resources 330 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥Ž endstream endobj 329 0 obj 36 endobj 330 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im407 2342 0 R >> >> endobj 1081 0 obj << /Length 1082 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 114.4594] /Resources 1083 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¥  endstream endobj 1082 0 obj 36 endobj 1083 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im408 2344 0 R >> >> endobj 76 0 obj << /Length 77 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 450.8552] /Resources 78 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥ endstream endobj 77 0 obj 36 endobj 78 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im409 2346 0 R >> >> endobj 346 0 obj << /Length 347 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 471.5776 731.988] /Resources 348 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@¤Óˆ endstream endobj 347 0 obj 36 endobj 348 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im410 2348 0 R >> >> endobj 1090 0 obj << /Length 1091 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 81.8684] /Resources 1092 0 R >> stream x+TT(BCC „Rɹ úž¹&@žK>PA ¤Û‰ endstream endobj 1091 0 obj 35 endobj 1092 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im411 2350 0 R >> >> endobj 172 0 obj << /Length 173 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 336.9284] /Resources 174 0 R >> stream x+TT(BCC „Rɹ úž¹&†F .ù@¤ãŠ endstream endobj 173 0 obj 36 endobj 174 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im412 2352 0 R >> >> endobj 310 0 obj << /Length 311 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 331.2604] /Resources 312 0 R >> stream x+TT(BCC „Rɹ úž¹&†Æ .ù@¤ë‹ endstream endobj 311 0 obj 36 endobj 312 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im413 2354 0 R >> >> endobj 1279 0 obj << /Length 1280 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 455.1404 188.4268] /Resources 1281 0 R >> stream x+TT(BC3 „Rɹ úž¹&†& .ù@¥ò– endstream endobj 1280 0 obj 36 endobj 1281 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im414 2356 0 R >> >> endobj 475 0 obj << /Length 476 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 372.07] /Resources 477 0 R >> stream x+TT(BCC „Rɹ úž¹&†¦ .ù@¤û endstream endobj 476 0 obj 36 endobj 477 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im415 2358 0 R >> >> endobj 61 0 obj << /Length 62 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 559.9642] /Resources 63 0 R >> stream x+TT(BCC „Rɹ úž¹&†f .ù@¥Ž endstream endobj 62 0 obj 36 endobj 63 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im416 2360 0 R >> >> endobj 586 0 obj << /Length 587 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 128.346] /Resources 588 0 R >> stream x+TT(BCC „Rɹ úž¹&†æ .ù@¥  endstream endobj 587 0 obj 36 endobj 588 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im417 2362 0 R >> >> endobj 718 0 obj << /Length 719 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 225.5864 743.324] /Resources 720 0 R >> stream x+TT(BC3 „Rɹ úž¹&† .ù@¦š endstream endobj 719 0 obj 36 endobj 720 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im418 2364 0 R >> >> endobj 1015 0 obj << /Length 1016 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 68.832] /Resources 1017 0 R >> stream x+TT(BCC „Rɹ úž¹&†– .ù@¥‘ endstream endobj 1016 0 obj 36 endobj 1017 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im419 2366 0 R >> >> endobj 37 0 obj << /Length 38 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 17.004 725.1864] /Resources 39 0 R >> stream x+TT(BC3 „Rɹ úž¹&F .ù@¥Û“ endstream endobj 38 0 obj 36 endobj 39 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im420 2368 0 R >> >> endobj 1006 0 obj << /Length 1007 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 102.5566] /Resources 1008 0 R >> stream x+TT(BCC „Rɹ úž¹&F† .ù@¤äŠ endstream endobj 1007 0 obj 36 endobj 1008 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im421 2370 0 R >> >> endobj 571 0 obj << /Length 572 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 287.6168] /Resources 573 0 R >> stream x+TT(BCC „Rɹ úž¹&FF .ù@¤ì‹ endstream endobj 572 0 obj 36 endobj 573 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im422 2372 0 R >> >> endobj 163 0 obj << /Length 164 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 369.236] /Resources 165 0 R >> stream x+TT(BCC „Rɹ úž¹&FÆ .ù@¤ôŒ endstream endobj 164 0 obj 36 endobj 165 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im423 2374 0 R >> >> endobj 841 0 obj << /Length 842 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 428.1832] /Resources 843 0 R >> stream x+TT(BCC „Rɹ úž¹&F& .ù@¤ü endstream endobj 842 0 obj 36 endobj 843 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im424 2376 0 R >> >> endobj 988 0 obj << /Length 989 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 169.1556] /Resources 990 0 R >> stream x+TT(BCC „Rɹ úž¹&F¦ .ù@¥Ž endstream endobj 989 0 obj 36 endobj 990 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im425 2378 0 R >> >> endobj 850 0 obj << /Length 851 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 394.1752] /Resources 852 0 R >> stream x+TT(BCC „Rɹ úž¹&Ff .ù@¥  endstream endobj 851 0 obj 36 endobj 852 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im426 2380 0 R >> >> endobj 940 0 obj << /Length 941 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 138.5484] /Resources 942 0 R >> stream x+TT(BCC „Rɹ úž¹&Fæ .ù@¥ endstream endobj 941 0 obj 36 endobj 942 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im427 2382 0 R >> >> endobj 1240 0 obj << /Length 1241 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 349.398] /Resources 1242 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@¥‘ endstream endobj 1241 0 obj 36 endobj 1242 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im428 2384 0 R >> >> endobj 1249 0 obj << /Length 1250 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 315.39] /Resources 1251 0 R >> stream x+TT(BCC „Rɹ úž¹&F– .ù@¥$’ endstream endobj 1250 0 obj 36 endobj 1251 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im429 2386 0 R >> >> endobj 580 0 obj << /Length 581 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 655.7876 150.4512] /Resources 582 0 R >> stream x+TT(BC3 „Rɹ úž¹&Æ .ù@¥ä” endstream endobj 581 0 obj 36 endobj 582 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im430 2388 0 R >> >> endobj 658 0 obj << /Length 659 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 695.146] /Resources 660 0 R >> stream x+TT(BCC „Rɹ úž¹&Ɔ .ù@¤í‹ endstream endobj 659 0 obj 36 endobj 660 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im431 2390 0 R >> >> endobj 667 0 obj << /Length 668 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 662.555] /Resources 669 0 R >> stream x+TT(BCC „Rɹ úž¹&ÆF .ù@¤õŒ endstream endobj 668 0 obj 36 endobj 669 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im432 2392 0 R >> >> endobj 19 0 obj << /Length 20 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 130.364 665.389] /Resources 21 0 R >> stream x+TT(BCC „Rɹ úž¹&ÆÆ .ù@¤ý endstream endobj 20 0 obj 36 endobj 21 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im433 2394 0 R >> >> endobj 556 0 obj << /Length 557 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 668.2572 386.24] /Resources 558 0 R >> stream x+TT(BC3 „Rɹ úž¹&Æ& .ù@¦˜ endstream endobj 557 0 obj 36 endobj 558 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im434 2396 0 R >> >> endobj 121 0 obj << /Length 122 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 209.9652] /Resources 123 0 R >> stream x+TT(BCC „Rɹ úž¹&Ʀ .ù@¥  endstream endobj 122 0 obj 36 endobj 123 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im435 2398 0 R >> >> endobj 484 0 obj << /Length 485 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 338.062] /Resources 486 0 R >> stream x+TT(BCC „Rɹ úž¹&Æf .ù@¥ endstream endobj 485 0 obj 36 endobj 486 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im436 2400 0 R >> >> endobj 928 0 obj << /Length 929 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 347.1308] /Resources 930 0 R >> stream x+TT(BCC „Rɹ úž¹&Ææ .ù@¥‘ endstream endobj 929 0 obj 36 endobj 930 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im437 2402 0 R >> >> endobj 493 0 obj << /Length 494 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 450.606 304.054] /Resources 495 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@¥%’ endstream endobj 494 0 obj 36 endobj 495 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im438 2404 0 R >> >> endobj 1159 0 obj << /Length 1160 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 560.531] /Resources 1161 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ– .ù@¥-“ endstream endobj 1160 0 obj 36 endobj 1161 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im439 2406 0 R >> >> endobj 274 0 obj << /Length 275 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 381.1388] /Resources 276 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¤î‹ endstream endobj 275 0 obj 36 endobj 276 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im440 2408 0 R >> >> endobj 1354 0 obj << /Length 1355 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 654.654 95.755] /Resources 1356 0 R >> stream x+TT(BCC „Rɹ úž¹&&† .ù@¤öŒ endstream endobj 1355 0 obj 36 endobj 1356 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im441 2410 0 R >> >> endobj 397 0 obj << /Length 398 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 571.5836] /Resources 399 0 R >> stream x+TT(BCC „Rɹ úž¹&&F .ù@¤þ endstream endobj 398 0 obj 36 endobj 399 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im442 2412 0 R >> >> endobj 169 0 obj << /Length 170 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 247.1248 347.1308] /Resources 171 0 R >> stream x+TT(BCC „Rɹ úž¹&&Æ .ù@¥Ž endstream endobj 170 0 obj 36 endobj 171 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im443 2414 0 R >> >> endobj 406 0 obj << /Length 407 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 472.1444 538.7092] /Resources 408 0 R >> stream x+TT(BCC „Rɹ úž¹&&& .ù@¥ endstream endobj 407 0 obj 36 endobj 408 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im444 2416 0 R >> >> endobj 1381 0 obj << /Length 1382 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 703.0812] /Resources 1383 0 R >> stream x+TT(BCC „Rɹ úž¹&&¦ .ù@¥ endstream endobj 1382 0 obj 36 endobj 1383 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im445 2418 0 R >> >> endobj 301 0 obj << /Length 302 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 363.0012] /Resources 303 0 R >> stream x+TT(BCC „Rɹ úž¹&&f .ù@¥‘ endstream endobj 302 0 obj 36 endobj 303 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im446 2420 0 R >> >> endobj 823 0 obj << /Length 824 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 549.195] /Resources 825 0 R >> stream x+TT(BCC „Rɹ úž¹&&æ .ù@¥&’ endstream endobj 824 0 obj 36 endobj 825 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im447 2422 0 R >> >> endobj 736 0 obj << /Length 737 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 676.4416] /Resources 738 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¥.“ endstream endobj 737 0 obj 36 endobj 738 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im448 2424 0 R >> >> endobj 883 0 obj << /Length 884 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 198.6292] /Resources 885 0 R >> stream x+TT(BCC „Rɹ úž¹&&– .ù@¥6” endstream endobj 884 0 obj 36 endobj 885 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im449 2426 0 R >> >> endobj 745 0 obj << /Length 746 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 645.2676] /Resources 747 0 R >> stream x+TT(BCC „Rɹ úž¹&¦ .ù@¤÷Œ endstream endobj 746 0 obj 36 endobj 747 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im450 2428 0 R >> >> endobj 181 0 obj << /Length 182 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 138.5484] /Resources 183 0 R >> stream x+TT(BCC „Rɹ úž¹&¦† .ù@¤ÿ endstream endobj 182 0 obj 36 endobj 183 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im451 2430 0 R >> >> endobj 94 0 obj << /Length 95 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 382.8392] /Resources 96 0 R >> stream x+TT(BCC „Rɹ úž¹&¦F .ù@¥Ž endstream endobj 95 0 obj 36 endobj 96 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im452 2432 0 R >> >> endobj 613 0 obj << /Length 614 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 737.0892] /Resources 615 0 R >> stream x+TT(BCC „Rɹ úž¹&¦Æ .ù@¥ endstream endobj 614 0 obj 36 endobj 615 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im453 2434 0 R >> >> endobj 1210 0 obj << /Length 1211 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 558.5472] /Resources 1212 0 R >> stream x+TT(BCC „Rɹ úž¹&¦& .ù@¥ endstream endobj 1211 0 obj 36 endobj 1212 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im454 2436 0 R >> >> endobj 997 0 obj << /Length 998 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 135.431] /Resources 999 0 R >> stream x+TT(BCC „Rɹ úž¹&¦¦ .ù@¥‘ endstream endobj 998 0 obj 36 endobj 999 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im455 2438 0 R >> >> endobj 1219 0 obj << /Length 1220 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 525.9562] /Resources 1221 0 R >> stream x+TT(BCC „Rɹ úž¹&¦f .ù@¥'’ endstream endobj 1220 0 obj 36 endobj 1221 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im456 2440 0 R >> >> endobj 1228 0 obj << /Length 1229 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 492.2316] /Resources 1230 0 R >> stream x+TT(BCC „Rɹ úž¹&¦æ .ù@¥/“ endstream endobj 1229 0 obj 36 endobj 1230 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im457 2442 0 R >> >> endobj 154 0 obj << /Length 155 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 207.4488 461.0576] /Resources 156 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦ .ù@¦6ž endstream endobj 155 0 obj 36 endobj 156 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im458 2444 0 R >> >> endobj 1477 0 obj << /Length 1478 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 225.5864 743.324] /Resources 1479 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦– .ù@¦>Ÿ endstream endobj 1478 0 obj 36 endobj 1479 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im459 2446 0 R >> >> endobj 1462 0 obj << /Length 1463 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 669.9234] /Resources 1464 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¥ endstream endobj 1463 0 obj 36 endobj 1464 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im460 2448 0 R >> >> endobj 1471 0 obj << /Length 1472 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 636.7656] /Resources 1473 0 R >> stream x+TT(BCC „Rɹ úž¹&f† .ù@¥Ž endstream endobj 1472 0 obj 36 endobj 1473 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im461 2450 0 R >> >> endobj 901 0 obj << /Length 902 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 132.0302] /Resources 903 0 R >> stream x+TT(BCC „Rɹ úž¹&fF .ù@¥ endstream endobj 902 0 obj 36 endobj 903 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im462 2452 0 R >> >> endobj 466 0 obj << /Length 467 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 503.5676] /Resources 468 0 R >> stream x+TT(BCC „Rɹ úž¹&fÆ .ù@¥ endstream endobj 467 0 obj 36 endobj 468 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im463 2454 0 R >> >> endobj 910 0 obj << /Length 911 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 98.3056] /Resources 912 0 R >> stream x+TT(BCC „Rɹ úž¹&f& .ù@¥ ‘ endstream endobj 911 0 obj 36 endobj 912 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im464 2456 0 R >> >> endobj 130 0 obj << /Length 131 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 175.9572] /Resources 132 0 R >> stream x+TT(BCC „Rɹ úž¹&f¦ .ù@¥(’ endstream endobj 131 0 obj 36 endobj 132 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im465 2458 0 R >> >> endobj 283 0 obj << /Length 284 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 347.1308] /Resources 285 0 R >> stream x+TT(BCC „Rɹ úž¹&ff .ù@¥0“ endstream endobj 284 0 obj 36 endobj 285 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im466 2460 0 R >> >> endobj 757 0 obj << /Length 758 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 351.9828 730.8544] /Resources 759 0 R >> stream x+TT(BCC „Rɹ úž¹&fæ .ù@¥8” endstream endobj 758 0 obj 36 endobj 759 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im467 2462 0 R >> >> endobj 244 0 obj << /Length 245 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 113.6092] /Resources 246 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¥@• endstream endobj 245 0 obj 36 endobj 246 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im468 2464 0 R >> >> endobj 1144 0 obj << /Length 1145 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 473.278 616.3608] /Resources 1146 0 R >> stream x+TT(BC3 „Rɹ úž¹&f– .ù@¦G  endstream endobj 1145 0 obj 36 endobj 1146 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im469 2466 0 R >> >> endobj 1132 0 obj << /Length 1133 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 571.0168] /Resources 1134 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥ Ž endstream endobj 1133 0 obj 36 endobj 1134 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im470 2468 0 R >> >> endobj 1141 0 obj << /Length 1142 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 538.1424] /Resources 1143 0 R >> stream x+TT(BCC „Rɹ úž¹&æ† .ù@¥ endstream endobj 1142 0 obj 36 endobj 1143 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im471 2470 0 R >> >> endobj 265 0 obj << /Length 266 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 798.6212 415.1468] /Resources 267 0 R >> stream x+TT(BCC „Rɹ úž¹&æF .ù@¥ endstream endobj 266 0 obj 36 endobj 267 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im472 2472 0 R >> >> endobj 1444 0 obj << /Length 1445 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 736.5224] /Resources 1446 0 R >> stream x+TT(BCC „Rɹ úž¹&æÆ .ù@¥!‘ endstream endobj 1445 0 obj 36 endobj 1446 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im473 2474 0 R >> >> endobj 88 0 obj << /Length 89 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 50.4452 405.5112] /Resources 90 0 R >> stream x+TT(BCC „Rɹ úž¹&æ& .ù@¥)’ endstream endobj 89 0 obj 36 endobj 90 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im474 2476 0 R >> >> endobj 544 0 obj << /Length 545 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 99.7226] /Resources 546 0 R >> stream x+TT(BCC „Rɹ úž¹&æ¦ .ù@¥1“ endstream endobj 545 0 obj 36 endobj 546 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im475 2478 0 R >> >> endobj 1063 0 obj << /Length 1064 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 995.8676 352.232] /Resources 1065 0 R >> stream x+TT(BCC „Rɹ úž¹&æf .ù@¥9” endstream endobj 1064 0 obj 36 endobj 1065 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im476 2480 0 R >> >> endobj 553 0 obj << /Length 554 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 65.998] /Resources 555 0 R >> stream x+TT(BCC „Rɹ úž¹&ææ .ù@¥A• endstream endobj 554 0 obj 36 endobj 555 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im477 2482 0 R >> >> endobj 1372 0 obj << /Length 1373 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 737.0892] /Resources 1374 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥I– endstream endobj 1373 0 obj 36 endobj 1374 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im478 2484 0 R >> >> endobj 379 0 obj << /Length 380 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 579.8364 549.195] /Resources 381 0 R >> stream x+TT(BCC „Rɹ úž¹&æ– .ù@¥Q— endstream endobj 380 0 obj 36 endobj 381 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im479 2486 0 R >> >> endobj 622 0 obj << /Length 623 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 703.0812] /Resources 624 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¥ endstream endobj 623 0 obj 36 endobj 624 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im480 2488 0 R >> >> endobj 631 0 obj << /Length 632 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 670.4902] /Resources 633 0 R >> stream x+TT(BCC „Rɹ úž¹&† .ù@¥ endstream endobj 632 0 obj 36 endobj 633 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im481 2490 0 R >> >> endobj 640 0 obj << /Length 641 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 637.3324] /Resources 642 0 R >> stream x+TT(BCC „Rɹ úž¹&F .ù@¥"‘ endstream endobj 641 0 obj 36 endobj 642 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im482 2492 0 R >> >> endobj 727 0 obj << /Length 728 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 224.4528 710.4496] /Resources 729 0 R >> stream x+TT(BCC „Rɹ úž¹&Æ .ù@¥*’ endstream endobj 728 0 obj 36 endobj 729 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im483 2494 0 R >> >> endobj 805 0 obj << /Length 806 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 15.8704 691.7452] /Resources 807 0 R >> stream x+TT(BCC „Rɹ úž¹&& .ù@¥2“ endstream endobj 806 0 obj 36 endobj 807 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im484 2496 0 R >> >> endobj 1054 0 obj << /Length 1055 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 16 16] /XStep 3385 /YStep 3385 /Matrix [0.5668 0 0 0.5668 997.0012 385.1064] /Resources 1056 0 R >> stream x+TT(BC3 „Rɹ úž¹&¦ .ù@¦9ž endstream endobj 1055 0 obj 36 endobj 1056 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im485 2498 0 R >> >> endobj 979 0 obj << /Length 980 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 217.9004] /Resources 981 0 R >> stream x+TT(BCC „Rɹ úž¹&f .ù@¥B• endstream endobj 980 0 obj 36 endobj 981 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im486 2500 0 R >> >> endobj 1333 0 obj << /Length 1334 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 662.0224 277.4144] /Resources 1335 0 R >> stream x+TT(BCC „Rɹ úž¹&æ .ù@¥J– endstream endobj 1334 0 obj 36 endobj 1335 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im487 2502 0 R >> >> endobj 1384 0 obj << /Length 1385 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 920.4832 692.0286] /Resources 1386 0 R >> stream x+TT(BCC „Rɹ úž¹& .ù@¥R— endstream endobj 1385 0 obj 36 endobj 1386 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im488 2504 0 R >> >> endobj 1453 0 obj << /Length 1454 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 702.5144] /Resources 1455 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥Z˜ endstream endobj 1454 0 obj 36 endobj 1455 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im489 2506 0 R >> >> endobj 814 0 obj << /Length 815 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 582.3528] /Resources 816 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥ endstream endobj 815 0 obj 36 endobj 816 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im490 2508 0 R >> >> endobj 1297 0 obj << /Length 1298 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 121.8278] /Resources 1299 0 R >> stream x+TT(BCC „Rɹ úž¹&–† .ù@¥#‘ endstream endobj 1298 0 obj 36 endobj 1299 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im491 2510 0 R >> >> endobj 892 0 obj << /Length 893 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 49.8784 164.9046] /Resources 894 0 R >> stream x+TT(BCC „Rɹ úž¹&–F .ù@¥+’ endstream endobj 893 0 obj 36 endobj 894 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im492 2512 0 R >> >> endobj 457 0 obj << /Length 458 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 688.0952 536.7254] /Resources 459 0 R >> stream x+TT(BCC „Rɹ úž¹&–Æ .ù@¥3“ endstream endobj 458 0 obj 36 endobj 459 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im493 2514 0 R >> >> endobj 1312 0 obj << /Length 1313 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 65.998] /Resources 1314 0 R >> stream x+TT(BCC „Rɹ úž¹&–& .ù@¥;” endstream endobj 1313 0 obj 36 endobj 1314 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im494 2516 0 R >> >> endobj 322 0 obj << /Length 323 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 998.7016 114.4594] /Resources 324 0 R >> stream x+TT(BCC „Rɹ úž¹&–¦ .ù@¥C• endstream endobj 323 0 obj 36 endobj 324 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im495 2518 0 R >> >> endobj 1201 0 obj << /Length 1202 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 667.1236 658.304] /Resources 1203 0 R >> stream x+TT(BCC „Rɹ úž¹&–f .ù@¥K– endstream endobj 1202 0 obj 36 endobj 1203 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im496 2520 0 R >> >> endobj 709 0 obj << /Length 710 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 818.4592 648.1016] /Resources 711 0 R >> stream x+TT(BCC „Rɹ úž¹&–æ .ù@¥S— endstream endobj 710 0 obj 36 endobj 711 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im497 2522 0 R >> >> endobj 52 0 obj << /Length 53 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 114.4936 593.122] /Resources 54 0 R >> stream x+TT(BCC „Rɹ úž¹&– .ù@¥[˜ endstream endobj 53 0 obj 36 endobj 54 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im498 2524 0 R >> >> endobj 943 0 obj << /Length 944 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 127.2124] /Resources 945 0 R >> stream x+TT(BCC „Rɹ úž¹&–– .ù@¥c™ endstream endobj 944 0 obj 36 endobj 945 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im499 2526 0 R >> >> endobj 1183 0 obj << /Length 1184 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 661.4556 756.3604] /Resources 1185 0 R >> stream x+TT(BCC „Rɹ úž¹¦ .ù@¤Ôˆ endstream endobj 1184 0 obj 36 endobj 1185 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im500 2528 0 R >> >> endobj 970 0 obj << /Length 971 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 915.9488 250.7748] /Resources 972 0 R >> stream x+TT(BCC „Rɹ úž¹¦† .ù@¤Ü‰ endstream endobj 971 0 obj 36 endobj 972 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im501 2530 0 R >> >> endobj 1435 0 obj << /Length 1436 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 1029.309 629.3972] /Resources 1437 0 R >> stream x+TT(BCC „Rɹ úž¹¦F .ù@¤äŠ endstream endobj 1436 0 obj 36 endobj 1437 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im502 2532 0 R >> >> endobj 865 0 obj << /Length 866 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 153.036 251.9084] /Resources 867 0 R >> stream x+TT(BCC „Rɹ úž¹¦Æ .ù@¤ì‹ endstream endobj 866 0 obj 36 endobj 867 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im503 2534 0 R >> >> endobj 250 0 obj << /Length 251 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 805.4228 91.504] /Resources 252 0 R >> stream x+TT(BCC „Rɹ úž¹¦& .ù@¤ôŒ endstream endobj 251 0 obj 36 endobj 252 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im504 2536 0 R >> >> endobj 535 0 obj << /Length 536 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 454.0068 132.597] /Resources 537 0 R >> stream x+TT(BCC „Rɹ úž¹¦¦ .ù@¤ü endstream endobj 536 0 obj 36 endobj 537 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im505 2538 0 R >> >> endobj 196 0 obj << /Length 197 0 R /Filter /FlateDecode /Type /Pattern /PatternType 1 /PaintType 1 /TilingType 1 /BBox [0 0 11 11] /XStep 3375 /YStep 3375 /Matrix [0.5668 0 0 0.5668 250.5256 83.5688] /Resources 198 0 R >> stream x+TT(BCC „Rɹ úž¹¦f .ù@¥Ž endstream endobj 197 0 obj 36 endobj 198 0 obj << /ProcSet [ /PDF /ImageB /ImageC /ImageI ] /XObject << /Im506 2540 0 R >> >> endobj 1582 0 obj << /Length 1583 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2543 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1583 0 obj 153 endobj 2410 0 obj << /Length 2411 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2545 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2411 0 obj 153 endobj 1964 0 obj << /Length 1965 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2547 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1965 0 obj 153 endobj 2414 0 obj << /Length 2415 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2549 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2415 0 obj 153 endobj 1968 0 obj << /Length 1969 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2551 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1969 0 obj 153 endobj 2418 0 obj << /Length 2419 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2553 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2419 0 obj 153 endobj 1972 0 obj << /Length 1973 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2555 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1973 0 obj 171 endobj 2422 0 obj << /Length 2423 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2557 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2423 0 obj 153 endobj 1976 0 obj << /Length 1977 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2559 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1977 0 obj 496 endobj 1538 0 obj << /Length 1539 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2561 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1539 0 obj 181 endobj 1766 0 obj << /Length 1767 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2563 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1767 0 obj 496 endobj 1604 0 obj << /Length 1605 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2565 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1605 0 obj 159 endobj 1644 0 obj << /Length 1645 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2567 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1645 0 obj 153 endobj 2210 0 obj << /Length 2211 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2569 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2211 0 obj 496 endobj 2392 0 obj << /Length 2393 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2571 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2393 0 obj 153 endobj 2396 0 obj << /Length 2397 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2573 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2397 0 obj 496 endobj 1954 0 obj << /Length 1955 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2575 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1955 0 obj 171 endobj 1578 0 obj << /Length 1579 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2577 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1579 0 obj 153 endobj 1674 0 obj << /Length 1675 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2579 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1675 0 obj 153 endobj 1550 0 obj << /Length 1551 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2581 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1551 0 obj 496 endobj 2200 0 obj << /Length 2201 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2583 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2201 0 obj 153 endobj 1600 0 obj << /Length 1601 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2585 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1601 0 obj 181 endobj 2204 0 obj << /Length 2205 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2587 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2205 0 obj 181 endobj 1784 0 obj << /Length 1785 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2589 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1785 0 obj 496 endobj 2208 0 obj << /Length 2209 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2591 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2209 0 obj 153 endobj 2390 0 obj << /Length 2391 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2593 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2391 0 obj 153 endobj 1574 0 obj << /Length 1575 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2595 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1575 0 obj 181 endobj 1764 0 obj << /Length 1765 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2597 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1765 0 obj 159 endobj 1788 0 obj << /Length 1789 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2599 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1789 0 obj 153 endobj 1950 0 obj << /Length 1951 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2601 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1951 0 obj 181 endobj 2374 0 obj << /Length 2375 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2603 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2375 0 obj 181 endobj 2172 0 obj << /Length 2173 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2605 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2173 0 obj 181 endobj 1548 0 obj << /Length 1549 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2607 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1549 0 obj 496 endobj 2378 0 obj << /Length 2379 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2609 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2379 0 obj 181 endobj 2176 0 obj << /Length 2177 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2611 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2177 0 obj 181 endobj 1760 0 obj << /Length 1761 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2613 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1761 0 obj 153 endobj 2180 0 obj << /Length 2181 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2615 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2181 0 obj 175 endobj 2382 0 obj << /Length 2383 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2617 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2383 0 obj 181 endobj 1702 0 obj << /Length 1703 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2619 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1703 0 obj 153 endobj 2142 0 obj << /Length 2143 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2621 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2143 0 obj 181 endobj 2184 0 obj << /Length 2185 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2623 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2185 0 obj 153 endobj 2386 0 obj << /Length 2387 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2625 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2387 0 obj 153 endobj 1544 0 obj << /Length 1545 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2627 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1545 0 obj 496 endobj 2146 0 obj << /Length 2147 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2629 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2147 0 obj 181 endobj 1944 0 obj << /Length 1945 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2631 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1945 0 obj 496 endobj 2150 0 obj << /Length 2151 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2633 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2151 0 obj 175 endobj 2192 0 obj << /Length 2193 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2635 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2193 0 obj 496 endobj 2188 0 obj << /Length 2189 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2637 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2189 0 obj 171 endobj 2154 0 obj << /Length 2155 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2639 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2155 0 obj 153 endobj 2074 0 obj << /Length 2075 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2641 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2075 0 obj 181 endobj 2158 0 obj << /Length 2159 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2643 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2159 0 obj 153 endobj 2078 0 obj << /Length 2079 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2645 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2079 0 obj 181 endobj 2162 0 obj << /Length 2163 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2647 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2163 0 obj 181 endobj 2368 0 obj << /Length 2369 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2649 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2369 0 obj 496 endobj 2082 0 obj << /Length 2083 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2651 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2083 0 obj 159 endobj 2166 0 obj << /Length 2167 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2653 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2167 0 obj 153 endobj 2086 0 obj << /Length 2087 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2655 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2087 0 obj 153 endobj 2170 0 obj << /Length 2171 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2657 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2171 0 obj 153 endobj 2090 0 obj << /Length 2091 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2659 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2091 0 obj 153 endobj 1930 0 obj << /Length 1931 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2661 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1931 0 obj 153 endobj 2136 0 obj << /Length 2137 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2663 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2137 0 obj 496 endobj 1934 0 obj << /Length 1935 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2665 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1935 0 obj 153 endobj 2094 0 obj << /Length 2095 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2667 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2095 0 obj 181 endobj 2098 0 obj << /Length 2099 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2669 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2099 0 obj 171 endobj 1938 0 obj << /Length 1939 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2671 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1939 0 obj 496 endobj 2102 0 obj << /Length 2103 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2673 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2103 0 obj 153 endobj 2106 0 obj << /Length 2107 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2675 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2107 0 obj 153 endobj 1546 0 obj << /Length 1547 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2677 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1547 0 obj 496 endobj 2110 0 obj << /Length 2111 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2679 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2111 0 obj 171 endobj 2114 0 obj << /Length 2115 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2681 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2115 0 obj 175 endobj 2362 0 obj << /Length 2363 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2683 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2363 0 obj 181 endobj 2118 0 obj << /Length 2119 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2685 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2119 0 obj 181 endobj 1852 0 obj << /Length 1853 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2687 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1853 0 obj 181 endobj 2366 0 obj << /Length 2367 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2689 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2367 0 obj 153 endobj 2122 0 obj << /Length 2123 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2691 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2123 0 obj 153 endobj 1920 0 obj << /Length 1921 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2693 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1921 0 obj 153 endobj 1856 0 obj << /Length 1857 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2695 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1857 0 obj 181 endobj 1860 0 obj << /Length 1861 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2697 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1861 0 obj 153 endobj 2126 0 obj << /Length 2127 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2699 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2127 0 obj 153 endobj 1924 0 obj << /Length 1925 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2701 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1925 0 obj 496 endobj 2046 0 obj << /Length 2047 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2703 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2047 0 obj 153 endobj 2130 0 obj << /Length 2131 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2705 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2131 0 obj 496 endobj 2050 0 obj << /Length 2051 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2707 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2051 0 obj 181 endobj 2054 0 obj << /Length 2055 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2709 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2055 0 obj 175 endobj 2058 0 obj << /Length 2059 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2711 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2059 0 obj 153 endobj 2062 0 obj << /Length 2063 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2713 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2063 0 obj 153 endobj 2066 0 obj << /Length 2067 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2715 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2067 0 obj 496 endobj 1842 0 obj << /Length 1843 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2717 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1843 0 obj 153 endobj 1754 0 obj << /Length 1755 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2719 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1755 0 obj 153 endobj 1846 0 obj << /Length 1847 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2721 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1847 0 obj 153 endobj 1868 0 obj << /Length 1869 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2723 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1869 0 obj 153 endobj 1910 0 obj << /Length 1911 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2725 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1911 0 obj 153 endobj 1850 0 obj << /Length 1851 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2727 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1851 0 obj 153 endobj 1872 0 obj << /Length 1873 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2729 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1873 0 obj 175 endobj 1914 0 obj << /Length 1915 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2731 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1915 0 obj 496 endobj 1698 0 obj << /Length 1699 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2733 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1699 0 obj 496 endobj 1876 0 obj << /Length 1877 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2735 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1877 0 obj 153 endobj 2040 0 obj << /Length 2041 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2737 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2041 0 obj 496 endobj 1880 0 obj << /Length 1881 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2739 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1881 0 obj 153 endobj 1884 0 obj << /Length 1885 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2741 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1885 0 obj 153 endobj 1824 0 obj << /Length 1825 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2743 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1825 0 obj 153 endobj 1888 0 obj << /Length 1889 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2745 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1889 0 obj 153 endobj 1828 0 obj << /Length 1829 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2747 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1829 0 obj 181 endobj 1892 0 obj << /Length 1893 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2749 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1893 0 obj 153 endobj 1832 0 obj << /Length 1833 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2751 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1833 0 obj 181 endobj 1896 0 obj << /Length 1897 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2753 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1897 0 obj 153 endobj 1836 0 obj << /Length 1837 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2755 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1837 0 obj 153 endobj 1900 0 obj << /Length 1901 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2757 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1901 0 obj 153 endobj 1840 0 obj << /Length 1841 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2759 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1841 0 obj 153 endobj 1750 0 obj << /Length 1751 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2761 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1751 0 obj 181 endobj 1904 0 obj << /Length 1905 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2763 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1905 0 obj 181 endobj 1908 0 obj << /Length 1909 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2765 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1909 0 obj 153 endobj 1806 0 obj << /Length 1807 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2767 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1807 0 obj 181 endobj 1810 0 obj << /Length 1811 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2769 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1811 0 obj 153 endobj 2344 0 obj << /Length 2345 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2771 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2345 0 obj 153 endobj 1814 0 obj << /Length 1815 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2773 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1815 0 obj 181 endobj 2306 0 obj << /Length 2307 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2775 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2307 0 obj 181 endobj 1818 0 obj << /Length 1819 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2777 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1819 0 obj 153 endobj 2348 0 obj << /Length 2349 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2779 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2349 0 obj 153 endobj 2310 0 obj << /Length 2311 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2781 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2311 0 obj 153 endobj 1822 0 obj << /Length 1823 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2783 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1823 0 obj 153 endobj 2352 0 obj << /Length 2353 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2785 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2353 0 obj 153 endobj 1666 0 obj << /Length 1667 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2787 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1667 0 obj 496 endobj 2314 0 obj << /Length 2315 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2789 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2315 0 obj 153 endobj 2356 0 obj << /Length 2357 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2791 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2357 0 obj 496 endobj 1696 0 obj << /Length 1697 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2793 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1697 0 obj 181 endobj 2318 0 obj << /Length 2319 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2795 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2319 0 obj 153 endobj 2322 0 obj << /Length 2323 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2797 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2323 0 obj 181 endobj 2326 0 obj << /Length 2327 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2799 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2327 0 obj 153 endobj 1746 0 obj << /Length 1747 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2801 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1747 0 obj 153 endobj 2288 0 obj << /Length 2289 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2803 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2289 0 obj 153 endobj 2330 0 obj << /Length 2331 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2805 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2331 0 obj 181 endobj 2292 0 obj << /Length 2293 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2807 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2293 0 obj 153 endobj 1802 0 obj << /Length 1803 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2809 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1803 0 obj 181 endobj 2334 0 obj << /Length 2335 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2811 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2335 0 obj 153 endobj 2296 0 obj << /Length 2297 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2813 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2297 0 obj 153 endobj 2338 0 obj << /Length 2339 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2815 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2339 0 obj 496 endobj 2300 0 obj << /Length 2301 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2817 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2301 0 obj 496 endobj 1778 0 obj << /Length 1779 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2819 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1779 0 obj 181 endobj 1566 0 obj << /Length 1567 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2821 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1567 0 obj 171 endobj 2034 0 obj << /Length 2035 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2823 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2035 0 obj 496 endobj 1670 0 obj << /Length 1671 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2825 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1671 0 obj 153 endobj 1742 0 obj << /Length 1743 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2827 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1743 0 obj 153 endobj 2286 0 obj << /Length 2287 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2829 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2287 0 obj 181 endobj 1664 0 obj << /Length 1665 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2831 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1665 0 obj 496 endobj 1780 0 obj << /Length 1781 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2833 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1781 0 obj 153 endobj 1562 0 obj << /Length 1563 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2835 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1563 0 obj 181 endobj 1532 0 obj << /Length 1533 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2837 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1533 0 obj 171 endobj 2032 0 obj << /Length 2033 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2839 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2033 0 obj 153 endobj 1738 0 obj << /Length 1739 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2841 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1739 0 obj 153 endobj 2280 0 obj << /Length 2281 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2843 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2281 0 obj 153 endobj 2276 0 obj << /Length 2277 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2845 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2277 0 obj 181 endobj 2284 0 obj << /Length 2285 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2847 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2285 0 obj 496 endobj 1690 0 obj << /Length 1691 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2849 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1691 0 obj 153 endobj 1558 0 obj << /Length 1559 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2851 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1559 0 obj 181 endobj 1662 0 obj << /Length 1663 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2853 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1663 0 obj 153 endobj 2270 0 obj << /Length 2271 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2855 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2271 0 obj 496 endobj 2026 0 obj << /Length 2027 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2857 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2027 0 obj 496 endobj 1734 0 obj << /Length 1735 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2859 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1735 0 obj 181 endobj 1686 0 obj << /Length 1687 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2861 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1687 0 obj 181 endobj 1776 0 obj << /Length 1777 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2863 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1777 0 obj 181 endobj 1632 0 obj << /Length 1633 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2865 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1633 0 obj 153 endobj 2016 0 obj << /Length 2017 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2867 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2017 0 obj 153 endobj 2264 0 obj << /Length 2265 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2869 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2265 0 obj 496 endobj 1658 0 obj << /Length 1659 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2871 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1659 0 obj 153 endobj 2020 0 obj << /Length 2021 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2873 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2021 0 obj 496 endobj 1730 0 obj << /Length 1731 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2875 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1731 0 obj 153 endobj 1570 0 obj << /Length 1571 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2877 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1571 0 obj 181 endobj 2238 0 obj << /Length 2239 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2879 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2239 0 obj 181 endobj 2242 0 obj << /Length 2243 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2881 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2243 0 obj 181 endobj 1682 0 obj << /Length 1683 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2883 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1683 0 obj 153 endobj 2246 0 obj << /Length 2247 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2885 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2247 0 obj 181 endobj 2516 0 obj << /Length 2517 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2887 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2517 0 obj 153 endobj 2250 0 obj << /Length 2251 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2889 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2251 0 obj 153 endobj 1628 0 obj << /Length 1629 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2891 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1629 0 obj 153 endobj 2520 0 obj << /Length 2521 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2893 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2521 0 obj 153 endobj 2254 0 obj << /Length 2255 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2895 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2255 0 obj 153 endobj 2524 0 obj << /Length 2525 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2897 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2525 0 obj 175 endobj 2258 0 obj << /Length 2259 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2899 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2259 0 obj 496 endobj 2014 0 obj << /Length 2015 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2901 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2015 0 obj 153 endobj 1536 0 obj << /Length 1537 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2903 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1537 0 obj 181 endobj 1654 0 obj << /Length 1655 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2905 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1655 0 obj 153 endobj 2528 0 obj << /Length 2529 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2907 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2529 0 obj 181 endobj 2532 0 obj << /Length 2533 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2909 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2533 0 obj 153 endobj 1726 0 obj << /Length 1727 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2911 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1727 0 obj 153 endobj 2536 0 obj << /Length 2537 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2913 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2537 0 obj 153 endobj 2540 0 obj << /Length 2541 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2915 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2541 0 obj 153 endobj 1678 0 obj << /Length 1679 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2917 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1679 0 obj 171 endobj 1624 0 obj << /Length 1625 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2919 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1625 0 obj 153 endobj 1554 0 obj << /Length 1555 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2921 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1555 0 obj 153 endobj 2504 0 obj << /Length 2505 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2923 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2505 0 obj 153 endobj 2508 0 obj << /Length 2509 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2925 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2509 0 obj 181 endobj 1722 0 obj << /Length 1723 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2927 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1723 0 obj 153 endobj 2470 0 obj << /Length 2471 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2929 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2471 0 obj 153 endobj 2512 0 obj << /Length 2513 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2931 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2513 0 obj 153 endobj 2474 0 obj << /Length 2475 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2933 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2475 0 obj 181 endobj 2478 0 obj << /Length 2479 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2935 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2479 0 obj 153 endobj 1864 0 obj << /Length 1865 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2937 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1865 0 obj 181 endobj 2482 0 obj << /Length 2483 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2939 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2483 0 obj 153 endobj 2486 0 obj << /Length 2487 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2941 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2487 0 obj 153 endobj 1620 0 obj << /Length 1621 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2943 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1621 0 obj 153 endobj 2490 0 obj << /Length 2491 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2945 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2491 0 obj 153 endobj 2452 0 obj << /Length 2453 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2947 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2453 0 obj 153 endobj 2228 0 obj << /Length 2229 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2949 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2229 0 obj 181 endobj 2494 0 obj << /Length 2495 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2951 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2495 0 obj 181 endobj 1786 0 obj << /Length 1787 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2953 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1787 0 obj 153 endobj 2232 0 obj << /Length 2233 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2955 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2233 0 obj 153 endobj 2456 0 obj << /Length 2457 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2957 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2457 0 obj 153 endobj 2460 0 obj << /Length 2461 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2959 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2461 0 obj 153 endobj 2236 0 obj << /Length 2237 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2961 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2237 0 obj 153 endobj 1992 0 obj << /Length 1993 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2963 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1993 0 obj 153 endobj 2464 0 obj << /Length 2465 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2965 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2465 0 obj 153 endobj 1718 0 obj << /Length 1719 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2967 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1719 0 obj 153 endobj 1996 0 obj << /Length 1997 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2969 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1997 0 obj 153 endobj 2468 0 obj << /Length 2469 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2971 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2469 0 obj 153 endobj 2498 0 obj << /Length 2499 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2973 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2499 0 obj 496 endobj 2000 0 obj << /Length 2001 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2975 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2001 0 obj 153 endobj 2004 0 obj << /Length 2005 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2977 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2005 0 obj 181 endobj 2008 0 obj << /Length 2009 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2979 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2009 0 obj 496 endobj 1616 0 obj << /Length 1617 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2981 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1617 0 obj 181 endobj 1986 0 obj << /Length 1987 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2983 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1987 0 obj 496 endobj 1714 0 obj << /Length 1715 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2985 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1715 0 obj 496 endobj 1774 0 obj << /Length 1775 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2987 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1775 0 obj 153 endobj 1612 0 obj << /Length 1613 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2989 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1613 0 obj 181 endobj 1592 0 obj << /Length 1593 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2991 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1593 0 obj 153 endobj 1980 0 obj << /Length 1981 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2993 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1981 0 obj 496 endobj 1794 0 obj << /Length 1795 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2995 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1795 0 obj 153 endobj 2218 0 obj << /Length 2219 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 2997 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2219 0 obj 153 endobj 2222 0 obj << /Length 2223 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 2999 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2223 0 obj 496 endobj 1608 0 obj << /Length 1609 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3001 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1609 0 obj 153 endobj 1712 0 obj << /Length 1713 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3003 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1713 0 obj 181 endobj 1588 0 obj << /Length 1589 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3005 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1589 0 obj 153 endobj 1648 0 obj << /Length 1649 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3007 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1649 0 obj 496 endobj 1672 0 obj << /Length 1673 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3009 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1673 0 obj 153 endobj 1978 0 obj << /Length 1979 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3011 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1979 0 obj 159 endobj 2428 0 obj << /Length 2429 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3013 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2429 0 obj 153 endobj 2432 0 obj << /Length 2433 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3015 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2433 0 obj 153 endobj 1798 0 obj << /Length 1799 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3017 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1799 0 obj 175 endobj 2436 0 obj << /Length 2437 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3019 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2437 0 obj 181 endobj 2440 0 obj << /Length 2441 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3021 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2441 0 obj 153 endobj 2444 0 obj << /Length 2445 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3023 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2445 0 obj 496 endobj 1584 0 obj << /Length 1585 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3025 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1585 0 obj 153 endobj 1708 0 obj << /Length 1709 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3027 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1709 0 obj 496 endobj 2214 0 obj << /Length 2215 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3029 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2215 0 obj 153 endobj 2400 0 obj << /Length 2401 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3031 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2401 0 obj 159 endobj 2404 0 obj << /Length 2405 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3033 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2405 0 obj 153 endobj 1540 0 obj << /Length 1541 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3035 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1541 0 obj 153 endobj 1958 0 obj << /Length 1959 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3037 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1959 0 obj 153 endobj 2408 0 obj << /Length 2409 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3039 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2409 0 obj 153 endobj 1768 0 obj << /Length 1769 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3041 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1769 0 obj 153 endobj 1962 0 obj << /Length 1963 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3043 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1963 0 obj 181 endobj 1646 0 obj << /Length 1647 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3045 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1647 0 obj 153 endobj 1966 0 obj << /Length 1967 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3047 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1967 0 obj 153 endobj 2412 0 obj << /Length 2413 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3049 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2413 0 obj 153 endobj 2416 0 obj << /Length 2417 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3051 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2417 0 obj 153 endobj 1970 0 obj << /Length 1971 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3053 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1971 0 obj 181 endobj 2420 0 obj << /Length 2421 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3055 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2421 0 obj 181 endobj 1974 0 obj << /Length 1975 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3057 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1975 0 obj 153 endobj 2424 0 obj << /Length 2425 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3059 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2425 0 obj 153 endobj 1580 0 obj << /Length 1581 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3061 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1581 0 obj 153 endobj 2394 0 obj << /Length 2395 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3063 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2395 0 obj 171 endobj 2212 0 obj << /Length 2213 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3065 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2213 0 obj 153 endobj 2398 0 obj << /Length 2399 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3067 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2399 0 obj 181 endobj 1552 0 obj << /Length 1553 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3069 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1553 0 obj 175 endobj 1642 0 obj << /Length 1643 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3071 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1643 0 obj 181 endobj 1602 0 obj << /Length 1603 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3073 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1603 0 obj 153 endobj 1706 0 obj << /Length 1707 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3075 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1707 0 obj 496 endobj 2198 0 obj << /Length 2199 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3077 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2199 0 obj 181 endobj 1576 0 obj << /Length 1577 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3079 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1577 0 obj 153 endobj 2202 0 obj << /Length 2203 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3081 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2203 0 obj 181 endobj 2206 0 obj << /Length 2207 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3083 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2207 0 obj 496 endobj 1598 0 obj << /Length 1599 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3085 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1599 0 obj 181 endobj 1948 0 obj << /Length 1949 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3087 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1949 0 obj 171 endobj 2196 0 obj << /Length 2197 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3089 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2197 0 obj 181 endobj 1952 0 obj << /Length 1953 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3091 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1953 0 obj 496 endobj 1762 0 obj << /Length 1763 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3093 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1763 0 obj 153 endobj 1704 0 obj << /Length 1705 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3095 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1705 0 obj 153 endobj 2372 0 obj << /Length 2373 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3097 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2373 0 obj 153 endobj 2376 0 obj << /Length 2377 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3099 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2377 0 obj 153 endobj 2174 0 obj << /Length 2175 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3101 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2175 0 obj 153 endobj 2380 0 obj << /Length 2381 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3103 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2381 0 obj 153 endobj 2178 0 obj << /Length 2179 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3105 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2179 0 obj 153 endobj 2384 0 obj << /Length 2385 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3107 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2385 0 obj 153 endobj 2140 0 obj << /Length 2141 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3109 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2141 0 obj 153 endobj 2182 0 obj << /Length 2183 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3111 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2183 0 obj 153 endobj 2388 0 obj << /Length 2389 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3113 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2389 0 obj 496 endobj 2144 0 obj << /Length 2145 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3115 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2145 0 obj 153 endobj 1942 0 obj << /Length 1943 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3117 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1943 0 obj 153 endobj 2186 0 obj << /Length 2187 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3119 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2187 0 obj 153 endobj 2148 0 obj << /Length 2149 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3121 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2149 0 obj 153 endobj 1946 0 obj << /Length 1947 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3123 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1947 0 obj 153 endobj 2190 0 obj << /Length 2191 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3125 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2191 0 obj 153 endobj 2152 0 obj << /Length 2153 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3127 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2153 0 obj 153 endobj 1866 0 obj << /Length 1867 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3129 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1867 0 obj 181 endobj 2194 0 obj << /Length 2195 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3131 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2195 0 obj 496 endobj 2072 0 obj << /Length 2073 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3133 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2073 0 obj 153 endobj 1758 0 obj << /Length 1759 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3135 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1759 0 obj 496 endobj 2156 0 obj << /Length 2157 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3137 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2157 0 obj 153 endobj 1700 0 obj << /Length 1701 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3139 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1701 0 obj 153 endobj 2076 0 obj << /Length 2077 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3141 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2077 0 obj 159 endobj 2160 0 obj << /Length 2161 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3143 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2161 0 obj 171 endobj 2164 0 obj << /Length 2165 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3145 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2165 0 obj 171 endobj 2080 0 obj << /Length 2081 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3147 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2081 0 obj 153 endobj 2370 0 obj << /Length 2371 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3149 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2371 0 obj 153 endobj 2084 0 obj << /Length 2085 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3151 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2085 0 obj 181 endobj 2168 0 obj << /Length 2169 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3153 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2169 0 obj 496 endobj 2088 0 obj << /Length 2089 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3155 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2089 0 obj 153 endobj 1928 0 obj << /Length 1929 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3157 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1929 0 obj 159 endobj 2092 0 obj << /Length 2093 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3159 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2093 0 obj 153 endobj 2134 0 obj << /Length 2135 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3161 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2135 0 obj 153 endobj 1932 0 obj << /Length 1933 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3163 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1933 0 obj 153 endobj 2096 0 obj << /Length 2097 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3165 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2097 0 obj 153 endobj 2138 0 obj << /Length 2139 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3167 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2139 0 obj 153 endobj 1936 0 obj << /Length 1937 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3169 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1937 0 obj 153 endobj 2100 0 obj << /Length 2101 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3171 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2101 0 obj 181 endobj 1940 0 obj << /Length 1941 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3173 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1941 0 obj 181 endobj 2104 0 obj << /Length 2105 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3175 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2105 0 obj 153 endobj 2108 0 obj << /Length 2109 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3177 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2109 0 obj 153 endobj 2070 0 obj << /Length 2071 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3179 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2071 0 obj 153 endobj 2112 0 obj << /Length 2113 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3181 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2113 0 obj 153 endobj 2116 0 obj << /Length 2117 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3183 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2117 0 obj 153 endobj 2364 0 obj << /Length 2365 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3185 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2365 0 obj 496 endobj 1854 0 obj << /Length 1855 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3187 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1855 0 obj 181 endobj 2120 0 obj << /Length 2121 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3189 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2121 0 obj 153 endobj 1918 0 obj << /Length 1919 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3191 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1919 0 obj 153 endobj 1858 0 obj << /Length 1859 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3193 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1859 0 obj 153 endobj 2124 0 obj << /Length 2125 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3195 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2125 0 obj 153 endobj 1922 0 obj << /Length 1923 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3197 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1923 0 obj 153 endobj 1862 0 obj << /Length 1863 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3199 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1863 0 obj 153 endobj 1926 0 obj << /Length 1927 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3201 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1927 0 obj 153 endobj 2044 0 obj << /Length 2045 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3203 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2045 0 obj 153 endobj 2132 0 obj << /Length 2133 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3205 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2133 0 obj 153 endobj 1756 0 obj << /Length 1757 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3207 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1757 0 obj 181 endobj 2048 0 obj << /Length 2049 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3209 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2049 0 obj 153 endobj 2052 0 obj << /Length 2053 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3211 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2053 0 obj 153 endobj 2128 0 obj << /Length 2129 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3213 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2129 0 obj 181 endobj 2056 0 obj << /Length 2057 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3215 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2057 0 obj 181 endobj 2060 0 obj << /Length 2061 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3217 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2061 0 obj 181 endobj 2064 0 obj << /Length 2065 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3219 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2065 0 obj 153 endobj 1844 0 obj << /Length 1845 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3221 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1845 0 obj 153 endobj 2068 0 obj << /Length 2069 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3223 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2069 0 obj 496 endobj 1848 0 obj << /Length 1849 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3225 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1849 0 obj 496 endobj 1870 0 obj << /Length 1871 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3227 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1871 0 obj 171 endobj 1912 0 obj << /Length 1913 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3229 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1913 0 obj 181 endobj 1638 0 obj << /Length 1639 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3231 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1639 0 obj 496 endobj 1874 0 obj << /Length 1875 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3233 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1875 0 obj 171 endobj 1916 0 obj << /Length 1917 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3235 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1917 0 obj 153 endobj 1878 0 obj << /Length 1879 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3237 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1879 0 obj 153 endobj 2042 0 obj << /Length 2043 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3239 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2043 0 obj 153 endobj 1882 0 obj << /Length 1883 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3241 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1883 0 obj 153 endobj 1752 0 obj << /Length 1753 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3243 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1753 0 obj 181 endobj 1568 0 obj << /Length 1569 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3245 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1569 0 obj 153 endobj 1886 0 obj << /Length 1887 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3247 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1887 0 obj 153 endobj 1826 0 obj << /Length 1827 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3249 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1827 0 obj 175 endobj 1890 0 obj << /Length 1891 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3251 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1891 0 obj 181 endobj 2360 0 obj << /Length 2361 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3253 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2361 0 obj 153 endobj 1830 0 obj << /Length 1831 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3255 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1831 0 obj 181 endobj 1894 0 obj << /Length 1895 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3257 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1895 0 obj 181 endobj 1834 0 obj << /Length 1835 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3259 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1835 0 obj 153 endobj 1898 0 obj << /Length 1899 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3261 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1899 0 obj 181 endobj 1838 0 obj << /Length 1839 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3263 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1839 0 obj 496 endobj 1902 0 obj << /Length 1903 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3265 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1903 0 obj 181 endobj 1906 0 obj << /Length 1907 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3267 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1907 0 obj 496 endobj 1804 0 obj << /Length 1805 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3269 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1805 0 obj 153 endobj 1668 0 obj << /Length 1669 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3271 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1669 0 obj 153 endobj 1808 0 obj << /Length 1809 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3273 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1809 0 obj 153 endobj 2342 0 obj << /Length 2343 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3275 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2343 0 obj 153 endobj 1812 0 obj << /Length 1813 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3277 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1813 0 obj 153 endobj 2304 0 obj << /Length 2305 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3279 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2305 0 obj 181 endobj 1816 0 obj << /Length 1817 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3281 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1817 0 obj 153 endobj 2346 0 obj << /Length 2347 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3283 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2347 0 obj 171 endobj 1748 0 obj << /Length 1749 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3285 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1749 0 obj 153 endobj 2308 0 obj << /Length 2309 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3287 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2309 0 obj 153 endobj 1820 0 obj << /Length 1821 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3289 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1821 0 obj 496 endobj 2312 0 obj << /Length 2313 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3291 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2313 0 obj 181 endobj 2350 0 obj << /Length 2351 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3293 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2351 0 obj 153 endobj 2354 0 obj << /Length 2355 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3295 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2355 0 obj 153 endobj 2316 0 obj << /Length 2317 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3297 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2317 0 obj 159 endobj 2358 0 obj << /Length 2359 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3299 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2359 0 obj 171 endobj 2320 0 obj << /Length 2321 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3301 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2321 0 obj 153 endobj 2324 0 obj << /Length 2325 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3303 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2325 0 obj 175 endobj 2038 0 obj << /Length 2039 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3305 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2039 0 obj 153 endobj 2328 0 obj << /Length 2329 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3307 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2329 0 obj 153 endobj 2290 0 obj << /Length 2291 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3309 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2291 0 obj 153 endobj 2332 0 obj << /Length 2333 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3311 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2333 0 obj 153 endobj 2294 0 obj << /Length 2295 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3313 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2295 0 obj 181 endobj 1694 0 obj << /Length 1695 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3315 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1695 0 obj 496 endobj 2336 0 obj << /Length 2337 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3317 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2337 0 obj 153 endobj 2298 0 obj << /Length 2299 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3319 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2299 0 obj 181 endobj 2340 0 obj << /Length 2341 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3321 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2341 0 obj 175 endobj 2302 0 obj << /Length 2303 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3323 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2303 0 obj 175 endobj 1744 0 obj << /Length 1745 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3325 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1745 0 obj 181 endobj 2036 0 obj << /Length 2037 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3327 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2037 0 obj 153 endobj 1564 0 obj << /Length 1565 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3329 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1565 0 obj 153 endobj 1740 0 obj << /Length 1741 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3331 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1741 0 obj 181 endobj 1692 0 obj << /Length 1693 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3333 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1693 0 obj 153 endobj 2274 0 obj << /Length 2275 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3335 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2275 0 obj 153 endobj 2030 0 obj << /Length 2031 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3337 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2031 0 obj 496 endobj 2278 0 obj << /Length 2279 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3339 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2279 0 obj 153 endobj 2282 0 obj << /Length 2283 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3341 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2283 0 obj 496 endobj 1560 0 obj << /Length 1561 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3343 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1561 0 obj 153 endobj 1736 0 obj << /Length 1737 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3345 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1737 0 obj 153 endobj 1534 0 obj << /Length 1535 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3347 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1535 0 obj 181 endobj 1652 0 obj << /Length 1653 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3349 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1653 0 obj 181 endobj 2268 0 obj << /Length 2269 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3351 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2269 0 obj 181 endobj 1688 0 obj << /Length 1689 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3353 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1689 0 obj 153 endobj 2024 0 obj << /Length 2025 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3355 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2025 0 obj 181 endobj 2272 0 obj << /Length 2273 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3357 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2273 0 obj 153 endobj 2028 0 obj << /Length 2029 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3359 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2029 0 obj 181 endobj 1650 0 obj << /Length 1651 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3361 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1651 0 obj 496 endobj 1634 0 obj << /Length 1635 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3363 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1635 0 obj 153 endobj 1556 0 obj << /Length 1557 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3365 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1557 0 obj 153 endobj 1660 0 obj << /Length 1661 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3367 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1661 0 obj 153 endobj 1732 0 obj << /Length 1733 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3369 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1733 0 obj 153 endobj 1596 0 obj << /Length 1597 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3371 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1597 0 obj 181 endobj 2262 0 obj << /Length 2263 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3373 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2263 0 obj 153 endobj 2018 0 obj << /Length 2019 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3375 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2019 0 obj 171 endobj 1684 0 obj << /Length 1685 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3377 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1685 0 obj 181 endobj 2022 0 obj << /Length 2023 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3379 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2023 0 obj 153 endobj 2266 0 obj << /Length 2267 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3381 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2267 0 obj 153 endobj 1630 0 obj << /Length 1631 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3383 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1631 0 obj 153 endobj 2240 0 obj << /Length 2241 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3385 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2241 0 obj 181 endobj 1656 0 obj << /Length 1657 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3387 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 1657 0 obj 159 endobj 2244 0 obj << /Length 2245 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3389 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2245 0 obj 153 endobj 2514 0 obj << /Length 2515 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3391 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2515 0 obj 153 endobj 2248 0 obj << /Length 2249 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3393 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2249 0 obj 153 endobj 1728 0 obj << /Length 1729 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3395 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1729 0 obj 181 endobj 2518 0 obj << /Length 2519 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3397 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2519 0 obj 153 endobj 2252 0 obj << /Length 2253 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3399 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2253 0 obj 153 endobj 2522 0 obj << /Length 2523 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3401 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2523 0 obj 153 endobj 2256 0 obj << /Length 2257 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3403 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2257 0 obj 153 endobj 2526 0 obj << /Length 2527 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3405 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2527 0 obj 181 endobj 2260 0 obj << /Length 2261 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3407 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2261 0 obj 153 endobj 1680 0 obj << /Length 1681 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3409 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1681 0 obj 181 endobj 2530 0 obj << /Length 2531 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3411 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2531 0 obj 175 endobj 2534 0 obj << /Length 2535 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3413 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2535 0 obj 153 endobj 1626 0 obj << /Length 1627 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3415 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1627 0 obj 153 endobj 2538 0 obj << /Length 2539 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3417 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2539 0 obj 153 endobj 1572 0 obj << /Length 1573 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3419 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1573 0 obj 496 endobj 1724 0 obj << /Length 1725 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3421 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1725 0 obj 153 endobj 2502 0 obj << /Length 2503 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3423 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2503 0 obj 153 endobj 1676 0 obj << /Length 1677 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3425 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1677 0 obj 153 endobj 1636 0 obj << /Length 1637 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3427 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1637 0 obj 153 endobj 2506 0 obj << /Length 2507 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3429 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2507 0 obj 153 endobj 2510 0 obj << /Length 2511 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3431 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2511 0 obj 153 endobj 1622 0 obj << /Length 1623 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3433 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1623 0 obj 153 endobj 2472 0 obj << /Length 2473 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3435 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` ìèmZW]2» «ž]}-'÷üzýr[suº«š씾ß¾þÿÿÿ÷çO[ÊóÒÌàjvu‚ôBd €à×»7›r’Ò­ !jÖUM†HÁÉgGNõ†(˜‘ž°£µh2\öÍõËsãÃàV™nŽ[* €&Õeç ÊBT]´h2š^ds€®‚Û‹,ŽŸ _˜oË endstream endobj 2473 0 obj 159 endobj 2476 0 obj << /Length 2477 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3437 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2477 0 obj 153 endobj 2480 0 obj << /Length 2481 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3439 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2481 0 obj 153 endobj 2012 0 obj << /Length 2013 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3441 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2013 0 obj 496 endobj 2484 0 obj << /Length 2485 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3443 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2485 0 obj 181 endobj 1720 0 obj << /Length 1721 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3445 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1721 0 obj 153 endobj 2488 0 obj << /Length 2489 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3447 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2489 0 obj 153 endobj 2492 0 obj << /Length 2493 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3449 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2493 0 obj 153 endobj 2454 0 obj << /Length 2455 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3451 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2455 0 obj 153 endobj 2230 0 obj << /Length 2231 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3453 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2231 0 obj 181 endobj 2496 0 obj << /Length 2497 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3455 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2497 0 obj 153 endobj 2458 0 obj << /Length 2459 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3457 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2459 0 obj 153 endobj 2234 0 obj << /Length 2235 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3459 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2235 0 obj 496 endobj 1990 0 obj << /Length 1991 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3461 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1991 0 obj 181 endobj 2462 0 obj << /Length 2463 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3463 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2463 0 obj 171 endobj 2500 0 obj << /Length 2501 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3465 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2501 0 obj 153 endobj 1994 0 obj << /Length 1995 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3467 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1995 0 obj 153 endobj 2466 0 obj << /Length 2467 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3469 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2467 0 obj 496 endobj 1618 0 obj << /Length 1619 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3471 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1619 0 obj 153 endobj 1790 0 obj << /Length 1791 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3473 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1791 0 obj 153 endobj 1998 0 obj << /Length 1999 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3475 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1999 0 obj 153 endobj 2002 0 obj << /Length 2003 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3477 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 2003 0 obj 171 endobj 2006 0 obj << /Length 2007 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3479 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 2007 0 obj 175 endobj 2010 0 obj << /Length 2011 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3481 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2011 0 obj 153 endobj 1716 0 obj << /Length 1717 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3483 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1717 0 obj 175 endobj 1984 0 obj << /Length 1985 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3485 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1985 0 obj 153 endobj 1988 0 obj << /Length 1989 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3487 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1989 0 obj 153 endobj 1594 0 obj << /Length 1595 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3489 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1595 0 obj 181 endobj 1614 0 obj << /Length 1615 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3491 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1615 0 obj 153 endobj 1640 0 obj << /Length 1641 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3493 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1641 0 obj 181 endobj 2226 0 obj << /Length 2227 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3495 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2227 0 obj 153 endobj 1792 0 obj << /Length 1793 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3497 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1793 0 obj 496 endobj 2450 0 obj << /Length 2451 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3499 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2451 0 obj 153 endobj 1982 0 obj << /Length 1983 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3501 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1983 0 obj 153 endobj 1772 0 obj << /Length 1773 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3503 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1773 0 obj 496 endobj 1590 0 obj << /Length 1591 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3505 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@€7ÇyÞäÛ<!‚Ìú|Ýô׋Ÿ,¾ž•ì*eG–²_aýó.í×SÇ_ÏRÿ^R»±…MÁ›#¬¿ß„ý}áô÷¶þßsJç× +ªwAþ÷Có?ç•>ÔVC3Ľ½õÏÛχx×N`Ã"ÍÀðâ 럧¶ïrc• ¾: Rðé·¨v%qa—‹~¾ªts3÷ãÑ”?èHG endstream endobj 1591 0 obj 171 endobj 1610 0 obj << /Length 1611 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3507 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1611 0 obj 153 endobj 2216 0 obj << /Length 2217 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3509 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2217 0 obj 181 endobj 2220 0 obj << /Length 2221 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3511 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2221 0 obj 181 endobj 2448 0 obj << /Length 2449 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3513 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2449 0 obj 153 endobj 2224 0 obj << /Length 2225 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3515 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2225 0 obj 153 endobj 1796 0 obj << /Length 1797 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3517 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1797 0 obj 181 endobj 2426 0 obj << /Length 2427 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3519 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2427 0 obj 181 endobj 2430 0 obj << /Length 2431 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3521 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2431 0 obj 181 endobj 2434 0 obj << /Length 2435 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3523 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 2435 0 obj 181 endobj 1606 0 obj << /Length 1607 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3525 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1607 0 obj 496 endobj 1710 0 obj << /Length 1711 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3527 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1711 0 obj 181 endobj 1586 0 obj << /Length 1587 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3529 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1587 0 obj 153 endobj 2438 0 obj << /Length 2439 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3531 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2439 0 obj 153 endobj 2442 0 obj << /Length 2443 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3533 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2443 0 obj 153 endobj 1782 0 obj << /Length 1783 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3535 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 1783 0 obj 496 endobj 2446 0 obj << /Length 2447 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /Interpolate true /ColorSpace 2542 0 R /SMask 3537 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xµÌIsÒpð~)žýž\®ž´~^¥NµÓ—º0C)H)6§Ð°BÙ!$1,%M…˜åŸ!@BŒe&Wǃï<óÌsøÍ»¶öÏwã&ó×ܺÝrÿÞyØ»·Þ»ÿXü“õë¬Æuß}ÔsÀƒ iåmÛŽ2s§[,íÙ/ûjn­¥1]ê“¥2ZŠÃÅ…¶ðæF®Ñ3c<§ùaµ= xCP¦ùFct¶;E)ý˜ÐšÒü}¦ïz¨nõÍY¹ÙÇiPàúÍÞ$EiHTùq¬³? Þx]ÿ™œcvÆjIRÅê*}9FÍKù–Æ•@JÀ9ýåI×õa”V–Ö5USI~ü¥¤Fp ãÌ ¦øP!Ãè;°àúPa êV¦®!eõ´ª”:&”WC˜”bG{iåcB@ëúöѹëƒ9 ¨Ö)©Áé¤$5Í\ÝO‹_©¡•v‘ „Ô¶Â ×ïeä¶lÁE9òM8Ê^&)àOv½q*Èoá܆ °dWÞi/*r½Iœc8ËñÎø”ühç0ûãCœßE:P xüu׿C„s劌bCË}«'i=NªÇUW4¨¬E+Æ_Íõž÷jíD¸íöyˆyd¶ôÓ}jÓ_óø(G:ÙxStý¿ÿï›— endstream endobj 2447 0 obj 496 endobj 1542 0 obj << /Length 1543 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3539 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1543 0 obj 153 endobj 1770 0 obj << /Length 1771 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3541 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1771 0 obj 181 endobj 1800 0 obj << /Length 1801 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3543 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1801 0 obj 153 endobj 1530 0 obj << /Length 1531 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3545 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` Ìh®™UWÕ”„UÏ̶¶­3§|9ºIm¹Ÿ¹š°ì´ïgŽ};°ãú% ³’ütÔájf¶5õ‚dïù²eõÇS_w×Í õöPW„¨™Q[ 4¨÷ËæUN{×]û².ÿRar‘DAy\èòúJ É@½@Ùµy—‹R*,áVþ–Æ‹²’&õe+Pe!*®Ú 4M/²9@W•Øš#‹ÃH’WŸ endstream endobj 1531 0 obj 181 endobj 2402 0 obj << /Length 2403 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3547 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2403 0 obj 153 endobj 1956 0 obj << /Length 1957 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3549 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4ÏŸ_7o^RCV=móçÏØµëÈïßÕ«V™£©ÊÎܵëô¿ûþý[óûwæÊ•:~~p5½@Ùƒÿþmú÷oÞ¿¿~¯Z¥SS3gÐd ÞÙ¿«ýÊ{øÐ¦¦bH\yyÝÚµ@“Azÿþ­úù3ÿÑ#‡ÆF¸@†ehhæªU@“z²vØ<tÐ^ Éhz‘ͺÊf/²8~6—¡hi endstream endobj 1957 0 obj 175 endobj 2406 0 obj << /Length 2407 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3551 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 2407 0 obj 153 endobj 1960 0 obj << /Length 1961 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /Interpolate true /ColorSpace 2542 0 R /SMask 3553 0 R /BitsPerComponent 8 /Filter /FlateDecode >> stream xc` 4mÞ\°|yÖìÙXõ´lÝÚ½gÏë?*7mrHOGS”íÙ³çÛøôçOÞ† fHjÀz!²`%ÿßþù“´q£!LMþ²e@“!RpòЋÞS§B,J˜8±fË ÉpÙ+oÞ„Íš…ì ÇÌ̼&ÕeCQe!*®Ú 4M/²9@WyN™‚,B ^>u† endstream endobj 1961 0 obj 153 endobj 2581 0 obj << /Length 2582 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2582 0 obj 50 endobj 3061 0 obj << /Length 3062 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3062 0 obj 87 endobj 2777 0 obj << /Length 2778 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2778 0 obj 87 endobj 2663 0 obj << /Length 2664 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2664 0 obj 50 endobj 2939 0 obj << /Length 2940 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2940 0 obj 87 endobj 3361 0 obj << /Length 3362 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3362 0 obj 50 endobj 3393 0 obj << /Length 3394 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3394 0 obj 87 endobj 3263 0 obj << /Length 3264 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3264 0 obj 50 endobj 2995 0 obj << /Length 2996 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2996 0 obj 87 endobj 2683 0 obj << /Length 2684 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2684 0 obj 88 endobj 2863 0 obj << /Length 2864 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2864 0 obj 88 endobj 2611 0 obj << /Length 2612 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2612 0 obj 88 endobj 3115 0 obj << /Length 3116 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3116 0 obj 87 endobj 3301 0 obj << /Length 3302 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3302 0 obj 87 endobj 2977 0 obj << /Length 2978 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2978 0 obj 88 endobj 3333 0 obj << /Length 3334 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3334 0 obj 87 endobj 3135 0 obj << /Length 3136 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3136 0 obj 50 endobj 3537 0 obj << /Length 3538 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3538 0 obj 50 endobj 2607 0 obj << /Length 2608 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2608 0 obj 50 endobj 2975 0 obj << /Length 2976 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2976 0 obj 87 endobj 3153 0 obj << /Length 3154 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3154 0 obj 50 endobj 3433 0 obj << /Length 3434 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3434 0 obj 87 endobj 2885 0 obj << /Length 2886 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2886 0 obj 88 endobj 3185 0 obj << /Length 3186 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3186 0 obj 50 endobj 2985 0 obj << /Length 2986 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2986 0 obj 50 endobj 3055 0 obj << /Length 3056 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3056 0 obj 88 endobj 2639 0 obj << /Length 2640 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2640 0 obj 87 endobj 3217 0 obj << /Length 3218 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3218 0 obj 88 endobj 2917 0 obj << /Length 2918 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2918 0 obj 100 endobj 2619 0 obj << /Length 2620 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2620 0 obj 87 endobj 3241 0 obj << /Length 3242 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3242 0 obj 87 endobj 2771 0 obj << /Length 2772 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2772 0 obj 87 endobj 3355 0 obj << /Length 3356 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3356 0 obj 88 endobj 3387 0 obj << /Length 3388 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3388 0 obj 87 endobj 2613 0 obj << /Length 2614 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2614 0 obj 87 endobj 2989 0 obj << /Length 2990 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2990 0 obj 88 endobj 3487 0 obj << /Length 3488 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3488 0 obj 87 endobj 2645 0 obj << /Length 2646 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2646 0 obj 88 endobj 3125 0 obj << /Length 3126 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3126 0 obj 87 endobj 2675 0 obj << /Length 2676 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2676 0 obj 87 endobj 2653 0 obj << /Length 2654 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2654 0 obj 87 endobj 3527 0 obj << /Length 3528 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3528 0 obj 88 endobj 3327 0 obj << /Length 3328 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3328 0 obj 87 endobj 2953 0 obj << /Length 2954 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2954 0 obj 87 endobj 3509 0 obj << /Length 3510 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3510 0 obj 88 endobj 2685 0 obj << /Length 2686 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2686 0 obj 88 endobj 2997 0 obj << /Length 2998 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2998 0 obj 87 endobj 3147 0 obj << /Length 3148 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3148 0 obj 87 endobj 2699 0 obj << /Length 2700 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2700 0 obj 87 endobj 2793 0 obj << /Length 2794 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2794 0 obj 88 endobj 3179 0 obj << /Length 3180 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3180 0 obj 87 endobj 2749 0 obj << /Length 2750 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2750 0 obj 87 endobj 2911 0 obj << /Length 2912 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2912 0 obj 87 endobj 2705 0 obj << /Length 2706 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2706 0 obj 50 endobj 3211 0 obj << /Length 3212 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3212 0 obj 87 endobj 2583 0 obj << /Length 2584 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2584 0 obj 87 endobj 3227 0 obj << /Length 3228 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3228 0 obj 100 endobj 2799 0 obj << /Length 2800 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2800 0 obj 87 endobj 3459 0 obj << /Length 3460 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3460 0 obj 50 endobj 2595 0 obj << /Length 2596 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2596 0 obj 88 endobj 2813 0 obj << /Length 2814 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2814 0 obj 87 endobj 3005 0 obj << /Length 3006 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3006 0 obj 87 endobj 3507 0 obj << /Length 3508 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3508 0 obj 87 endobj 2735 0 obj << /Length 2736 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2736 0 obj 87 endobj 2671 0 obj << /Length 2672 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2672 0 obj 50 endobj 2879 0 obj << /Length 2880 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2880 0 obj 88 endobj 2875 0 obj << /Length 2876 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2876 0 obj 87 endobj 3069 0 obj << /Length 3070 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3070 0 obj 88 endobj 3029 0 obj << /Length 3030 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3030 0 obj 87 endobj 2785 0 obj << /Length 2786 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2786 0 obj 87 endobj 2947 0 obj << /Length 2948 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2948 0 obj 87 endobj 3401 0 obj << /Length 3402 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3402 0 obj 87 endobj 2693 0 obj << /Length 2694 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2694 0 obj 87 endobj 2837 0 obj << /Length 2838 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2838 0 obj 100 endobj 3469 0 obj << /Length 3470 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3470 0 obj 50 endobj 2807 0 obj << /Length 2808 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2808 0 obj 87 endobj 3277 0 obj << /Length 3278 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3278 0 obj 87 endobj 3539 0 obj << /Length 3540 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3540 0 obj 87 endobj 3009 0 obj << /Length 3010 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3010 0 obj 87 endobj 3309 0 obj << /Length 3310 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3310 0 obj 87 endobj 3427 0 obj << /Length 3428 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3428 0 obj 87 endobj 3547 0 obj << /Length 3548 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3548 0 obj 87 endobj 3441 0 obj << /Length 3442 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3442 0 obj 50 endobj 2893 0 obj << /Length 2894 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2894 0 obj 87 endobj 2795 0 obj << /Length 2796 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2796 0 obj 87 endobj 3063 0 obj << /Length 3064 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3064 0 obj 100 endobj 2925 0 obj << /Length 2926 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2926 0 obj 88 endobj 2779 0 obj << /Length 2780 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2780 0 obj 87 endobj 3225 0 obj << /Length 3226 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3226 0 obj 50 endobj 3097 0 obj << /Length 3098 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3098 0 obj 87 endobj 2627 0 obj << /Length 2628 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2628 0 obj 50 endobj 3249 0 obj << /Length 3250 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3250 0 obj 88 endobj 3363 0 obj << /Length 3364 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3364 0 obj 87 endobj 3395 0 obj << /Length 3396 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3396 0 obj 88 endobj 3529 0 obj << /Length 3530 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3530 0 obj 87 endobj 2725 0 obj << /Length 2726 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2726 0 obj 87 endobj 2819 0 obj << /Length 2820 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2820 0 obj 88 endobj 3101 0 obj << /Length 3102 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3102 0 obj 87 endobj 3117 0 obj << /Length 3118 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3118 0 obj 87 endobj 2841 0 obj << /Length 2842 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2842 0 obj 87 endobj 3133 0 obj << /Length 3134 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3134 0 obj 87 endobj 2865 0 obj << /Length 2866 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2866 0 obj 87 endobj 3089 0 obj << /Length 3090 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3090 0 obj 88 endobj 2979 0 obj << /Length 2980 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2980 0 obj 50 endobj 3303 0 obj << /Length 3304 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3304 0 obj 88 endobj 3335 0 obj << /Length 3336 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3336 0 obj 87 endobj 2827 0 obj << /Length 2828 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2828 0 obj 87 endobj 2961 0 obj << /Length 2962 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2962 0 obj 87 endobj 3155 0 obj << /Length 3156 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3156 0 obj 87 endobj 3435 0 obj << /Length 3436 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3436 0 obj 87 endobj 2887 0 obj << /Length 2888 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2888 0 obj 87 endobj 3041 0 obj << /Length 3042 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3042 0 obj 87 endobj 3187 0 obj << /Length 3188 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3188 0 obj 88 endobj 2757 0 obj << /Length 2758 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2758 0 obj 87 endobj 2919 0 obj << /Length 2920 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2920 0 obj 87 endobj 3219 0 obj << /Length 3220 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3220 0 obj 87 endobj 3091 0 obj << /Length 3092 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3092 0 obj 50 endobj 2621 0 obj << /Length 2622 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2622 0 obj 88 endobj 3243 0 obj << /Length 3244 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3244 0 obj 88 endobj 3373 0 obj << /Length 3374 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3374 0 obj 87 endobj 2831 0 obj << /Length 2832 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2832 0 obj 50 endobj 3541 0 obj << /Length 3542 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3542 0 obj 88 endobj 3127 0 obj << /Length 3128 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3128 0 obj 87 endobj 3077 0 obj << /Length 3078 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3078 0 obj 88 endobj 2955 0 obj << /Length 2956 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2956 0 obj 87 endobj 2999 0 obj << /Length 3000 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3000 0 obj 50 endobj 3409 0 obj << /Length 3410 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3410 0 obj 88 endobj 2701 0 obj << /Length 2702 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2702 0 obj 50 endobj 3157 0 obj << /Length 3158 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3158 0 obj 87 endobj 3165 0 obj << /Length 3166 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3166 0 obj 87 endobj 2859 0 obj << /Length 2860 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2860 0 obj 88 endobj 2587 0 obj << /Length 2588 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2588 0 obj 88 endobj 3197 0 obj << /Length 3198 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3198 0 obj 87 endobj 2751 0 obj << /Length 2752 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2752 0 obj 88 endobj 3423 0 obj << /Length 3424 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3424 0 obj 87 endobj 3495 0 obj << /Length 3496 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3496 0 obj 87 endobj 2815 0 obj << /Length 2816 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2816 0 obj 50 endobj 3285 0 obj << /Length 3286 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3286 0 obj 87 endobj 3317 0 obj << /Length 3318 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3318 0 obj 87 endobj 3189 0 obj << /Length 3190 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3190 0 obj 87 endobj 3511 0 obj << /Length 3512 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3512 0 obj 88 endobj 2901 0 obj << /Length 2902 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2902 0 obj 87 endobj 3071 0 obj << /Length 3072 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3072 0 obj 88 endobj 2933 0 obj << /Length 2934 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2934 0 obj 88 endobj 2787 0 obj << /Length 2788 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2788 0 obj 50 endobj 3257 0 obj << /Length 3258 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3258 0 obj 88 endobj 3403 0 obj << /Length 3404 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3404 0 obj 87 endobj 2715 0 obj << /Length 2716 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2716 0 obj 50 endobj 2733 0 obj << /Length 2734 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2734 0 obj 50 endobj 3471 0 obj << /Length 3472 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3472 0 obj 87 endobj 2903 0 obj << /Length 2904 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2904 0 obj 88 endobj 3109 0 obj << /Length 3110 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3110 0 obj 87 endobj 3279 0 obj << /Length 3280 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3280 0 obj 88 endobj 2849 0 obj << /Length 2850 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2850 0 obj 87 endobj 3311 0 obj << /Length 3312 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3312 0 obj 87 endobj 3365 0 obj << /Length 3366 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3366 0 obj 87 endobj 2601 0 obj << /Length 2602 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2602 0 obj 88 endobj 2969 0 obj << /Length 2970 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2970 0 obj 87 endobj 3269 0 obj << /Length 3270 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3270 0 obj 87 endobj 3035 0 obj << /Length 3036 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3036 0 obj 87 endobj 3273 0 obj << /Length 3274 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3274 0 obj 87 endobj 3049 0 obj << /Length 3050 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3050 0 obj 87 endobj 2651 0 obj << /Length 2652 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2652 0 obj 87 endobj 2765 0 obj << /Length 2766 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2766 0 obj 87 endobj 2927 0 obj << /Length 2928 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2928 0 obj 87 endobj 2895 0 obj << /Length 2896 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2896 0 obj 87 endobj 2661 0 obj << /Length 2662 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2662 0 obj 87 endobj 3349 0 obj << /Length 3350 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3350 0 obj 88 endobj 2629 0 obj << /Length 2630 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2630 0 obj 88 endobj 3251 0 obj << /Length 3252 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3252 0 obj 88 endobj 3381 0 obj << /Length 3382 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3382 0 obj 87 endobj 3443 0 obj << /Length 3444 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3444 0 obj 88 endobj 3501 0 obj << /Length 3502 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3502 0 obj 87 endobj 2681 0 obj << /Length 2682 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2682 0 obj 88 endobj 3293 0 obj << /Length 3294 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3294 0 obj 87 endobj 2727 0 obj << /Length 2728 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2728 0 obj 87 endobj 2591 0 obj << /Length 2592 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2592 0 obj 87 endobj 3481 0 obj << /Length 3482 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3482 0 obj 87 endobj 3103 0 obj << /Length 3104 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3104 0 obj 87 endobj 3119 0 obj << /Length 3120 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3120 0 obj 87 endobj 2843 0 obj << /Length 2844 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2844 0 obj 87 endobj 2867 0 obj << /Length 2868 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2868 0 obj 87 endobj 3013 0 obj << /Length 3014 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3014 0 obj 87 endobj 3021 0 obj << /Length 3022 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3022 0 obj 87 endobj 2963 0 obj << /Length 2964 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2964 0 obj 87 endobj 3417 0 obj << /Length 3418 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3418 0 obj 87 endobj 2557 0 obj << /Length 2558 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2558 0 obj 87 endobj 3173 0 obj << /Length 3174 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3174 0 obj 88 endobj 2983 0 obj << /Length 2984 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2984 0 obj 50 endobj 3043 0 obj << /Length 3044 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3044 0 obj 88 endobj 3205 0 obj << /Length 3206 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3206 0 obj 87 endobj 2759 0 obj << /Length 2760 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2760 0 obj 87 endobj 3453 0 obj << /Length 3454 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3454 0 obj 88 endobj 3375 0 obj << /Length 3376 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3376 0 obj 100 endobj 2853 0 obj << /Length 2854 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2854 0 obj 87 endobj 3033 0 obj << /Length 3034 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3034 0 obj 87 endobj 3551 0 obj << /Length 3552 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3552 0 obj 87 endobj 2987 0 obj << /Length 2988 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2988 0 obj 87 endobj 3231 0 obj << /Length 3232 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3232 0 obj 50 endobj 2549 0 obj << /Length 2550 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2550 0 obj 87 endobj 2991 0 obj << /Length 2992 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2992 0 obj 87 endobj 3341 0 obj << /Length 3342 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3342 0 obj 50 endobj 2941 0 obj << /Length 2942 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2942 0 obj 87 endobj 3233 0 obj << /Length 3234 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3234 0 obj 100 endobj 3345 0 obj << /Length 3346 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3346 0 obj 87 endobj 3505 0 obj << /Length 3506 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3506 0 obj 100 endobj 3265 0 obj << /Length 3266 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3266 0 obj 88 endobj 2687 0 obj << /Length 2688 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2688 0 obj 88 endobj 3411 0 obj << /Length 3412 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3412 0 obj 88 endobj 3159 0 obj << /Length 3160 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3160 0 obj 87 endobj 2791 0 obj << /Length 2792 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2792 0 obj 50 endobj 3167 0 obj << /Length 3168 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3168 0 obj 87 endobj 3199 0 obj << /Length 3200 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3200 0 obj 87 endobj 2801 0 obj << /Length 2802 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2802 0 obj 87 endobj 3003 0 obj << /Length 3004 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3004 0 obj 88 endobj 3081 0 obj << /Length 3082 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3082 0 obj 88 endobj 3287 0 obj << /Length 3288 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3288 0 obj 87 endobj 3191 0 obj << /Length 3192 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3192 0 obj 87 endobj 2673 0 obj << /Length 2674 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2674 0 obj 87 endobj 3057 0 obj << /Length 3058 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3058 0 obj 87 endobj 3549 0 obj << /Length 3550 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3550 0 obj 88 endobj 2773 0 obj << /Length 2774 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2774 0 obj 88 endobj 2935 0 obj << /Length 2936 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2936 0 obj 87 endobj 3027 0 obj << /Length 3028 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3028 0 obj 50 endobj 3357 0 obj << /Length 3358 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3358 0 obj 87 endobj 3389 0 obj << /Length 3390 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3390 0 obj 87 endobj 3259 0 obj << /Length 3260 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3260 0 obj 87 endobj 2835 0 obj << /Length 2836 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2836 0 obj 88 endobj 2717 0 obj << /Length 2718 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2718 0 obj 87 endobj 3111 0 obj << /Length 3112 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3112 0 obj 87 endobj 2647 0 obj << /Length 2648 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2648 0 obj 88 endobj 3015 0 obj << /Length 3016 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3016 0 obj 87 endobj 3297 0 obj << /Length 3298 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3298 0 obj 87 endobj 3367 0 obj << /Length 3368 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3368 0 obj 87 endobj 3329 0 obj << /Length 3330 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3330 0 obj 87 endobj 3521 0 obj << /Length 3522 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3522 0 obj 88 endobj 2603 0 obj << /Length 2604 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2604 0 obj 88 endobj 3445 0 obj << /Length 3446 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3446 0 obj 87 endobj 2971 0 obj << /Length 2972 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2972 0 obj 87 endobj 2631 0 obj << /Length 2632 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2632 0 obj 50 endobj 3149 0 obj << /Length 3150 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3150 0 obj 87 endobj 3429 0 obj << /Length 3430 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3430 0 obj 87 endobj 2881 0 obj << /Length 2882 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2882 0 obj 88 endobj 3181 0 obj << /Length 3182 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3182 0 obj 87 endobj 3051 0 obj << /Length 3052 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3052 0 obj 87 endobj 2913 0 obj << /Length 2914 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2914 0 obj 87 endobj 3141 0 obj << /Length 3142 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3142 0 obj 87 endobj 3213 0 obj << /Length 3214 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3214 0 obj 88 endobj 3095 0 obj << /Length 3096 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3096 0 obj 87 endobj 2615 0 obj << /Length 2616 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2616 0 obj 88 endobj 2767 0 obj << /Length 2768 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2768 0 obj 88 endobj 3351 0 obj << /Length 3352 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3352 0 obj 88 endobj 3383 0 obj << /Length 3384 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3384 0 obj 87 endobj 3461 0 obj << /Length 3462 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3462 0 obj 88 endobj 3001 0 obj << /Length 3002 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3002 0 obj 87 endobj 3295 0 obj << /Length 3296 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3296 0 obj 87 endobj 3483 0 obj << /Length 3484 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3484 0 obj 88 endobj 3121 0 obj << /Length 3122 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3122 0 obj 87 endobj 3087 0 obj << /Length 3088 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3088 0 obj 100 endobj 3023 0 obj << /Length 3024 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3024 0 obj 50 endobj 2657 0 obj << /Length 2658 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2658 0 obj 87 endobj 2949 0 obj << /Length 2950 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2950 0 obj 88 endobj 2981 0 obj << /Length 2982 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2982 0 obj 88 endobj 2695 0 obj << /Length 2696 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2696 0 obj 88 endobj 3419 0 obj << /Length 3420 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3420 0 obj 50 endobj 3175 0 obj << /Length 3176 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3176 0 obj 87 endobj 2745 0 obj << /Length 2746 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2746 0 obj 87 endobj 3455 0 obj << /Length 3456 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3456 0 obj 87 endobj 3465 0 obj << /Length 3466 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3466 0 obj 87 endobj 3207 0 obj << /Length 3208 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3208 0 obj 88 endobj 3093 0 obj << /Length 3094 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3094 0 obj 87 endobj 3473 0 obj << /Length 3474 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3474 0 obj 87 endobj 2809 0 obj << /Length 2810 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2810 0 obj 88 endobj 2833 0 obj << /Length 2834 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2834 0 obj 87 endobj 3237 0 obj << /Length 3238 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3238 0 obj 87 endobj 3065 0 obj << /Length 3066 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3066 0 obj 87 endobj 3343 0 obj << /Length 3344 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3344 0 obj 87 endobj 2781 0 obj << /Length 2782 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2782 0 obj 87 endobj 3083 0 obj << /Length 3084 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3084 0 obj 50 endobj 2943 0 obj << /Length 2944 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2944 0 obj 87 endobj 3347 0 obj << /Length 3348 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3348 0 obj 88 endobj 3397 0 obj << /Length 3398 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3398 0 obj 87 endobj 3535 0 obj << /Length 3536 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3536 0 obj 50 endobj 2689 0 obj << /Length 2690 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2690 0 obj 87 endobj 2803 0 obj << /Length 2804 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2804 0 obj 87 endobj 3489 0 obj << /Length 3490 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3490 0 obj 88 endobj 3503 0 obj << /Length 3504 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3504 0 obj 50 endobj 3305 0 obj << /Length 3306 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3306 0 obj 87 endobj 3323 0 obj << /Length 3324 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3324 0 obj 88 endobj 3337 0 obj << /Length 3338 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3338 0 obj 50 endobj 2563 0 obj << /Length 2564 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2564 0 obj 50 endobj 3143 0 obj << /Length 3144 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3144 0 obj 100 endobj 3437 0 obj << /Length 3438 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3438 0 obj 87 endobj 2889 0 obj << /Length 2890 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2890 0 obj 87 endobj 3321 0 obj << /Length 3322 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3322 0 obj 88 endobj 2571 0 obj << /Length 2572 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2572 0 obj 87 endobj 2907 0 obj << /Length 2908 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2908 0 obj 88 endobj 3059 0 obj << /Length 3060 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3060 0 obj 87 endobj 2921 0 obj << /Length 2922 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2922 0 obj 87 endobj 3221 0 obj << /Length 3222 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3222 0 obj 87 endobj 2775 0 obj << /Length 2776 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2776 0 obj 88 endobj 2623 0 obj << /Length 2624 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2624 0 obj 87 endobj 3245 0 obj << /Length 3246 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3246 0 obj 87 endobj 3359 0 obj << /Length 3360 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3360 0 obj 88 endobj 3391 0 obj << /Length 3392 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3392 0 obj 87 endobj 3553 0 obj << /Length 3554 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3554 0 obj 87 endobj 3129 0 obj << /Length 3130 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3130 0 obj 88 endobj 3497 0 obj << /Length 3498 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3498 0 obj 50 endobj 2855 0 obj << /Length 2856 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2856 0 obj 50 endobj 3299 0 obj << /Length 3300 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3300 0 obj 100 endobj 3331 0 obj << /Length 3332 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3332 0 obj 88 endobj 3447 0 obj << /Length 3448 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3448 0 obj 87 endobj 2957 0 obj << /Length 2958 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2958 0 obj 87 endobj 3491 0 obj << /Length 3492 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3492 0 obj 87 endobj 2633 0 obj << /Length 2634 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2634 0 obj 88 endobj 3267 0 obj << /Length 3268 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3268 0 obj 50 endobj 3151 0 obj << /Length 3152 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3152 0 obj 88 endobj 2883 0 obj << /Length 2884 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2884 0 obj 87 endobj 3037 0 obj << /Length 3038 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3038 0 obj 87 endobj 3183 0 obj << /Length 3184 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3184 0 obj 87 endobj 2577 0 obj << /Length 2578 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2578 0 obj 87 endobj 2753 0 obj << /Length 2754 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2754 0 obj 87 endobj 2703 0 obj << /Length 2704 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2704 0 obj 87 endobj 3215 0 obj << /Length 3216 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3216 0 obj 88 endobj 2649 0 obj << /Length 2650 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2650 0 obj 50 endobj 2617 0 obj << /Length 2618 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2618 0 obj 88 endobj 3271 0 obj << /Length 3272 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3272 0 obj 87 endobj 2915 0 obj << /Length 2916 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2916 0 obj 87 endobj 2817 0 obj << /Length 2818 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2818 0 obj 50 endobj 3369 0 obj << /Length 3370 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3370 0 obj 87 endobj 3431 0 obj << /Length 3432 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3432 0 obj 87 endobj 2573 0 obj << /Length 2574 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2574 0 obj 50 endobj 2555 0 obj << /Length 2556 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2556 0 obj 100 endobj 3123 0 obj << /Length 3124 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3124 0 obj 87 endobj 3011 0 obj << /Length 3012 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3012 0 obj 87 endobj 3073 0 obj << /Length 3074 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3074 0 obj 87 endobj 2789 0 obj << /Length 2790 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2790 0 obj 87 endobj 2951 0 obj << /Length 2952 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2952 0 obj 88 endobj 2565 0 obj << /Length 2566 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2566 0 obj 87 endobj 2551 0 obj << /Length 2552 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2552 0 obj 87 endobj 3405 0 obj << /Length 3406 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3406 0 obj 88 endobj 2697 0 obj << /Length 2698 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2698 0 obj 87 endobj 3161 0 obj << /Length 3162 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3162 0 obj 87 endobj 2559 0 obj << /Length 2560 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2560 0 obj 50 endobj 2747 0 obj << /Length 2748 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2748 0 obj 88 endobj 3193 0 obj << /Length 3194 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3194 0 obj 87 endobj 2545 0 obj << /Length 2546 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2546 0 obj 87 endobj 3475 0 obj << /Length 3476 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3476 0 obj 87 endobj 2811 0 obj << /Length 2812 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2812 0 obj 87 endobj 2851 0 obj << /Length 2852 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2852 0 obj 88 endobj 3281 0 obj << /Length 3282 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3282 0 obj 87 endobj 3031 0 obj << /Length 3032 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3032 0 obj 87 endobj 3523 0 obj << /Length 3524 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3524 0 obj 88 endobj 3313 0 obj << /Length 3314 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3314 0 obj 88 endobj 3137 0 obj << /Length 3138 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3138 0 obj 87 endobj 2635 0 obj << /Length 2636 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2636 0 obj 50 endobj 3517 0 obj << /Length 3518 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3518 0 obj 88 endobj 2897 0 obj << /Length 2898 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2898 0 obj 88 endobj 2641 0 obj << /Length 2642 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2642 0 obj 88 endobj 3513 0 obj << /Length 3514 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3514 0 obj 87 endobj 3067 0 obj << /Length 3068 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3068 0 obj 88 endobj 2929 0 obj << /Length 2930 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2930 0 obj 87 endobj 2783 0 obj << /Length 2784 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2784 0 obj 87 endobj 3239 0 obj << /Length 3240 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3240 0 obj 87 endobj 2553 0 obj << /Length 2554 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2554 0 obj 87 endobj 3253 0 obj << /Length 3254 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3254 0 obj 87 endobj 3399 0 obj << /Length 3400 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3400 0 obj 87 endobj 2729 0 obj << /Length 2730 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2730 0 obj 88 endobj 2667 0 obj << /Length 2668 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2668 0 obj 88 endobj 3105 0 obj << /Length 3106 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3106 0 obj 87 endobj 2677 0 obj << /Length 2678 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2678 0 obj 50 endobj 3079 0 obj << /Length 3080 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3080 0 obj 87 endobj 2845 0 obj << /Length 2846 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2846 0 obj 88 endobj 2655 0 obj << /Length 2656 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2656 0 obj 87 endobj 2869 0 obj << /Length 2870 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2870 0 obj 50 endobj 3307 0 obj << /Length 3308 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3308 0 obj 87 endobj 2543 0 obj << /Length 2544 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2544 0 obj 87 endobj 2597 0 obj << /Length 2598 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2598 0 obj 87 endobj 2567 0 obj << /Length 2568 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2568 0 obj 87 endobj 3339 0 obj << /Length 3340 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3340 0 obj 87 endobj 3515 0 obj << /Length 3516 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3516 0 obj 87 endobj 2965 0 obj << /Length 2966 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2966 0 obj 87 endobj 2679 0 obj << /Length 2680 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2680 0 obj 100 endobj 2707 0 obj << /Length 2708 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2708 0 obj 88 endobj 2891 0 obj << /Length 2892 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2892 0 obj 87 endobj 3045 0 obj << /Length 3046 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3046 0 obj 87 endobj 2709 0 obj << /Length 2710 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2710 0 obj 88 endobj 3229 0 obj << /Length 3230 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3230 0 obj 88 endobj 2761 0 obj << /Length 2762 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2762 0 obj 88 endobj 2923 0 obj << /Length 2924 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2924 0 obj 87 endobj 3223 0 obj << /Length 3224 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3224 0 obj 50 endobj 3377 0 obj << /Length 3378 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3378 0 obj 88 endobj 2625 0 obj << /Length 2626 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2626 0 obj 87 endobj 2569 0 obj << /Length 2570 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2570 0 obj 50 endobj 3247 0 obj << /Length 3248 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3248 0 obj 87 endobj 3439 0 obj << /Length 3440 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3440 0 obj 87 endobj 3519 0 obj << /Length 3520 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3520 0 obj 88 endobj 2719 0 obj << /Length 2720 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2720 0 obj 87 endobj 3477 0 obj << /Length 3478 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3478 0 obj 100 endobj 2737 0 obj << /Length 2738 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2738 0 obj 50 endobj 2665 0 obj << /Length 2666 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2666 0 obj 87 endobj 3131 0 obj << /Length 3132 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3132 0 obj 50 endobj 2741 0 obj << /Length 2742 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2742 0 obj 87 endobj 3017 0 obj << /Length 3018 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3018 0 obj 88 endobj 2547 0 obj << /Length 2548 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2548 0 obj 87 endobj 2959 0 obj << /Length 2960 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2960 0 obj 87 endobj 3413 0 obj << /Length 3414 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3414 0 obj 87 endobj 3169 0 obj << /Length 3170 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3170 0 obj 87 endobj 3039 0 obj << /Length 3040 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3040 0 obj 87 endobj 3449 0 obj << /Length 3450 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3450 0 obj 87 endobj 2579 0 obj << /Length 2580 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2580 0 obj 87 endobj 3201 0 obj << /Length 3202 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3202 0 obj 87 endobj 3139 0 obj << /Length 3140 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3140 0 obj 87 endobj 2755 0 obj << /Length 2756 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2756 0 obj 87 endobj 3371 0 obj << /Length 3372 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3372 0 obj 88 endobj 3467 0 obj << /Length 3468 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3468 0 obj 87 endobj 3275 0 obj << /Length 3276 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3276 0 obj 87 endobj 3007 0 obj << /Length 3008 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3008 0 obj 50 endobj 3289 0 obj << /Length 3290 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3290 0 obj 50 endobj 2575 0 obj << /Length 2576 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2576 0 obj 100 endobj 2797 0 obj << /Length 2798 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2798 0 obj 88 endobj 3075 0 obj << /Length 3076 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3076 0 obj 50 endobj 2659 0 obj << /Length 2660 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2660 0 obj 87 endobj 2937 0 obj << /Length 2938 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2938 0 obj 88 endobj 3261 0 obj << /Length 3262 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3262 0 obj 88 endobj 3407 0 obj << /Length 3408 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3408 0 obj 87 endobj 2993 0 obj << /Length 2994 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2994 0 obj 50 endobj 3163 0 obj << /Length 3164 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3164 0 obj 87 endobj 2723 0 obj << /Length 2724 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2724 0 obj 87 endobj 3195 0 obj << /Length 3196 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3196 0 obj 87 endobj 2609 0 obj << /Length 2610 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2610 0 obj 88 endobj 2821 0 obj << /Length 2822 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2822 0 obj 100 endobj 3463 0 obj << /Length 3464 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3464 0 obj 100 endobj 3099 0 obj << /Length 3100 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3100 0 obj 87 endobj 3113 0 obj << /Length 3114 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3114 0 obj 50 endobj 2839 0 obj << /Length 2840 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2840 0 obj 87 endobj 3283 0 obj << /Length 3284 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3284 0 obj 100 endobj 2561 0 obj << /Length 2562 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2562 0 obj 88 endobj 3315 0 obj << /Length 3316 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3316 0 obj 50 endobj 3493 0 obj << /Length 3494 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3494 0 obj 88 endobj 3235 0 obj << /Length 3236 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3236 0 obj 87 endobj 2605 0 obj << /Length 2606 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2606 0 obj 88 endobj 2829 0 obj << /Length 2830 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2830 0 obj 88 endobj 2739 0 obj << /Length 2740 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2740 0 obj 87 endobj 3545 0 obj << /Length 3546 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3546 0 obj 88 endobj 2973 0 obj << /Length 2974 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2974 0 obj 50 endobj 2743 0 obj << /Length 2744 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2744 0 obj 87 endobj 2637 0 obj << /Length 2638 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2638 0 obj 100 endobj 2899 0 obj << /Length 2900 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2900 0 obj 50 endobj 3053 0 obj << /Length 3054 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3054 0 obj 88 endobj 2769 0 obj << /Length 2770 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2770 0 obj 87 endobj 2931 0 obj << /Length 2932 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2932 0 obj 87 endobj 3085 0 obj << /Length 3086 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3086 0 obj 88 endobj 3353 0 obj << /Length 3354 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3354 0 obj 87 endobj 3385 0 obj << /Length 3386 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3386 0 obj 88 endobj 3255 0 obj << /Length 3256 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3256 0 obj 88 endobj 2825 0 obj << /Length 2826 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2826 0 obj 87 endobj 2731 0 obj << /Length 2732 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2732 0 obj 50 endobj 3485 0 obj << /Length 3486 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3486 0 obj 87 endobj 2669 0 obj << /Length 2670 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 2670 0 obj 100 endobj 3107 0 obj << /Length 3108 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3108 0 obj 87 endobj 2643 0 obj << /Length 2644 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2644 0 obj 87 endobj 2585 0 obj << /Length 2586 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2586 0 obj 88 endobj 2847 0 obj << /Length 2848 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2848 0 obj 50 endobj 2871 0 obj << /Length 2872 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2872 0 obj 87 endobj 3025 0 obj << /Length 3026 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3026 0 obj 87 endobj 3325 0 obj << /Length 3326 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3326 0 obj 88 endobj 2599 0 obj << /Length 2600 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2600 0 obj 87 endobj 2967 0 obj << /Length 2968 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2968 0 obj 87 endobj 3145 0 obj << /Length 3146 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc```˜´‹HÁ§¿þ©²€Xÿþýý¿G$ÿïÿÿÿ§™AÂÿÿÿ¢ffþû³ÝZ¬1ùß7/°6†¤ÿíøA*€Ì?VP&ßã†<Q~%I6 O˜!ô endstream endobj 3146 0 obj 100 endobj 3421 0 obj << /Length 3422 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3422 0 obj 87 endobj 2861 0 obj << /Length 2862 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2862 0 obj 88 endobj 3177 0 obj << /Length 3178 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3178 0 obj 87 endobj 3319 0 obj << /Length 3320 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3320 0 obj 88 endobj 3047 0 obj << /Length 3048 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3048 0 obj 87 endobj 2711 0 obj << /Length 2712 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2712 0 obj 87 endobj 3209 0 obj << /Length 3210 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3210 0 obj 87 endobj 2909 0 obj << /Length 2910 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2910 0 obj 87 endobj 2763 0 obj << /Length 2764 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2764 0 obj 88 endobj 2589 0 obj << /Length 2590 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2590 0 obj 50 endobj 3379 0 obj << /Length 3380 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3380 0 obj 87 endobj 2593 0 obj << /Length 2594 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2594 0 obj 87 endobj 3425 0 obj << /Length 3426 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3426 0 obj 87 endobj 3457 0 obj << /Length 3458 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3458 0 obj 87 endobj 2721 0 obj << /Length 2722 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2722 0 obj 87 endobj 3479 0 obj << /Length 3480 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3480 0 obj 88 endobj 3531 0 obj << /Length 3532 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3532 0 obj 87 endobj 2823 0 obj << /Length 2824 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2824 0 obj 50 endobj 2873 0 obj << /Length 2874 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2874 0 obj 50 endobj 2877 0 obj << /Length 2878 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2878 0 obj 88 endobj 2857 0 obj << /Length 2858 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 2858 0 obj 50 endobj 3019 0 obj << /Length 3020 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3020 0 obj 88 endobj 3499 0 obj << /Length 3500 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3500 0 obj 87 endobj 2945 0 obj << /Length 2946 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2946 0 obj 87 endobj 2691 0 obj << /Length 2692 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2692 0 obj 87 endobj 3415 0 obj << /Length 3416 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3416 0 obj 87 endobj 2713 0 obj << /Length 2714 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2714 0 obj 87 endobj 3171 0 obj << /Length 3172 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3172 0 obj 88 endobj 3451 0 obj << /Length 3452 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3452 0 obj 87 endobj 3533 0 obj << /Length 3534 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3534 0 obj 87 endobj 3525 0 obj << /Length 3526 0 R /Type /XObject /Subtype /Image /Width 16 /Height 16 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ÿ‘ 2÷¶ # ¿ß€Þ|T÷ôä«d÷#@¶ Ѝð(°» endstream endobj 3526 0 obj 50 endobj 3203 0 obj << /Length 3204 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3204 0 obj 87 endobj 2905 0 obj << /Length 2906 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 2906 0 obj 87 endobj 2805 0 obj << /Length 2806 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 2806 0 obj 88 endobj 3291 0 obj << /Length 3292 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ª”X!þß×c±¬ÿÿØ`Öÿÿ€ìC@1X*Ê wÌ:ä$ÇÀ¢ûÈ>ä­/ÈÀÀ¦÷ÄbÁ¦·ÈI̲Eebå™*R endstream endobj 3292 0 obj 88 endobj 3543 0 obj << /Length 3544 0 R /Type /XObject /Subtype /Image /Width 11 /Height 11 /ColorSpace /DeviceGray /BitsPerComponent 8 /Filter /FlateDecode >> stream xc`@ú×4Y!&oþ¿1a±¬ÿÿß‚Ø`Ö°ø  ìeP}f]u’c`1©½æ­/ÈÀÀT}Õ[_ˆh›É'=0 È•Š:«+« endstream endobj 3544 0 obj 87 endobj 1528 0 obj << /Type /ExtGState /ca 0.3 >> endobj 1529 0 obj << /Type /ExtGState /ca 1 >> endobj 3555 0 obj << /Length 3556 0 R /N 3 /Alternate /DeviceRGB /Filter /FlateDecode >> stream x–wTSهϽ7½Ð" %ôz Ò;HQ‰I€P†„&vDF)VdTÀG‡"cE ƒ‚b× òPÆÁQDEåÝŒk ï­5óÞšýÇYßÙç·×Ùgï}׺Pü‚ÂtX€4¡XîëÁ\ËÄ÷XÀáffGøDÔü½=™™¨HƳöî.€d»Û,¿P&sÖÿ‘"7C$ EÕ6<~&å”S³Å2ÿÊô•)2†12¡ ¢¬"ãįlö§æ+»É˜—&ä¡Yμ4žŒ»PÞš%ᣌ¡\˜%àg£|e½TIšå÷(ÓÓøœL0™_Ìç&¡l‰2Eî‰ò”Ä9¼r‹ù9hžx¦g䊉Ib¦טiåèÈfúñ³Sùb1+”ÃMáˆxLÏô´ Ž0€¯o–E%Ym™h‘í­ííYÖæhù¿Ùß~Sý=ÈzûUñ&ìÏžAŒžYßlì¬/½ö$Z›³¾•U´m@åá¬Oï ò´Þœó†l^’Äâ ' ‹ììlsŸk.+è7ûŸ‚oÊ¿†9÷™ËîûV;¦?#I3eE妧¦KDÌÌ —Ïdý÷ÿãÀ9iÍÉÃ,œŸÀñ…èUQè” „‰h»…Ø A1ØvƒjpÔzÐN‚6p\WÀ p €G@ †ÁK0Þi‚ð¢Aª¤™BÖZyCAP8ÅC‰’@ùÐ&¨*ƒª¡CP=ô#tº]ƒú Ð 4ý}„˜Óa ض€Ù°;GÂËàDxœÀÛáJ¸>·Âáð,…_“@ÈÑFXñDBX$!k‘"¤©Eš¤¹H‘q䇡a˜Æã‡YŒábVaÖbJ0Õ˜c˜VLæ6f3ù‚¥bÕ±¦X'¬?v 6›-ÄV``[°—±Øaì;ÇÀâp~¸\2n5®·׌»€ëà á&ñx¼*Þï‚Ásðb|!¾ ߯¿' Zk‚!– $l$Tçý„Â4Q¨Ot"†yÄ\b)±ŽØA¼I&N“I†$R$)™´TIj"]&=&½!“É:dGrY@^O®$Ÿ _%’?P”(&OJEBÙN9J¹@y@yC¥R ¨nÔXª˜ºZO½D}J}/G“3—ó—ãÉ­“«‘k•ë—{%O”×—w—_.Ÿ'_!Jþ¦ü¸QÁ@ÁS£°V¡Fá´Â=…IEš¢•bˆbšb‰bƒâ5ÅQ%¼’’·O©@é°Ò%¥!BÓ¥yÒ¸´M´:ÚeÚ0G7¤ûÓ“éÅôè½ô e%e[å(ååå³ÊRÂ0`ø3R¥Œ“Œ»Œó4æ¹ÏãÏÛ6¯i^ÿ¼)•ù*n*|•"•f••ªLUoÕÕªmªOÔ0j&jajÙjûÕ.«Ï§ÏwžÏ_4ÿäü‡ê°º‰z¸újõÃê=ꓚ¾U—4Æ5šnšÉšåšç4Ç´hZ µZåZçµ^0•™îÌTf%³‹9¡­®í§-Ñ>¤Ý«=­c¨³Xg£N³Î]’.[7A·\·SwBOK/X/_¯Qï¡>QŸ­Ÿ¤¿G¿[ÊÀÐ Ú`‹A›Á¨¡Š¡¿aža£ác#ª‘«Ñ*£Z£;Æ8c¶qŠñ>ã[&°‰I’IÉMSØÔÞT`ºÏ´Ï kæh&4«5»Ç¢°ÜYY¬FÖ 9Ã<È|£y›ù+ =‹X‹Ý_,í,S-ë,Y)YXm´ê°úÃÚÄšk]c}džjãc³Î¦Ýæµ­©-ßv¿í};š]°Ý»N»Ïöö"û&û1=‡x‡½÷Øtv(»„}Õëèá¸ÎñŒã'{'±ÓI§ßYÎ)ΠΣ ðÔ-rÑqá¸r‘.d.Œ_xp¡ÔUÛ•ãZëúÌM×çvÄmÄÝØ=Ùý¸û+K‘G‹Ç”§“çÏ ^ˆ—¯W‘W¯·’÷bïjï§>:>‰>>¾v¾«}/øaýývúÝó×ðçú×ûO8¬ è ¤FV> 2 uÃÁÁ»‚/Ò_$\ÔBüCv…< 5 ]ús.,4¬&ìy¸Ux~xw-bEDCÄ»HÈÒÈG‹KwFÉGÅEÕGME{E—EK—X,Y³äFŒZŒ ¦={$vr©÷ÒÝK‡ãìâ ãî.3\–³ìÚrµå©ËÏ®_ÁYq*ßÿ‰©åL®ô_¹wåד»‡û’çÆ+çñ]øeü‘—„²„ÑD—Ä]‰cI®IIãOAµàu²_òä©””£)3©Ñ©Íi„´ø´ÓB%aа+]3='½/Ã4£0CºÊiÕîU¢@Ñ‘L(sYf»˜ŽþLõHŒ$›%ƒY ³j²ÞgGeŸÊQÌæôäšänËÉóÉû~5f5wug¾vþ†üÁ5îk­…Ö®\Û¹Nw]Áºáõ¾ëm mHÙðËFËeßnŠÞÔQ Q°¾`h³ïæÆB¹BQá½-Î[lÅllíÝf³­jÛ—"^ÑõbËâŠâO%Ü’ëßY}WùÝÌö„í½¥ö¥ûwàvwÜÝéºóX™bY^ÙЮà]­åÌò¢ò·»Wì¾Va[q`id´2¨²½J¯jGÕ§ê¤êšæ½ê{·íÚÇÛ׿ßmÓÅ>¼È÷Pk­AmÅaÜá¬ÃÏë¢êº¿g_DíHñ‘ÏG…G¥ÇÂuÕ;Ô×7¨7”6’ƱãqÇoýàõC{«éP3£¹ø8!9ñâÇøïž <ÙyŠ}ªé'ýŸö¶ÐZŠZ¡ÖÜÖ‰¶¤6i{L{ßé€ÓÎ-?›ÿ|ôŒö™š³ÊgKϑΜ›9Ÿw~òBÆ…ñ‹‰‡:Wt>º´äÒ®°®ÞË—¯^ñ¹r©Û½ûüU—«g®9];}}½í†ýÖ»ž–_ì~iéµïm½ép³ý–ã­Ž¾}çú]û/Þöº}åŽÿ‹úî.¾{ÿ^Ü=é}ÞýÑ©^?Ìz8ýhýcìã¢' O*žª?­ýÕø×f©½ôì ×`ϳˆg†¸C/ÿ•ù¯OÃÏ©Ï+F´FêG­GÏŒùŒÝz±ôÅðËŒ—Óã…¿)þ¶÷•Ñ«Ÿ~wû½gbÉÄðkÑë™?JÞ¨¾9úÖömçdèäÓwi獵ŠÞ«¾?öý¡ûcôÇ‘éìOøO•Ÿ?w| üòx&mfæß÷„óû endstream endobj 3556 0 obj 2612 endobj 7 0 obj [ /ICCBased 3555 0 R ] endobj 3557 0 obj << /Length 3558 0 R /N 3 /Alternate /DeviceRGB /Filter /FlateDecode >> stream x–wTSهϽ7½Ð" %ôz Ò;HQ‰I€P†„&vDF)VdTÀG‡"cE ƒ‚b× òPÆÁQDEåÝŒk ï­5óÞšýÇYßÙç·×Ùgï}׺Pü‚ÂtX€4¡XîëÁ\ËÄ÷XÀáffGøDÔü½=™™¨HƳöî.€d»Û,¿P&sÖÿ‘"7C$ EÕ6<~&å”S³Å2ÿÊô•)2†12¡ ¢¬"ãįlö§æ+»É˜—&ä¡Yμ4žŒ»PÞš%ᣌ¡\˜%àg£|e½TIšå÷(ÓÓøœL0™_Ìç&¡l‰2Eî‰ò”Ä9¼r‹ù9hžx¦g䊉Ib¦טiåèÈfúñ³Sùb1+”ÃMáˆxLÏô´ Ž0€¯o–E%Ym™h‘í­ííYÖæhù¿Ùß~Sý=ÈzûUñ&ìÏžAŒžYßlì¬/½ö$Z›³¾•U´m@åá¬Oï ò´Þœó†l^’Äâ ' ‹ììlsŸk.+è7ûŸ‚oÊ¿†9÷™ËîûV;¦?#I3eE妧¦KDÌÌ —Ïdý÷ÿãÀ9iÍÉÃ,œŸÀñ…èUQè” „‰h»…Ø A1ØvƒjpÔzÐN‚6p\WÀ p €G@ †ÁK0Þi‚ð¢Aª¤™BÖZyCAP8ÅC‰’@ùÐ&¨*ƒª¡CP=ô#tº]ƒú Ð 4ý}„˜Óa ض€Ù°;GÂËàDxœÀÛáJ¸>·Âáð,…_“@ÈÑFXñDBX$!k‘"¤©Eš¤¹H‘q䇡a˜Æã‡YŒábVaÖbJ0Õ˜c˜VLæ6f3ù‚¥bÕ±¦X'¬?v 6›-ÄV``[°—±Øaì;ÇÀâp~¸\2n5®·׌»€ëà á&ñx¼*Þï‚Ásðb|!¾ ߯¿' Zk‚!– $l$Tçý„Â4Q¨Ot"†yÄ\b)±ŽØA¼I&N“I†$R$)™´TIj"]&=&½!“É:dGrY@^O®$Ÿ _%’?P”(&OJEBÙN9J¹@y@yC¥R ¨nÔXª˜ºZO½D}J}/G“3—ó—ãÉ­“«‘k•ë—{%O”×—w—_.Ÿ'_!Jþ¦ü¸QÁ@ÁS£°V¡Fá´Â=…IEš¢•bˆbšb‰bƒâ5ÅQ%¼’’·O©@é°Ò%¥!BÓ¥yÒ¸´M´:ÚeÚ0G7¤ûÓ“éÅôè½ô e%e[å(ååå³ÊRÂ0`ø3R¥Œ“Œ»Œó4æ¹ÏãÏÛ6¯i^ÿ¼)•ù*n*|•"•f••ªLUoÕÕªmªOÔ0j&jajÙjûÕ.«Ï§ÏwžÏ_4ÿäü‡ê°º‰z¸újõÃê=ꓚ¾U—4Æ5šnšÉšåšç4Ç´hZ µZåZçµ^0•™îÌTf%³‹9¡­®í§-Ñ>¤Ý«=­c¨³Xg£N³Î]’.[7A·\·SwBOK/X/_¯Qï¡>QŸ­Ÿ¤¿G¿[ÊÀÐ Ú`‹A›Á¨¡Š¡¿aža£ác#ª‘«Ñ*£Z£;Æ8c¶qŠñ>ã[&°‰I’IÉMSØÔÞT`ºÏ´Ï kæh&4«5»Ç¢°ÜYY¬FÖ 9Ã<È|£y›ù+ =‹X‹Ý_,í,S-ë,Y)YXm´ê°úÃÚÄšk]c}džjãc³Î¦Ýæµ­©-ßv¿í};š]°Ý»N»Ïöö"û&û1=‡x‡½÷Øtv(»„}Õëèá¸ÎñŒã'{'±ÓI§ßYÎ)ΠΣ ðÔ-rÑqá¸r‘.d.Œ_xp¡ÔUÛ•ãZëúÌM×çvÄmÄÝØ=Ùý¸û+K‘G‹Ç”§“çÏ ^ˆ—¯W‘W¯·’÷bïjï§>:>‰>>¾v¾«}/øaýývúÝó×ðçú×ûO8¬ è ¤FV> 2 uÃÁÁ»‚/Ò_$\ÔBüCv…< 5 ]ús.,4¬&ìy¸Ux~xw-bEDCÄ»HÈÒÈG‹KwFÉGÅEÕGME{E—EK—X,Y³äFŒZŒ ¦={$vr©÷ÒÝK‡ãìâ ãî.3\–³ìÚrµå©ËÏ®_ÁYq*ßÿ‰©åL®ô_¹wåד»‡û’çÆ+çñ]øeü‘—„²„ÑD—Ä]‰cI®IIãOAµàu²_òä©””£)3©Ñ©Íi„´ø´ÓB%aа+]3='½/Ã4£0CºÊiÕîU¢@Ñ‘L(sYf»˜ŽþLõHŒ$›%ƒY ³j²ÞgGeŸÊQÌæôäšänËÉóÉû~5f5wug¾vþ†üÁ5îk­…Ö®\Û¹Nw]Áºáõ¾ëm mHÙðËFËeßnŠÞÔQ Q°¾`h³ïæÆB¹BQá½-Î[lÅllíÝf³­jÛ—"^ÑõbËâŠâO%Ü’ëßY}WùÝÌö„í½¥ö¥ûwàvwÜÝéºóX™bY^ÙЮà]­åÌò¢ò·»Wì¾Va[q`id´2¨²½J¯jGÕ§ê¤êšæ½ê{·íÚÇÛ׿ßmÓÅ>¼È÷Pk­AmÅaÜá¬ÃÏë¢êº¿g_DíHñ‘ÏG…G¥ÇÂuÕ;Ô×7¨7”6’ƱãqÇoýàõC{«éP3£¹ø8!9ñâÇøïž <ÙyŠ}ªé'ýŸö¶ÐZŠZ¡ÖÜÖ‰¶¤6i{L{ßé€ÓÎ-?›ÿ|ôŒö™š³ÊgKϑΜ›9Ÿw~òBÆ…ñ‹‰‡:Wt>º´äÒ®°®ÞË—¯^ñ¹r©Û½ûüU—«g®9];}}½í†ýÖ»ž–_ì~iéµïm½ép³ý–ã­Ž¾}çú]û/Þöº}åŽÿ‹úî.¾{ÿ^Ü=é}ÞýÑ©^?Ìz8ýhýcìã¢' O*žª?­ýÕø×f©½ôì ×`ϳˆg†¸C/ÿ•ù¯OÃÏ©Ï+F´FêG­GÏŒùŒÝz±ôÅðËŒ—Óã…¿)þ¶÷•Ñ«Ÿ~wû½gbÉÄðkÑë™?JÞ¨¾9úÖömçdèäÓwi獵ŠÞ«¾?öý¡ûcôÇ‘éìOøO•Ÿ?w| üòx&mfæß÷„óû endstream endobj 3558 0 obj 2612 endobj 2542 0 obj [ /ICCBased 3557 0 R ] endobj 3 0 obj << /Type /Pages /MediaBox [0 0 612 792] /Count 1 /Kids [ 2 0 R ] >> endobj 3559 0 obj << /Type /Catalog /Pages 3 0 R /Version /1.4 >> endobj 8 0 obj << /Type /Font /Subtype /Type0 /Encoding /Identity-H /DescendantFonts [3560 0 R] /BaseFont /FMNBGT+CairoFont-0-0 >> endobj 3560 0 obj << /Type /Font /Subtype /CIDFontType0 /BaseFont /FMNBGT+CairoFont-0-0 /CIDSystemInfo << /Registry (Adobe) /Ordering (Identity) /Supplement 0 >> /W 3561 0 R /DW 1000 /FontDescriptor 3562 0 R >> endobj 3561 0 obj [ 1 [ 666 500 556 556 333 222 833 556 277 277 556 500 222 556 556 500 722 556 556 277 722 610 666 722 833 666 666 556 277 556 500 500 666 722 722 333 556 556 333 666 556 610 777 500 777 556 556 556 556 722 277 1000 666 500 ] ] endobj 3562 0 obj << /Type /FontDescriptor /FontName /FMNBGT+CairoFont-0-0 /Flags 32 /FontBBox [-32 -253 915 768] /ItalicAngle 0 /Ascent 736 /Descent -221 /CapHeight 654 /StemV 0 /XHeight 490 /MaxWidth 945 /FontFile3 3563 0 R >> endobj 3563 0 obj << /Length 3564 0 R /Subtype /CIDFontType0C /Filter /FlateDecode >> stream xEX |SUºo£R눓÷æ=gÁyŽ;£(²(« ÊRè¥M÷tÉÚ´Y»—–¯@“.é’¦I“¦Mé¾ÐÒ…– ²«¨ˆ Èè(°ô%¯EBBZŒ1!e• ;«tõÙnzÙÈž“˜Îóå’½WÓ ‡¥-­<,ê} ¸ü Û·ÝÓ” îÔ.Ã(Âaì®ó¶A½½ºÑâ†O•fhÍj0kLY#(”2}|>h‹Õ% „Wp›;zv gžÃ뀻Ξ€Ãã'š/!tcW~§ ±’==>s¨â\[â0ŨÈy†)±4¸A”„r7Î’½?¦ /`Ö†z§×Þæ6[Â>Üìµ`Õ^Ày¬¸Œ.„=XLìÆ“ZêŒ&Òª'«&]¡œê4o—üTúí쯢)bwn¾–„N]:Mýh¸’9›{5´4¶Wu# `{^³jskt¶Lp´45zk¡¹ÆgmG¸ˆ#*O8Ô*¬‰¸‹¼Åž& Ü ; ܺÐ×dZT)˜ž«RƒJ““€aÔíX`TîsêVÜ\PfÊ–ˆ Ãt³B r•y'®£n¾_¦ÏOˆ³»˜§­ÙÕR-4²È{8¦l¦dXãÈ(ܼ£ú*ÃÅÍù0´Ëë¥ZÔ—šö€ºPkÔiÁ¨Ë×gÃ]©“飿_â|W§æKnÒ@Â#LôÀ*¶H¼ù‚¡Îšc+ëžêÒzò–cyPƒÖ2 ØÌ+É-ÉÝ ¹{s÷š¤(¯69Áè,ôb; ÷5[EZÞfoSË=BîðQZ¼O>ø=ø!„q?’¤Œ‹!q'ãnÓz¹9þ÷ÿ"û’ò+Òï`óH†ñö%ª³ÔUœê±w¢[LÕ‰cSqtj˜ÃÓäh®om«¥ á NdöGC_´s=> ¸8kmÜ6nÛ¦X%¡¬JNƪÖ7d{׳ç)…or3%îÛžœÌRw¦+Ù±KìlLO‡ôtc®Œ°ÄÛÒ ió!ùi„aìjhê¤ òÜ3JFW¡¡ }ÖÖZu»{ñ()r ÍEú= /Ö—Ja{!KÝ£.4äƒÂhR¡ PY•Õ`îU.OÒ¸¿¶ÂZ*öUc- /×¥­…Ìštr9ìÂÔœ,ä™ ³ö(` åïiçPŸúš‡m§p,§G=G"F’§'æï+/øšûì£àæØiý%p‹%ûÓ­™6¸ä½¦£íØjuׂ§ÖæB +ßže³UU‘Pkì,ºZV£­wv;Ž5ôuù ³m¤Žñ2ÓtîWzU¦Àb¢ÆÂ†œzÈjJ¶EˆÙ£,Ò›Ao.Ðc ¦Zç2AMAc¡§Ž›Ø[ÆCF§ :4ödŒÜ©KJä”0ýË/ⶆÔNué•NÀÇ仩Dî»k’vôîwZ¡ÇÖæqw£µ¶»bʽû=H˜zSw!y ’F·º—"b%ñ³Ç§B%„aì+ü ùèjÝè~\nZ“± Â…à…aÂ}ÔûÐÏq>Âýeü=‰dþ‰;qó4w—ÄУ#öQhî„æÎš1< xÖ<ªhÅÁ”úx„hLÒ+R@žbŽÄõ€[m;›€‹ä/©ËoÐ5ª)óì,þ!Ž-¥ÞaY©*ÜrSjaÂf wÇŽB̨ö,~ø¾ãlïÐûÆ-ïÆÍ÷êÌù¾¢LûŠP¦=þÓÔ§Åü Åý—ò—Ùßïô‚‘ùgðA>àa £oó_Ä…L(»Íb‰Šf1¡ˆä Æ(Z=Pœ¹÷‘Æ#ºÞ$èMj ÇWheºÈd)¤Ä†e‘·-}!¼Áž@ÆßÇÿŸ$³*£<‡‰ËGr;+[àm¨iÇaÀñì®xG`)S‰ü\þw’ÃØUÙüëû#ºÎdW*Êe¤'OÔSÊç®J¸ëÈ&q¨ ËçÒ:¶âbÀ˜üdt ufªZrÆÚl¨ÕU¤í“Âþ'Y™|_Ö3X4Uƺ"@f!+±”T”VBiÕ^Gi q!¬tXß&«]eúr£ G|óWÓ^zW4ퟃ¤þïËSóGêCæ'Dþ†µe쀲vìÆbü·Ø“„RþC-a5*Ê’ , •H.ô¿øLtÃÔ<þuî°Dæ.2„‹ì ¿TÂM£‘jHùCÈ^âdLèF¶L±GéqӯŠ1qBÂWÔpÔÜþ4óÑÈ Ð=¿"€{Oz£ð5CåÌJ=Ô¥µ!œÄ¯kl­–~Ëê±?eþeš¦bÂãg’䯦Á4î&ó‹O‰Aý qÜ n„(sø£²—Œ;A³*g Μ[³Ð»ê£®™¯#‹z/c8§r9-¦NÐ˜Ç BIk©‰Iü£îºï}pŒô½}òKŠÿ@r\ãP‚bþi(ÿ8­ Þ-c›4ø ƽËof—è¯?’}Kb™hF–QÈ>¾[#±D4%÷gƒ3Ï]ìEÇ^»§<í¶nì5õ¤{!½9©–h_ÕDmdæè -,/g|ãƒHãsL8‚,]ØÎ춺Ê:+4Wù,Ä'Oã¤vP C±®¸˜PÖfiHÃ_Q-@Ø‚õ»ÂîƒêÑâsd[JÇDèÇoµ_ª; M«¯â瀟›o(/ƒa4õBÔg”lìy_du6TélJ› ê¥ÕqÖ8°Äò%>aX˜¾²#ãVmzжCxúJrWÅO§òÀ}K;.ºÛ ´0n=G P` ôØâ§÷Ò]7Ì„(aX4Ñi"€ÛHD¾Áa¯‚GWåÂûxDéÝuV)†¨ò2GT¹·¸%¯ -éu»’PfNWA†Ê¸WS·;,œ”†ò·{G±~ÑÞñ/¢_2÷¯;Ö…ða Ådœj ¨ý^2ò‚ݶ6,š/î!ÄŸ†Ïvm|¶^”ÿ oS˜¸¯\„S7?äîEàÀÏãÞ\ÏùwIzN9.âÚLežß=»¼Ö¼LÄÆMJÊ€]êå"»XÚ¸®oô‡‘ŠpOµõœü H¨ØHº3š"­«á9dEs½ÙNÈvfTSplÅ8…j“ bpàöêÝ®$p%uêGº°µÚé—«¶­²¨ æ­VGÄË >5Â@(¸·y¤c7¦} ßü¬éÁ#0täXó‡Ýò;9×ÀŸÚ(y;ñÐúúy@*g\Ý“è†$÷NÛV„õ¸UAËЬÄÇ:Öô„A÷ö“Šëbuê†×ɲAÈ$ë^aÜyþØ«ÈÔg²¤ •Ê1ê0óz¤å½Ô²iÖ]}\Œƒ_žyN»ÒñO^›Ç”w¬2Áñ|©Äž[¯oСb‰J ×çmÏJ€¤Uk’U“àx¶¯ø(|Šì€ºBWc†Æì¶<*eçpÐ톚–ò±½ï€^©ÍR™Ae–1¦4iŒíƒØþ̳ø¿ó® £phtÜØÔwæµi¡z®DÑ–"nÌ^ŘŒÌÍ“V'ž¼n‹vÓ^"­ÝH;ü·p¨Ås êÚ­ÝxðŒiDÙöóæps$®°>Åq±¬ji:¶6kŽö˜| m¦†LÕËe ™Ãq `´%¡& 8÷ƒ¤>·^W— Ä Åmåò@iä\̨ÎÊVšAI ‘¨ÉVŒtí>»i-Ÿ^k¼0pú'&¼g±+×GÀôžc§-ƒÕ‘Þ;:mGi{Lš7²¹$ø&, ô<Ï- Ò:ÐÿV|>ÉÜ­N»¼Þš6ììËiW¹Aí–ÙÈ›PªÑ쳺0eo Ю½ìdõ¨«zÎëøá žÐvï†î˜†(që»5+*>4©|³ Ö%²TÊm€Ô mZA ð³itÄ£A¶ÿMÛ¸‹(…6‰ßQżåŸÏ¾áç‹…íÿ\v›Ÿ+á)b&ó‘=Ä?ÆþÇÿ˜øWx’öž_Òwœïú¿%߯‡˜ÿ–„~oä·ߦ­)Ã9Ì¿övàýñýÔÓ7·o‡Çý‰3HöI«dvŒ:¦ùHg„[6’ÛchΆò¦Hò—flÙœ›SÖé—#,À5®ðÃ1¤:Yv9ùÄ2Vp)|-§.d›6¦ÍYÑ®º„VHhÍñàûŒÖÎ0¾2Ýž ö¬–¼.±Pu4ÔwB•«¼  x•¸­G™$ô×#Æñð0ˆšß˜ýÿiç}à endstream endobj 3564 0 obj 4369 endobj 12 0 obj << /Type /Font /Subtype /Type0 /Encoding /Identity-H /DescendantFonts [3565 0 R] /BaseFont /YTAYDR+CairoFont-1-0 >> endobj 3565 0 obj << /Type /Font /Subtype /CIDFontType0 /BaseFont /YTAYDR+CairoFont-1-0 /CIDSystemInfo << /Registry (Adobe) /Ordering (Identity) /Supplement 0 >> /W 3566 0 R /DW 1000 /FontDescriptor 3567 0 R >> endobj 3566 0 obj [ 1 [ 610 277 556 556 722 333 277 610 610 556 556 389 610 333 610 889 610 277 610 556 610 666 610 722 722 1000 610 666 ] ] endobj 3567 0 obj << /Type /FontDescriptor /FontName /YTAYDR+CairoFont-1-0 /Flags 32 /FontBBox [-32 -249 940 773] /ItalicAngle 0 /Ascent 741 /Descent -217 /CapHeight 658 /StemV 0 /XHeight 494 /MaxWidth 970 /FontFile3 3568 0 R >> endobj 3568 0 obj << /Length 3569 0 R /Subtype /CIDFontType0C /Filter /FlateDecode >> stream xUW lT×/¹aKIú¥F iC‚BB¤QˆB!„¤bK QÁ¦@ð2cãuÆöì»Ç3ãñr½ÏâÙ7gÆ;^c R”&ì ¦i¥´„¨jÓHUËÿæ;Rß·µÕ×¼3Oÿÿ÷î»÷ÜsïÏ-[&ÊÈÈXýv^±¼|w¹L¹éåM/‰2–‰D¢ úÛÄ=É=…+ŸF^úà'³:’^¹n­H´jÇÊç(ˆ W®@ü¨0–¯-ÉÈxhõ®ürqÁ¾ü™²X©‰–Ðuž\:¿˜h­h­0]*òˆÎgô.‘,¹ºtãÒ·–&–m]v,'ùäÆC¯?4ñpÙÃßÁ¡æòȵå/ߺüì ùŠî7V¶âjî>ç劘‘_GöãÏ_×ìÎÏ„üÌÃå»r°ÐUƒ[Òuî#üSHpVLا)ò.J„ÃQ/$½Îa„xA>|xà?c"i÷N9zª =]Üyá()µ'Àªp”b>`¶» "…ˆ´Ç8Š0ˆ)$ ˆÌj¶›Íç¾føut–!,E~˜þà\šN(rif57Í>`=ŒÕA¯:°ÖVÕê ¬†Èê³ ÔU V*ÛuÞjðZŽ0B7&]]AH„¼½“°•¦«9Üêi°ËíÅ`Ìî7:ÁèT¶ÊJPi5 ºªÆP§þI$͓ޡx7œšü8þÂoð¼eB Êx¾È×Ô£ºQºæª;´Ö´×¸j5„ÿ)’Zw»Á õ®OChÕJÜR}‰µá8J|¥I(K†ñà•®ÉsiHF:fÚ`²mþ¬»ØL³¢M箆 ¶×:‰ÄXKÀ §³ƒ€~{‡Ù fçqßk8èÏ Ëc Wõâ(àÙðøð \Ý@¸‚3æ± «ì<Ѷø#©9|67•®“RTך«Ál­± ÐÐfñÙÀg?cþ“.˜Ç4©JHVøJP˜¥ÉÍ/†ü’wõ¯#¼†Bù ÔLà °ÏÐ`ΞdåÜ=çŠçYsÏõ§n€Øy§?­º¨åHv˜Ò]Ë.a¦ô#ÒÞlH \yàÊkÍÇÀšmûàÈËÛrxÿ1%À¬„°?ÀS5ÝÖÞ|éæÞdðä–@œ ‹,Ý@¾¤Ó äU:òÕM¦6´ÕêÓ-Ø‚­­thi|–ì«#ûês<ò¶ö²_] ¤,F†aqg¿“аÜç¬\=3 ½{)þYz‹½C0U³ùÁ”¬ôÑð¾%½¬*G–ÒçF‰àuäR„¥¤Â$” FüŽ º?@¸€¦Ùü©¸ûì·\„I˜"š€œšÓN¨_éæb"Ð?%š2¥Rn„JS™nt³yç oJõ ~x/zsì<Œ¿ØEÃÞ‹i{ÂýsÒüôÌççeýé’h‚JW‚¥­´e”'¹óÃR˺4¹‡±Û]ÈOšvǹõŒ^c)w[FÙsÊ’Ò„A–»¤¥(¯Öi€=®dõéÊx!D˼'ÛÄÐ"o,¢+ω4e zÕ6Åk’iŒ;Cp»œÎ‰^[j(••‰#ïTRbíѱ#ãpäƒÊ›ø à×7'ÏÂé³%n!Làˆm@¿à«édØýlŒðo±~¾ä.¿…ü™ÝBØmTEÞæ½„ÝÏwÒÛH¶°¯-ü+„ßAÃË=ÁÎq£LåC[Ï:bm´aM#رkaN[µ£ séývÂÿDˆ_š°OPÜL¢áDÀ ]±~÷B ×÷ñË¡b…ü-‚Òe»¼¦!„Iì ‡ÁiMa? ìøB`{›Ô××96pØjì¶PkÔfµ46E ÕvÌJ•Æûiüˆ¾|KI*_²C³%L{ƒ;„cî"Ôgø ¹CÇ~‚º‡Ã1ˆôž |†àÂöç÷‡âžaŸabiÏ(Mtœ¶ŒªÒ J—ùÄ,5©d ’YĘ˜éÇd“õšFF±ÇK»ô &ûðžò—¶àžTöȾ¨ºŠ¿¼»:q&>¼–ú©}×Ê'~‡â{q'àåÞìCó>}°jVÊ%™˜5j+Á§õ¨Z+ Y×TÅÐÀÿe1ïŒÖì^¨J(;J °Â`,»¡V êœë 1d¯ì­‹Û}`éRz‹ò±Âlª»©V…4ùO /dÜÿäj*¦¹šŒ¸Ç…3õYzˆèýjO%„zbñ¤ÒþÞö„NŒ×ÆÔ‰*ÅóÜ FÛ# äÍ—B…ö8TË%B)|7˜Ó'‡°1n§É0Œi´"ÝZµ½pÿ[füDlþ p³úíÜcw,S¾!‹<åQ0vƒÆ5¶›ðk©±³úbn'þx ôAOç ‡û[œVŽgÏ;‘–Y U4Æ‚– ¸¨h‡¹Óe‰éC ði\š54«‹ñ8]þòBõô-íˆ[C`îTx  ±Ü¬U€V^]„tùïõm6°‚ÎñNééŒuQ§u¤Ú¨ðöa·#Yµ˜´Ücì_™úˆ=d €1*÷” zYªÐÑVA^[‚bÀü–2—‚9=ªÓ»q§7¾3Öœš‹º<£¤¢rÞÝ/ÝŠð*þ2!™ñ”æ ~A%0vsb &¦>J|.T¾ Æ1ŒKYÎ@µz^ÂW°™x§gXàòTõª ÔI™p¬ãX¼Ø±”a`Yk¹[áì~ÕYÁŒdG,ïsk˜~SR¥eê³5Ÿk"¸ÛrDY ’ƒ;¥ˆpû‚Á>ðÄÚq hæ™”&½ÑåêBKÂnÌìŸñÍeü#àçá«#30<}1ù;¡ˆ×FlóžœÝÌý‹»ËÌ­<¾‰°ÿp áçñᄾ‰gÈÜEr.!Ì3d¡ö‰çKúúÙ1—.ÝîþŠVíUxWrq;ôd²›³ßˆ¤z ªË‚ò‰?á0æªÊr 4Çp·n ì“@¿xL3…0#¡T?øÃÞ”û°´ªš·—¼“y ²Ží–¿†ðnë?xÞ»*½‡ì#TçÖôÿý굅ÞdÕBcÁgÎë|?vµÐíõ'…vgÜØ-óƒÁ)o¡db7Üg’UqA+ü:¯Æ¥—ª¥Ë‹mÅúЕ”+%&è3wj}rð)Ú ð(-K›”MhѺL~êaái©õ×zëÝP©b®’†Ó¶nC ~©3›ö&[¯ þyŠB^ýÉTÃPMÊ2oõ#GË ²ë û¢ðàz2§Yœ -s¾ÿ¿Ï¿¸ÀÑ¿ÍJèa'<­·8w—ŽFŽ¢0g'Üès³›Ù¬œi)qɽHHÇL—0Ýs˜?š\¯«½ ö–z²Ý°3HÞ  É"p¼Oqo~Ÿ™ƒÉñëÑ{·ñ²fFÓ’Ô{Í4]ÖÓR?®í) ¢CÖF¥²ËlJ#( •àN¹G¯¿µ§úŒØHÉŒyTŸRÁxqô˜Ðï“gÍ£¹¿PmAØ„»¢Yã9^q oû5ÿ¿ŸI+… úy#Zuè±ÿi, endstream endobj 3569 0 obj 2820 endobj 3570 0 obj (Mac OS X 10.7.4 Quartz PDFContext) endobj 3571 0 obj (cairo 1.9.1 \(http://cairographics.org\)) endobj 3572 0 obj (D:20120830172844Z00'00') endobj 1 0 obj << /Producer 3570 0 R /Creator 3571 0 R /CreationDate 3572 0 R /ModDate 3572 0 R >> endobj xref 0 3573 0000000000 65535 f 0000647788 00000 n 0000063747 00000 n 0000638508 00000 n 0000000022 00000 n 0000063726 00000 n 0000063860 00000 n 0000635687 00000 n 0000638657 00000 n 0000146734 00000 n 0000147008 00000 n 0000147027 00000 n 0000643969 00000 n 0000153450 00000 n 0000153724 00000 n 0000153743 00000 n 0000196913 00000 n 0000197188 00000 n 0000197207 00000 n 0000241513 00000 n 0000241786 00000 n 0000241805 00000 n 0000112795 00000 n 0000113069 00000 n 0000113088 00000 n 0000215480 00000 n 0000215754 00000 n 0000215773 00000 n 0000105733 00000 n 0000106005 00000 n 0000106024 00000 n 0000223357 00000 n 0000223631 00000 n 0000223650 00000 n 0000158178 00000 n 0000158452 00000 n 0000158471 00000 n 0000236393 00000 n 0000236666 00000 n 0000236685 00000 n 0000101801 00000 n 0000102074 00000 n 0000102093 00000 n 0000174408 00000 n 0000174682 00000 n 0000174701 00000 n 0000163319 00000 n 0000163593 00000 n 0000163612 00000 n 0000107293 00000 n 0000107567 00000 n 0000107586 00000 n 0000267184 00000 n 0000267458 00000 n 0000267477 00000 n 0000084879 00000 n 0000085153 00000 n 0000085172 00000 n 0000138829 00000 n 0000139104 00000 n 0000139123 00000 n 0000234822 00000 n 0000235097 00000 n 0000235116 00000 n 0000136460 00000 n 0000136734 00000 n 0000136753 00000 n 0000113970 00000 n 0000114245 00000 n 0000114264 00000 n 0000209561 00000 n 0000209836 00000 n 0000209855 00000 n 0000171639 00000 n 0000171913 00000 n 0000171932 00000 n 0000232066 00000 n 0000232340 00000 n 0000232359 00000 n 0000130941 00000 n 0000131215 00000 n 0000131234 00000 n 0000080566 00000 n 0000080839 00000 n 0000080858 00000 n 0000220992 00000 n 0000221266 00000 n 0000221285 00000 n 0000257699 00000 n 0000257973 00000 n 0000257992 00000 n 0000194155 00000 n 0000194429 00000 n 0000194448 00000 n 0000248994 00000 n 0000249268 00000 n 0000249287 00000 n 0000154236 00000 n 0000154511 00000 n 0000154530 00000 n 0000225325 00000 n 0000225602 00000 n 0000225622 00000 n 0000130548 00000 n 0000130825 00000 n 0000130845 00000 n 0000135674 00000 n 0000135951 00000 n 0000135971 00000 n 0000185858 00000 n 0000186135 00000 n 0000186155 00000 n 0000136067 00000 n 0000136344 00000 n 0000136364 00000 n 0000132514 00000 n 0000132790 00000 n 0000132810 00000 n 0000214690 00000 n 0000214966 00000 n 0000214986 00000 n 0000242292 00000 n 0000242569 00000 n 0000242589 00000 n 0000146341 00000 n 0000146618 00000 n 0000146638 00000 n 0000135281 00000 n 0000135558 00000 n 0000135578 00000 n 0000254135 00000 n 0000254412 00000 n 0000254432 00000 n 0000123038 00000 n 0000123315 00000 n 0000123335 00000 n 0000212708 00000 n 0000212985 00000 n 0000213005 00000 n 0000149094 00000 n 0000149371 00000 n 0000149391 00000 n 0000153057 00000 n 0000153334 00000 n 0000153354 00000 n 0000108071 00000 n 0000108347 00000 n 0000108367 00000 n 0000089600 00000 n 0000089876 00000 n 0000089896 00000 n 0000132906 00000 n 0000133182 00000 n 0000133202 00000 n 0000251366 00000 n 0000251644 00000 n 0000251664 00000 n 0000071148 00000 n 0000071424 00000 n 0000071444 00000 n 0000219810 00000 n 0000220088 00000 n 0000220108 00000 n 0000237573 00000 n 0000237850 00000 n 0000237870 00000 n 0000203636 00000 n 0000203911 00000 n 0000203931 00000 n 0000245445 00000 n 0000245723 00000 n 0000245743 00000 n 0000233244 00000 n 0000233522 00000 n 0000233542 00000 n 0000121462 00000 n 0000121740 00000 n 0000121760 00000 n 0000073890 00000 n 0000074166 00000 n 0000074186 00000 n 0000248600 00000 n 0000248878 00000 n 0000248898 00000 n 0000144755 00000 n 0000145033 00000 n 0000145053 00000 n 0000180717 00000 n 0000180995 00000 n 0000181015 00000 n 0000218623 00000 n 0000218901 00000 n 0000218921 00000 n 0000141207 00000 n 0000141484 00000 n 0000141504 00000 n 0000270336 00000 n 0000270613 00000 n 0000270633 00000 n 0000217836 00000 n 0000218113 00000 n 0000218133 00000 n 0000189423 00000 n 0000189700 00000 n 0000189720 00000 n 0000084096 00000 n 0000084373 00000 n 0000084393 00000 n 0000207189 00000 n 0000207467 00000 n 0000207487 00000 n 0000129361 00000 n 0000129639 00000 n 0000129659 00000 n 0000166878 00000 n 0000167156 00000 n 0000167176 00000 n 0000088421 00000 n 0000088697 00000 n 0000088717 00000 n 0000229290 00000 n 0000229568 00000 n 0000229588 00000 n 0000074280 00000 n 0000074556 00000 n 0000074576 00000 n 0000141994 00000 n 0000142272 00000 n 0000142292 00000 n 0000106509 00000 n 0000106786 00000 n 0000106806 00000 n 0000136848 00000 n 0000137126 00000 n 0000137146 00000 n 0000088812 00000 n 0000089089 00000 n 0000089109 00000 n 0000224932 00000 n 0000225209 00000 n 0000225229 00000 n 0000115145 00000 n 0000115423 00000 n 0000115443 00000 n 0000255316 00000 n 0000255594 00000 n 0000255614 00000 n 0000182699 00000 n 0000182977 00000 n 0000182997 00000 n 0000269551 00000 n 0000269827 00000 n 0000269847 00000 n 0000077818 00000 n 0000078093 00000 n 0000078113 00000 n 0000177566 00000 n 0000177842 00000 n 0000177862 00000 n 0000106118 00000 n 0000106394 00000 n 0000106414 00000 n 0000195328 00000 n 0000195606 00000 n 0000195626 00000 n 0000256906 00000 n 0000257184 00000 n 0000257204 00000 n 0000179929 00000 n 0000180207 00000 n 0000180227 00000 n 0000117122 00000 n 0000117400 00000 n 0000117420 00000 n 0000244261 00000 n 0000244539 00000 n 0000244559 00000 n 0000179535 00000 n 0000179813 00000 n 0000179833 00000 n 0000113576 00000 n 0000113854 00000 n 0000113874 00000 n 0000254528 00000 n 0000254806 00000 n 0000254826 00000 n 0000175985 00000 n 0000176263 00000 n 0000176283 00000 n 0000117516 00000 n 0000117794 00000 n 0000117814 00000 n 0000223745 00000 n 0000224023 00000 n 0000224043 00000 n 0000170458 00000 n 0000170736 00000 n 0000170756 00000 n 0000178350 00000 n 0000178628 00000 n 0000178648 00000 n 0000246632 00000 n 0000246910 00000 n 0000246930 00000 n 0000170852 00000 n 0000171129 00000 n 0000171149 00000 n 0000091956 00000 n 0000092233 00000 n 0000092253 00000 n 0000233638 00000 n 0000233916 00000 n 0000233936 00000 n 0000097460 00000 n 0000097737 00000 n 0000097757 00000 n 0000156203 00000 n 0000156480 00000 n 0000156500 00000 n 0000126991 00000 n 0000127268 00000 n 0000127288 00000 n 0000265998 00000 n 0000266276 00000 n 0000266296 00000 n 0000089991 00000 n 0000090268 00000 n 0000090288 00000 n 0000231275 00000 n 0000231551 00000 n 0000231571 00000 n 0000155412 00000 n 0000155689 00000 n 0000155709 00000 n 0000090383 00000 n 0000090659 00000 n 0000090679 00000 n 0000216262 00000 n 0000216539 00000 n 0000216559 00000 n 0000122644 00000 n 0000122922 00000 n 0000122942 00000 n 0000071538 00000 n 0000071813 00000 n 0000071833 00000 n 0000232454 00000 n 0000232731 00000 n 0000232751 00000 n 0000090774 00000 n 0000091050 00000 n 0000091070 00000 n 0000084488 00000 n 0000084764 00000 n 0000084784 00000 n 0000217444 00000 n 0000217720 00000 n 0000217740 00000 n 0000147122 00000 n 0000147399 00000 n 0000147419 00000 n 0000075847 00000 n 0000076123 00000 n 0000076143 00000 n 0000209950 00000 n 0000210225 00000 n 0000210245 00000 n 0000114359 00000 n 0000114636 00000 n 0000114656 00000 n 0000076635 00000 n 0000076912 00000 n 0000076932 00000 n 0000199674 00000 n 0000199952 00000 n 0000199972 00000 n 0000128967 00000 n 0000129245 00000 n 0000129265 00000 n 0000259669 00000 n 0000259946 00000 n 0000259966 00000 n 0000192178 00000 n 0000192456 00000 n 0000192476 00000 n 0000120675 00000 n 0000120952 00000 n 0000120972 00000 n 0000227307 00000 n 0000227585 00000 n 0000227605 00000 n 0000180323 00000 n 0000180601 00000 n 0000180621 00000 n 0000118308 00000 n 0000118586 00000 n 0000118606 00000 n 0000245051 00000 n 0000245329 00000 n 0000245349 00000 n 0000181111 00000 n 0000181388 00000 n 0000181408 00000 n 0000102975 00000 n 0000103252 00000 n 0000103272 00000 n 0000245839 00000 n 0000246117 00000 n 0000246137 00000 n 0000165698 00000 n 0000165976 00000 n 0000165996 00000 n 0000102584 00000 n 0000102860 00000 n 0000102880 00000 n 0000228499 00000 n 0000228776 00000 n 0000228796 00000 n 0000166485 00000 n 0000166762 00000 n 0000166782 00000 n 0000145149 00000 n 0000145427 00000 n 0000145447 00000 n 0000209167 00000 n 0000209445 00000 n 0000209465 00000 n 0000075060 00000 n 0000075335 00000 n 0000075355 00000 n 0000106901 00000 n 0000107178 00000 n 0000107198 00000 n 0000220204 00000 n 0000220482 00000 n 0000220502 00000 n 0000143176 00000 n 0000143454 00000 n 0000143474 00000 n 0000081342 00000 n 0000081619 00000 n 0000081639 00000 n 0000206796 00000 n 0000207073 00000 n 0000207093 00000 n 0000104156 00000 n 0000104433 00000 n 0000104453 00000 n 0000142782 00000 n 0000143060 00000 n 0000143080 00000 n 0000189029 00000 n 0000189307 00000 n 0000189327 00000 n 0000140414 00000 n 0000140692 00000 n 0000140712 00000 n 0000265207 00000 n 0000265485 00000 n 0000265505 00000 n 0000189816 00000 n 0000190094 00000 n 0000190114 00000 n 0000127384 00000 n 0000127662 00000 n 0000127682 00000 n 0000253349 00000 n 0000253627 00000 n 0000253647 00000 n 0000190997 00000 n 0000191275 00000 n 0000191295 00000 n 0000092348 00000 n 0000092625 00000 n 0000092645 00000 n 0000234431 00000 n 0000234706 00000 n 0000234726 00000 n 0000177958 00000 n 0000178234 00000 n 0000178254 00000 n 0000116730 00000 n 0000117006 00000 n 0000117026 00000 n 0000242685 00000 n 0000242961 00000 n 0000242981 00000 n 0000178744 00000 n 0000179020 00000 n 0000179040 00000 n 0000098641 00000 n 0000098915 00000 n 0000098935 00000 n 0000243471 00000 n 0000243747 00000 n 0000243767 00000 n 0000162528 00000 n 0000162804 00000 n 0000162824 00000 n 0000103367 00000 n 0000103644 00000 n 0000103664 00000 n 0000212314 00000 n 0000212592 00000 n 0000212612 00000 n 0000087236 00000 n 0000087513 00000 n 0000087533 00000 n 0000078599 00000 n 0000078876 00000 n 0000078896 00000 n 0000220598 00000 n 0000220876 00000 n 0000220896 00000 n 0000156989 00000 n 0000157267 00000 n 0000157287 00000 n 0000081734 00000 n 0000082011 00000 n 0000082031 00000 n 0000215868 00000 n 0000216146 00000 n 0000216166 00000 n 0000119887 00000 n 0000120165 00000 n 0000120185 00000 n 0000071927 00000 n 0000072203 00000 n 0000072223 00000 n 0000210734 00000 n 0000211012 00000 n 0000211032 00000 n 0000131329 00000 n 0000131607 00000 n 0000131627 00000 n 0000269943 00000 n 0000270220 00000 n 0000270240 00000 n 0000194543 00000 n 0000194821 00000 n 0000194841 00000 n 0000132120 00000 n 0000132398 00000 n 0000132418 00000 n 0000258087 00000 n 0000258364 00000 n 0000258384 00000 n 0000194937 00000 n 0000195212 00000 n 0000195232 00000 n 0000119096 00000 n 0000119372 00000 n 0000119392 00000 n 0000258878 00000 n 0000259154 00000 n 0000259174 00000 n 0000241900 00000 n 0000242176 00000 n 0000242196 00000 n 0000191784 00000 n 0000192062 00000 n 0000192082 00000 n 0000166092 00000 n 0000166369 00000 n 0000166389 00000 n 0000198489 00000 n 0000198766 00000 n 0000198786 00000 n 0000110033 00000 n 0000110310 00000 n 0000110330 00000 n 0000237179 00000 n 0000237457 00000 n 0000237477 00000 n 0000172823 00000 n 0000173101 00000 n 0000173121 00000 n 0000093924 00000 n 0000094201 00000 n 0000094221 00000 n 0000240333 00000 n 0000240611 00000 n 0000240631 00000 n 0000143570 00000 n 0000143846 00000 n 0000143866 00000 n 0000235211 00000 n 0000235487 00000 n 0000235507 00000 n 0000226914 00000 n 0000227191 00000 n 0000227211 00000 n 0000149886 00000 n 0000150163 00000 n 0000150183 00000 n 0000086450 00000 n 0000086724 00000 n 0000086744 00000 n 0000213500 00000 n 0000213776 00000 n 0000213796 00000 n 0000150279 00000 n 0000150555 00000 n 0000150575 00000 n 0000073502 00000 n 0000073776 00000 n 0000073796 00000 n 0000190603 00000 n 0000190881 00000 n 0000190901 00000 n 0000111224 00000 n 0000111502 00000 n 0000111522 00000 n 0000249382 00000 n 0000249660 00000 n 0000249680 00000 n 0000197701 00000 n 0000197979 00000 n 0000197999 00000 n 0000134488 00000 n 0000134766 00000 n 0000134786 00000 n 0000260062 00000 n 0000260340 00000 n 0000260360 00000 n 0000198095 00000 n 0000198373 00000 n 0000198393 00000 n 0000121856 00000 n 0000122134 00000 n 0000122154 00000 n 0000260456 00000 n 0000260734 00000 n 0000260754 00000 n 0000198882 00000 n 0000199159 00000 n 0000199179 00000 n 0000122250 00000 n 0000122528 00000 n 0000122548 00000 n 0000260850 00000 n 0000261128 00000 n 0000261148 00000 n 0000185070 00000 n 0000185348 00000 n 0000185368 00000 n 0000121068 00000 n 0000121346 00000 n 0000121366 00000 n 0000113183 00000 n 0000113460 00000 n 0000113480 00000 n 0000175592 00000 n 0000175869 00000 n 0000175889 00000 n 0000114752 00000 n 0000115029 00000 n 0000115049 00000 n 0000240727 00000 n 0000241004 00000 n 0000241024 00000 n 0000176379 00000 n 0000176657 00000 n 0000176677 00000 n 0000096676 00000 n 0000096953 00000 n 0000096973 00000 n 0000241120 00000 n 0000241397 00000 n 0000241417 00000 n 0000160154 00000 n 0000160432 00000 n 0000160452 00000 n 0000097068 00000 n 0000097345 00000 n 0000097365 00000 n 0000224538 00000 n 0000224816 00000 n 0000224836 00000 n 0000160548 00000 n 0000160826 00000 n 0000160846 00000 n 0000115938 00000 n 0000116216 00000 n 0000116236 00000 n 0000211527 00000 n 0000211805 00000 n 0000211825 00000 n 0000130154 00000 n 0000130432 00000 n 0000130452 00000 n 0000079782 00000 n 0000080059 00000 n 0000080079 00000 n 0000219017 00000 n 0000219295 00000 n 0000219315 00000 n 0000141600 00000 n 0000141878 00000 n 0000141898 00000 n 0000080174 00000 n 0000080451 00000 n 0000080471 00000 n 0000205610 00000 n 0000205888 00000 n 0000205908 00000 n 0000142388 00000 n 0000142666 00000 n 0000142686 00000 n 0000266790 00000 n 0000267068 00000 n 0000267088 00000 n 0000206004 00000 n 0000206282 00000 n 0000206302 00000 n 0000128573 00000 n 0000128851 00000 n 0000128871 00000 n 0000235603 00000 n 0000235880 00000 n 0000235900 00000 n 0000185464 00000 n 0000185742 00000 n 0000185762 00000 n 0000204027 00000 n 0000204305 00000 n 0000204325 00000 n 0000261244 00000 n 0000261522 00000 n 0000261542 00000 n 0000186251 00000 n 0000186529 00000 n 0000186549 00000 n 0000123824 00000 n 0000124102 00000 n 0000124122 00000 n 0000247419 00000 n 0000247697 00000 n 0000247717 00000 n 0000186645 00000 n 0000186923 00000 n 0000186943 00000 n 0000108462 00000 n 0000108737 00000 n 0000108757 00000 n 0000248206 00000 n 0000248484 00000 n 0000248504 00000 n 0000171245 00000 n 0000171523 00000 n 0000171543 00000 n 0000108852 00000 n 0000109129 00000 n 0000109149 00000 n 0000177172 00000 n 0000177450 00000 n 0000177470 00000 n 0000254922 00000 n 0000255200 00000 n 0000255220 00000 n 0000218229 00000 n 0000218507 00000 n 0000218527 00000 n 0000230881 00000 n 0000231159 00000 n 0000231179 00000 n 0000155018 00000 n 0000155296 00000 n 0000155316 00000 n 0000222963 00000 n 0000223241 00000 n 0000223261 00000 n 0000200860 00000 n 0000201137 00000 n 0000201157 00000 n 0000151467 00000 n 0000151745 00000 n 0000151765 00000 n 0000082918 00000 n 0000083193 00000 n 0000083213 00000 n 0000211921 00000 n 0000212198 00000 n 0000212218 00000 n 0000148302 00000 n 0000148579 00000 n 0000148599 00000 n 0000217052 00000 n 0000217328 00000 n 0000217348 00000 n 0000193364 00000 n 0000193640 00000 n 0000193660 00000 n 0000078208 00000 n 0000078484 00000 n 0000078504 00000 n 0000094316 00000 n 0000094591 00000 n 0000094611 00000 n 0000192572 00000 n 0000192849 00000 n 0000192869 00000 n 0000138436 00000 n 0000138713 00000 n 0000138733 00000 n 0000261638 00000 n 0000261915 00000 n 0000261935 00000 n 0000202051 00000 n 0000202329 00000 n 0000202349 00000 n 0000107680 00000 n 0000107956 00000 n 0000107976 00000 n 0000264021 00000 n 0000264299 00000 n 0000264319 00000 n 0000183093 00000 n 0000183371 00000 n 0000183391 00000 n 0000120281 00000 n 0000120559 00000 n 0000120579 00000 n 0000247026 00000 n 0000247303 00000 n 0000247323 00000 n 0000183881 00000 n 0000184159 00000 n 0000184179 00000 n 0000105341 00000 n 0000105618 00000 n 0000105638 00000 n 0000207583 00000 n 0000207860 00000 n 0000207880 00000 n 0000154625 00000 n 0000154902 00000 n 0000154922 00000 n 0000112011 00000 n 0000112288 00000 n 0000112308 00000 n 0000237966 00000 n 0000238243 00000 n 0000238263 00000 n 0000174015 00000 n 0000174292 00000 n 0000174312 00000 n 0000095495 00000 n 0000095771 00000 n 0000095791 00000 n 0000238753 00000 n 0000239030 00000 n 0000239050 00000 n 0000158566 00000 n 0000158843 00000 n 0000158863 00000 n 0000097852 00000 n 0000098129 00000 n 0000098149 00000 n 0000208774 00000 n 0000209051 00000 n 0000209071 00000 n 0000222570 00000 n 0000222847 00000 n 0000222867 00000 n 0000269158 00000 n 0000269435 00000 n 0000269455 00000 n 0000221380 00000 n 0000221657 00000 n 0000221677 00000 n 0000156596 00000 n 0000156873 00000 n 0000156893 00000 n 0000080952 00000 n 0000081227 00000 n 0000081247 00000 n 0000074670 00000 n 0000074945 00000 n 0000074965 00000 n 0000123431 00000 n 0000123708 00000 n 0000123728 00000 n 0000247813 00000 n 0000248090 00000 n 0000248110 00000 n 0000202445 00000 n 0000202722 00000 n 0000202742 00000 n 0000126205 00000 n 0000126482 00000 n 0000126502 00000 n 0000264814 00000 n 0000265091 00000 n 0000265111 00000 n 0000191391 00000 n 0000191668 00000 n 0000191688 00000 n 0000126598 00000 n 0000126875 00000 n 0000126895 00000 n 0000252956 00000 n 0000253233 00000 n 0000253253 00000 n 0000190210 00000 n 0000190487 00000 n 0000190507 00000 n 0000111618 00000 n 0000111895 00000 n 0000111915 00000 n 0000253743 00000 n 0000254019 00000 n 0000254039 00000 n 0000118702 00000 n 0000118980 00000 n 0000119000 00000 n 0000092740 00000 n 0000093017 00000 n 0000093037 00000 n 0000160942 00000 n 0000161220 00000 n 0000161240 00000 n 0000195722 00000 n 0000195999 00000 n 0000196019 00000 n 0000112404 00000 n 0000112679 00000 n 0000112699 00000 n 0000243077 00000 n 0000243355 00000 n 0000243375 00000 n 0000162134 00000 n 0000162412 00000 n 0000162432 00000 n 0000099030 00000 n 0000099307 00000 n 0000099327 00000 n 0000169665 00000 n 0000169943 00000 n 0000169963 00000 n 0000239146 00000 n 0000239424 00000 n 0000239444 00000 n 0000267572 00000 n 0000267850 00000 n 0000267870 00000 n 0000133298 00000 n 0000133576 00000 n 0000133596 00000 n 0000147515 00000 n 0000147793 00000 n 0000147813 00000 n 0000083308 00000 n 0000083584 00000 n 0000083604 00000 n 0000210341 00000 n 0000210618 00000 n 0000210638 00000 n 0000147909 00000 n 0000148186 00000 n 0000148206 00000 n 0000086059 00000 n 0000086335 00000 n 0000086355 00000 n 0000183487 00000 n 0000183765 00000 n 0000183785 00000 n 0000144361 00000 n 0000144639 00000 n 0000144659 00000 n 0000268365 00000 n 0000268643 00000 n 0000268663 00000 n 0000200466 00000 n 0000200744 00000 n 0000200764 00000 n 0000124218 00000 n 0000124495 00000 n 0000124515 00000 n 0000262430 00000 n 0000262708 00000 n 0000262728 00000 n 0000204421 00000 n 0000204699 00000 n 0000204719 00000 n 0000095103 00000 n 0000095380 00000 n 0000095400 00000 n 0000238359 00000 n 0000238637 00000 n 0000238657 00000 n 0000187039 00000 n 0000187317 00000 n 0000187337 00000 n 0000109244 00000 n 0000109521 00000 n 0000109541 00000 n 0000250175 00000 n 0000250452 00000 n 0000250472 00000 n 0000172027 00000 n 0000172308 00000 n 0000172329 00000 n 0000109636 00000 n 0000109916 00000 n 0000109937 00000 n 0000236780 00000 n 0000237061 00000 n 0000237082 00000 n 0000172426 00000 n 0000172705 00000 n 0000172726 00000 n 0000093529 00000 n 0000093807 00000 n 0000093828 00000 n 0000235996 00000 n 0000236275 00000 n 0000236296 00000 n 0000128175 00000 n 0000128455 00000 n 0000128476 00000 n 0000167272 00000 n 0000167553 00000 n 0000167574 00000 n 0000226117 00000 n 0000226398 00000 n 0000226419 00000 n 0000149487 00000 n 0000149768 00000 n 0000149789 00000 n 0000085662 00000 n 0000085942 00000 n 0000085963 00000 n 0000213101 00000 n 0000213382 00000 n 0000213403 00000 n 0000150671 00000 n 0000150952 00000 n 0000150973 00000 n 0000073107 00000 n 0000073386 00000 n 0000073407 00000 n 0000213892 00000 n 0000214173 00000 n 0000214194 00000 n 0000134089 00000 n 0000134370 00000 n 0000134391 00000 n 0000148695 00000 n 0000148976 00000 n 0000148997 00000 n 0000115539 00000 n 0000115820 00000 n 0000115841 00000 n 0000262031 00000 n 0000262312 00000 n 0000262333 00000 n 0000169266 00000 n 0000169547 00000 n 0000169568 00000 n 0000119488 00000 n 0000119769 00000 n 0000119790 00000 n 0000258480 00000 n 0000258760 00000 n 0000258781 00000 n 0000181504 00000 n 0000181785 00000 n 0000181806 00000 n 0000102187 00000 n 0000102467 00000 n 0000102488 00000 n 0000205211 00000 n 0000205492 00000 n 0000205513 00000 n 0000151861 00000 n 0000152141 00000 n 0000152162 00000 n 0000088025 00000 n 0000088304 00000 n 0000088325 00000 n 0000231667 00000 n 0000231948 00000 n 0000231969 00000 n 0000170059 00000 n 0000170340 00000 n 0000170361 00000 n 0000091165 00000 n 0000091443 00000 n 0000091464 00000 n 0000232847 00000 n 0000233126 00000 n 0000233147 00000 n 0000155805 00000 n 0000156085 00000 n 0000156106 00000 n 0000091560 00000 n 0000091839 00000 n 0000091860 00000 n 0000159755 00000 n 0000160036 00000 n 0000160057 00000 n 0000138038 00000 n 0000138318 00000 n 0000138339 00000 n 0000089204 00000 n 0000089483 00000 n 0000089504 00000 n 0000215082 00000 n 0000215362 00000 n 0000215383 00000 n 0000137242 00000 n 0000137522 00000 n 0000137543 00000 n 0000077027 00000 n 0000077305 00000 n 0000077326 00000 n 0000200068 00000 n 0000200348 00000 n 0000200369 00000 n 0000137640 00000 n 0000137920 00000 n 0000137941 00000 n 0000079388 00000 n 0000079665 00000 n 0000079686 00000 n 0000173616 00000 n 0000173897 00000 n 0000173918 00000 n 0000129755 00000 n 0000130036 00000 n 0000130057 00000 n 0000256108 00000 n 0000256389 00000 n 0000256410 00000 n 0000192965 00000 n 0000193246 00000 n 0000193267 00000 n 0000116332 00000 n 0000116612 00000 n 0000116633 00000 n 0000256507 00000 n 0000256788 00000 n 0000256809 00000 n 0000255710 00000 n 0000255990 00000 n 0000256011 00000 n 0000093132 00000 n 0000093412 00000 n 0000093433 00000 n 0000161735 00000 n 0000162016 00000 n 0000162037 00000 n 0000179136 00000 n 0000179417 00000 n 0000179438 00000 n 0000098244 00000 n 0000098524 00000 n 0000098545 00000 n 0000243863 00000 n 0000244143 00000 n 0000244164 00000 n 0000162920 00000 n 0000163201 00000 n 0000163222 00000 n 0000099422 00000 n 0000099702 00000 n 0000099723 00000 n 0000225718 00000 n 0000225999 00000 n 0000226020 00000 n 0000163707 00000 n 0000163987 00000 n 0000164008 00000 n 0000085266 00000 n 0000085545 00000 n 0000085566 00000 n 0000226516 00000 n 0000226796 00000 n 0000226817 00000 n 0000201652 00000 n 0000201933 00000 n 0000201954 00000 n 0000267966 00000 n 0000268247 00000 n 0000268268 00000 n 0000133692 00000 n 0000133971 00000 n 0000133992 00000 n 0000168469 00000 n 0000168750 00000 n 0000168771 00000 n 0000078991 00000 n 0000079271 00000 n 0000079292 00000 n 0000203237 00000 n 0000203518 00000 n 0000203539 00000 n 0000140808 00000 n 0000141089 00000 n 0000141110 00000 n 0000266392 00000 n 0000266672 00000 n 0000266693 00000 n 0000165299 00000 n 0000165580 00000 n 0000165601 00000 n 0000202838 00000 n 0000203119 00000 n 0000203140 00000 n 0000249776 00000 n 0000250057 00000 n 0000250078 00000 n 0000201253 00000 n 0000201534 00000 n 0000201555 00000 n 0000125008 00000 n 0000125289 00000 n 0000125310 00000 n 0000250568 00000 n 0000250849 00000 n 0000250870 00000 n 0000187832 00000 n 0000188113 00000 n 0000188134 00000 n 0000110426 00000 n 0000110707 00000 n 0000110728 00000 n 0000250967 00000 n 0000251248 00000 n 0000251269 00000 n 0000152658 00000 n 0000152939 00000 n 0000152960 00000 n 0000164105 00000 n 0000164383 00000 n 0000164404 00000 n 0000184673 00000 n 0000184952 00000 n 0000184973 00000 n 0000239540 00000 n 0000239819 00000 n 0000239840 00000 n 0000159358 00000 n 0000159637 00000 n 0000159658 00000 n 0000095886 00000 n 0000096164 00000 n 0000096185 00000 n 0000239937 00000 n 0000240215 00000 n 0000240236 00000 n 0000175195 00000 n 0000175474 00000 n 0000175495 00000 n 0000096281 00000 n 0000096559 00000 n 0000096580 00000 n 0000167671 00000 n 0000167952 00000 n 0000167973 00000 n 0000153838 00000 n 0000154118 00000 n 0000154139 00000 n 0000224139 00000 n 0000224420 00000 n 0000224441 00000 n 0000196514 00000 n 0000196795 00000 n 0000196816 00000 n 0000139218 00000 n 0000139499 00000 n 0000139520 00000 n 0000076238 00000 n 0000076518 00000 n 0000076539 00000 n 0000143962 00000 n 0000144243 00000 n 0000144264 00000 n 0000234032 00000 n 0000234313 00000 n 0000234334 00000 n 0000072712 00000 n 0000072991 00000 n 0000073012 00000 n 0000072317 00000 n 0000072596 00000 n 0000072617 00000 n 0000083699 00000 n 0000083979 00000 n 0000084000 00000 n 0000197302 00000 n 0000197583 00000 n 0000197604 00000 n 0000140016 00000 n 0000140296 00000 n 0000140317 00000 n 0000264415 00000 n 0000264696 00000 n 0000264717 00000 n 0000193756 00000 n 0000194037 00000 n 0000194058 00000 n 0000117910 00000 n 0000118190 00000 n 0000118211 00000 n 0000204815 00000 n 0000205093 00000 n 0000205114 00000 n 0000127778 00000 n 0000128057 00000 n 0000128078 00000 n 0000265601 00000 n 0000265880 00000 n 0000265901 00000 n 0000131723 00000 n 0000132002 00000 n 0000132023 00000 n 0000211128 00000 n 0000211409 00000 n 0000211430 00000 n 0000168868 00000 n 0000169148 00000 n 0000169169 00000 n 0000228892 00000 n 0000229172 00000 n 0000229193 00000 n 0000206398 00000 n 0000206678 00000 n 0000206699 00000 n 0000139617 00000 n 0000139898 00000 n 0000139919 00000 n 0000262824 00000 n 0000263105 00000 n 0000263126 00000 n 0000161336 00000 n 0000161617 00000 n 0000161638 00000 n 0000230482 00000 n 0000230763 00000 n 0000230784 00000 n 0000124611 00000 n 0000124890 00000 n 0000124911 00000 n 0000216655 00000 n 0000216934 00000 n 0000216955 00000 n 0000184275 00000 n 0000184555 00000 n 0000184576 00000 n 0000099819 00000 n 0000100098 00000 n 0000100119 00000 n 0000244655 00000 n 0000244933 00000 n 0000244954 00000 n 0000181903 00000 n 0000182182 00000 n 0000182203 00000 n 0000101009 00000 n 0000101287 00000 n 0000101308 00000 n 0000157383 00000 n 0000157662 00000 n 0000157683 00000 n 0000176773 00000 n 0000177054 00000 n 0000177075 00000 n 0000101404 00000 n 0000101684 00000 n 0000101705 00000 n 0000259270 00000 n 0000259551 00000 n 0000259572 00000 n 0000182300 00000 n 0000182581 00000 n 0000182602 00000 n 0000103759 00000 n 0000104039 00000 n 0000104060 00000 n 0000246233 00000 n 0000246514 00000 n 0000246535 00000 n 0000263223 00000 n 0000263504 00000 n 0000263525 00000 n 0000187433 00000 n 0000187714 00000 n 0000187735 00000 n 0000168070 00000 n 0000168351 00000 n 0000168372 00000 n 0000104548 00000 n 0000104827 00000 n 0000104848 00000 n 0000229684 00000 n 0000229965 00000 n 0000229986 00000 n 0000104944 00000 n 0000105224 00000 n 0000105245 00000 n 0000230083 00000 n 0000230364 00000 n 0000230385 00000 n 0000094706 00000 n 0000094986 00000 n 0000095007 00000 n 0000077422 00000 n 0000077701 00000 n 0000077722 00000 n 0000221773 00000 n 0000222053 00000 n 0000222074 00000 n 0000157780 00000 n 0000158060 00000 n 0000158081 00000 n 0000082126 00000 n 0000082405 00000 n 0000082426 00000 n 0000222171 00000 n 0000222452 00000 n 0000222473 00000 n 0000145543 00000 n 0000145824 00000 n 0000145845 00000 n 0000082522 00000 n 0000082801 00000 n 0000082822 00000 n 0000207976 00000 n 0000208257 00000 n 0000208278 00000 n 0000145942 00000 n 0000146223 00000 n 0000146244 00000 n 0000268759 00000 n 0000269040 00000 n 0000269061 00000 n 0000208375 00000 n 0000208656 00000 n 0000208677 00000 n 0000158959 00000 n 0000159240 00000 n 0000159261 00000 n 0000257300 00000 n 0000257581 00000 n 0000257602 00000 n 0000174796 00000 n 0000175077 00000 n 0000175098 00000 n 0000125407 00000 n 0000125688 00000 n 0000125709 00000 n 0000263622 00000 n 0000263903 00000 n 0000263924 00000 n 0000188231 00000 n 0000188512 00000 n 0000188533 00000 n 0000125806 00000 n 0000126087 00000 n 0000126108 00000 n 0000252158 00000 n 0000252439 00000 n 0000252460 00000 n 0000188630 00000 n 0000188911 00000 n 0000188932 00000 n 0000110825 00000 n 0000111106 00000 n 0000111127 00000 n 0000252557 00000 n 0000252838 00000 n 0000252859 00000 n 0000173217 00000 n 0000173498 00000 n 0000173519 00000 n 0000251760 00000 n 0000252040 00000 n 0000252061 00000 n 0000100215 00000 n 0000100495 00000 n 0000100516 00000 n 0000164501 00000 n 0000164782 00000 n 0000164803 00000 n 0000100612 00000 n 0000100892 00000 n 0000100913 00000 n 0000227701 00000 n 0000227982 00000 n 0000228003 00000 n 0000164900 00000 n 0000165181 00000 n 0000165202 00000 n 0000086839 00000 n 0000087119 00000 n 0000087140 00000 n 0000228100 00000 n 0000228381 00000 n 0000228402 00000 n 0000151070 00000 n 0000151349 00000 n 0000151370 00000 n 0000087628 00000 n 0000087908 00000 n 0000087929 00000 n 0000214291 00000 n 0000214572 00000 n 0000214593 00000 n 0000152259 00000 n 0000152540 00000 n 0000152561 00000 n 0000219411 00000 n 0000219692 00000 n 0000219713 00000 n 0000196115 00000 n 0000196396 00000 n 0000196417 00000 n 0000134882 00000 n 0000135163 00000 n 0000135184 00000 n 0000075450 00000 n 0000075730 00000 n 0000075751 00000 n 0000199275 00000 n 0000199556 00000 n 0000199577 00000 n 0000632849 00000 n 0000632898 00000 n 0000489293 00000 n 0000489681 00000 n 0000337017 00000 n 0000337395 00000 n 0000447223 00000 n 0000447611 00000 n 0000351973 00000 n 0000352361 00000 n 0000274528 00000 n 0000274916 00000 n 0000380660 00000 n 0000381020 00000 n 0000488119 00000 n 0000488479 00000 n 0000289552 00000 n 0000290255 00000 n 0000301364 00000 n 0000302067 00000 n 0000285255 00000 n 0000285958 00000 n 0000279429 00000 n 0000280132 00000 n 0000387284 00000 n 0000387666 00000 n 0000355485 00000 n 0000355845 00000 n 0000451144 00000 n 0000451504 00000 n 0000340080 00000 n 0000340468 00000 n 0000446459 00000 n 0000446819 00000 n 0000336607 00000 n 0000336995 00000 n 0000443071 00000 n 0000443431 00000 n 0000333201 00000 n 0000333579 00000 n 0000425245 00000 n 0000425605 00000 n 0000346530 00000 n 0000346918 00000 n 0000461672 00000 n 0000462375 00000 n 0000282845 00000 n 0000283233 00000 n 0000389615 00000 n 0000389975 00000 n 0000278665 00000 n 0000279025 00000 n 0000385710 00000 n 0000386070 00000 n 0000270729 00000 n 0000271089 00000 n 0000378401 00000 n 0000378761 00000 n 0000485523 00000 n 0000485883 00000 n 0000373839 00000 n 0000374199 00000 n 0000480382 00000 n 0000480760 00000 n 0000370451 00000 n 0000370811 00000 n 0000476584 00000 n 0000476972 00000 n 0000452290 00000 n 0000452678 00000 n 0000391132 00000 n 0000391520 00000 n 0000280536 00000 n 0000280924 00000 n 0000388098 00000 n 0000388458 00000 n 0000275663 00000 n 0000276029 00000 n 0000484388 00000 n 0000485091 00000 n 0000373047 00000 n 0000373407 00000 n 0000480782 00000 n 0000481142 00000 n 0000370041 00000 n 0000370429 00000 n 0000476994 00000 n 0000477354 00000 n 0000367799 00000 n 0000368187 00000 n 0000473084 00000 n 0000473444 00000 n 0000359771 00000 n 0000360131 00000 n 0000464689 00000 n 0000465049 00000 n 0000355103 00000 n 0000355463 00000 n 0000460908 00000 n 0000461268 00000 n 0000349316 00000 n 0000349676 00000 n 0000454656 00000 n 0000455016 00000 n 0000343552 00000 n 0000343912 00000 n 0000450762 00000 n 0000451122 00000 n 0000463543 00000 n 0000463903 00000 n 0000422182 00000 n 0000422885 00000 n 0000477376 00000 n 0000477764 00000 n 0000387688 00000 n 0000388076 00000 n 0000276051 00000 n 0000276411 00000 n 0000382598 00000 n 0000382958 00000 n 0000374221 00000 n 0000374924 00000 n 0000450037 00000 n 0000450740 00000 n 0000447633 00000 n 0000448021 00000 n 0000352383 00000 n 0000352743 00000 n 0000455448 00000 n 0000455814 00000 n 0000345041 00000 n 0000345401 00000 n 0000451526 00000 n 0000451886 00000 n 0000340490 00000 n 0000340850 00000 n 0000335500 00000 n 0000336203 00000 n 0000325195 00000 n 0000325898 00000 n 0000431059 00000 n 0000431419 00000 n 0000334326 00000 n 0000334686 00000 n 0000374946 00000 n 0000375306 00000 n 0000279047 00000 n 0000279407 00000 n 0000463161 00000 n 0000463521 00000 n 0000354703 00000 n 0000355081 00000 n 0000459712 00000 n 0000460100 00000 n 0000347760 00000 n 0000348120 00000 n 0000453482 00000 n 0000453870 00000 n 0000342732 00000 n 0000343120 00000 n 0000448453 00000 n 0000448813 00000 n 0000339698 00000 n 0000340058 00000 n 0000443863 00000 n 0000444223 00000 n 0000439954 00000 n 0000440657 00000 n 0000327027 00000 n 0000327415 00000 n 0000313999 00000 n 0000314702 00000 n 0000402920 00000 n 0000403280 00000 n 0000287996 00000 n 0000288356 00000 n 0000393459 00000 n 0000393819 00000 n 0000388480 00000 n 0000389183 00000 n 0000378783 00000 n 0000379486 00000 n 0000485113 00000 n 0000485501 00000 n 0000373429 00000 n 0000373817 00000 n 0000368934 00000 n 0000369637 00000 n 0000475416 00000 n 0000475798 00000 n 0000364411 00000 n 0000364771 00000 n 0000467358 00000 n 0000467718 00000 n 0000356659 00000 n 0000357019 00000 n 0000462397 00000 n 0000462757 00000 n 0000353557 00000 n 0000353917 00000 n 0000456982 00000 n 0000457370 00000 n 0000346148 00000 n 0000346508 00000 n 0000451908 00000 n 0000452268 00000 n 0000342322 00000 n 0000342710 00000 n 0000446841 00000 n 0000447201 00000 n 0000337799 00000 n 0000338159 00000 n 0000443453 00000 n 0000443841 00000 n 0000334708 00000 n 0000335068 00000 n 0000442279 00000 n 0000442667 00000 n 0000328611 00000 n 0000328971 00000 n 0000433779 00000 n 0000434139 00000 n 0000320089 00000 n 0000320477 00000 n 0000424835 00000 n 0000425223 00000 n 0000310960 00000 n 0000311320 00000 n 0000416754 00000 n 0000417142 00000 n 0000401813 00000 n 0000402516 00000 n 0000286800 00000 n 0000287160 00000 n 0000393077 00000 n 0000393437 00000 n 0000283255 00000 n 0000283621 00000 n 0000274938 00000 n 0000275641 00000 n 0000381806 00000 n 0000382166 00000 n 0000488501 00000 n 0000488889 00000 n 0000479657 00000 n 0000480360 00000 n 0000369659 00000 n 0000370019 00000 n 0000343142 00000 n 0000343530 00000 n 0000332791 00000 n 0000333179 00000 n 0000336225 00000 n 0000336585 00000 n 0000486669 00000 n 0000487372 00000 n 0000281356 00000 n 0000282059 00000 n 0000361737 00000 n 0000362097 00000 n 0000283643 00000 n 0000284003 00000 n 0000473466 00000 n 0000473826 00000 n 0000478168 00000 n 0000478871 00000 n 0000371558 00000 n 0000371918 00000 n 0000482748 00000 n 0000483136 00000 n 0000376480 00000 n 0000376862 00000 n 0000488911 00000 n 0000489271 00000 n 0000330167 00000 n 0000330555 00000 n 0000430677 00000 n 0000431037 00000 n 0000321291 00000 n 0000321679 00000 n 0000431441 00000 n 0000431801 00000 n 0000321701 00000 n 0000322061 00000 n 0000432205 00000 n 0000432565 00000 n 0000322465 00000 n 0000322853 00000 n 0000432997 00000 n 0000433357 00000 n 0000323285 00000 n 0000323645 00000 n 0000434543 00000 n 0000435246 00000 n 0000324431 00000 n 0000324791 00000 n 0000316595 00000 n 0000316955 00000 n 0000426009 00000 n 0000426391 00000 n 0000317359 00000 n 0000317747 00000 n 0000427205 00000 n 0000427593 00000 n 0000318151 00000 n 0000318539 00000 n 0000428025 00000 n 0000428385 00000 n 0000318943 00000 n 0000319303 00000 n 0000428817 00000 n 0000429520 00000 n 0000319707 00000 n 0000320067 00000 n 0000310578 00000 n 0000310938 00000 n 0000419540 00000 n 0000419900 00000 n 0000311342 00000 n 0000311702 00000 n 0000420647 00000 n 0000421350 00000 n 0000312488 00000 n 0000312848 00000 n 0000303713 00000 n 0000304101 00000 n 0000412906 00000 n 0000413294 00000 n 0000305269 00000 n 0000305657 00000 n 0000414080 00000 n 0000414440 00000 n 0000305679 00000 n 0000306039 00000 n 0000415226 00000 n 0000415586 00000 n 0000358597 00000 n 0000358985 00000 n 0000400296 00000 n 0000400684 00000 n 0000311724 00000 n 0000312084 00000 n 0000421372 00000 n 0000421750 00000 n 0000312870 00000 n 0000313252 00000 n 0000422907 00000 n 0000423285 00000 n 0000314724 00000 n 0000315084 00000 n 0000423689 00000 n 0000424049 00000 n 0000315831 00000 n 0000316191 00000 n 0000424453 00000 n 0000424813 00000 n 0000316213 00000 n 0000316573 00000 n 0000425627 00000 n 0000425987 00000 n 0000316977 00000 n 0000317337 00000 n 0000426413 00000 n 0000426801 00000 n 0000317769 00000 n 0000318129 00000 n 0000427615 00000 n 0000428003 00000 n 0000318561 00000 n 0000318921 00000 n 0000428407 00000 n 0000428795 00000 n 0000319325 00000 n 0000319685 00000 n 0000429542 00000 n 0000429930 00000 n 0000320499 00000 n 0000320887 00000 n 0000429952 00000 n 0000430655 00000 n 0000320909 00000 n 0000321269 00000 n 0000312106 00000 n 0000312466 00000 n 0000421772 00000 n 0000422160 00000 n 0000313274 00000 n 0000313977 00000 n 0000423307 00000 n 0000423667 00000 n 0000413698 00000 n 0000414058 00000 n 0000304887 00000 n 0000305247 00000 n 0000414844 00000 n 0000415204 00000 n 0000306443 00000 n 0000307146 00000 n 0000415608 00000 n 0000415968 00000 n 0000406771 00000 n 0000407137 00000 n 0000297576 00000 n 0000297936 00000 n 0000407923 00000 n 0000408283 00000 n 0000298683 00000 n 0000299043 00000 n 0000409069 00000 n 0000409429 00000 n 0000299875 00000 n 0000300578 00000 n 0000409861 00000 n 0000410249 00000 n 0000398004 00000 n 0000398364 00000 n 0000290687 00000 n 0000291390 00000 n 0000399150 00000 n 0000399510 00000 n 0000391542 00000 n 0000391920 00000 n 0000284025 00000 n 0000284413 00000 n 0000392352 00000 n 0000393055 00000 n 0000278265 00000 n 0000278643 00000 n 0000490085 00000 n 0000490467 00000 n 0000381042 00000 n 0000381402 00000 n 0000490871 00000 n 0000491231 00000 n 0000382188 00000 n 0000382576 00000 n 0000271493 00000 n 0000271853 00000 n 0000382980 00000 n 0000383340 00000 n 0000272257 00000 n 0000272617 00000 n 0000384126 00000 n 0000384514 00000 n 0000273021 00000 n 0000273399 00000 n 0000384946 00000 n 0000385306 00000 n 0000273803 00000 n 0000274506 00000 n 0000375328 00000 n 0000375694 00000 n 0000370833 00000 n 0000371536 00000 n 0000479275 00000 n 0000479635 00000 n 0000475820 00000 n 0000476180 00000 n 0000368209 00000 n 0000368912 00000 n 0000476202 00000 n 0000476562 00000 n 0000470785 00000 n 0000471173 00000 n 0000363647 00000 n 0000364007 00000 n 0000471977 00000 n 0000472337 00000 n 0000364793 00000 n 0000365153 00000 n 0000473848 00000 n 0000474208 00000 n 0000366282 00000 n 0000366642 00000 n 0000474230 00000 n 0000474608 00000 n 0000366664 00000 n 0000367052 00000 n 0000474630 00000 n 0000475012 00000 n 0000367074 00000 n 0000367777 00000 n 0000475034 00000 n 0000475394 00000 n 0000466223 00000 n 0000466926 00000 n 0000351591 00000 n 0000351951 00000 n 0000343934 00000 n 0000344294 00000 n 0000453082 00000 n 0000453460 00000 n 0000345423 00000 n 0000346126 00000 n 0000453892 00000 n 0000454252 00000 n 0000448835 00000 n 0000449223 00000 n 0000341597 00000 n 0000342300 00000 n 0000449627 00000 n 0000450015 00000 n 0000444627 00000 n 0000445330 00000 n 0000337417 00000 n 0000337777 00000 n 0000333601 00000 n 0000334304 00000 n 0000442689 00000 n 0000443049 00000 n 0000438016 00000 n 0000438376 00000 n 0000315106 00000 n 0000315809 00000 n 0000424071 00000 n 0000424431 00000 n 0000415990 00000 n 0000416350 00000 n 0000307168 00000 n 0000307528 00000 n 0000417164 00000 n 0000417524 00000 n 0000308275 00000 n 0000308663 00000 n 0000417546 00000 n 0000417906 00000 n 0000308685 00000 n 0000309067 00000 n 0000418338 00000 n 0000418726 00000 n 0000309089 00000 n 0000309449 00000 n 0000418748 00000 n 0000419136 00000 n 0000309471 00000 n 0000309831 00000 n 0000419158 00000 n 0000419518 00000 n 0000309853 00000 n 0000310556 00000 n 0000419922 00000 n 0000420625 00000 n 0000411035 00000 n 0000411395 00000 n 0000401431 00000 n 0000401791 00000 n 0000293323 00000 n 0000293711 00000 n 0000403302 00000 n 0000403668 00000 n 0000294115 00000 n 0000294503 00000 n 0000404490 00000 n 0000404850 00000 n 0000295660 00000 n 0000296026 00000 n 0000405254 00000 n 0000405642 00000 n 0000296430 00000 n 0000296790 00000 n 0000406389 00000 n 0000406749 00000 n 0000297194 00000 n 0000297554 00000 n 0000407159 00000 n 0000407519 00000 n 0000299065 00000 n 0000299453 00000 n 0000408305 00000 n 0000408665 00000 n 0000299475 00000 n 0000299853 00000 n 0000409451 00000 n 0000409839 00000 n 0000300600 00000 n 0000300960 00000 n 0000410271 00000 n 0000410631 00000 n 0000300982 00000 n 0000301342 00000 n 0000410653 00000 n 0000411013 00000 n 0000302089 00000 n 0000302467 00000 n 0000411417 00000 n 0000411777 00000 n 0000302489 00000 n 0000302871 00000 n 0000411799 00000 n 0000412159 00000 n 0000303303 00000 n 0000303691 00000 n 0000413316 00000 n 0000413676 00000 n 0000304505 00000 n 0000304865 00000 n 0000414462 00000 n 0000414822 00000 n 0000306061 00000 n 0000306421 00000 n 0000417928 00000 n 0000418316 00000 n 0000307550 00000 n 0000308253 00000 n 0000416372 00000 n 0000416732 00000 n 0000407541 00000 n 0000407901 00000 n 0000297958 00000 n 0000298661 00000 n 0000408687 00000 n 0000409047 00000 n 0000396133 00000 n 0000396493 00000 n 0000288378 00000 n 0000288766 00000 n 0000397622 00000 n 0000397982 00000 n 0000290277 00000 n 0000290665 00000 n 0000398768 00000 n 0000399128 00000 n 0000291412 00000 n 0000291794 00000 n 0000399914 00000 n 0000400274 00000 n 0000292941 00000 n 0000293301 00000 n 0000402538 00000 n 0000402898 00000 n 0000293733 00000 n 0000294093 00000 n 0000403690 00000 n 0000404068 00000 n 0000294525 00000 n 0000294913 00000 n 0000404090 00000 n 0000404468 00000 n 0000296048 00000 n 0000296408 00000 n 0000405664 00000 n 0000406367 00000 n 0000296812 00000 n 0000297172 00000 n 0000284845 00000 n 0000285233 00000 n 0000394605 00000 n 0000394965 00000 n 0000286390 00000 n 0000286778 00000 n 0000395369 00000 n 0000395729 00000 n 0000287182 00000 n 0000287564 00000 n 0000396515 00000 n 0000396875 00000 n 0000288788 00000 n 0000289148 00000 n 0000398386 00000 n 0000398746 00000 n 0000292541 00000 n 0000292919 00000 n 0000399532 00000 n 0000399892 00000 n 0000291816 00000 n 0000292519 00000 n 0000400706 00000 n 0000401409 00000 n 0000391942 00000 n 0000392330 00000 n 0000389205 00000 n 0000389593 00000 n 0000280154 00000 n 0000280514 00000 n 0000389997 00000 n 0000390385 00000 n 0000280946 00000 n 0000281334 00000 n 0000390407 00000 n 0000391110 00000 n 0000282081 00000 n 0000282441 00000 n 0000276433 00000 n 0000277136 00000 n 0000386492 00000 n 0000386852 00000 n 0000379508 00000 n 0000379868 00000 n 0000481164 00000 n 0000481552 00000 n 0000371940 00000 n 0000372300 00000 n 0000481574 00000 n 0000481962 00000 n 0000372322 00000 n 0000373025 00000 n 0000482366 00000 n 0000482726 00000 n 0000477786 00000 n 0000478146 00000 n 0000360917 00000 n 0000361305 00000 n 0000468886 00000 n 0000469274 00000 n 0000362119 00000 n 0000362479 00000 n 0000470060 00000 n 0000470763 00000 n 0000363265 00000 n 0000363625 00000 n 0000346940 00000 n 0000347328 00000 n 0000455038 00000 n 0000455426 00000 n 0000347350 00000 n 0000347738 00000 n 0000455836 00000 n 0000456196 00000 n 0000348142 00000 n 0000348530 00000 n 0000456600 00000 n 0000456960 00000 n 0000348934 00000 n 0000349294 00000 n 0000457774 00000 n 0000458134 00000 n 0000350080 00000 n 0000350440 00000 n 0000458538 00000 n 0000458898 00000 n 0000350866 00000 n 0000351569 00000 n 0000459330 00000 n 0000459690 00000 n 0000452700 00000 n 0000453060 00000 n 0000344316 00000 n 0000345019 00000 n 0000454274 00000 n 0000454634 00000 n 0000448043 00000 n 0000448431 00000 n 0000340872 00000 n 0000341575 00000 n 0000449245 00000 n 0000449605 00000 n 0000444245 00000 n 0000444605 00000 n 0000338563 00000 n 0000338951 00000 n 0000445352 00000 n 0000445712 00000 n 0000338181 00000 n 0000338541 00000 n 0000445734 00000 n 0000446437 00000 n 0000338973 00000 n 0000339676 00000 n 0000335090 00000 n 0000335478 00000 n 0000328993 00000 n 0000329353 00000 n 0000438780 00000 n 0000439140 00000 n 0000329785 00000 n 0000330145 00000 n 0000439544 00000 n 0000439932 00000 n 0000330959 00000 n 0000331319 00000 n 0000441061 00000 n 0000441449 00000 n 0000332066 00000 n 0000332769 00000 n 0000441875 00000 n 0000442257 00000 n 0000432587 00000 n 0000432975 00000 n 0000322875 00000 n 0000323263 00000 n 0000434161 00000 n 0000434521 00000 n 0000324049 00000 n 0000324409 00000 n 0000435268 00000 n 0000435656 00000 n 0000325920 00000 n 0000326280 00000 n 0000436442 00000 n 0000436808 00000 n 0000327437 00000 n 0000327797 00000 n 0000437230 00000 n 0000437590 00000 n 0000327819 00000 n 0000328207 00000 n 0000437612 00000 n 0000437994 00000 n 0000328229 00000 n 0000328589 00000 n 0000438398 00000 n 0000438758 00000 n 0000329375 00000 n 0000329763 00000 n 0000439162 00000 n 0000439522 00000 n 0000330577 00000 n 0000330937 00000 n 0000440679 00000 n 0000441039 00000 n 0000331341 00000 n 0000332044 00000 n 0000441471 00000 n 0000441853 00000 n 0000431823 00000 n 0000432183 00000 n 0000322083 00000 n 0000322443 00000 n 0000433379 00000 n 0000433757 00000 n 0000323667 00000 n 0000324027 00000 n 0000435678 00000 n 0000436038 00000 n 0000324813 00000 n 0000325173 00000 n 0000436060 00000 n 0000436420 00000 n 0000326302 00000 n 0000327005 00000 n 0000436830 00000 n 0000437208 00000 n 0000426823 00000 n 0000427183 00000 n 0000302893 00000 n 0000303281 00000 n 0000412181 00000 n 0000412884 00000 n 0000304123 00000 n 0000304483 00000 n 0000294935 00000 n 0000295638 00000 n 0000404872 00000 n 0000405232 00000 n 0000393841 00000 n 0000394201 00000 n 0000284435 00000 n 0000284823 00000 n 0000394223 00000 n 0000394583 00000 n 0000285980 00000 n 0000286368 00000 n 0000394987 00000 n 0000395347 00000 n 0000287586 00000 n 0000287974 00000 n 0000395751 00000 n 0000396111 00000 n 0000289170 00000 n 0000289530 00000 n 0000396897 00000 n 0000397600 00000 n 0000282463 00000 n 0000282823 00000 n 0000277158 00000 n 0000277518 00000 n 0000386092 00000 n 0000386470 00000 n 0000277540 00000 n 0000278243 00000 n 0000386874 00000 n 0000387262 00000 n 0000379890 00000 n 0000380256 00000 n 0000489703 00000 n 0000490063 00000 n 0000380278 00000 n 0000380638 00000 n 0000490489 00000 n 0000490849 00000 n 0000381424 00000 n 0000381784 00000 n 0000271111 00000 n 0000271471 00000 n 0000383362 00000 n 0000383722 00000 n 0000271875 00000 n 0000272235 00000 n 0000383744 00000 n 0000384104 00000 n 0000272639 00000 n 0000272999 00000 n 0000384536 00000 n 0000384924 00000 n 0000273421 00000 n 0000273781 00000 n 0000385328 00000 n 0000385688 00000 n 0000483158 00000 n 0000483546 00000 n 0000375716 00000 n 0000376076 00000 n 0000483568 00000 n 0000483956 00000 n 0000376098 00000 n 0000376458 00000 n 0000483978 00000 n 0000484366 00000 n 0000376884 00000 n 0000377272 00000 n 0000485905 00000 n 0000486265 00000 n 0000377294 00000 n 0000377654 00000 n 0000486287 00000 n 0000486647 00000 n 0000377676 00000 n 0000378379 00000 n 0000487394 00000 n 0000488097 00000 n 0000481984 00000 n 0000482344 00000 n 0000478893 00000 n 0000479253 00000 n 0000360535 00000 n 0000360895 00000 n 0000468504 00000 n 0000468864 00000 n 0000362501 00000 n 0000362861 00000 n 0000469678 00000 n 0000470038 00000 n 0000362883 00000 n 0000363243 00000 n 0000471195 00000 n 0000471573 00000 n 0000364029 00000 n 0000364389 00000 n 0000472359 00000 n 0000473062 00000 n 0000365175 00000 n 0000365535 00000 n 0000357041 00000 n 0000357401 00000 n 0000465071 00000 n 0000465437 00000 n 0000357805 00000 n 0000358193 00000 n 0000465459 00000 n 0000465819 00000 n 0000358215 00000 n 0000358575 00000 n 0000465841 00000 n 0000466201 00000 n 0000359007 00000 n 0000359367 00000 n 0000466948 00000 n 0000467336 00000 n 0000359389 00000 n 0000359749 00000 n 0000467740 00000 n 0000468100 00000 n 0000360153 00000 n 0000360513 00000 n 0000468122 00000 n 0000468482 00000 n 0000361327 00000 n 0000361715 00000 n 0000469296 00000 n 0000469656 00000 n 0000365557 00000 n 0000366260 00000 n 0000471595 00000 n 0000471955 00000 n 0000462779 00000 n 0000463139 00000 n 0000355867 00000 n 0000356227 00000 n 0000463925 00000 n 0000464285 00000 n 0000356249 00000 n 0000356637 00000 n 0000464307 00000 n 0000464667 00000 n 0000357423 00000 n 0000357783 00000 n 0000456218 00000 n 0000456578 00000 n 0000348552 00000 n 0000348912 00000 n 0000457392 00000 n 0000457752 00000 n 0000349698 00000 n 0000350058 00000 n 0000458156 00000 n 0000458516 00000 n 0000350462 00000 n 0000350844 00000 n 0000458920 00000 n 0000459308 00000 n 0000352765 00000 n 0000353153 00000 n 0000460122 00000 n 0000460504 00000 n 0000353175 00000 n 0000353535 00000 n 0000460526 00000 n 0000460886 00000 n 0000353939 00000 n 0000354299 00000 n 0000461290 00000 n 0000461650 00000 n 0000354321 00000 n 0000354681 00000 n 0000638467 00000 n 0000596474 00000 n 0000596737 00000 n 0000588055 00000 n 0000588318 00000 n 0000604313 00000 n 0000604576 00000 n 0000546850 00000 n 0000547113 00000 n 0000586102 00000 n 0000586365 00000 n 0000593137 00000 n 0000593400 00000 n 0000584099 00000 n 0000584375 00000 n 0000543215 00000 n 0000543478 00000 n 0000587239 00000 n 0000587465 00000 n 0000613561 00000 n 0000613825 00000 n 0000572392 00000 n 0000572618 00000 n 0000585818 00000 n 0000586081 00000 n 0000597042 00000 n 0000597305 00000 n 0000601284 00000 n 0000601510 00000 n 0000573790 00000 n 0000574053 00000 n 0000583852 00000 n 0000584078 00000 n 0000608500 00000 n 0000608776 00000 n 0000580800 00000 n 0000581063 00000 n 0000606017 00000 n 0000606280 00000 n 0000491253 00000 n 0000491479 00000 n 0000506494 00000 n 0000506757 00000 n 0000620550 00000 n 0000620814 00000 n 0000527729 00000 n 0000527993 00000 n 0000625360 00000 n 0000625586 00000 n 0000540375 00000 n 0000540638 00000 n 0000625891 00000 n 0000626154 00000 n 0000507607 00000 n 0000507871 00000 n 0000596758 00000 n 0000597021 00000 n 0000621935 00000 n 0000622198 00000 n 0000534689 00000 n 0000534953 00000 n 0000557285 00000 n 0000557549 00000 n 0000614662 00000 n 0000614926 00000 n 0000496147 00000 n 0000496373 00000 n 0000611567 00000 n 0000611831 00000 n 0000494231 00000 n 0000494495 00000 n 0000500561 00000 n 0000500824 00000 n 0000560943 00000 n 0000561207 00000 n 0000582184 00000 n 0000582448 00000 n 0000499140 00000 n 0000499403 00000 n 0000523858 00000 n 0000524122 00000 n 0000575496 00000 n 0000575759 00000 n 0000601000 00000 n 0000601263 00000 n 0000516295 00000 n 0000516521 00000 n 0000538099 00000 n 0000538363 00000 n 0000558138 00000 n 0000558364 00000 n 0000579131 00000 n 0000579395 00000 n 0000590614 00000 n 0000590840 00000 n 0000616332 00000 n 0000616608 00000 n 0000498273 00000 n 0000498536 00000 n 0000591431 00000 n 0000591695 00000 n 0000620266 00000 n 0000620529 00000 n 0000501414 00000 n 0000501678 00000 n 0000555579 00000 n 0000555843 00000 n 0000581937 00000 n 0000582163 00000 n 0000536394 00000 n 0000536657 00000 n 0000502267 00000 n 0000502530 00000 n 0000595659 00000 n 0000595922 00000 n 0000564049 00000 n 0000564312 00000 n 0000609330 00000 n 0000609593 00000 n 0000537530 00000 n 0000537793 00000 n 0000492068 00000 n 0000492294 00000 n 0000603213 00000 n 0000603476 00000 n 0000594274 00000 n 0000594538 00000 n 0000619684 00000 n 0000619960 00000 n 0000509028 00000 n 0000509254 00000 n 0000552205 00000 n 0000552468 00000 n 0000501983 00000 n 0000502246 00000 n 0000594843 00000 n 0000595069 00000 n 0000598178 00000 n 0000598454 00000 n 0000539522 00000 n 0000539786 00000 n 0000493661 00000 n 0000493925 00000 n 0000503689 00000 n 0000503953 00000 n 0000549114 00000 n 0000549378 00000 n 0000570476 00000 n 0000570739 00000 n 0000629475 00000 n 0000629738 00000 n 0000511265 00000 n 0000511528 00000 n 0000564903 00000 n 0000565167 00000 n 0000586671 00000 n 0000586934 00000 n 0000504542 00000 n 0000504805 00000 n 0000526629 00000 n 0000526855 00000 n 0000581368 00000 n 0000581631 00000 n 0000505963 00000 n 0000506189 00000 n 0000598476 00000 n 0000598740 00000 n 0000599329 00000 n 0000599593 00000 n 0000624223 00000 n 0000624486 00000 n 0000630043 00000 n 0000630306 00000 n 0000532205 00000 n 0000532431 00000 n 0000555011 00000 n 0000555274 00000 n 0000602384 00000 n 0000602647 00000 n 0000626743 00000 n 0000627006 00000 n 0000610999 00000 n 0000611262 00000 n 0000517680 00000 n 0000517943 00000 n 0000540091 00000 n 0000540354 00000 n 0000593989 00000 n 0000594253 00000 n 0000619153 00000 n 0000619379 00000 n 0000532452 00000 n 0000532678 00000 n 0000508744 00000 n 0000509007 00000 n 0000602966 00000 n 0000603192 00000 n 0000615232 00000 n 0000615495 00000 n 0000603744 00000 n 0000604007 00000 n 0000616048 00000 n 0000616311 00000 n 0000565719 00000 n 0000565982 00000 n 0000587486 00000 n 0000587750 00000 n 0000505395 00000 n 0000505658 00000 n 0000528298 00000 n 0000528562 00000 n 0000581084 00000 n 0000581347 00000 n 0000606869 00000 n 0000607132 00000 n 0000522759 00000 n 0000523022 00000 n 0000544600 00000 n 0000544863 00000 n 0000599899 00000 n 0000600163 00000 n 0000625075 00000 n 0000625339 00000 n 0000536678 00000 n 0000536941 00000 n 0000561228 00000 n 0000561492 00000 n 0000617162 00000 n 0000617425 00000 n 0000499708 00000 n 0000499971 00000 n 0000553058 00000 n 0000553322 00000 n 0000575211 00000 n 0000575475 00000 n 0000491784 00000 n 0000492047 00000 n 0000515480 00000 n 0000515743 00000 n 0000568845 00000 n 0000569108 00000 n 0000592569 00000 n 0000592832 00000 n 0000510413 00000 n 0000510676 00000 n 0000531389 00000 n 0000531615 00000 n 0000585249 00000 n 0000585512 00000 n 0000549968 00000 n 0000550194 00000 n 0000504826 00000 n 0000505090 00000 n 0000514613 00000 n 0000514876 00000 n 0000608798 00000 n 0000609062 00000 n 0000507076 00000 n 0000507339 00000 n 0000550783 00000 n 0000551046 00000 n 0000570760 00000 n 0000571023 00000 n 0000631995 00000 n 0000632259 00000 n 0000512094 00000 n 0000512357 00000 n 0000567424 00000 n 0000567688 00000 n 0000588623 00000 n 0000588886 00000 n 0000507892 00000 n 0000508155 00000 n 0000529151 00000 n 0000529377 00000 n 0000583037 00000 n 0000583263 00000 n 0000517964 00000 n 0000518228 00000 n 0000611852 00000 n 0000612128 00000 n 0000627596 00000 n 0000627822 00000 n 0000618869 00000 n 0000619132 00000 n 0000520770 00000 n 0000521033 00000 n 0000614947 00000 n 0000615211 00000 n 0000524712 00000 n 0000524938 00000 n 0000567709 00000 n 0000567972 00000 n 0000554726 00000 n 0000554990 00000 n 0000511549 00000 n 0000511825 00000 n 0000612979 00000 n 0000613242 00000 n 0000518817 00000 n 0000519080 00000 n 0000541511 00000 n 0000541774 00000 n 0000595374 00000 n 0000595638 00000 n 0000620835 00000 n 0000621061 00000 n 0000533837 00000 n 0000534100 00000 n 0000588907 00000 n 0000589171 00000 n 0000545467 00000 n 0000545730 00000 n 0000577449 00000 n 0000577675 00000 n 0000628375 00000 n 0000628601 00000 n 0000527444 00000 n 0000527708 00000 n 0000623085 00000 n 0000623349 00000 n 0000493946 00000 n 0000494210 00000 n 0000519385 00000 n 0000519648 00000 n 0000541795 00000 n 0000542058 00000 n 0000595943 00000 n 0000596169 00000 n 0000621082 00000 n 0000621345 00000 n 0000627843 00000 n 0000628069 00000 n 0000509560 00000 n 0000509823 00000 n 0000628090 00000 n 0000628354 00000 n 0000509275 00000 n 0000509539 00000 n 0000558953 00000 n 0000559217 00000 n 0000579948 00000 n 0000580211 00000 n 0000497209 00000 n 0000497473 00000 n 0000521906 00000 n 0000522169 00000 n 0000573221 00000 n 0000573484 00000 n 0000598761 00000 n 0000599024 00000 n 0000514329 00000 n 0000514592 00000 n 0000537246 00000 n 0000537509 00000 n 0000591146 00000 n 0000591410 00000 n 0000616630 00000 n 0000616856 00000 n 0000530535 00000 n 0000530798 00000 n 0000532983 00000 n 0000533247 00000 n 0000631711 00000 n 0000631974 00000 n 0000574074 00000 n 0000574338 00000 n 0000624791 00000 n 0000625054 00000 n 0000505679 00000 n 0000505942 00000 n 0000559806 00000 n 0000560069 00000 n 0000582753 00000 n 0000583016 00000 n 0000498842 00000 n 0000499118 00000 n 0000523043 00000 n 0000523306 00000 n 0000574643 00000 n 0000574906 00000 n 0000600184 00000 n 0000600447 00000 n 0000515195 00000 n 0000515459 00000 n 0000536962 00000 n 0000537225 00000 n 0000592285 00000 n 0000592548 00000 n 0000617446 00000 n 0000617709 00000 n 0000531104 00000 n 0000531368 00000 n 0000553343 00000 n 0000553606 00000 n 0000609614 00000 n 0000609878 00000 n 0000492315 00000 n 0000492578 00000 n 0000547665 00000 n 0000547928 00000 n 0000569376 00000 n 0000569639 00000 n 0000629191 00000 n 0000629454 00000 n 0000510697 00000 n 0000510960 00000 n 0000564333 00000 n 0000564597 00000 n 0000585533 00000 n 0000585797 00000 n 0000503120 00000 n 0000503383 00000 n 0000525813 00000 n 0000526076 00000 n 0000578563 00000 n 0000578826 00000 n 0000604597 00000 n 0000604860 00000 n 0000521054 00000 n 0000521317 00000 n 0000542647 00000 n 0000542910 00000 n 0000597894 00000 n 0000598157 00000 n 0000622219 00000 n 0000622482 00000 n 0000534974 00000 n 0000535237 00000 n 0000557854 00000 n 0000558117 00000 n 0000615801 00000 n 0000616027 00000 n 0000496394 00000 n 0000496657 00000 n 0000495084 00000 n 0000495348 00000 n 0000519954 00000 n 0000520180 00000 n 0000564618 00000 n 0000564882 00000 n 0000543784 00000 n 0000544010 00000 n 0000497741 00000 n 0000497967 00000 n 0000546319 00000 n 0000546582 00000 n 0000500845 00000 n 0000501109 00000 n 0000547134 00000 n 0000547397 00000 n 0000610468 00000 n 0000610694 00000 n 0000493377 00000 n 0000493640 00000 n 0000503974 00000 n 0000504237 00000 n 0000526097 00000 n 0000526323 00000 n 0000562367 00000 n 0000562630 00000 n 0000551067 00000 n 0000551331 00000 n 0000508176 00000 n 0000508439 00000 n 0000608006 00000 n 0000608232 00000 n 0000512946 00000 n 0000513209 00000 n 0000584681 00000 n 0000584944 00000 n 0000542079 00000 n 0000542342 00000 n 0000555864 00000 n 0000556127 00000 n 0000604028 00000 n 0000604292 00000 n 0000628622 00000 n 0000628886 00000 n 0000542363 00000 n 0000542626 00000 n 0000563802 00000 n 0000564028 00000 n 0000621366 00000 n 0000621629 00000 n 0000553627 00000 n 0000553853 00000 n 0000510129 00000 n 0000510392 00000 n 0000589476 00000 n 0000589739 00000 n 0000545751 00000 n 0000546014 00000 n 0000535542 00000 n 0000535805 00000 n 0000580232 00000 n 0000580495 00000 n 0000605449 00000 n 0000605712 00000 n 0000522190 00000 n 0000522453 00000 n 0000544031 00000 n 0000544295 00000 n 0000599045 00000 n 0000599308 00000 n 0000623939 00000 n 0000624202 00000 n 0000536110 00000 n 0000536373 00000 n 0000559522 00000 n 0000559785 00000 n 0000616877 00000 n 0000617141 00000 n 0000497988 00000 n 0000498252 00000 n 0000552489 00000 n 0000552752 00000 n 0000574359 00000 n 0000574622 00000 n 0000491500 00000 n 0000491763 00000 n 0000514897 00000 n 0000515173 00000 n 0000568277 00000 n 0000568540 00000 n 0000592000 00000 n 0000592264 00000 n 0000509844 00000 n 0000510108 00000 n 0000530819 00000 n 0000531083 00000 n 0000584965 00000 n 0000585228 00000 n 0000609083 00000 n 0000609309 00000 n 0000525528 00000 n 0000525792 00000 n 0000595090 00000 n 0000595353 00000 n 0000551352 00000 n 0000551616 00000 n 0000569129 00000 n 0000569355 00000 n 0000617730 00000 n 0000617994 00000 n 0000563504 00000 n 0000563780 00000 n 0000519669 00000 n 0000519933 00000 n 0000523611 00000 n 0000523837 00000 n 0000566856 00000 n 0000567119 00000 n 0000560659 00000 n 0000560922 00000 n 0000516011 00000 n 0000516274 00000 n 0000612448 00000 n 0000612711 00000 n 0000518249 00000 n 0000518512 00000 n 0000540943 00000 n 0000541206 00000 n 0000594559 00000 n 0000594822 00000 n 0000619982 00000 n 0000620245 00000 n 0000533268 00000 n 0000533531 00000 n 0000555295 00000 n 0000555558 00000 n 0000612732 00000 n 0000612958 00000 n 0000494516 00000 n 0000494779 00000 n 0000518533 00000 n 0000518796 00000 n 0000541227 00000 n 0000541490 00000 n 0000563220 00000 n 0000563483 00000 n 0000584397 00000 n 0000584660 00000 n 0000501699 00000 n 0000501962 00000 n 0000525244 00000 n 0000525507 00000 n 0000576917 00000 n 0000577181 00000 n 0000603497 00000 n 0000603723 00000 n 0000519101 00000 n 0000519364 00000 n 0000495653 00000 n 0000495879 00000 n 0000590330 00000 n 0000590593 00000 n 0000606585 00000 n 0000606848 00000 n 0000560090 00000 n 0000560353 00000 n 0000572639 00000 n 0000572915 00000 n 0000622503 00000 n 0000622779 00000 n 0000504258 00000 n 0000504521 00000 n 0000558385 00000 n 0000558648 00000 n 0000579663 00000 n 0000579927 00000 n 0000496678 00000 n 0000496904 00000 n 0000521338 00000 n 0000521601 00000 n 0000526876 00000 n 0000527139 00000 n 0000549684 00000 n 0000549947 00000 n 0000586955 00000 n 0000587218 00000 n 0000610715 00000 n 0000610978 00000 n 0000527160 00000 n 0000527423 00000 n 0000550215 00000 n 0000550478 00000 n 0000605165 00000 n 0000605428 00000 n 0000630327 00000 n 0000630591 00000 n 0000543499 00000 n 0000543763 00000 n 0000565435 00000 n 0000565698 00000 n 0000623370 00000 n 0000623633 00000 n 0000505111 00000 n 0000505374 00000 n 0000559238 00000 n 0000559501 00000 n 0000580516 00000 n 0000580779 00000 n 0000497494 00000 n 0000497720 00000 n 0000522474 00000 n 0000522738 00000 n 0000529966 00000 n 0000530229 00000 n 0000551921 00000 n 0000552184 00000 n 0000587771 00000 n 0000588034 00000 n 0000611283 00000 n 0000611546 00000 n 0000528014 00000 n 0000528277 00000 n 0000550499 00000 n 0000550762 00000 n 0000606301 00000 n 0000606564 00000 n 0000631427 00000 n 0000631690 00000 n 0000544316 00000 n 0000544579 00000 n 0000566571 00000 n 0000566835 00000 n 0000624507 00000 n 0000624770 00000 n 0000506210 00000 n 0000506473 00000 n 0000560374 00000 n 0000560638 00000 n 0000581652 00000 n 0000581916 00000 n 0000498557 00000 n 0000498821 00000 n 0000523327 00000 n 0000523590 00000 n 0000574927 00000 n 0000575190 00000 n 0000600468 00000 n 0000600694 00000 n 0000515764 00000 n 0000515990 00000 n 0000506778 00000 n 0000507054 00000 n 0000599614 00000 n 0000599878 00000 n 0000546603 00000 n 0000546829 00000 n 0000547949 00000 n 0000548225 00000 n 0000614378 00000 n 0000614641 00000 n 0000567993 00000 n 0000568256 00000 n 0000592853 00000 n 0000593116 00000 n 0000499424 00000 n 0000499687 00000 n 0000524143 00000 n 0000524407 00000 n 0000575780 00000 n 0000576043 00000 n 0000601531 00000 n 0000601794 00000 n 0000516542 00000 n 0000516806 00000 n 0000538384 00000 n 0000538648 00000 n 0000593421 00000 n 0000593684 00000 n 0000618584 00000 n 0000618848 00000 n 0000531636 00000 n 0000531900 00000 n 0000554442 00000 n 0000554705 00000 n 0000609899 00000 n 0000610163 00000 n 0000493130 00000 n 0000493356 00000 n 0000548829 00000 n 0000549093 00000 n 0000579416 00000 n 0000579642 00000 n 0000535258 00000 n 0000535521 00000 n 0000582469 00000 n 0000582732 00000 n 0000535826 00000 n 0000536089 00000 n 0000607722 00000 n 0000607985 00000 n 0000512378 00000 n 0000512641 00000 n 0000533552 00000 n 0000533816 00000 n 0000589192 00000 n 0000589455 00000 n 0000613263 00000 n 0000613539 00000 n 0000529398 00000 n 0000529661 00000 n 0000551637 00000 n 0000551900 00000 n 0000608253 00000 n 0000608479 00000 n 0000632280 00000 n 0000632544 00000 n 0000539807 00000 n 0000540070 00000 n 0000562651 00000 n 0000562914 00000 n 0000556148 00000 n 0000556411 00000 n 0000577696 00000 n 0000577972 00000 n 0000494800 00000 n 0000495063 00000 n 0000520201 00000 n 0000520465 00000 n 0000571576 00000 n 0000571839 00000 n 0000596190 00000 n 0000596453 00000 n 0000513230 00000 n 0000513493 00000 n 0000534121 00000 n 0000534384 00000 n 0000590045 00000 n 0000590309 00000 n 0000613846 00000 n 0000614072 00000 n 0000529682 00000 n 0000529945 00000 n 0000623654 00000 n 0000623918 00000 n 0000573505 00000 n 0000573769 00000 n 0000571860 00000 n 0000572124 00000 n 0000621650 00000 n 0000621914 00000 n 0000502836 00000 n 0000503099 00000 n 0000556716 00000 n 0000556979 00000 n 0000577994 00000 n 0000578258 00000 n 0000495369 00000 n 0000495632 00000 n 0000520486 00000 n 0000520749 00000 n 0000572145 00000 n 0000572371 00000 n 0000597326 00000 n 0000597589 00000 n 0000547418 00000 n 0000547644 00000 n 0000568561 00000 n 0000568824 00000 n 0000548247 00000 n 0000548510 00000 n 0000569660 00000 n 0000569924 00000 n 0000537814 00000 n 0000538078 00000 n 0000561513 00000 n 0000561777 00000 n 0000618015 00000 n 0000618278 00000 n 0000499992 00000 n 0000500256 00000 n 0000553874 00000 n 0000554137 00000 n 0000576064 00000 n 0000576328 00000 n 0000492599 00000 n 0000492825 00000 n 0000516827 00000 n 0000517090 00000 n 0000534405 00000 n 0000534668 00000 n 0000556432 00000 n 0000556695 00000 n 0000583284 00000 n 0000583547 00000 n 0000607153 00000 n 0000607417 00000 n 0000524428 00000 n 0000524691 00000 n 0000545169 00000 n 0000545445 00000 n 0000600715 00000 n 0000600979 00000 n 0000625607 00000 n 0000625870 00000 n 0000538669 00000 n 0000538932 00000 n 0000561798 00000 n 0000562061 00000 n 0000618299 00000 n 0000618563 00000 n 0000500277 00000 n 0000500540 00000 n 0000554158 00000 n 0000554421 00000 n 0000576349 00000 n 0000576612 00000 n 0000492846 00000 n 0000493109 00000 n 0000517111 00000 n 0000517375 00000 n 0000569945 00000 n 0000570208 00000 n 0000593705 00000 n 0000593968 00000 n 0000510981 00000 n 0000511244 00000 n 0000531921 00000 n 0000532184 00000 n 0000586386 00000 n 0000586650 00000 n 0000610184 00000 n 0000610447 00000 n 0000526344 00000 n 0000526608 00000 n 0000549399 00000 n 0000549663 00000 n 0000604881 00000 n 0000605144 00000 n 0000629759 00000 n 0000630022 00000 n 0000542931 00000 n 0000543194 00000 n 0000565188 00000 n 0000565414 00000 n 0000622801 00000 n 0000623064 00000 n 0000528583 00000 n 0000528846 00000 n 0000626175 00000 n 0000626438 00000 n 0000513514 00000 n 0000513777 00000 n 0000558669 00000 n 0000558932 00000 n 0000583568 00000 n 0000583831 00000 n 0000496925 00000 n 0000497188 00000 n 0000521622 00000 n 0000521885 00000 n 0000572937 00000 n 0000573200 00000 n 0000601815 00000 n 0000602078 00000 n 0000514082 00000 n 0000514308 00000 n 0000538953 00000 n 0000539217 00000 n 0000557570 00000 n 0000557833 00000 n 0000578279 00000 n 0000578542 00000 n 0000605733 00000 n 0000605996 00000 n 0000630612 00000 n 0000630875 00000 n 0000544884 00000 n 0000545148 00000 n 0000566003 00000 n 0000566266 00000 n 0000626459 00000 n 0000626722 00000 n 0000507360 00000 n 0000507586 00000 n 0000562082 00000 n 0000562346 00000 n 0000612150 00000 n 0000612426 00000 n 0000566287 00000 n 0000566550 00000 n 0000607438 00000 n 0000607701 00000 n 0000511847 00000 n 0000512073 00000 n 0000532699 00000 n 0000532962 00000 n 0000567140 00000 n 0000567403 00000 n 0000588339 00000 n 0000588602 00000 n 0000602668 00000 n 0000602944 00000 n 0000627027 00000 n 0000627291 00000 n 0000540659 00000 n 0000540922 00000 n 0000562935 00000 n 0000563199 00000 n 0000619400 00000 n 0000619663 00000 n 0000501130 00000 n 0000501393 00000 n 0000571044 00000 n 0000571308 00000 n 0000578847 00000 n 0000579110 00000 n 0000614093 00000 n 0000614357 00000 n 0000528867 00000 n 0000529130 00000 n 0000577202 00000 n 0000577428 00000 n 0000628907 00000 n 0000629170 00000 n 0000539238 00000 n 0000539501 00000 n 0000571329 00000 n 0000571555 00000 n 0000548531 00000 n 0000548807 00000 n 0000508460 00000 n 0000508723 00000 n 0000503404 00000 n 0000503668 00000 n 0000530250 00000 n 0000530514 00000 n 0000591716 00000 n 0000591979 00000 n 0000597610 00000 n 0000597873 00000 n 0000590861 00000 n 0000591125 00000 n 0000602099 00000 n 0000602363 00000 n 0000557000 00000 n 0000557264 00000 n 0000589760 00000 n 0000590024 00000 n 0000631180 00000 n 0000631406 00000 n 0000502551 00000 n 0000502815 00000 n 0000517396 00000 n 0000517659 00000 n 0000627312 00000 n 0000627575 00000 n 0000630896 00000 n 0000631159 00000 n 0000570229 00000 n 0000570455 00000 n 0000495900 00000 n 0000496126 00000 n 0000512662 00000 n 0000512925 00000 n 0000524959 00000 n 0000525223 00000 n 0000632565 00000 n 0000632828 00000 n 0000615516 00000 n 0000615780 00000 n 0000513798 00000 n 0000514061 00000 n 0000552773 00000 n 0000553037 00000 n 0000546035 00000 n 0000546298 00000 n 0000576633 00000 n 0000576896 00000 n 0000632945 00000 n 0000635664 00000 n 0000635725 00000 n 0000638444 00000 n 0000638591 00000 n 0000638788 00000 n 0000638999 00000 n 0000639244 00000 n 0000639473 00000 n 0000643946 00000 n 0000644101 00000 n 0000644312 00000 n 0000644453 00000 n 0000644682 00000 n 0000647606 00000 n 0000647629 00000 n 0000647683 00000 n 0000647744 00000 n trailer << /Size 3573 /Root 3559 0 R /Info 1 0 R /ID [ ] >> startxref 647887 %%EOF cummeRbund/vignettes/cummeRbund-example-workflow.Rnw0000644000175200017520000001165014516004263024003 0ustar00biocbuildbiocbuild% % % %\VignetteIndexEntry{Sample cummeRbund workflow} %\VignetteKeywords{cummeRbund,visualization,sequencing,cufflinks,cuffdiff} %\VignettePackage{cummeRbund} % %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %\SweaveOpts{prefix.string=graphics/plot} \documentclass[10pt]{article} \usepackage{amsmath} \usepackage[authoryear,round]{natbib} \usepackage{hyperref} \hypersetup{ colorlinks, citecolor=black, filecolor=black, linkcolor=red, urlcolor=black } \usepackage{theorem} \usepackage{float} \usepackage{ifthen} \usepackage[OT1]{fontenc} \newcommand{\R}{{\textsf{R}}} \newcommand{\code}[1]{{\texttt{#1}}} \newcommand{\term}[1]{{\emph{#1}}} \newcommand{\Rpackage}[1]{\textsf{#1}} \newcommand{\Rfunction}[1]{\texttt{#1}} \newcommand{\Robject}[1]{\texttt{#1}} \newcommand{\Rclass}[1]{{\textit{#1}}} \newcommand{\Rmethod}[1]{{\textit{#1}}} \newcommand{\Rfunarg}[1]{{\textit{#1}}} \bibliographystyle{plainnat} \title{cummeRbund: Sample Workflow} \author{Loyal A. Goff, Cole Trapnell} \date{} \title{CummeRbund workflow} \author{Loyal A. Goff} \begin{document} <>= options(width=65) @ \maketitle This document is a work in progress and will continually be updated as new features or analyses are integrated into the cummeRbund pipeline. This guide is being released as is, with the understanding that existing gaps will be completed in due time. Please bear with us as we work to expand this resource. \tableofcontents \section{Overview} \section{Workflow Summary} \section{Reading cuffdiff output} <>= library(cummeRbund) @ <>= cuff <- readCufflinks(dir=system.file("extdata", package="cummeRbund")) cuff @ This example uses the 'test' dataset that is included in the cummeRbund package. Importantly, if your current working directory contains the output from your cuffdiff analysis, simply calling \Rfunction{cuff<-readCufflinks()} will automatically find the default files and begin parsing your data. \section{Quality Assessment of data} \subsection{Evaluating model fit} <>= d<-dispersionPlot(genes(cuff)) d @ <>= <> print(d) @ \subsection{Identifying outlier replicates} <>= pBoxRep<-csBoxplot(genes(cuff),replicates=T) pBoxRep @ <>= pDendro<-csDendro(genes(cuff),replicates=T) pDendro @ <>= <> print(pBoxRep) @ <>= <> print(pDendro) @ \subsection{Determining relationships between conditions} <>= pBox<-csBoxplot(genes(cuff)) pBox @ <>= <> print(pBox) @ \section{Analysis of differential expression} \subsection{Identifying differentially expressed genes} <>= sigGeneIds<-getSig(cuff,alpha=0.05,level="genes") head(sigGeneIds) length(sigGeneIds) @ <>= hESCvsFibroblast.sigGeneIds<-getSig(cuff,"hESC","Fibroblasts",alpha=0.05,level="genes") head(hESCvsFibroblast.sigGeneIds) length(hESCvsFibroblast.sigGeneIds) @ \subsubsection{Creating significant gene sets} <>= sigGenes<-getGenes(cuff,sigGeneIds) sigGenes @ \subsubsection{Visualization of significant gene sets} \subsection{Identifying differentially expressed features} <>= sigGeneIds<-getSig(cuff,alpha=0.05,level="isoforms") head(sigGeneIds) length(sigGeneIds) @ \subsubsection{Creating significant feature sets} \subsubsection{Visualization of significant feature sets} \subsection{Analysis of individual genes} \subsubsection{Subsetting individual genes} \subsubsection{Creating a CuffGene object} <>= Pink1<-getGene(cuff,'PINK1') Pink1 @ \subsubsection{Visualization of individual genes} \section{Data Exploration} \subsection{Identifying patterns of gene expression} Partitioning around medioids as e.g. \subsection{Similarity analysis} \Rmethod{findSimilar} \subsection{Specificity analysis} \Rmethod{csSpecificity} \section{Analysis of differential splicing} \section{Analysis of differential promoter usage} \section{Linking with additional analyses} \subsection{Gene Ontology Analysis (clusterProfiler)} In this particular example, the reference .gtf file that was used has the official gene symbol (HUGO) stored in the \emph{gene name} attribute field. This value is carried over by cuffdiff and cummeRbund into the \emph{gene\_short\_name} field for each feature. We will exploit this ID and use it to map genes to their \emph{Entrez ID} to be able to use the very nice \Rpackage{clusterProfiler} package. The first step is to translate \subsection{Gene Set Enrichment Analysis (Preranked)} We will generate .rnk and .gmx files for use in the GSEA Preranked analysis. \subsection{Principal component analysis} \section{Visualization Tips/Tricks} \subsection{Faceting} \section{Session Info} \end{document} cummeRbund/vignettes/cummeRbund-manual.Rnw0000644000175200017520000015743314516004263021767 0ustar00biocbuildbiocbuild% % % %\VignetteIndexEntry{CummeRbund User Guide} %\VignetteKeywords{cummeRbund,visualization,NGS,sequencing,cufflinks,cuffdiff} %\VignettePackage{cummeRbund} % %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% %\SweaveOpts{prefix.string=graphics/cummeRbund-manual} \documentclass[10pt]{article} \usepackage[margin=0.75in]{geometry} \usepackage{amsmath} \usepackage[authoryear,round]{natbib} \usepackage{hyperref} \usepackage{graphicx, subfig} \hypersetup{ colorlinks, citecolor=black, filecolor=black, linkcolor=red, urlcolor=black } \usepackage{theorem} \usepackage{float} \usepackage{ifthen} \usepackage[OT1]{fontenc} %%%%%% % Alter some LaTeX defaults for better treatment of figures: % See p.105 of "TeX Unbound" for suggested values. % See pp. 199-200 of Lamport's "LaTeX" book for details. % General parameters, for ALL pages: \renewcommand{\topfraction}{0.9} % max fraction of floats at top \renewcommand{\bottomfraction}{0.8} % max fraction of floats at bottom % Parameters for TEXT pages (not float pages): \setcounter{topnumber}{2} \setcounter{bottomnumber}{2} \setcounter{totalnumber}{4} % 2 may work better \setcounter{dbltopnumber}{2} % for 2-column pages \renewcommand{\dbltopfraction}{0.9} % fit big float above 2-col. text \renewcommand{\textfraction}{0.07} % allow minimal text w. figs % Parameters for FLOAT pages (not text pages): \renewcommand{\floatpagefraction}{0.7} % require fuller float pages % N.B.: floatpagefraction MUST be less than topfraction !! \renewcommand{\dblfloatpagefraction}{0.7} % require fuller float pages % remember to use [htp] or [htpb] for placement %%%%%%%%%%% \newcommand{\R}{{\textsf{R}}} \newcommand{\code}[1]{{\texttt{#1}}} \newcommand{\term}[1]{{\emph{#1}}} \newcommand{\Rpackage}[1]{\textsf{#1}} \newcommand{\Rfunction}[1]{\texttt{#1}} \newcommand{\Robject}[1]{\texttt{#1}} \newcommand{\Rclass}[1]{{\textit{#1}}} \newcommand{\Rmethod}[1]{{\textit{#1}}} \newcommand{\Rfunarg}[1]{{\textit{#1}}} \bibliographystyle{plainnat} \title{CummeRbund: Visualization and Exploration of Cufflinks High-throughput Sequencing Data} \author{Loyal A. Goff, Cole Trapnell, David Kelley} \date{May 7, 2014} \begin{document} <>= options(width=65) @ \maketitle \tableofcontents \clearpage \section{Requirements} NOTE: cummeRbund 2.0 was designed in conjunction with the release of cufflinks 2.0. While we attempted to preserve backwards-compatability, it is highly recommended that you update your cufflinks installation to version $\ge$2.0 to take full advantage of the improvements in modeling, reporting, and visualization that have been incorporated. \begin{itemize} \item Cufflinks $\ge$ v2.0.1 \item SQLite \item R $\ge$ v3.0 \item Packages: \begin{itemize} \item \Rpackage{RSQLite} \item \Rpackage{ggplot2 $\ge$ v0.9.3} \item \Rpackage{reshape2} \item \Rpackage{plyr} \item \Rpackage{fastcluster} \item \Rpackage{rtracklayer} \item \Rpackage{Gviz} \item \Rpackage{BiocGenerics $\ge$ 0.3.2} \item Recommended: \begin{itemize} \item \Rpackage{Hmisc} \end{itemize} \end{itemize} \end{itemize} \clearpage \section{Introduction} \Rpackage{cummeRbund} is a visualization package for Cufflinks high-throughput sequencing data. It is designed to help you navigate through the large amount of data produced from a Cuffdiff RNA-Seq differential expression analysis. The results of this analysis are typically a large number of inter-related files that are not terribly intuitive to navigate through. cummeRbund helps promote rapid analysis of RNA-Seq data by aggregating, indexing, and allowing you easily visualize and create publication-ready figures of your RNA-Seq data while maintaining appropriate relationships between connected data points. CummeRbund is a multifaceted suite for streamlined analysis and visualization of massively parallel RNA differential expression data sequencing data. CummeRbund begins by re-organizing output files of a cuffdiff analysis, and storing these data in a local SQLite database. CummeRbund indexes the data to speed up access to specific feature data (genes, isoforms, TSS, CDS, etc.), and preserves the various relationships between these features. Access to data elements is managed via the RSQLite package and data are presented in appropriately structured R classes with various convenience functions designed to streamline your workflow. This persistent database storage means that inter-connected expression values are rapidly accessible and quickly searchable in future analyses. CummeRbund defines two types of data classes, 'pointer' or reference classes describe SQL connections to the database without directly containing data, and 'data' classes that retrieve a subset of related data points such as associated features from a given gene or gene set. Each class type has methods for direct access to FPKM vales, differential expression information, statistical test results, raw and normalized fragment counts, individual replicate FPKM values, and additional annotation information for features. Output formats allow for browsing and analysis of data in standard R objects (data.frame, list, etc). CummeRbund was designed to provide analysis and visualization tools analogous to microarray data. In this regard, numerous plotting methods are provided for visualization of RNA-Seq data quality and global statistics, and simple routines for plotting expression levels for one or thousands of genes, their isoforms, TSS groups, or CDS groups. The base class, \Rclass{cuffSet} is a 'pointer' to cuffdiff data that are stored out-of-memory in a sqlite database. \clearpage \section{CummeRbund Classes} \subsection{CuffSet Class} A pointer class to control access to the sqlite tables holding the Cufflinks data. The primary slot is DB which contains the RSQLite connection object. This can be accessed using the \Rmethod{DB()} accessor. The additional slots (genes, isoforms, TSS, and CDS) are each instances of the \Rclass{CuffData} class and are pointers to sets of tables for each data subtype. They can be accessed with similar accessor wrappers. This is the default class created by \Rmethod{readCufflinks}. By default, \Rclass{CuffData} accessor methods applied to a \Rclass{CuffSet} class will operate on the 'genes' slot. The \Rmethod{runInfo()} method can be used to retrieve information about the actual cuffdiff run itself, including command-line arguments used to generate the results files. \subsection{CuffData Class} The \Rclass{CuffData} class is also a pointer class to the SQL backend, but each instance is specific for a data subtype (genes, isoforms, TSS, CDS). Again, there is an DB slot (accessible using \Rmethod{DB()}) that contains the RSQLite connection object. There are several accessor, setter, and plotting methods that allow for global analysis of all features within a \Rmethod{CuffData} class.Subsetting is currently being re-written, however, it is primarily done through the 'gene\_id' field. Available slots for the CuffData class are: \begin{itemize} \item DB: RSQLite connection object \item tables: A \Rclass{list} of tables in the SQLite DB that contain the cufflinks data. \item filters: A \Rclass{list} of filters for subsetting (not implemented yet). \item type: A \Rclass{character} field describing the data (ie. 'genes','isoforms','TSS','CDS','other') \item idField: The name of the identifying index field for this object (eg. 'gene\_id' for type='gene', or 'isoform\_id' for type='isoform') \end{itemize} Making the best use of either the CuffSet or CuffData classes will enable you to keep the entire dataset out of memory and significantly improve performance for large cufflinks datasets. \subsection{CuffDist Class} The \Rclass{CuffDist} class is an pointer class that contains the results of the various 'distribution tests' performed by cuffdiff. These include differential promoter usage, differential splicing, and differential CDS usage. These are independent tests from the differential analysis of gene-, isoform-, TSS-, and CDS-level features and therefore have their own container type to distinguish them as such. The 'promoters', 'relCDS', and 'splicing' slots of a \Rclass{CuffSet} class are all \Rclass{CuffDist} instances. Available slots for the CuffDist class are: \begin{itemize} \item DB: RSQLite connection object \item tables: A \Rclass{list} of tables in the SQLite DB that contain the distribution test data. \item type: A \Rclass{character} field describing the data (ie. 'promoters','relCDS','splicing') \item idField: The name of the identifying index field for this object (eg. 'TSS\_group\_id' for type='promoters', or 'CDS\_id' for type='relCDS', etc.) \end{itemize} \subsection{CuffFeatureSet Class} The \Rclass{CuffFeatureSet} class is a data-storage container that holds all available data for a pre-determined list of features. Slots for FPKM data, differential regulation data, and feature-level annotation are all available. Unlike the previous classes, this class contains no connection information to the SQL database, but rather contains several slots with \Rclass{data.frame} objects storing multiple-features worth of information. There are available accessors, and plotting methods that are designed to present multiple-features worth of information (eg. heatmaps, scatterplots, etc) Available slots for a \Rclass{CuffFeatureSet} object include: \begin{itemize} \item annotation: Holds all feature-level annotation information for all features in object. \item fpkm: A data frame of FPKM data across all conditions, for all features in object. \item repFpkm: A data frame of deconvolved FPKM values across individual replicates, for all features in object. \item diff: A data frame of differential expression/regulation data for all features in object. \item count: A data frame containing raw and normalized fragment counts, variance, dispersion, and uncertainty for all features in object. \item genome: A character string indicating which build of the genome the associated features are derived from. (e.g. `hg19',`mm9') \end{itemize} A specialized sub-class of \Rclass{CuffFeatureSet} is the \Rclass{CuffGeneSet} class. This subclass adds additional slots to contain all isoforms, TSS, and CDS information for a given set of gene\_ids. The \Rclass{CuffGeneSet} class is designed to aggregate all relevant information for a set of genes into one object for easy analysis and/or manipulation. The \Rclass{CuffGeneSet} object adds the following slots: \begin{itemize} \item ids: A 'character' list of all gene\_ids used in object. \item isoforms: A \Rclass{CuffFeatureSet} object for all isoforms of genes in object. \item TSS: A \Rclass{CuffFeatureSet} object for all TSS of genes in object. \item CDS: A \Rclass{CuffFeatureSet} object for all CDS of genes in object. \end{itemize} \subsection{CuffFeature Class} The \Rclass{CuffFeature} class is designed for single-feature-level data analysis and plotting. The methods available for this object are designed to analyze or visualize information about a specific feature. This is a 'data' object, as opposed to a 'pointer' object to the database backend. There is a validity requirement that a \Rclass{CuffFeature} object only point to data from a single feature. Available slots for a \Rclass{CuffFeature} object include: \begin{itemize} \item annotation: Holds feature-level annotation information for a given feature. \item fpkm: A data frame of FPKM data across all samples for a given feature. \item repFpkm: A data frame of deconvolved FPKM values across all replicates for a given feature. \item diff: A data frame of differential expression/regulation data for a given feature. \item count: A data frame containing raw and normalized fragment counts, variance, dispersion, and uncertainty for a given feature. \end{itemize} A specialized sub-class of \Rclass{CuffFeature} is the \Rclass{CuffGene} class. This subclass adds additional slots to contain all isoform, TSS, and CDS information for a given gene. The \Rclass{CuffGene} object adds the following slots: \begin{itemize} \item id: The common 'gene\_id' for all data in object \item isoforms: A \Rclass{CuffFeature} object for all isoforms of a given gene. \item TSS: A \Rclass{CuffFeature} object for all TSS of a given gene. \item CDS: A \Rclass{CuffFeature} object for all CDS of a given gene. \item features: A \Rclass{data.frame} object containing feature information for the transcript models describing the gene. \end{itemize} \clearpage \section{Reading cuffdiff output} \Rpackage{cummeRbund} was designed to process the multi-file output format for a 'cuffdiff' differential expression analysis. In this type of analysis, a user will use a reference .gtf file (either known annotation or a .gtf file created from a cufflinks assembly or merge of assemblies) and quantitate the expression values and differential regulation of the annotation(s) in the .gtf file across two or more SAM/BAM files. By design, cuffdiff produces a number of output files that contain test results for changes in expression at the level of transcripts, primary transcripts, and genes. It also tracks changes in the relative abundance of transcripts sharing a common transcription start site, and in the relative abundances of the primary transcripts of each gene. Tracking the former allows one to see changes in splicing, and the latter lets one see changes in relative promoter use within a gene. \\ Note:Early versions of Cuffdiff required that transcripts in the input GTF be annotated with certain attributes in order to look for changes in primary transcript expression, splicing, coding output, and promoter use. This is no longer the case with >=v1.1.1 of \Rpackage{cummeRbund}, however we still recommend the use of both the following attributes in your GTF file to enable all downstream features of \Rpackage{cummeRbund}. \\ These attributes are: \begin{itemize} \item tss\_id: The ID of this transcript's inferred start site. Determines which primary transcript this processed transcript is believed to come from. Cuffcompare appends this attribute to every transcript reported in the .combined.gtf file. \item p\_id The ID of the coding sequence this transcript contains. This attribute is attached by Cuffcompare to the .combined.gtf records only when it is run with a reference annotation that include CDS records. Further, differential CDS analysis is only performed when all isoforms of a gene have p\_id attributes, because neither Cufflinks nor Cuffcompare attempt to assign an open reading frame to transcripts. \end{itemize} cuffdiff calculates the FPKM of each transcript, primary transcript, and gene in each sample. Primary transcript and gene FPKMs are computed by summing the FPKMs of transcripts in each primary transcript group or gene group. The results are output in FPKM tracking files, the structure of which can be found in the cufflinks manual.\\ There are four FPKM tracking files: \begin{itemize} \item \emph{isoforms.fpkm\_tracking} Transcript FPKMs \item \emph{genes.fpkm\_tracking} Gene FPKMs. Tracks the summed FPKM of transcripts sharing each gene\_id \item \emph{cds.fpkm\_tracking} Coding sequence FPKMs. Tracks the summed FPKM of transcripts sharing each p\_id, independent of tss\_id \item \emph{tss\_groups.fpkm\_tracking} Primary transcript FPKMs. Tracks the summed FPKM of transcripts sharing each tss\_id \end{itemize} cuffdiff also performs differential expression tests between supplied conditions. This tab delimited file lists the results of differential expression testing between samples for spliced transcripts, primary transcripts, genes, and coding sequences. For detailed file structure see cufflinks manual. \\ Four .diff files are created: \begin{itemize} \item \emph{isoform\_exp.diff} Transcript differential FPKM. \item \emph{gene\_exp.diff} Gene differential FPKM. Tests difference sin the summed FPKM of transcripts sharing each gene\_id \item \emph{tss\_group\_exp.diff} Primary transcript differential FPKM. Tests differences in the summed FPKM of transcripts sharing each tss\_id \item \emph{cds\_exp.diff} Coding sequence differential FPKM. Tests differences in the summed FPKM of transcripts sharing each p\_id independent of tss\_id \end{itemize} In addition, cuffdiff also performs differential splicing, CDS usage, and promoter usage tests for each gene across conditions: \begin{itemize} \item \emph{splicing.diff} Differential splicing tests. \item \emph{CDS.diff} Differential coding output. \item \emph{promoters.diff} Differential promoter use. \end{itemize} All of these output files are related to each other through their various tracking\_ids, but parsing through individual files to query for important result information requires both a good deal of patience and a strong grasp of command-line text manipulation. Enter cummeRbund, an R solution to aggregate, organize, and help visualize this multi-layered dataset. \\ One of the principle benefits of using cummeRbund is that data are stored in a SQLite database. This allows for out-of-memory analysis of data, quick retrieval, and only a one-time cost to setup the tables. By default, cummeRbund assumes that all output files from cuffdiff are in the current working directory. To read these files, populate the 'cuffData.db' database backend, and return the \Rclass{CuffSet} pointer object, you can do the following. <>= library(cummeRbund) @ %%fileDir<-("../../extdata/") <>= myDir<-system.file("extdata", package="cummeRbund") #You can leave blank if cwd or replace with your own directory path. gtfFile<-system.file("extdata/chr1_snippet.gtf",package="cummeRbund") #path to .gtf file used in cuffdiff analysis. cuff <- readCufflinks(dir=myDir,gtfFile=gtfFile,genome="hg19",rebuild=T) @ <>= cuff<-readCufflinks() @ <>= cuff @ Again, by default $dir$ is assumed to be the current working directory and \code{cuff<-readCufflinks()} should work if all appropriate files are in the current working directory. We now also recommend that you use both the \Rfunarg{genome} and \Rfunarg{gtfFile} arguments to readCufflinks(). This will allow cummeRbund to archive the transcript structure information located in the .gtf file associated with your particular cuffdiff run, as well as associate these transcripts with an appropriate genome build (e.g. 'hg19', 'mm9', etc) so as to allow for transcript-level visualizations and future integration with other external resources. Should you need to rebuild the SQLite backend for any reason, you can add the option \Rfunarg{rebuild=T} to \Rmethod{readCufflinks}. Once the database is created, \Rmethod{readCufflinks} will default to using the SQL backend and should not need to rebuild this database. Each R session should begin with a call to \Rmethod{readCufflinks} so as to initialize the database connection and create an object with the appropriate RSQLite connection information. \subsection{Adding additional feature annotation} Gene- or feature-level annotation can be permanently added to the database tables for future querying. If you have a data.frame where the first column contains the 'tracking\_id' (eg. 'gene\_id' for genes, 'isoform\_id' for isoforms, etc). You can easily add feature level annotation using the \Rfunction{addFeatures()} function: <>= #annot<-read.table("gene_annotation.tab",sep="\t",header=T,na.string="-") #addFeatures(cuff,annot,level="genes") @ By default, features added to a \Rclass{CuffSet} object are assumed to be gene-level annotations, but the level can selected using the argument \Rfunarg{level}. Features added to a \Rclass{CuffData} object are assumed to be of the same type as the 'type' value for that given object (e.g. gene-level features for 'genes', isoform-level features for isoforms, etc.) \clearpage \section{Global statistics and Quality Control} Several plotting methods are available that allow for quality-control or global analysis of cufflinks data. A good place to begin is to evaluate the quality of the model fitting. Overdispersion is a common problem in RNA-Seq data. As of cufflinks $v2.0$ mean counts, variance, and dispersion are all emitted, allowing you to visualize the estimated overdispersion for each sample as a quality control measure. <>= disp<-dispersionPlot(genes(cuff)) disp @ \begin{figure}[htp] \begin{center} \subfloat[Count vs dispersion plot by condition for all genes.]{ <>= print(disp) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_dispersion_plot} } \end{center} \end{figure} Alternatively a call to \code{dispersionPlot(cuff)} directly will allow you to visualize the full model fit. The squared coefficient of variation is a normalized measure of cross-replicate variability that can be useful for evaluating the quality your RNA-seq data. Differences in $CV^2$ can result in lower numbers of differentially expressed genes due to a higher degree of variability between replicate fpkm estimates. <>= genes.scv<-fpkmSCVPlot(genes(cuff)) isoforms.scv<-fpkmSCVPlot(isoforms(cuff)) @ \begin{figure}[htp] \begin{center} \subfloat[The squared coefficient of variation allows visualization of cross-replicate variability between conditions and can be a useful metric in determining data quality at the gene level (left) or isoform level (right). Here we demonstrate the variability of each individual ENCODE project RNA-seq conditions.]{ \includegraphics[width=0.85\textwidth]{ENCODE_SCV} } \end{center} \end{figure} %FPKM distributions - Density To assess the distributions of FPKM scores across samples, you can use the \Rmethod{csDensity} plot (Figure 1). <>= dens<-csDensity(genes(cuff)) dens densRep<-csDensity(genes(cuff),replicates=T) densRep @ \begin{figure}[htp] \begin{center} \subfloat[Density plot of individual conditions.]{ <>= <> print(dens) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dens} } \qquad \subfloat[Density plot with replicates=TRUE exposes individual replicate FPKM distributions.]{ <>= print(densRep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dens_rep}} \end{center} \end{figure} %FPKM distributions - Boxplot Boxplots can be visualized using the \Rmethod{csBoxplot} method (Figure 2). <>= b<-csBoxplot(genes(cuff)) b brep<-csBoxplot(genes(cuff),replicates=T) brep @ \begin{figure}[htp] \begin{center} \subfloat[Box plot of FPKM distributions for individual conditions.]{ <>= <> print(b) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_box} } \qquad \subfloat[Box plot with replicates=TRUE exposes individual replicate FPKM distributions.]{ <>= print(brep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_box_rep}} \end{center} \end{figure} %Scatterplots A matrix of pairwise scatterplots can be drawn using the csScatterMatrix() method. <>= s<-csScatterMatrix(genes(cuff)) @ \begin{figure}[htp] \begin{center} \subfloat[Scatterplots can be useful to identify global changes and trends in gene expression between pairs of conditions.]{ <>= <> print(s) @ \includegraphics[width=0.65\textwidth]{cummeRbund-manual-global_plots_scatter_1}} \end{center} \end{figure} Individual Pairwise comparisons can be made by using \Rmethod{csScatter}. You must specify the sample names to use for the $x$ and $y$ axes: <>= s<-csScatter(genes(cuff),"hESC","Fibroblasts",smooth=T) s @ \begin{figure}[htp] \begin{center} \subfloat[Pairwise scatterplots can identify biases in gene expression between two particular conditions.]{ <>= <> print(s) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_scatter_2}} \end{center} \end{figure} %Dendrograms <>= dend<-csDendro(genes(cuff)) dend.rep<-csDendro(genes(cuff),replicates=T) @ \begin{figure}[htp] \begin{center} \subfloat[Dendrogram of JS distances between conditions.]{ <>= <> plot(dend) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dendro} } \qquad \subfloat[Dendrogram with replicates=TRUE can identify outlier replicates.]{ <>= plot(dend.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_dendro_rep}} \end{center} \end{figure} %MA plots MvsA plots can be useful to determine any systematic bias that may be present between conditions. The CuffData method \Rmethod{MAplot()} can be used to examine these intensity vs fold-change plots. You must specify the sample names to use for the pairwise comparison with $x$ and $y$: <>= m<-MAplot(genes(cuff),"hESC","Fibroblasts") m mCount<-MAplot(genes(cuff),"hESC","Fibroblasts",useCount=T) mCount @ \begin{figure}[htp] \begin{center} \subfloat[MA plots can identify biases across ranges of intensity and fold-change.]{ <>= <> print(m) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_MA}} \qquad \subfloat[MA plot drawn on normalized count values instead of FPKM.]{ <>= print(mCount) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_MA_count}} \end{center} \end{figure} %Volcano plots Volcano plots are also available for the \Rclass{CuffData} objects. <>= v<-csVolcanoMatrix(genes(cuff)) v @ \begin{figure}[htp] \begin{center} \subfloat[Volcano plots explore the relationship between fold-change and significance.]{ <>= <> print(v) @ \includegraphics[width=0.65\textwidth]{cummeRbund-manual-global_plots_volcano_1}} \end{center} \end{figure} For individual pairwise comparisons, you must specify the comparisons by sample name. <>= v<-csVolcano(genes(cuff),"hESC","Fibroblasts") v @ \begin{figure}[htp] \begin{center} \subfloat[Volcano plots explore the relationship between fold-change and significance.]{ <>= <> print(v) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-global_plots_volcano_2}} \end{center} \end{figure} \clearpage \section{Accessing Data} \subsection*{Cuffdiff run information} Run-level information such as run parameters, and sample information can be accessed from a \Rclass{CuffSet} object by using the \Rmethod{runInfo} and \Rmethod{replicates} methods: <>= runInfo(cuff) replicates(cuff) @ \subsection*{Features/Annotation} Feature-level information can be accessed directly from a \Rclass{CuffData} object using the \Rmethod{fpkm}, \Rmethod{repFpkm}, \Rmethod{count}, \Rmethod{diffData}, or \Rmethod{annotation} methods: <>= gene.features<-annotation(genes(cuff)) head(gene.features) gene.fpkm<-fpkm(genes(cuff)) head(gene.fpkm) gene.repFpkm<-repFpkm(genes(cuff)) head(gene.repFpkm) gene.counts<-count(genes(cuff)) head(gene.counts) isoform.fpkm<-fpkm(isoforms(cuff)) head(isoform.fpkm) gene.diff<-diffData(genes(cuff)) head(gene.diff) @ \subsection*{Condition and feature names} Vectors of sample names and feature names are available by using the \Rmethod{samples} and \Rmethod{featureNames} methods: <>= sample.names<-samples(genes(cuff)) head(sample.names) gene.featurenames<-featureNames(genes(cuff)) head(gene.featurenames) @ \subsection*{Convenience functions} To facilitate Bioconductor-like operations, an 'FPKM-matrix' can be returned easily using the \Rmethod{fpkmMatrix} method: <>= gene.matrix<-fpkmMatrix(genes(cuff)) head(gene.matrix) @ A matrix of replicate FPKM values can be retrieved by using \Rmethod{repFpkmMatrix} <>= gene.rep.matrix<-repFpkmMatrix(genes(cuff)) head(gene.rep.matrix) @ Similarly, a matrix of normalized counts can be generated by using \Rmethod{countMatrix} <>= gene.count.matrix<-countMatrix(genes(cuff)) head(gene.count.matrix) @ \subsection{Writing your own SQL accessors} Since the cuffData.db is a SQLite database backend, if you are familiar with SQL and/or RSQLite query construction, you can simply design your own SQL queries to access the data that you are after. \begin{figure}[h] \centering \includegraphics[angle=90, height=\textheight]{cuffData_schema.pdf} \end{figure} \clearpage \section{Creating Gene Sets} Gene Sets (stored in a \Rclass{CuffGeneSet} object) can be created using the \Rmethod{getGenes} method on a CuffSet object. You must first create a vector of 'gene\_id' or 'gene\_short\_name' values to identify the genes you wish to select: <>= data(sampleData) myGeneIds<-sampleIDs myGeneIds myGenes<-getGenes(cuff,myGeneIds) myGenes @ The same \Rmethod{fpkm}, \Rmethod{repFpkm}, \Rmethod{count}, \Rmethod{annotation}, \Rmethod{diffData}, \Rmethod{samples}, and \Rmethod{featureNames} methods are available for instances of the \Rmethod{CuffGeneSet} class, but additional accessor methods are available for the \Rmethod{promoters}, \Rmethod{relCDS}, and \Rmethod{splicing} slot data as well. <>= #FPKM values for genes in gene set head(fpkm(myGenes)) #Isoform-level FPKMs for gene set head(fpkm(isoforms(myGenes))) #Replicate FPKMs for TSS groups within gene set head(repFpkm(TSS(myGenes))) @ As of \Rpackage{cummeRbund} $v2.0$ \Rclass{CuffGeneSet} classes can be created from any type of identifier ('gene\_id','isoform\_id','TSS\_group\_id', or 'CDS\_id'). When you pass a list of identifiers that are not gene\_id to \Rmethod{getGenes()}, the function attempts to lookup the parent gene\_id for each feature and returns \emph{all} relevant information for the given genes and all of their sub-features (not just the sub-features passed to \Rmethod{getGenes()}). If you are interested in just retrieving information for a given set of features, please use the new \Rmethod{getFeatures()} method described later. More recent versions of cummeRbund allow for subsetting of conditions as well, by passing a vector of condition names to getGenes using the \Rfunarg{sampleIdList} argument. <>= myGeneset.pluri<-getGenes(cuff,myGeneIds,sampleIdList=c("hESC","iPS")) myGeneset.pluri @ \subsection{Geneset level plots} There are several plotting functions available for gene-set-level visualization: The \Rmethod{csHeatmap()} function is a plotting wrapper that takes as input either a CuffGeneSet or a CuffFeatureSet object (essentially a collection of genes and/or features) and produces a heatmap of FPKM expression values. The 'cluster' argument can be used to re-order either 'row', 'column', or 'both' dimensions of this matrix. By default, the Jensen-Shannon distance is used as the clustering metric, however, any function that produces a \Rclass{dist} object can be passed to the 'cluster' argument as well. <>= h<-csHeatmap(myGenes,cluster='both') h h.rep<-csHeatmap(myGenes,cluster='both',replicates=T) h.rep @ \begin{figure}[htp] \begin{center} \subfloat[Heatmaps provide a convenient way to visualize the expression of entire gene sets at once.]{ <>= <> print(h) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_heatmap}} \qquad \subfloat[Same heatmap, with replicates=T can help to visualize variance between replicates.]{ <>= print(h.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_heatmap_rep}} \end{center} \end{figure} If you prefer barplots over heatmaps for genesets (although this is not necessarily recommended for large gene sets). You can use the \Rmethod{expressionBarplot()} method on a \Rclass{CuffFeatureSet} or a \Rclass{CuffGeneSet} object. <>= b<-expressionBarplot(myGenes) b @ \begin{figure}[htp] \begin{center} \subfloat[A (somewhat crowded) barplot for all genes in a CuffGeneSet object.]{ <>= <> print(b) @ \includegraphics[width=0.9\textwidth]{cummeRbund-manual-geneset_plots_barplot}} \end{center} \end{figure} The \Rmethod{csScatter()} method can be used to produce scatter plot comparisons between any two conditions. <>= s<-csScatter(myGenes,"Fibroblasts","hESC",smooth=T) s @ \begin{figure}[htp] \begin{center} \subfloat[Scatterplot showing relationship between two conditions for genes in a CuffGeneSet.]{ <>= <> print(s) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_scatter}} \end{center} \end{figure} The volcano plot is a useful visualization to compare fold change between any two conditions and significance (-log P-values). <>= v<-csVolcano(myGenes,"Fibroblasts","hESC") v @ \begin{figure}[htp] \begin{center} \subfloat[Fold-change vs significance for genes in a CuffGeneSet object.]{ <>= <> print(v) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_volcano}} \end{center} \end{figure} Similar plots can be made for all sub-level features of a \Rclass{CuffGeneSet} class by specifying which slot you would like to plot (eg. \Rfunarg{isoforms(myGenes)},\Rfunarg{TSS(myGenes)},\Rfunarg{CDS(myGenes)}). <>= ih<-csHeatmap(isoforms(myGenes),cluster='both',labRow=F) ih th<-csHeatmap(TSS(myGenes),cluster='both',labRow=F) th @ \begin{figure}[htp] \begin{center} \subfloat[A heatmap of isoform-level FPKM values for all genes in a CuffGeneSet object.]{ <>= <> print(ih) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_isoform_heatmap}} \qquad \subfloat[A heatmap of TSS-level FPKM values for all genes in a CuffGeneSet object.]{ <>= print(th) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_TSS_heatmap}} \end{center} \end{figure} Dendrograms can provide insight into the relationships between conditions for various genesets (e.g. significant genes used to draw relationships between conditions). As of v1.1.3 the method \Rmethod{csDendro()} can be used to plot a dendrogram based on Jensen-Shannon distances between conditions for a given \Rclass{CuffFeatureSet} or \Rclass{CuffGeneSet}. <>= den<-csDendro(myGenes) @ \begin{figure}[htp] \begin{center} \subfloat[A dendrogram of the relationship between conditions based on the expression of genes in a CuffGeneSet.]{ <>= <> plot(den) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-geneset_plots_dendro}} \end{center} \end{figure} \clearpage \section{Individual Genes} An individual CuffGene object can be created by using the \Rfunction{getGene()} function for a given 'gene\_id' or 'gene\_short\_name'. As of cummeRbund $\ge v2.0$ you can also use isoform\_id, tss\_group\_id, or cds\_id values to retrieve the corresponding parent gene object. <>= myGeneId<-"PINK1" myGene<-getGene(cuff,myGeneId) myGene head(fpkm(myGene)) head(fpkm(isoforms(myGene))) @ \subsection{Gene-level plots} <>= gl<-expressionPlot(myGene) gl gl.rep<-expressionPlot(myGene,replicates=TRUE) gl.rep gl.iso.rep<-expressionPlot(isoforms(myGene),replicates=T) gl.iso.rep gl.cds.rep<-expressionPlot(CDS(myGene),replicates=T) gl.cds.rep @ \begin{figure}[htp] \begin{center} \subfloat[Expression plot of a single gene.]{ <>= <> print(gl) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_line} } \qquad \subfloat[Expression plot of a single gene with replicate FPKMs exposed.]{ <>= print(gl.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_replicate_line}} \qquad \subfloat[Expression plot of all isoforms of a single gene with replicate FPKMs exposed.]{ <>= print(gl.iso.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_iso_replicate_line}} \qquad \subfloat[Expression plot of all CDS for a single gene with replicate FPKMs exposed.]{ <>= print(gl.cds.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_cds_replicate_line}} \end{center} \end{figure} <>= gb<-expressionBarplot(myGene) gb gb.rep<-expressionBarplot(myGene,replicates=T) gb.rep @ \begin{figure}[htp] \begin{center} \subfloat[Expression Barplot of a single gene.]{ <>= <> print(gb) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_bar} } \qquad \subfloat[Expression Barplot of a single gene with replicate FPKMs exposed.]{ <>= print(gb.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_bar_rep}} \end{center} \end{figure} <>= igb<-expressionBarplot(isoforms(myGene),replicates=T) igb @ \begin{figure}[htp] \begin{center} \subfloat[Expression Barplot of all isoforms single gene with replicates exposed.]{ <>= <> print(igb) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_bar_isoforms}} \end{center} \end{figure} <>= gp<-csPie(myGene,level="isoforms") gp @ \begin{figure}[htp] \begin{center} \subfloat[Pie charts showing relative proportion of individual isoforms for a single gene across conditions.]{ <>= <> print(gp) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_plots_pie} } \end{center} \end{figure} \clearpage \subsubsection{Gene Feature plots} If you included both the genome build and gtfFile in your call to \Rmethod{readCufflinks()} then you will be able to access some of the transcript-structure level features that are now being integrated into cummeRbund. For now, these features are extended only to the single gene, \Rclass{CuffGene} objects. Feature data are loaded into the \'features\' table of the cuffData.db database. When a \Rclass{CuffGene} object is created using \Rmethod{getGene()}, all relative features are selected from this table and a \'features\' slot is added to the resulting object. <>= head(features(myGene)) @ The \Rpackage{Gviz} package can be used to display features in a 'track'-like format. In particular, the \Rclass{GeneRegionTrack} class creates a mechanism by which we can start to visualize transcript-level structures in their genomic context. \Rpackage{cummeRbund} implements the \Rmethod{makeGeneRegionTrack()} method to quickly create a \Rclass{GeneRegionTrack} from the gene features. <>= genetrack<-makeGeneRegionTrack(myGene) plotTracks(genetrack) @ We can then use some of the additional features from the \Rpackage{Gviz} package to add additional tracks from an external data source. \textit{Note: This feature is now deprecated owing to developmental constraints. It is still provided with cummeRbund, but is no longer supported.} <>= trackList<-list() myStart<-min(features(myGene)$start) myEnd<-max(features(myGene)$end) myChr<-unique(features(myGene)$seqnames) genome<-'hg19' ideoTrack <- IdeogramTrack(genome = genome, chromosome = myChr) trackList<-c(trackList,ideoTrack) axtrack<-GenomeAxisTrack() trackList<-c(trackList,axtrack) genetrack<-makeGeneRegionTrack(myGene) genetrack trackList<-c(trackList,genetrack) biomTrack<-BiomartGeneRegionTrack(genome=genome,chromosome=as.character(myChr), start=myStart,end=myEnd,name="ENSEMBL",showId=T) trackList<-c(trackList,biomTrack) conservation <- UcscTrack(genome = genome, chromosome = myChr, track = "Conservation", table = "phyloP100wayAll", from = myStart-2000, to = myEnd+2000, trackType = "DataTrack", start = "start", end = "end", data = "score", type = "hist", window = "auto", col.histogram = "darkblue", fill.histogram = "darkblue", ylim = c(-3.7, 4), name = "Conservation") trackList<-c(trackList,conservation) plotTracks(trackList,from=myStart-2000,to=myEnd+2000) @ \clearpage \section{Data Exploration} The cummeRbund package is more than just a visualization tool as well. We are working to implement several different means of data exploration from gene and condition clustering, finding features with similar expression profiles, as well as incorporating Gene Ontology analysis. \subsection{Overview of significant features} The \Rmethod{sigMatrix()} function can provide you with a ``quick--and--dirty'' view of the number of significant features of a particular type, and at a given alpha ($0.05$ by default). For example: <>= mySigMat<-sigMatrix(cuff,level='genes',alpha=0.05) @ \begin{figure}[htp] \begin{center} \subfloat[Significant features overview matrix. This plot describes the number of significant genes at a 5\%FDR for each pairwise interaction tested.]{ <>= <> print(mySigMat) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-sig_mat_plot_1}} \end{center} \end{figure} \subsection{Creating gene sets from significantly regulated genes} One of the primary roles of a differential expression analysis is to conduct significance tests on each feature (genes, isoforms, TSS, and CDS) for appropriate pairwise comparisons of conditions. The results of these tests (after multiple testing correction of course) can be used to determine which genes are differentially regulated. \Rpackage{cummeRbund} makes accessing the results of these significance tests simple via \Rmethod{getSig()}. This function takes a CuffSet object and will scan at various feature levels ('genes' by default) to produce a \Rclass{vector} of feature IDs. By default \Rmethod{getSig()} outputs a vector of tracking IDs corresponding to all \emph{genes} that reject the null hypothesis in any condition tested. The default feature type can be changed by adjusting the 'level' argument to \Rmethod{getSig()}. In addition, a alpha value can be provided on which to filter the resulting list (the default is $0.05$ to match the default of cuffdiff). <>= mySigGeneIds<-getSig(cuff,alpha=0.05,level='genes') head(mySigGeneIds) length(mySigGeneIds) @ By default \Rmethod{getSig()} outputs a vector of tracking IDs corresponding to all \emph{genes} that reject the null hypothesis in any condition tested. The default feature type can be changed by adjusting the 'level' argument to \Rmethod{getSig()}. In addition, a alpha value can be provided on which to filter the resulting list (the default is $0.05$ to match the default of cuffdiff). Significance results for specific pairwise comparisons can be retrieved as well by specifying the two conditions as 'x' and 'y'. In this case, p-values are adjusted to reduce the impact of multiple-testing correction when only one set of tests is being conducted. <>= hESC_vs_iPS.sigIsoformIds<-getSig(cuff,x='hESC',y='iPS',alpha=0.05,level='isoforms') head(hESC_vs_iPS.sigIsoformIds) length(hESC_vs_iPS.sigIsoformIds) @ The values returned for each level of this list can be used as an argument to getGenes, to create a \Rclass{CuffGeneSet} object of significantly regulated genes (or features). <>= mySigGenes<-getGenes(cuff,mySigGeneIds) mySigGenes @ Alternatively, you can use the \Rmethod{getSigTable()} method to return a full test-table of 'significant features' x 'pairwise tests' for all comparisons. Only features in which the null hypothesis can be rejected in at least one test are reported. <>= mySigTable<-getSigTable(cuff,alpha=0.01,level='genes') head(mySigTable,20) @ \subsection{Exploring the relationships between conditions} \subsubsection{Distance matrix} Similarities between conditions and/or replicates can provide useful insight into the relationship between various groupings of conditions and can aid in identifying outlier replicates that do not behave as expected. cummeRbund provides the \Rmethod{csDistHeat()} method to visualize the pairwise similarities between conditions: <>= myDistHeat<-csDistHeat(genes(cuff)) @ \begin{figure}[htp] \begin{center} \subfloat[JS distance heatmap between conditions across all gene features.]{ <>= <> print(myDistHeat) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-dist_heat_plot_1}} \end{center} \end{figure} Again with the \Rfunarg{replicates} argument, distances between individual replicates can be presented. <>= myRepDistHeat<-csDistHeat(genes(cuff),replicates=T) @ \begin{figure}[htp] \begin{center} \subfloat[JS distance heatmap between replicate samples across all gene features.]{ <>= <> print(myRepDistHeat) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-dist_heat_plot_2}} \end{center} \end{figure} This method can be used to explore similarities between conditions for all features, or just those features contained within a \Rclass{CuffGeneSet} class. Additionally, the \Rfunarg{samples.not.genes=F} argument will display distances between individual genes or features across conditions. \subsubsection{Dimensionality reduction} Dimensionality reduction is an informative approach for clustering and exploring the relationships between conditions. It can be useful for feature selection as well as identifying the sources of variability within your data. To this end, we have applied two different dimensionality reduction strategies in \Rpackage{cummeRbund}: principal component analysis (PCA) and multi-dimensional scaling (MDS). We provide the two wrapper methods, \Rmethod{PCAplot} and \Rmethod{MDSplot} <>= genes.PCA<-PCAplot(genes(cuff),"PC1","PC2") genes.MDS<-MDSplot(genes(cuff)) genes.PCA.rep<-PCAplot(genes(cuff),"PC1","PC2",replicates=T) genes.MDS.rep<-MDSplot(genes(cuff),replicates=T) @ \begin{figure}[htp] \begin{center} \subfloat[PCA plot for gene-level features]{ <>= <> print(genes.PCA) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_PCA} } \qquad \subfloat[MDS plot for gene-level features]{ <>= print(genes.MDS) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_MDS}} \qquad \subfloat[Individual replicate level PCA plot for gene-level features]{ <>= print(genes.PCA.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_PCA_rep}} \qquad \subfloat[Individual replicate level MDS plot for gene-level features]{ <>= print(genes.MDS.rep) @ \includegraphics[width=0.4\textwidth]{cummeRbund-manual-gene_MDS_rep}} \end{center} \end{figure} CummeRbund also includes a convenience wrapper around the \Rpackage{NMFN} function \Rfunction{nnmf} for non-negative matrix factorization. You can use the \Rfunction{csNMF()} method for either CuffData and CuffFeatureSet objects. \clearpage \subsection{Partitioning} K-means clustering is a useful tool that can be helpful in identifying clusters of genes with similar expression profiles. In fact, these profiles are learned from the data during the clustering. \Rmethod{csCluster()} uses the \Rmethod{pam()} method from the \Rpackage{clustering} package to perform the partitioning around medoids. In this case however, the distance metric used by default is the Jensen-Shannon distance instead of the default Euclidean distance. Prior to performing this particular partitioning, the user must choose the number of clusters (K) into which the expression profiles should be divided. <>= ic<-csCluster(myGenes,k=4) head(ic$cluster) icp<-csClusterPlot(ic) icp @ As of v$1.1.1$ of \Rpackage{cummeRbund}, the output of csCluster is a modified \Rclass{pam} object. This replaces the default plotting behavior of the original csCluster plot to allow for further analysis of the clustering results. The original plotting behavior has been recapitulated in the \Rmethod{csClusterPlot()} method. \begin{figure}[htp] \begin{center} \subfloat[PAM clustering with JS distance for a CuffGeneSet.]{ <>= print(icp) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-geneset_plots_cluster} } \end{center} \end{figure} \clearpage \subsection{Specificity} In some cases, a researcher may be interested in identifying features that are 'condition-specific'. Or, more likely, producing an ordered list of genes based on their specificity for a given condition. We define a specificity score (S) as the following: \begin{equation} S_{g,i}=1-JSD(p_g,\hat{q_i}) \end{equation} Where $JSD$ is the Jensen-Shannon distance, $p_g$ is the expression profile of a given gene $g$ expressed as a density (probability) of $log_{10} FPKM+1$, and $\hat{q_i}$ is the unit vector of 'perfect expression' in a particular condition $i$. We have created a method, \Rmethod{csSpecificity()} that outputs a matrix (with identical shape to that produced by \Rmethod{fpkmMatrix()}) of specificity scores (S) across all conditions for all features in a \Rclass{CuffFeatureSet} or \Rclass{CuffGeneSet}. <>= myGenes.spec<-csSpecificity(myGenes) head(myGenes.spec) @ $S=1.0$ if the feature is expressed exclusively in that condition. The \Rmethod{findSimilar()} method outlined below is another method that can be used to identify genes based on specificity but has the added feature that you can determine similarity to a more complex $q$ expression profile. \clearpage \subsection{Finding similar genes} Another common question in large-scale gene expression analyses is 'How can I find genes with similar expression profiles to gene $x$?'. We have implemented a method, \Rmethod{findSimilar} to allow you to identify a fixed number of the most similar genes to a given gene of interest. For example, if you wanted to find the 20 genes most similar to "PINK1", you could do the following: <>= mySimilar<-findSimilar(cuff,"PINK1",n=20) mySimilar.expression<-expressionPlot(mySimilar,logMode=T,showErrorbars=F) @ \begin{figure}[htp] \begin{center} \subfloat[Top 20 most similar genes to 'PINK1'.]{ <>= <> print(mySimilar.expression) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-similar_plots_1}} \end{center} \end{figure} By default, findSimilar will return a CuffGeneSet of similar genes matching your criteria. Recently a few additional features have been added as well to enhance this type of exploration: \begin{itemize} \item If 'returnGeneSet' is set to FALSE, then findSimilar returns a data.frame of distance-ranked similar genes with distances. This is useful if you would like to see a rank-ordered list of similar genes. \item The 'distThresh' argument allows you to pass a value [between 0-1] to be used as a distance threshold instead of an arbitrary 'n' number of genes. setting distThresh=1.0 will return all genes ranked by their distance to your gene of interest. \end{itemize} You are also able to provide your own expression profile in lieu of a 'gene\_id'. The vector provided must match the order and length of \Rmethod{samples()}. <>= myProfile<-c(500,0,400) mySimilar2<-findSimilar(cuff,myProfile,n=10) mySimilar2.expression<-expressionPlot(mySimilar2,logMode=T,showErrorbars=F) @ \begin{figure}[htp] \begin{center} \subfloat[Top 10 genes most similar genes to a provided expression profile.]{ <>= <> print(mySimilar2.expression) @ \includegraphics[width=0.6\textwidth]{cummeRbund-manual-similar_plots_2}} \end{center} \end{figure} \Rmethod{findSimilar()} also uses the Jensen-Shannon distance between the probability distributions of each gene across conditions to determine the similarity. We have found this to be a more robust way to determine distance between genes using the high dynamic range of FPKM data. Future versions may allow for other dissimilarity measures to be used instead. \clearpage \section{Miscellaneous} \begin{itemize} \item In appropriate plots, using the argument replicates=T will allow you to visualize replicate-level FPKM values either in lieu of or in addition to condition-level FPKMs. \item As of v1.1.3 we attempt to provide new visual cues in most plots that will indicate the quantification status for a particular feature in each given condition. We have enabled this feature by default for most plots to suggest a measure of reliability for each feature in a particular condition. In most cases, this feature can be disabled by setting 'showStatus=FALSE'. \item CummeRbund will now work with the hidden '--no-diff' argument for cuffdiff. This will quantify features against .bam files but not do differential testing. This is useful when you want to aggregate very large numbers of conditions, and cannot afford the time or space for the differential test results. (Not recommended unless you have a SPECIFIC need for this). \item All plotting functions return ggplot objects and the resulting objects can be manipulated/faceted/altered using standard ggplot2 methods. \item There are occasional DB connectivity issues that arise. Not entirely sure why yet. If necessary, just \Rfunction{readCufflinks} again and this should solve connectivity issues with a new RSQLite connection object. If connectivity continues to be a problem, try \Rfunction{cuff<-readCufflinks(rebuild=T)} \item I am still working on fully documenting each of the methods. There are a good number of arguments that exist, but might be hard to find without looking at the reference manual. \end{itemize} \clearpage \section{Known Issues} \begin{itemize} \item Large cuffdiff runs (e.g. $\ge$10 conditions) produce very large results files. These will take some time to parse and populate the cuffData.db sqlite database. While this is only a one time cost, the process can take a while. We are working on making the table writes and indexing significantly faster. \item Cuffdiff does not 'require' that gene\_ids, isoform\_ids, TSS\_group\_ids, or CDS\_ids be unique in your reference gtf file. In fact, duplicate IDs will be aggregated by cummeRbund in the indexing phase and will produce undesireable effects. Please ensure that all of your IDs are unique prior to running cuffdiff (see cuffmerge for help) to avoid this issue. \end{itemize} \clearpage \section{Session info} <>= end<-dbDisconnect(cuff@DB) @ <>= sessionInfo() @ \end{document}